diff --git a/.gitattributes b/.gitattributes index dcfa0cc4b7c..07e64ed84fb 100644 --- a/.gitattributes +++ b/.gitattributes @@ -266,8 +266,6 @@ Approximate_min_ellipsoid_d/documentation/boundingbox.mw -text svneol=native#app Arithmetic_kernel/include/CGAL/CORE_arithmetic_kernel.h -text Arithmetic_kernel/include/CGAL/GMP_arithmetic_kernel.h -text Arithmetic_kernel/include/CGAL/LEDA_arithmetic_kernel.h -text -Arithmetic_kernel/include/CGAL/OLD/GMP/Gmpfr_interval_type.h -text -Arithmetic_kernel/include/CGAL/OLD/Gmpfr_interval.h -text Arithmetic_kernel/package_info/Arithmetic_kernel/description.txt -text Arithmetic_kernel/package_info/Arithmetic_kernel/maintainer -text Arithmetic_kernel/test/Arithmetic_kernel/Arithmetic_kernel.cpp -text @@ -1378,6 +1376,8 @@ Envelope_3/test/Envelope_3/data/spheres/stest6.cin -text Envelope_3/test/Envelope_3/data/spheres/stest7.cin -text Envelope_3/test/Envelope_3/data/spheres/stest8.cin -text Envelope_3/test/Envelope_3/data/spheres/stest9.cin -text +Envelope_3/test/Envelope_3/data/triangles/edge_bug.cin -text +Envelope_3/test/Envelope_3/data/triangles/edge_bug_all.cin -text Envelope_3/test/Envelope_3/data/triangles/grid_inter_tri_const_envelope.cin -text Envelope_3/test/Envelope_3/data/triangles/grid_inter_tri_const_envelope_40.cin -text Envelope_3/test/Envelope_3/data/triangles/grid_intersecting_triangles.cin -text @@ -3189,6 +3189,7 @@ Scripts/developer_scripts/check_library_uses_no_qpl_files.exceptions -text Scripts/developer_scripts/check_macro_names -text Scripts/developer_scripts/check_no_CGAL_USE_without_includes_before -text Scripts/developer_scripts/check_svn_keywords -text +Scripts/developer_scripts/clean_up_branch.sh -text Scripts/developer_scripts/common_impl.rb -text Scripts/developer_scripts/create_assertions.sh eol=lf Scripts/developer_scripts/create_cgal_test -text diff --git a/AABB_tree/demo/AABB_tree/MainWindow.cpp b/AABB_tree/demo/AABB_tree/MainWindow.cpp index c4ffcc8ae3f..e3282019ab2 100644 --- a/AABB_tree/demo/AABB_tree/MainWindow.cpp +++ b/AABB_tree/demo/AABB_tree/MainWindow.cpp @@ -402,8 +402,10 @@ void MainWindow::on_actionRefine_loop_triggered() void MainWindow::on_actionSave_snapshot_triggered() { + // save snapshot to file QApplication::setOverrideCursor(Qt::WaitCursor); - m_pViewer->saveSnapshot(QString("snapshot.png")); + QString filename = QFileDialog::getSaveFileName(this,tr("Save snapshot to file..."),"snapshot00.png","*.png"); + m_pViewer->saveSnapshot(filename); QApplication::restoreOverrideCursor(); } void MainWindow::on_actionCopy_snapshot_triggered() diff --git a/Algebraic_kernel_d/include/CGAL/RS/isole_1.h b/Algebraic_kernel_d/include/CGAL/RS/isole_1.h index f40c5a99da2..d8d86f18779 100644 --- a/Algebraic_kernel_d/include/CGAL/RS/isole_1.h +++ b/Algebraic_kernel_d/include/CGAL/RS/isole_1.h @@ -45,7 +45,7 @@ isolator::operator()(const Polynomial_ &p,unsigned int prec){ CGAL_error_msg( "isolator not implemented for this type of polynomials"); return std::vector(); -}; +} template <> inline std::vector @@ -69,7 +69,7 @@ isolator >::operator()(const Polynomial &p, intervals.push_back(Gmpfi(intervals_mpfi[j])); free(intervals_mpfi); return intervals; -}; +} } // namespace RS diff --git a/Arithmetic_kernel/include/CGAL/OLD/GMP/Gmpfr_interval_type.h b/Arithmetic_kernel/include/CGAL/OLD/GMP/Gmpfr_interval_type.h deleted file mode 100644 index 83260480752..00000000000 --- a/Arithmetic_kernel/include/CGAL/OLD/GMP/Gmpfr_interval_type.h +++ /dev/null @@ -1,166 +0,0 @@ -// TODO: add sign to RET - - -#ifndef CGAL_GMPFR_INTERVAL_TYPE_H -#define CGAL_GMPFR_INTERVAL_TYPE_H - -#include -#include -#include - -#define OP(o,d) Gmpfr r; \ - mpfr_ ## o (r.fr(), a.fr(), b.fr(), GMP_RND ## d); \ - return r; - -namespace CGAL { - -namespace internal { - -struct Rounding_for_gmpfr { -private: typedef CGAL::Gmpfr T; -public: - Rounding_for_gmpfr(){}; - ~Rounding_for_gmpfr(){}; - - T conv_down(const T& a){ // TODO: fix this - return add_down(T(0),a); - }; - T conv_up (const T& a){ // TODO: fix this - return add_up(T(0),a); - }; - // mathematical operations - T add_down(const T& a, const T& b) { - OP(add,D); - }; - T add_up (const T& a, const T& b){ - OP(add,U); - }; - T sub_down(const T& a, const T& b){ - OP(sub,D); - }; - T sub_up (const T& a, const T& b){ - OP(sub,U); - }; - T mul_down(const T& a, const T& b){ - OP(mul,D); - }; - T mul_up (const T& a, const T& b){ - OP(mul,U); - }; - T div_down(const T& a, const T& b){ - OP(div,D); - }; - T div_up (const T& a, const T& b){ - OP(div,U); - }; - - T sqrt_down(const T& a){ - T b; - mpfr_sqrt(b.fr(), a.fr(), GMP_RNDD); - return b; - }; - T sqrt_up (const T& a){ - T b; - mpfr_sqrt(b.fr(), a.fr(), GMP_RNDU); - return b; - }; - - T median(const T& a, const T& b) { - T result(a + (b-a)/2); - CGAL_postcondition(a <= result); - CGAL_postcondition(result <= b); - return result; - }; - T int_down(const T& a) { - T r; - mpfr_floor(r.fr(), a.fr()); - return r; - }; - T int_up (const T& a) { - T r; - mpfr_ceil(r.fr(), a.fr()); - return r; - }; -}; - -class Checking_for_gmpfr { - - typedef CGAL::Gmpfr T; - -public: - - static T pos_inf() { - T b; - mpfr_set_inf(b.fr(), 1); - return b; - } - - static T neg_inf() { - T b; - mpfr_set_inf(b.fr(), -1); - return b; - } - - static T nan() { - T b; - mpfr_set_nan(b.fr()); - return b; - } - - static bool is_nan(const T& b) { - return mpfr_nan_p(b.fr()); - } - - static T empty_lower() { - return T(1); - } - - static T empty_upper() { - return T(0); - } - - static bool is_empty(const T& a, const T& b) { -// return a==T(1) && b == T(0); -// return false; - return a > b; // TODO: optimize this - } -}; - -} // namespace internal -} //namespace CGAL - -namespace boost { -namespace numeric { -inline -std::ostream& operator << - (std::ostream& os, const boost::numeric::interval& x) -{ - os << "[" - << x.lower() << ", " << x.upper() << "]"; - return os; -} - - -}//namespace numeric -}//namespace boost - -namespace CGAL { - -typedef boost::numeric::interval< - Gmpfr, - boost::numeric::interval_lib::policies - < internal::Rounding_for_gmpfr, internal::Checking_for_gmpfr > > -Gmpfr_interval; - -// I have to redfine these operators, since the test reports an -// ambiguity with operators in CGAL::Polynomial -// However, it seems that this is due to the use of struct interval_holder -// in the definition of the operators in boost. - -inline bool operator == (const Gmpfr_interval& x , const Gmpfr_interval& y) -{return x.operator==(y) ;} - -} //namespace CGAL -//#endif // CGAL_USE_LEDA -#undef OP -#endif // CGAL_GMPFR_INTERVAL_TYPE_H diff --git a/Arithmetic_kernel/include/CGAL/OLD/Gmpfr_interval.h b/Arithmetic_kernel/include/CGAL/OLD/Gmpfr_interval.h deleted file mode 100644 index 403e94ac5a7..00000000000 --- a/Arithmetic_kernel/include/CGAL/OLD/Gmpfr_interval.h +++ /dev/null @@ -1,336 +0,0 @@ -// Copyright (c) 2008 Max-Planck-Institute Saarbruecken (Germany), -// National University of Athens (Greece). -// Copyright (c) 2009 Max-Planck-Institute Saarbruecken (Germany). -// All rights reserved. -// -// This file is part of CGAL (www.cgal.org); you can redistribute it and/or -// modify it under the terms of the GNU Lesser General Public License as -// published by the Free Software Foundation; version 2.1 of the License. -// See the file LICENSE.LGPL distributed with CGAL. -// -// Licensees holding a valid commercial license may use this file in -// accordance with the commercial license agreement provided with the software. -// -// This file is provided AS IS with NO WARRANTY OF ANY KIND, INCLUDING THE -// WARRANTY OF DESIGN, MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE. -// -// $URL$ -// $Id$ -// -// Author(s) : George Tzoumas , -// Michael Hemmer -// -// ============================================================================ -// -// \brief provide CGAL support for class CGAL::Gmpfr_interval. -// - -#ifndef CGAL_GMPFR_INTERVAL_H -#define CGAL_GMPFR_INTERVAL_H - -#include -#include -#include -#include -#include -#include -#include - -namespace CGAL { - -template <> class Algebraic_structure_traits< Gmpfr_interval > - : public Algebraic_structure_traits_base < Gmpfr_interval, - Field_with_sqrt_tag >{ - -public: - typedef Tag_false Is_exact; - typedef Tag_true Is_numerical_sensitive; - - class Sqrt - : public std::unary_function< Type, Type > { - public: - Type operator()( const Type& x ) const { - return ::boost::numeric::sqrt(x); - } - }; -}; - -template <> class Real_embeddable_traits< Gmpfr_interval > - : public INTERN_RET::Real_embeddable_traits_base { -public: - - class Abs - : public std::unary_function< Type, Type > { - public: - Type operator()( const Type& x ) const { - return ::boost::numeric::abs(x); - } - }; - - class To_double - : public std::unary_function< Type, double > { - public: - double operator()( const Type& x ) const { - return ::boost::numeric::median(x).to_double(); - } - }; - - class To_interval - : public std::unary_function< Type, std::pair< double, double > > { - public: - std::pair operator()( const Type& x ) const { - std::pair lower_I(x.lower().to_interval()); - std::pair upper_I(x.upper().to_interval()); - return std::pair< double, double >( - (CGAL::min)(lower_I.first , upper_I.first ), - (CGAL::max)(lower_I.second, upper_I.second)); - } - }; -}; - -template<> -class Interval_traits -{ -public: - typedef Interval_traits Self; - typedef Gmpfr_interval Interval; - typedef CGAL::Gmpfr Bound; - typedef CGAL::Tag_true With_empty_interval; - typedef CGAL::Tag_true Is_interval; - - struct Construct :public std::binary_function{ - Interval operator()( const Bound& l,const Bound& r) const { - CGAL_precondition( l < r ); - return Interval(l,r); - } - }; - - struct Lower :public std::unary_function{ - Bound operator()( const Interval& a ) const { - return a.lower(); - } - }; - - struct Upper :public std::unary_function{ - Bound operator()( const Interval& a ) const { - return a.upper(); - } - }; - - struct Width :public std::unary_function{ - Bound operator()( const Interval& a ) const { - return ::boost::numeric::width(a); - } - }; - - struct Median :public std::unary_function{ - Bound operator()( const Interval& a ) const { - return ::boost::numeric::median(a); - } - }; - - struct Norm :public std::unary_function{ - Bound operator()( const Interval& a ) const { - return ::boost::numeric::norm(a); - } - }; - - struct Empty :public std::unary_function{ - bool operator()( const Interval& a ) const { - return ::boost::numeric::empty(a); - } - }; - - struct Singleton :public std::unary_function{ - bool operator()( const Interval& a ) const { - return ::boost::numeric::singleton(a); - } - }; - - struct Zero_in :public std::unary_function{ - bool operator()( const Interval& a ) const { - return ::boost::numeric::in_zero(a); - } - }; - - struct In :public std::binary_function{ - bool operator()( Bound x, const Interval& a ) const { - return ::boost::numeric::in(x,a); - } - }; - - struct Equal :public std::binary_function{ - bool operator()( const Interval& a, const Interval& b ) const { - return ::boost::numeric::equal(a,b); - } - }; - - struct Overlap :public std::binary_function{ - bool operator()( const Interval& a, const Interval& b ) const { - return ::boost::numeric::overlap(a,b); - } - }; - - struct Subset :public std::binary_function{ - bool operator()( const Interval& a, const Interval& b ) const { - return ::boost::numeric::subset(a,b); - } - }; - - struct Proper_subset :public std::binary_function{ - bool operator()( const Interval& a, const Interval& b ) const { - return ::boost::numeric::proper_subset(a,b); - } - }; - - struct Hull :public std::binary_function{ - Interval operator()( const Interval& a, const Interval& b ) const { - return ::boost::numeric::hull(a,b); - } - }; - - struct Intersection :public std::binary_function{ - Interval operator()( const Interval& a, const Interval& b ) const { - Interval r = ::boost::numeric::intersect(a,b); - return r; - } - }; -}; - -template<> -class Bigfloat_interval_traits: - public Interval_traits -{ -public: - typedef Gmpfr_interval NT; - - typedef CGAL::Gmpfr BF; - - struct Get_significant_bits: public std::unary_function{ - - long operator()( NT x) const { - if(CGAL::zero_in(x)) return -1; - BF labs = CGAL::lower(CGAL::abs(x)) ; - BF w = CGAL::width(x); - BF err; - mpfr_div(err.fr(), w.fr(), labs.fr(), GMP_RNDU); - mpfr_log2(err.fr(), err.fr(), GMP_RNDD); - return -mpfr_get_si(err.fr(), GMP_RNDU); - } - }; - - struct Set_precision { - // type for the \c AdaptableUnaryFunction concept. - typedef long argument_type; - // type for the \c AdaptableUnaryFunction concept. - typedef long result_type; - - long operator()( long prec ) const { - long old_prec = mpfr_get_default_prec(); -// std::cerr << "precision set to " << prec << " from " << old_prec << std::endl; - mpfr_set_default_prec(prec); - return old_prec; - } - }; - - struct Get_precision { - // type for the \c AdaptableGenerator concept. - typedef long result_type; - long operator()() const { - return mpfr_get_default_prec(); - } - }; - -}; - -//Gmp internal coercions: -CGAL_DEFINE_COERCION_TRAITS_FOR_SELF(Gmpfr_interval) - -// The following definitions reflect the interaction of the Gmpfr - -// built in types : - CGAL_DEFINE_COERCION_TRAITS_FROM_TO(short ,Gmpfr_interval) - CGAL_DEFINE_COERCION_TRAITS_FROM_TO(int ,Gmpfr_interval) - CGAL_DEFINE_COERCION_TRAITS_FROM_TO(long ,Gmpfr_interval) - CGAL_DEFINE_COERCION_TRAITS_FROM_TO(float ,Gmpfr_interval) - CGAL_DEFINE_COERCION_TRAITS_FROM_TO(double ,Gmpfr_interval) - - -template <> -struct Coercion_traits{ - typedef Tag_true Are_explicit_interoperable; - typedef Tag_false Are_implicit_interoperable; - typedef CGAL::Gmpfr_interval Type; - - struct Cast{ - typedef Type result_type; - Type operator()(const CGAL::Gmpfr_interval& x) const { return x;} - Type operator()(const CGAL::Gmpz x) const { - CGAL::Gmpfr lower, upper; - mpfr_set_z (lower.fr(), x.mpz(), GMP_RNDD); - mpfr_set_z (upper.fr(), x.mpz(), GMP_RNDU); - Type bfi(lower, upper); - CGAL_postcondition( bfi.lower() <= x ); - CGAL_postcondition( bfi.upper() >= x ); - return bfi; - } - }; -}; - -template <> // mirror -struct Coercion_traits - :public Coercion_traits{}; - -template <> -struct Coercion_traits{ - typedef Tag_true Are_explicit_interoperable; - typedef Tag_false Are_implicit_interoperable; - typedef CGAL::Gmpfr_interval Type; - typedef Coercion_traits CTZ; - - struct Cast{ - typedef Type result_type; - Type operator()(const CGAL::Gmpfr_interval& x) const { return x;} - Type operator()(const CGAL::Gmpq x) const { - // early exits - if (CGAL::is_zero(x)) return Type(0,0); - if (CGAL::is_one(x.denominator())){ - return CTZ::Cast()(x.numerator()); - } - // TODO: ensure that prec is reached for resulting interval ? - Gmpfr lower, upper, nf, df; - CGAL::Gmpz num = x.numerator(); - CGAL::Gmpz den = x.denominator(); - mp_prec_t prec = mpfr_get_default_prec(); - CGAL_assertion( mpfr_get_prec(lower.fr()) == prec); - CGAL_assertion( mpfr_get_prec(upper.fr()) == prec ); - - mpfr_set_z (nf.fr(), num.mpz(), GMP_RNDD); - mpfr_set_z (df.fr(), den.mpz(), - (CGAL::sign(num) == CGAL::NEGATIVE)? GMP_RNDD: GMP_RNDU); - mpfr_div(lower.fr(), nf.fr(), df.fr(), GMP_RNDD); - - mpfr_set_z (nf.fr(), num.mpz(), GMP_RNDU); - mpfr_set_z (df.fr(), den.mpz(), - (CGAL::sign(num) == CGAL::NEGATIVE)? GMP_RNDU: GMP_RNDD); - mpfr_div(upper.fr(), nf.fr(), df.fr(), GMP_RNDU); - - Type bfi(lower, upper); - - CGAL_postcondition( bfi.lower() <= x ); - CGAL_postcondition( bfi.upper() >= x ); - return bfi; - } - }; -}; - -template <> // mirror -struct Coercion_traits - :public Coercion_traits{}; - - -// lower GMP types: -CGAL_DEFINE_COERCION_TRAITS_FROM_TO(Gmpfr,Gmpfr_interval) - -} //namespace CGAL -#endif // CGAL_GMPFR_INTERVAL_H diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_def.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_def.tex index 6a369b421d2..55fdc39adbe 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_def.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_def.tex @@ -55,7 +55,7 @@ polygon vertices is referred to as the polygon \textbf{(outer) boundary}. \item A \textbf{Relatively simple} polygon allows vertices with a degree$>$2, but all of its edges are disjoint in their interior. Furthermore, it must be an orientable polygon. Namely when it is inserted into an arrangement and its outer boundary is traversed, the same face is adjacent to all of the halfedges (no crossing over any curve during the traversal). %\textbf{insert relativelySimplePolygon.tex}\\ -Note that while polygon C has the same curves as polygon B, traversal of the curves leads to crossing over a previouly traversed curve, and is therefore neither simple nor relatively simple. +Note that while polygon C has the same curves as polygon B, traversal of the curves leads to crossing over a previously traversed curve, and is therefore neither simple nor relatively simple. %\textbf{insert NotRelativelySimplePolygon.tex}\\ \\ \item A polygon in our context must be relatively simple and its outer boundary vertices must be ordered in a counterclockwise direction around the interior of the polygon. @@ -98,7 +98,7 @@ In our context, a polygon must uphold the following conditions:\\ \begin{enumerate} \item\textit{Closed Boundary} - the polygon's outer boundary must be a connected sequence of curves, that start and end at the same vertex. \item \textit{Simplicity} - the polygon must be simple. -\item \textit{Orientaion} - the polygon's outer boundary must be \textit{counter-clockwise oriented}. +\item \textit{Orientation} - the polygon's outer boundary must be \textit{counter-clockwise oriented}. \end{enumerate} diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_general.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_general.tex index 3462d813172..cd00bd8c977 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_general.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_general.tex @@ -250,10 +250,10 @@ The class-template \ccc{Gps_traits_2} models the concept \ccc{GeneralPolygonSetTraits_2}, and can be used to instantiate the class template \ccc{General_polygon_set_2}. -It serves as an adapter for a geoemtric traits class, which models the +It serves as an adapter for a geometric traits class, which models the concept \ccc{ArrangementDirectionalXMonotoneTraits_2}. It can be used for performing set-operations on general polygons. -The implementation of the adapetr is rather simple, as it is derived +The implementation of the adapter is rather simple, as it is derived from the instantiated template-parameter \ccc{ArrXMonotoneTraits_2} inheriting its necessary types and methods. It further exploits the methods provided by the instantiated parameter diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_intro.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_intro.tex index fc05d91e843..5b084d07246 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_intro.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_intro.tex @@ -61,6 +61,6 @@ in more depth. In Section~\ref{bso_sec:bso_lin} we focus on Boolean set-operations on linear polygons, introducing the notion of polygons with holes and of a general polygon set. Section~\ref{bso_sec:bso_gen} introduces general polygons. -We first discuss polygons whose edges are either line segements or circular +We first discuss polygons whose edges are either line segments or circular arcs and then explain how to construct and use general polygons whose edges can be arbitrary weakly $x$-monotone curves. diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_linear.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_linear.tex index e17d8e2d5c3..d33437a3927 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_linear.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2/bso_linear.tex @@ -5,7 +5,7 @@ The basic library of \cgal\ includes the \ccc{Polygon_2} class-template that represents a linear polygon in the plane. The polygon is represented by its vertices stored in a container of objects of type \ccc{Kernel::Point_2}. The polygon edges are line -segments (\ccc{Kenrel::Segment_2} objects) between adjacent points in +segments (\ccc{Kernel::Segment_2} objects) between adjacent points in the container. By default, the \ccc{Container} is a vector of \ccc{Kernel::Point_2} objects. @@ -37,7 +37,7 @@ computes the union of two polygons is called \ccc{join()}, since the word \ccc{union} is reserved in \CC.} \ccc{difference()}, \ccc{symmetric_difference()} and the predicate \ccc{do_intersect()} that accept two \ccc{Polygon_2} objects as their input. We explain how -these functions should be used throught several examples in the +these functions should be used through several examples in the following sections. % ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ @@ -151,7 +151,7 @@ upside-down triangle. In general, there are many ways to arrive at a particular point set. However, the set of polygons with holes obtained through the application of any sequence of operations is unique. The set depicted on the right is represented as a single -polygon having a triangular outer boundary with a single triangluar +polygon having a triangular outer boundary with a single triangular hole in its interior --- and not as three triangles that have no holes at all. As a general rule, if two point sets are connected, then they belong to the same polygon with holes. @@ -233,7 +233,7 @@ output polygons to its associated container. \subsubsection{Example --- Joining and Intersecting Simple Polygons\label{bso_sssec:ex_simple_bops}} % ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -The following example demonstartes the usage of the free functions +The following example demonstrates the usage of the free functions \ccc{join()} and \ccc{intersect()} for computing the union and the intersection of the two simple polygons depicted in Figure~\ref{fig:simple}~(b). The example uses the auxiliary function @@ -245,7 +245,7 @@ the header file \ccc{print_utils.h} under the examples folder. % ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ \subsubsection{Operations on Polygons with Holes\label{bso_sssec:pwh_bops}} % ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ -We have demonstrated that free functions that perform boolean set operations on simple polygons may output polygons with holes. In addition to these functions, the Boolean set-operations package provides the following overriden free functions that accept +We have demonstrated that free functions that perform boolean set operations on simple polygons may output polygons with holes. In addition to these functions, the Boolean set-operations package provides the following overridden free functions that accept \ccc{General_polygon_with_holes_2} objects as their input - %Having introduced polygons with holes and explained how the free functions %output such objects, it is only natural to perform operations on sets that @@ -284,7 +284,7 @@ contains of five holes: \ccIncludeExampleCode{Boolean_set_operations_2/symmetric_difference.cpp} -In some cases it is convinient to connect the outer boundary of a +In some cases it is convenient to connect the outer boundary of a polygon with holes with the holes inside it. The function \ccc{connect_holes()} accepts a polygon with holes, and connects the topmost vertex in each hole with the polygon @@ -331,7 +331,7 @@ into the set using the \ccc{insert()} method, as long as the inserted polygons and the existing polygons in the set are disjoint. The \ccc{Polygon_set_2} class also provides access functions for accessing the polygons with holes it contains, and a few queries. The -most improtant query is \ccc{S.oriented_side(q)}, which determined +most important query is \ccc{S.oriented_side(q)}, which determined whether the query point $q$ is contained in the interior of the set $S$, lies on the boundary of the set, or neither. @@ -347,8 +347,8 @@ functions. Member functions of the \ccc{General_polygon_set_2} that perform Boolean set-operations come in two flavors: for example, \ccc{S.join(P, Q)} -computes the union of $P$ and $Q$ and assigned the reuslt to $S$, while -\ccc{S.join(P)} preformes the operation $S \longleftarrow S \cup P$. +computes the union of $P$ and $Q$ and assigned the result to $S$, while +\ccc{S.join(P)} performs the operation $S \longleftarrow S \cup P$. Similarly, \ccc{S.complement(P)} sets $S$ to be the complement of $P$, while $S.complement()$ simply negates the set $S$. @@ -358,7 +358,7 @@ while $S.complement()$ simply negates the set $S$. The free functions reviewed in Section~\ref{bso_ssec:polygons_with_holes} serve as a wrapper for the polygon-set class, and are only provided for -convinience. A typical such function constructs a pair of +convenience. A typical such function constructs a pair of \ccc{General_polygon_set_2} objects, invokes the appropriate method to apply the desired Boolean operation, and transforms the resulting polygon set to the required output format. Thus, when several diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Boolean_set_operations_2.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Boolean_set_operations_2.tex index 07124850d78..dcd4a312407 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Boolean_set_operations_2.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Boolean_set_operations_2.tex @@ -6,7 +6,7 @@ %============ An instance of the \ccClassTemplateName\ class-template represents a point set in the plane. An \ccc{Arrangement_2} data structure is used -internaly to represent the point set. The class template provides +internally to represent the point set. The class template provides methods to apply Boolean-set operations on pairs of instances of \ccc{Boolean_set_operations_2} and a few other utility methods. At this point only regularized Boolean-set operations are implemented. @@ -122,8 +122,8 @@ with holes type.} \ccMethod{void difference(const Boolean_set_operations_2& bops);} {computes the difference between this and \ccc{bops}.} -\ccMethod{void symetric_difference(const Boolean_set_operations_2& bops);} - {computes the symetric difference between this and \ccc{bops}.} +\ccMethod{void symmetric_difference(const Boolean_set_operations_2& bops);} + {computes the symmetric difference between this and \ccc{bops}.} \ccPredicates % =========== diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_difference.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_difference.tex index dfa4d9f9766..021e158b31f 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_difference.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_difference.tex @@ -112,7 +112,7 @@ OutputIterator difference(const General_polygon_with_holes_2 & p1, % polygons (or general polygons with holes) given in the first range, and % another set given in the second range. (The value type of the input iterator % is used to distinguish between the two types.) The result, represented -% by a set of general poygon with holes, is inserted into an output container +% by a set of general polygon with holes, is inserted into an output container % through a given output iterator \ccc{oi}. The output iterator is % returned. The value type of the \ccc{OutputIterator} is % \ccc{General_polygon_with_holes_2}.} diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_intersection.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_intersection.tex index 41cb8d8d516..2f10fa88932 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_intersection.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_intersection.tex @@ -111,7 +111,7 @@ OutputIterator intersection(InputIterator begin, InputIterator end, {Computes the intersection of the general polygons (or general polygons with holes) in the given range. (The value type of the input iterator is used to distinguish between the two.) The result, represented by a set -of general poygon with holes, is inserted into an output container +of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} @@ -125,7 +125,7 @@ OutputIterator intersection(InputIterator1 pgn_begin1, OutputIterator oi);} {Computes the intersection of the general polygons and general polygons with holes in the given two ranges. The result, represented by a set -of general poygon with holes, is inserted into an output container +of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_join.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_join.tex index a7401e57c61..057cef5daad 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_join.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_join.tex @@ -109,7 +109,7 @@ OutputIterator join(InputIterator begin, InputIterator end, {Computes the union of the general polygons (or general polygons with holes) in the given range. (The value type of the input iterator is used to distinguish between the two.) The result, represented by a set -of general poygon with holes, is inserted into an output container +of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} @@ -121,7 +121,7 @@ OutputIterator join(InputIterator1 pgn_begin1, InputIterator1 pgn_end1, OutputIterator oi);} {Computes the union of the general polygons and general polygons with holes in the given two ranges. The result, represented by a set -of general poygon with holes, is inserted into an output container +of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_symmetric_difference.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_symmetric_difference.tex index a218fd0bdc9..334452d353f 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_symmetric_difference.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/Bso_symmetric_difference.tex @@ -119,7 +119,7 @@ polygons with holes) in the given range. A point is contained in the symmetric difference, if and only if it is contained in odd number of input polygons. (The value type of the input iterator is used to distinguish between the two.) The result, represented by a set -of general poygon with holes, is inserted into an output container +of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} @@ -134,7 +134,7 @@ OutputIterator symmetric_difference(InputIterator1 pgn_begin1, {Computes the union of the general polygons and general polygons with holes in the given two ranges. A point is contained in the symmetric difference, if and only if it is contained in odd number of -input polygons. The result, represented by a set of general poygon with +input polygons. The result, represented by a set of general polygon with holes, is inserted into an output container through a given output iterator \ccc{oi}. The output iterator is returned. The value type of the \ccc{OutputIterator} is \ccc{Traits::Polygon_with_holes_2}.} diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetDcel.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetDcel.tex index 76b0cdcfd38..c79d1a46dc0 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetDcel.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetDcel.tex @@ -57,7 +57,7 @@ defined. \ccCreationVariable{dcel} % ======================= \ccConstructor{Arr_dcel();} - {constructs an empty \dcel\ with one unbouned face.} + {constructs an empty \dcel\ with one unbounded face.} \ccMethod{Face* assign (const Self& other, const Face *uf);}{% assigns the contents of the \ccc{other} \dcel\, whose unbounded face diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetTraits_2.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetTraits_2.tex index bbb405b8a37..b06d5c9d7b0 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetTraits_2.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/GeneralPolygonSetTraits_2.tex @@ -86,7 +86,7 @@ $x$-monotone curves. It uses the operator\\ \ccMethod{Construct_holes construct_holes_object() const;} {returns a functor that obtains begin/end iterators over a container of holes.} -\ccMethod{Is_unbounded construct_is_unbounded_object();} {returns a functor that detemines if the polygon with holes is unbounded} +\ccMethod{Is_unbounded construct_is_unbounded_object();} {returns a functor that determines if the polygon with holes is unbounded} \ccHasModels diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_2.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_2.tex index 8e00a60fe4f..da67a1b5b31 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_2.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_2.tex @@ -10,14 +10,14 @@ The class \ccRefName\ models the concept \ccc{GeneralPolygon_2}. It represents a simple general-polygon. It is parameterized with the type \ccc{ArrTraits} that models the concept -\ccc{ArrangementDirectionalXMonotoneTraits}. The latter is a refinment +\ccc{ArrangementDirectionalXMonotoneTraits}. The latter is a refinement of the concept \ccc{ArrangementXMonotoneTraits_2}. In addition to the requirements of the concept \ccc{ArrangementXMonotoneTraits_2}, a model of the concept \ccc{ArrangementDirectionalXMonotoneTraits} must support the following functions: \begin{itemize} \item Given an $x$-monotone curve, construct its opposite curve. -\item Given an $x$-monotone curve, compare its two endpoints lexigroaphically. +\item Given an $x$-monotone curve, compare its two endpoints lexicographically. \end{itemize} This class supports a few convenient operations in addition to the diff --git a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_set_2.tex b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_set_2.tex index f32fc6b2a2d..27a46170d73 100644 --- a/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_set_2.tex +++ b/Boolean_set_operations_2/doc_tex/Boolean_set_operations_2_ref/General_polygon_set_2.tex @@ -188,7 +188,7 @@ void insert(InputIterator1 pgn_begin, InputIterator1 pgn_end, \ccMethod{void complement(const Polygon_set_2 & other);} {computes the complement of \ccc{other}. - \ccVar\ is overriden by the result.} + \ccVar\ is overridden by the result.} % \ccMethod{void complement(const Polygon_2 & pgn);} % {computes the complement of \ccc{pgn}.} @@ -346,7 +346,7 @@ void do_intersect(InputIterator1 pgn_begin, InputIterator1 pgn_end, \ccMethod{bool locate(const Point_2 & p, Polygon_with_holes_2 & pgn);} {obtains a polygon with holes that contains the query point \ccc{p}, if exists, through \ccc{pgn}, and returns \ccc{true}. - Otherwise, returns \ccc{flase}.} + Otherwise, returns \ccc{false}.} \ccMethod{Oriented_side oriented_side(const Point_2 & q);} {returns either the constant \ccc{ON_ORIENTED_BOUNDARY}, diff --git a/Developers_manual/doc_tex/Developers_manual/directory_structure.tex b/Developers_manual/doc_tex/Developers_manual/directory_structure.tex index 39d92d47d65..cbf788ed008 100644 --- a/Developers_manual/doc_tex/Developers_manual/directory_structure.tex +++ b/Developers_manual/doc_tex/Developers_manual/directory_structure.tex @@ -268,7 +268,7 @@ the basic library can have the following documentation. | |--- *.tex | - +--- *.((ps)|(eps)|(pdf)|(gif)|(jpg)|(png)) + +--- *.((pdf)|(gif)|(jpg)|(png)) doc_tex/Optimisation_ref/ |--- main.tex @@ -277,7 +277,7 @@ the basic library can have the following documentation. | |--- *.tex | - +--- *.((ps)|(eps)|(pdf)|(gif)|(jpg)|(png)) + +--- *.((pdf)|(gif)|(jpg)|(png)) \end{verbatim} @@ -300,9 +300,7 @@ the basic library can have the following documentation. contained in this package in a systematic way. \item[{\tt *.tex}] -- the source files for the Users' and Reference Manual that are input by {\tt main.tex} - \item[{\tt *.((ps)|(eps))}] -- the PostScript pictures included in - the PostScript documentation. - \item[{\tt *.pdf}] -- the PDF pictures included in + \item[{\tt *.pdf}] -- the PDF pictures included in the PDF documentation. \item[{\tt *.((gif)|(jpg)|(png))}] -- the raster images included in the HTML documentation. diff --git a/Envelope_3/include/CGAL/Envelope_3/Envelope_element_visitor_3.h b/Envelope_3/include/CGAL/Envelope_3/Envelope_element_visitor_3.h index 73be7773928..c503e4e6955 100644 --- a/Envelope_3/include/CGAL/Envelope_3/Envelope_element_visitor_3.h +++ b/Envelope_3/include/CGAL/Envelope_3/Envelope_element_visitor_3.h @@ -632,8 +632,9 @@ public: original_src->point())) || (original_src->is_at_open_boundary() && is_min_end_at_inf)) { - overlaps++; source_is_special = true; + if (split_points.front().third == true) + overlaps++; } // check if target is a special vertex, by checking the last point in diff --git a/Envelope_3/test/Envelope_3/data/triangles/edge_bug.cin b/Envelope_3/test/Envelope_3/data/triangles/edge_bug.cin new file mode 100644 index 00000000000..5f08c2c4af4 --- /dev/null +++ b/Envelope_3/test/Envelope_3/data/triangles/edge_bug.cin @@ -0,0 +1,14 @@ +3 + +0 0 0 +3 0 3 +0 -3 3 + +1 -2 0 +-2 -2 3 +1 1 3 + +1 2 0 +4 2 3 +1 -1 3 + diff --git a/Envelope_3/test/Envelope_3/data/triangles/edge_bug_all.cin b/Envelope_3/test/Envelope_3/data/triangles/edge_bug_all.cin new file mode 100644 index 00000000000..9195c47588c --- /dev/null +++ b/Envelope_3/test/Envelope_3/data/triangles/edge_bug_all.cin @@ -0,0 +1,21 @@ +16 + +50 -100 0 1050 -100 1000 50 900 1000 +50 -100 0 1050 -100 1000 50 -1100 1000 +50 -100 0 -950 -100 1000 50 -1100 1000 +50 -100 0 -950 -100 1000 50 900 1000 + +0 0 0 1000 0 1000 0 1000 1000 +0 0 0 1000 0 1000 0 -1000 1000 +0 0 0 -1000 0 1000 0 -1000 1000 +0 0 0 -1000 0 1000 0 1000 1000 + +50 100 0 1050 100 1000 50 1100 1000 +50 100 0 1050 100 1000 50 -900 1000 +50 100 0 -950 100 1000 50 -900 1000 +50 100 0 -950 100 1000 50 1100 1000 + +-50 100 0 950 100 1000 -50 1100 1000 +-50 100 0 950 100 1000 -50 -900 1000 +-50 100 0 -1050 100 1000 -50 -900 1000 +-50 100 0 -1050 100 1000 -50 1100 1000 diff --git a/Envelope_3/test/Envelope_3/triangles_test.cmd b/Envelope_3/test/Envelope_3/triangles_test.cmd index 30999b107fd..dacc3853536 100644 --- a/Envelope_3/test/Envelope_3/triangles_test.cmd +++ b/Envelope_3/test/Envelope_3/triangles_test.cmd @@ -29,4 +29,7 @@ ./data/triangles/grid_inter_tri_const_envelope_40.cin ./data/triangles/random_50_small_0.5.in ./data/triangles/random_50_small_1.in +./data/triangles/edge_bug.cin +./data/triangles/edge_bug_all.cin + diff --git a/Filtered_kernel/include/CGAL/Lazy.h b/Filtered_kernel/include/CGAL/Lazy.h index 75a895c098e..f59b27d316c 100644 --- a/Filtered_kernel/include/CGAL/Lazy.h +++ b/Filtered_kernel/include/CGAL/Lazy.h @@ -1393,9 +1393,9 @@ public: template < typename L1> result_type - operator()(const L1& l1, int i) const + operator()(const L1& l1, int) const { - return result_type(&l1,i); + return result_type(&l1,2); } }; @@ -1422,9 +1422,9 @@ public: template < typename L1> result_type - operator()(const L1& l1, int i) const + operator()(const L1& l1, int) const { - return result_type(&l1,i); + return result_type(&l1,3); } }; diff --git a/Generator/doc_tex/Generator/generators.tex b/Generator/doc_tex/Generator/generators.tex index a4708e7c486..b37c859088f 100644 --- a/Generator/doc_tex/Generator/generators.tex +++ b/Generator/doc_tex/Generator/generators.tex @@ -122,15 +122,15 @@ for the example output. \end{ccTexOnly} \begin{ccHtmlOnly} - -
- Figure: - Output of example program for point generators. - - - Point Generator Example Output -
+
+ + + + + + + +
Point Generator Example Output
Figure: Output of example program for point generators.
\end{ccHtmlOnly} \section{Example Generating Grid Points} @@ -145,16 +145,16 @@ for the example output. \ccIncludeExampleCode{Generator/random_grid.cpp} \begin{ccHtmlOnly} -
-
- Figure: - Output of example program for point generators working - on integer points. - - - Integer Point Generator Example Output -
+
+ + + + + + + +
Integer Point Generator Example Output
Figure: Output of example program for point generators working + on integer points.
\end{ccHtmlOnly}% @@ -200,15 +200,15 @@ output. \ccIncludeExampleCode{Generator/random_segments1.cpp} \begin{ccHtmlOnly} -
-
- Figure: - Output of example program for the generic segment generator. - - - Segment Generator Example Output -
+
+ + + + + + + +
Segment Generator Example Output
Figure: Output of example program for the generic segment generator.
\end{ccHtmlOnly} The second example generates a regular structure of 100 segments; see @@ -225,16 +225,17 @@ used. \ccIncludeExampleCode{Generator/random_segments2.cpp} \begin{ccHtmlOnly} -
- + +
- Figure: + + + + + + +
Segment Generator Example Output 2
Figure: Output of example program for the generic segment generator using - pre-computed point locations. - - - Segment Generator Example Output 2 -
+ pre-computed point locations.
\end{ccHtmlOnly} \lcTex{\ccIndexSubitemEnd[c]{generator}{segment}} diff --git a/Generator/doc_tex/Generator/hypergrid.gif b/Generator/doc_tex/Generator/hypergrid.gif index d703e61dce8..e4ff3bbaff7 100644 Binary files a/Generator/doc_tex/Generator/hypergrid.gif and b/Generator/doc_tex/Generator/hypergrid.gif differ diff --git a/GraphicsView/demo/L1_Voronoi_diagram_2/L1_voronoi_diagram_2.cpp b/GraphicsView/demo/L1_Voronoi_diagram_2/L1_voronoi_diagram_2.cpp index e1c424896cf..ac209c4bf79 100644 --- a/GraphicsView/demo/L1_Voronoi_diagram_2/L1_voronoi_diagram_2.cpp +++ b/GraphicsView/demo/L1_Voronoi_diagram_2/L1_voronoi_diagram_2.cpp @@ -1,3 +1,23 @@ +// Copyright (c) 2008 GeometryFactory Sarl (France). +// All rights reserved. +// +// This file is part of CGAL (www.cgal.org); you may redistribute it under +// the terms of the Q Public License version 1.0. +// See the file LICENSE.QPL distributed with CGAL. +// +// Licensees holding a valid commercial license may use this file in +// accordance with the commercial license agreement provided with the software. +// +// This file is provided AS IS with NO WARRANTY OF ANY KIND, INCLUDING THE +// WARRANTY OF DESIGN, MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE. +// +// $URL: $ +// $Id: $ +// +// +// Author(s) : Ophir Setter +// + // CGAL headers #include #include @@ -35,8 +55,6 @@ typedef CGAL::L1_voronoi_traits_2 Traits_3; typedef Traits_3::Surface_3 Surface_3; typedef CGAL::Envelope_diagram_2 Envelope_diagram_2; -// Ask Efi how to get rid of this. I was not successful in defining a new -// << operator that does not output a string for Arr_linear_object namespace CGAL { template Qt::PainterOstream& diff --git a/Installation/config/testfiles/CGAL_CFG_NO_CPP0X_STATIC_ASSERT.cpp b/Installation/config/testfiles/CGAL_CFG_NO_CPP0X_STATIC_ASSERT.cpp index 0a0e1d1a352..9fe6379dd13 100644 --- a/Installation/config/testfiles/CGAL_CFG_NO_CPP0X_STATIC_ASSERT.cpp +++ b/Installation/config/testfiles/CGAL_CFG_NO_CPP0X_STATIC_ASSERT.cpp @@ -18,7 +18,7 @@ // Author(s) : Marc Glisse //| If a compiler does not support static_assert (from C++0x) -//| CGAL_CFG_NO_STATIC_ASSERT is set. +//| CGAL_CFG_NO_CPP0X_STATIC_ASSERT is set. int main(){ static_assert(true,"Everything is fine"); diff --git a/Installation/include/CGAL/internal/gcc_cpp0x.h b/Installation/include/CGAL/internal/gcc_cpp0x.h index 76db7a38313..5a5e0ccade6 100644 --- a/Installation/include/CGAL/internal/gcc_cpp0x.h +++ b/Installation/include/CGAL/internal/gcc_cpp0x.h @@ -35,6 +35,7 @@ #undef CGAL_CFG_NO_CPP0X_ISFINITE #undef CGAL_CFG_NO_CPP0X_LONG_LONG #undef CGAL_CFG_NO_CPP0X_RVALUE_REFERENCE +#undef CGAL_CFG_NO_CPP0X_STATIC_ASSERT #undef CGAL_CFG_NO_CPP0X_TUPLE #undef CGAL_CFG_NO_CPP0X_VARIADIC_TEMPLATES diff --git a/Intersections_3/include/CGAL/Intersections_3/intersection_3_1_impl.h b/Intersections_3/include/CGAL/Intersections_3/intersection_3_1_impl.h index 3eebdc99584..c44eb81f555 100644 --- a/Intersections_3/include/CGAL/Intersections_3/intersection_3_1_impl.h +++ b/Intersections_3/include/CGAL/Intersections_3/intersection_3_1_impl.h @@ -266,17 +266,21 @@ intersection_collinear_segments(const typename K::Segment_3 &s1, if ( cln_order(p,r,q) ){ if ( cln_order(p,s,q) ) return make_object(s2); - if ( cln_order(r,p,s) ) - return r!=p ? make_object( typename K::Segment_3(r,p) ) : make_object(p); - else - return r!=q ? make_object( typename K::Segment_3(r,q) ) : make_object(q); + if ( cln_order(r,p,s) ){ + if (r!=p) return make_object( typename K::Segment_3(r,p) ); + if ( cln_order(r,q,s) ) return make_object(s1); + return make_object(p); + } + return r!=q ? make_object( typename K::Segment_3(r,q) ) : make_object(q); } if ( cln_order(p,s,q) ){ - if ( cln_order(r,p,s) ) - return s!=p ? make_object( typename K::Segment_3(s,p) ) : make_object(p); - else - return s!=q ? make_object( typename K::Segment_3(s,q) ) : make_object(q); + if ( cln_order(r,p,s) ){ + if (s!=p) return make_object( typename K::Segment_3(s,p) ); + if (cln_order(r,q,s)) return make_object(s1); + return make_object(p); + } + return s!=q ? make_object( typename K::Segment_3(s,q) ) : make_object(q); } if ( cln_order(r,p,s) ) diff --git a/Intersections_3/include/CGAL/Triangle_3_Triangle_3_intersection.h b/Intersections_3/include/CGAL/Triangle_3_Triangle_3_intersection.h index cf05a7373a7..05958fca41e 100644 --- a/Intersections_3/include/CGAL/Triangle_3_Triangle_3_intersection.h +++ b/Intersections_3/include/CGAL/Triangle_3_Triangle_3_intersection.h @@ -138,8 +138,8 @@ intersection( } //The supporting planes of the triangles intersect along a line. - Object inter1=inter(t1,*line); - Object inter2=inter(t2,*line); + Object inter1=intersection_coplanar(t1,*line,k); + Object inter2=intersection_coplanar(t2,*line,k); const typename Kernel::Segment_3* sgt1=CGAL::object_cast(&inter1); diff --git a/Intersections_3/test/Intersections_3/segment_segment.cpp b/Intersections_3/test/Intersections_3/segment_segment.cpp index 4a42c464774..fecf2b873f1 100644 --- a/Intersections_3/test/Intersections_3/segment_segment.cpp +++ b/Intersections_3/test/Intersections_3/segment_segment.cpp @@ -9,6 +9,87 @@ typedef CGAL::Cartesian K; // The construction test has to be working // The equal test has to be working +#define TEST_CASE_SEGMENT_BASE(i,j,k,l,i1,i2) \ +{\ + typename K::Segment_3 s1(pts[i],pts[j]); \ + typename K::Segment_3 s2(pts[k],pts[l]); \ + CGAL::Object obj= CGAL::intersection(s1,s2); \ + typename K::Segment_3 s; \ + typename K::Segment_3 res(pts[i1],pts[i2]);\ + if (!CGAL::assign(s,obj) || ( s!=res && s!=res.opposite() ) ) {\ + std::cerr << "ERROR test-case "<< i << j << k < +void all_cases_collinear(typename K::Point_3 pts[4]){ + std::cout << "4 points cases\n"; + TEST_CASE_EMPTY(0,1,2,3) + TEST_CASE_SEGMENT(0,2,1,3,1,2) + TEST_CASE_SEGMENT(0,3,2,1,1,2) + std::cout << "3 points cases\n"; + TEST_CASE_SEGMENT(0,1,0,2,0,1) + TEST_CASE_SEGMENT(0,2,1,2,1,2) + TEST_CASE_POINT(1,2,0,1,1) + std::cout << "2 points cases\n"; + TEST_CASE_SEGMENT(1,2,1,2,1,2) +} + template void _test_intersection_construct(K) { @@ -68,5 +149,9 @@ int main() { K k; _test_intersection_construct(k); + + + K::Point_3 pts[4] = {K::Point_3(0,0,0),K::Point_3(1,0,0),K::Point_3(2,0,0),K::Point_3(3,0,0)}; + all_cases_collinear(pts); return 0; } diff --git a/Kernel_23/doc_tex/Kernel_23_ref/intersection.tex b/Kernel_23/doc_tex/Kernel_23_ref/intersection.tex index d3ef3720711..3c31c52ac68 100644 --- a/Kernel_23/doc_tex/Kernel_23_ref/intersection.tex +++ b/Kernel_23/doc_tex/Kernel_23_ref/intersection.tex @@ -458,6 +458,7 @@ type A & type B & \parbox{4 cm}{\vspace{1 mm}{return type}} \\ +
Point_3
Segment_3
Triangle_3
std::vector < Point_3 >
diff --git a/Maintenance/git/authors-file.txt b/Maintenance/git/authors-file.txt index 2dfeb91625c..0dbf27301c5 100644 --- a/Maintenance/git/authors-file.txt +++ b/Maintenance/git/authors-file.txt @@ -1,5 +1,6 @@ abru = Antoine Bru afabri = Andreas Fabri +andreasfabri = Andreas Fabri akobel = Alexander Kobel amebarki = Abdelkrim Mebarki ameyer = Andreas Meyer diff --git a/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/CMakeCache.txt b/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/CMakeCache.txt index 10ae148aa81..a6de99a5a4e 100644 --- a/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/CMakeCache.txt +++ b/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/CMakeCache.txt @@ -39,7 +39,7 @@ CGAL_CORE_PACKAGE_DIR:PATH=/home/lrineau/CGAL/CGAL-I CGAL_CXX_FLAGS:STRING=-m32 -frounding-math //Value Computed by CMake -CGAL_Core_BINARY_DIR:STATIC=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/src/Core +CGAL_Core_BINARY_DIR:STATIC=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/src/CGALCore //The CGAL_Core library CGAL_Core_LIBRARY:STRING=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL_Core.so @@ -87,8 +87,11 @@ CGAL_INSTALL_MAN_DIR:STRING=share/man/man1 //Value Computed by CMake CGAL_ImageIO_BINARY_DIR:STATIC=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/src/CGALimageIO +//The CGAL_ImageIO library +CGAL_ImageIO_LIBRARY:STRING=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL_ImageIO.so + //Dependencies for the target -CGAL_ImageIO_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;general;/usr/lib64/libGLU.so;general;/usr/lib64/libGL.so;general;/usr/lib64/libX11.so;general;/usr/lib64/libXext.so;general;/usr/lib64/libz.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so; +CGAL_ImageIO_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;general;/usr/lib/libGLU.so;general;/usr/lib/libGL.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so; //Value Computed by CMake CGAL_ImageIO_SOURCE_DIR:STATIC=/home/lrineau/CGAL/CGAL-I/src/CGALimageIO @@ -102,8 +105,11 @@ CGAL_MAINTENANCE_PACKAGE_DIR:PATH=/home/lrineau/CGAL/CGAL-I //Value Computed by CMake CGAL_Qt3_BINARY_DIR:STATIC=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/src/CGALQt +//The CGAL_Qt3 library +CGAL_Qt3_LIBRARY:STRING=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL_Qt3.so + //Dependencies for the target -CGAL_Qt3_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;general;/usr/lib64/qt-3.3/lib/libqassistantclient.a;general;/usr/lib64/qt-3.3/lib/libqt-mt.so;general;/usr/lib64/libX11.so;general;/usr/lib64/libXext.so;general;dl;general;-lpthread;general;/usr/lib64/libGLU.so;general;/usr/lib64/libGL.so;general;/usr/lib64/libX11.so;general;/usr/lib64/libXext.so; +CGAL_Qt3_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;general;/usr/lib/qt-3.3/lib/libqassistantclient.a;general;/usr/lib/qt-3.3/lib/libqt-mt.so;general;dl;general;-lpthread;general;/usr/lib/libGLU.so;general;/usr/lib/libGL.so; //Value Computed by CMake CGAL_Qt3_SOURCE_DIR:STATIC=/home/lrineau/CGAL/CGAL-I/src/CGALQt @@ -111,8 +117,11 @@ CGAL_Qt3_SOURCE_DIR:STATIC=/home/lrineau/CGAL/CGAL-I/src/CGALQt //Value Computed by CMake CGAL_Qt4_BINARY_DIR:STATIC=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/src/CGALQt4 +//The CGAL_Qt4 library +CGAL_Qt4_LIBRARY:STRING=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL_Qt4.so + //Dependencies for the target -CGAL_Qt4_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib64/libgmpxx.so;general;/usr/lib64/libmpfr.so;general;/usr/lib64/libgmp.so;general;/usr/lib64/libboost_thread-mt.so;optimized;/usr/lib64/libQtOpenGL.so;debug;/usr/lib64/libQtOpenGL_debug.so;general;-lGLU;general;-lGL;optimized;/usr/lib64/libQtGui.so;debug;/usr/lib64/libQtGui_debug.so;general;/usr/lib64/libpng.so;general;/usr/lib64/libSM.so;general;/usr/lib64/libICE.so;general;/usr/lib64/libXi.so;general;/usr/lib64/libXrender.so;general;/usr/lib64/libXrandr.so;general;/usr/lib64/libXcursor.so;general;/usr/lib64/libXinerama.so;general;/usr/lib64/libXfixes.so;general;/usr/lib64/libfreetype.so;general;/usr/lib64/libfontconfig.so;optimized;/usr/lib64/libQtCore.so;debug;/usr/lib64/libQtCore_debug.so;general;/usr/lib64/libz.so;general;/usr/lib64/libgthread-2.0.so;general;/usr/lib64/libglib-2.0.so;general;/usr/lib64/libgobject-2.0.so;general;/usr/lib64/librt.so;general;/usr/lib64/libGLU.so;general;/usr/lib64/libGL.so;general;/usr/lib64/libX11.so;general;/usr/lib64/libXext.so; +CGAL_Qt4_LIB_DEPENDS:STATIC=general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;general;/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so;general;/usr/lib/libgmpxx.so;general;/usr/lib/libmpfr.so;general;/usr/lib/libgmp.so;general;/usr/lib/libboost_thread-mt.so;optimized;/usr/lib64/libQtOpenGL.so;debug;/usr/lib64/libQtOpenGL_debug.so;optimized;/usr/lib64/libQtGui.so;debug;/usr/lib64/libQtGui_debug.so;optimized;/usr/lib64/libQtCore.so;debug;/usr/lib64/libQtCore_debug.so;general;/usr/lib/libGLU.so;general;/usr/lib/libGL.so; //Value Computed by CMake CGAL_Qt4_SOURCE_DIR:STATIC=/home/lrineau/CGAL/CGAL-I/src/CGALQt4 @@ -287,17 +296,638 @@ MPFR_LIBRARIES:FILEPATH=/usr/lib/libmpfr.so //Missing description MPFR_LIBRARIES_DIR:FILEPATH=/usr/lib +//Path to a file. +OPENGL_INCLUDE_DIR:PATH=/usr/include + +//Path to a library. +OPENGL_gl_LIBRARY:FILEPATH=/usr/lib/libGL.so + +//Path to a library. +OPENGL_glu_LIBRARY:FILEPATH=/usr/lib/libGLU.so + +//Path to a file. +OPENGL_xmesa_INCLUDE_DIR:PATH=OPENGL_xmesa_INCLUDE_DIR-NOTFOUND + +//Path to a file. +QT3_INCLUDE_DIR:PATH=/usr/lib/qt-3.3/include + +//Path to a program. +QT3_MOC_EXECUTABLE:FILEPATH=/usr/lib/qt-3.3/bin/moc + +//Path to a library. +QT3_QASSISTANTCLIENT_LIBRARY:FILEPATH=/usr/lib/qt-3.3/lib/libqassistantclient.a + +//Path to a library. +QT3_QT_LIBRARY:FILEPATH=/usr/lib/qt-3.3/lib/libqt-mt.so + +//Path to a program. +QT3_UIC_EXECUTABLE:FILEPATH=/usr/lib/qt-3.3/bin/uic + +//Path to a library. +QT_ARTHURPLUGIN_PLUGIN_DEBUG:FILEPATH=QT_ARTHURPLUGIN_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_ARTHURPLUGIN_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libarthurplugin.so + +//Path to a library. +QT_CONTAINEREXTENSION_PLUGIN_DEBUG:FILEPATH=QT_CONTAINEREXTENSION_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_CONTAINEREXTENSION_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libcontainerextension.so + +//Path to a library. +QT_CUSTOMWIDGETPLUGIN_PLUGIN_DEBUG:FILEPATH=QT_CUSTOMWIDGETPLUGIN_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_CUSTOMWIDGETPLUGIN_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libcustomwidgetplugin.so + +//Path to a program. +QT_DBUSCPP2XML_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/qdbuscpp2xml + +//Path to a program. +QT_DBUSXML2CPP_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/qdbusxml2cpp + +//Path to a program. +QT_DESIGNER_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/designer-qt4 + +//The location of the Qt docs +QT_DOC_DIR:PATH=/usr/share/doc/qt4 + +//The location of the Qt imports +QT_IMPORTS_DIR:PATH=/usr/lib64/qt4/imports + +//Path to a program. +QT_LINGUIST_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/linguist-qt4 + +//Path to a program. +QT_LRELEASE_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/lrelease-qt4 + +//Path to a program. +QT_LUPDATE_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/lupdate-qt4 + +//The location of the Qt mkspecs containing qconfig.pri +QT_MKSPECS_DIR:PATH=/usr/lib64/qt4/mkspecs + +//Path to a program. +QT_MOC_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/moc-qt4 + +//Path to a library. +QT_PHONONWIDGETS_PLUGIN_DEBUG:FILEPATH=QT_PHONONWIDGETS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_PHONONWIDGETS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libphononwidgets.so + +//Path to a file. +QT_PHONON_INCLUDE_DIR:PATH=/usr/include/phonon + +//The Qt PHONON library +QT_PHONON_LIBRARY:STRING=/usr/lib64/libphonon.so + +//Path to a library. +QT_PHONON_LIBRARY_DEBUG:FILEPATH=QT_PHONON_LIBRARY_DEBUG-NOTFOUND + +//Path to a library. +QT_PHONON_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libphonon.so + +//Path to a library. +QT_PHONON_QT7_PLUGIN_DEBUG:FILEPATH=QT_PHONON_QT7_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_PHONON_QT7_PLUGIN_RELEASE:FILEPATH=QT_PHONON_QT7_PLUGIN_RELEASE-NOTFOUND + +//The location of the Qt plugins +QT_PLUGINS_DIR:PATH=/usr/lib64/qt4/plugins + +//Path to a library. +QT_QCNCODECS_PLUGIN_DEBUG:FILEPATH=QT_QCNCODECS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QCNCODECS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/codecs/libqcncodecs.so + +//Path to a program. +QT_QCOLLECTIONGENERATOR_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/qcollectiongenerator + +//Path to a library. +QT_QCOREWLANBEARER_PLUGIN_DEBUG:FILEPATH=QT_QCOREWLANBEARER_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QCOREWLANBEARER_PLUGIN_RELEASE:FILEPATH=QT_QCOREWLANBEARER_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QDECLARATIVEVIEW_PLUGIN_DEBUG:FILEPATH=QT_QDECLARATIVEVIEW_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QDECLARATIVEVIEW_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libqdeclarativeview.so + +//Path to a library. +QT_QDECORATIONDEFAULT_PLUGIN_DEBUG:FILEPATH=QT_QDECORATIONDEFAULT_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QDECORATIONDEFAULT_PLUGIN_RELEASE:FILEPATH=QT_QDECORATIONDEFAULT_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QDECORATIONWINDOWS_PLUGIN_DEBUG:FILEPATH=QT_QDECORATIONWINDOWS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QDECORATIONWINDOWS_PLUGIN_RELEASE:FILEPATH=QT_QDECORATIONWINDOWS_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QGENERICBEARER_PLUGIN_DEBUG:FILEPATH=QT_QGENERICBEARER_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QGENERICBEARER_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/bearer/libqgenericbearer.so + +//Path to a library. +QT_QGIF_PLUGIN_DEBUG:FILEPATH=QT_QGIF_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QGIF_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqgif.so + +//Path to a library. +QT_QGLGRAPHICSSYSTEM_PLUGIN_DEBUG:FILEPATH=QT_QGLGRAPHICSSYSTEM_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QGLGRAPHICSSYSTEM_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/graphicssystems/libqglgraphicssystem.so + +//Path to a library. +QT_QICO_PLUGIN_DEBUG:FILEPATH=QT_QICO_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QICO_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqico.so + +//Path to a library. +QT_QIMSW_MULTI_PLUGIN_DEBUG:FILEPATH=QT_QIMSW_MULTI_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QIMSW_MULTI_PLUGIN_RELEASE:FILEPATH=QT_QIMSW_MULTI_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QJPCODECS_PLUGIN_DEBUG:FILEPATH=QT_QJPCODECS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QJPCODECS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/codecs/libqjpcodecs.so + +//Path to a library. +QT_QJPEG_PLUGIN_DEBUG:FILEPATH=QT_QJPEG_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QJPEG_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqjpeg.so + +//Path to a library. +QT_QKRCODECS_PLUGIN_DEBUG:FILEPATH=QT_QKRCODECS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QKRCODECS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/codecs/libqkrcodecs.so + +//Where can one of the qmake4 or qmake-qt4 libraries be found +QT_QMAKE_EXECUTABLE:FILEPATH=/usr/bin/qmake-qt4 + +//Path to a library. +QT_QMNG_PLUGIN_DEBUG:FILEPATH=QT_QMNG_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QMNG_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqmng.so + +//Path to a library. +QT_QSQLDB2_PLUGIN_DEBUG:FILEPATH=QT_QSQLDB2_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLDB2_PLUGIN_RELEASE:FILEPATH=QT_QSQLDB2_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLIBASE_PLUGIN_DEBUG:FILEPATH=QT_QSQLIBASE_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLIBASE_PLUGIN_RELEASE:FILEPATH=QT_QSQLIBASE_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLITE2_PLUGIN_DEBUG:FILEPATH=QT_QSQLITE2_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLITE2_PLUGIN_RELEASE:FILEPATH=QT_QSQLITE2_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLITE_PLUGIN_DEBUG:FILEPATH=QT_QSQLITE_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLITE_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/sqldrivers/libqsqlite.so + +//Path to a library. +QT_QSQLMYSQL_PLUGIN_DEBUG:FILEPATH=QT_QSQLMYSQL_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLMYSQL_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/sqldrivers/libqsqlmysql.so + +//Path to a library. +QT_QSQLOCI_PLUGIN_DEBUG:FILEPATH=QT_QSQLOCI_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLOCI_PLUGIN_RELEASE:FILEPATH=QT_QSQLOCI_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLODBC_PLUGIN_DEBUG:FILEPATH=QT_QSQLODBC_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLODBC_PLUGIN_RELEASE:FILEPATH=QT_QSQLODBC_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLPSQL_PLUGIN_DEBUG:FILEPATH=QT_QSQLPSQL_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLPSQL_PLUGIN_RELEASE:FILEPATH=QT_QSQLPSQL_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSQLTDS_PLUGIN_DEBUG:FILEPATH=QT_QSQLTDS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSQLTDS_PLUGIN_RELEASE:FILEPATH=QT_QSQLTDS_PLUGIN_RELEASE-NOTFOUND + +//Path to a library. +QT_QSVGICON_PLUGIN_DEBUG:FILEPATH=QT_QSVGICON_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSVGICON_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/iconengines/libqsvgicon.so + +//Path to a library. +QT_QSVG_PLUGIN_DEBUG:FILEPATH=QT_QSVG_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QSVG_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqsvg.so + +//Path to a library. +QT_QT3SUPPORTWIDGETS_PLUGIN_DEBUG:FILEPATH=QT_QT3SUPPORTWIDGETS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QT3SUPPORTWIDGETS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libqt3supportwidgets.so + +//Path to a file. +QT_QT3SUPPORT_INCLUDE_DIR:PATH=/usr/include/Qt3Support + +//The Qt QT3SUPPORT library +QT_QT3SUPPORT_LIBRARY:STRING=optimized;/usr/lib64/libQt3Support.so;debug;/usr/lib64/libQt3Support_debug.so + +//Path to a library. +QT_QT3SUPPORT_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQt3Support_debug.so + +//Path to a library. +QT_QT3SUPPORT_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQt3Support.so + +//Path to a library. +QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_DEBUG:FILEPATH=QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/accessible/libqtaccessiblecompatwidgets.so + +//Path to a library. +QT_QTACCESSIBLEWIDGETS_PLUGIN_DEBUG:FILEPATH=QT_QTACCESSIBLEWIDGETS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTACCESSIBLEWIDGETS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/accessible/libqtaccessiblewidgets.so + +//Path to a file. +QT_QTASSISTANTCLIENT_INCLUDE_DIR:PATH=QT_QTASSISTANTCLIENT_INCLUDE_DIR-NOTFOUND + +//The Qt QTASSISTANTCLIENT library +QT_QTASSISTANTCLIENT_LIBRARY:STRING= + +//Path to a library. +QT_QTASSISTANTCLIENT_LIBRARY_DEBUG:FILEPATH=QT_QTASSISTANTCLIENT_LIBRARY_DEBUG-NOTFOUND + +//Path to a library. +QT_QTASSISTANTCLIENT_LIBRARY_RELEASE:FILEPATH=QT_QTASSISTANTCLIENT_LIBRARY_RELEASE-NOTFOUND + +//Path to a file. +QT_QTASSISTANT_INCLUDE_DIR:PATH=QT_QTASSISTANT_INCLUDE_DIR-NOTFOUND + +//The Qt QTASSISTANT library +QT_QTASSISTANT_LIBRARY:STRING= + +//Path to a library. +QT_QTASSISTANT_LIBRARY_DEBUG:FILEPATH=QT_QTASSISTANT_LIBRARY_DEBUG-NOTFOUND + +//Path to a library. +QT_QTASSISTANT_LIBRARY_RELEASE:FILEPATH=QT_QTASSISTANT_LIBRARY_RELEASE-NOTFOUND + +//The Qt QTCLUCENE library +QT_QTCLUCENE_LIBRARY:STRING=optimized;/usr/lib64/libQtCLucene.so;debug;/usr/lib64/libQtCLucene_debug.so + +//Path to a library. +QT_QTCLUCENE_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtCLucene_debug.so + +//Path to a library. +QT_QTCLUCENE_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtCLucene.so + +//(This variable does not exist and should not be used) +QT_QTCORE_INCLUDE_DIR:PATH=/usr/include/QtCore + +//The Qt QTCORE library +QT_QTCORE_LIBRARY:STRING=optimized;/usr/lib64/libQtCore.so;debug;/usr/lib64/libQtCore_debug.so + +//Path to a library. +QT_QTCORE_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtCore_debug.so + +//Path to a library. +QT_QTCORE_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtCore.so + +//Path to a file. +QT_QTDBUS_INCLUDE_DIR:PATH=/usr/include/QtDBus + +//The Qt QTDBUS library +QT_QTDBUS_LIBRARY:STRING=optimized;/usr/lib64/libQtDBus.so;debug;/usr/lib64/libQtDBus_debug.so + +//Path to a library. +QT_QTDBUS_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtDBus_debug.so + +//Path to a library. +QT_QTDBUS_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtDBus.so + +//Path to a file. +QT_QTDECLARATIVE_INCLUDE_DIR:PATH=/usr/include/QtDeclarative + +//The Qt QTDECLARATIVE library +QT_QTDECLARATIVE_LIBRARY:STRING=optimized;/usr/lib64/libQtDeclarative.so;debug;/usr/lib64/libQtDeclarative_debug.so + +//Path to a library. +QT_QTDECLARATIVE_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtDeclarative_debug.so + +//Path to a library. +QT_QTDECLARATIVE_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtDeclarative.so + +//Path to a file. +QT_QTDESIGNERCOMPONENTS_INCLUDE_DIR:PATH=/usr/include/QtDesigner + +//The Qt QTDESIGNERCOMPONENTS library +QT_QTDESIGNERCOMPONENTS_LIBRARY:STRING=optimized;/usr/lib64/libQtDesignerComponents.so;debug;/usr/lib64/libQtDesignerComponents_debug.so + +//Path to a library. +QT_QTDESIGNERCOMPONENTS_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtDesignerComponents_debug.so + +//Path to a library. +QT_QTDESIGNERCOMPONENTS_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtDesignerComponents.so + +//Path to a file. +QT_QTDESIGNER_INCLUDE_DIR:PATH=/usr/include/QtDesigner + +//The Qt QTDESIGNER library +QT_QTDESIGNER_LIBRARY:STRING=optimized;/usr/lib64/libQtDesigner.so;debug;/usr/lib64/libQtDesigner_debug.so + +//Path to a library. +QT_QTDESIGNER_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtDesigner_debug.so + +//Path to a library. +QT_QTDESIGNER_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtDesigner.so + +//Path to a file. +QT_QTGUI_INCLUDE_DIR:PATH=/usr/include/QtGui + +//The Qt QTGUI library +QT_QTGUI_LIBRARY:STRING=optimized;/usr/lib64/libQtGui.so;debug;/usr/lib64/libQtGui_debug.so + +//Path to a library. +QT_QTGUI_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtGui_debug.so + +//Path to a library. +QT_QTGUI_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtGui.so + +//Path to a file. +QT_QTHELP_INCLUDE_DIR:PATH=/usr/include/QtHelp + +//The Qt QTHELP library +QT_QTHELP_LIBRARY:STRING=optimized;/usr/lib64/libQtHelp.so;debug;/usr/lib64/libQtHelp_debug.so + +//Path to a library. +QT_QTHELP_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtHelp_debug.so + +//Path to a library. +QT_QTHELP_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtHelp.so + +//Path to a library. +QT_QTIFF_PLUGIN_DEBUG:FILEPATH=QT_QTIFF_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTIFF_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/imageformats/libqtiff.so + +//Path to a file. +QT_QTMULTIMEDIA_INCLUDE_DIR:PATH=/usr/include/QtMultimedia + +//The Qt QTMULTIMEDIA library +QT_QTMULTIMEDIA_LIBRARY:STRING=optimized;/usr/lib64/libQtMultimedia.so;debug;/usr/lib64/libQtMultimedia_debug.so + +//Path to a library. +QT_QTMULTIMEDIA_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtMultimedia_debug.so + +//Path to a library. +QT_QTMULTIMEDIA_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtMultimedia.so + +//Path to a file. +QT_QTNETWORK_INCLUDE_DIR:PATH=/usr/include/QtNetwork + +//The Qt QTNETWORK library +QT_QTNETWORK_LIBRARY:STRING=optimized;/usr/lib64/libQtNetwork.so;debug;/usr/lib64/libQtNetwork_debug.so + +//Path to a library. +QT_QTNETWORK_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtNetwork_debug.so + +//Path to a library. +QT_QTNETWORK_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtNetwork.so + +//Path to a file. +QT_QTNSPLUGIN_INCLUDE_DIR:PATH=QT_QTNSPLUGIN_INCLUDE_DIR-NOTFOUND + +//The Qt QTNSPLUGIN library +QT_QTNSPLUGIN_LIBRARY:STRING= + +//Path to a library. +QT_QTNSPLUGIN_LIBRARY_DEBUG:FILEPATH=QT_QTNSPLUGIN_LIBRARY_DEBUG-NOTFOUND + +//Path to a library. +QT_QTNSPLUGIN_LIBRARY_RELEASE:FILEPATH=QT_QTNSPLUGIN_LIBRARY_RELEASE-NOTFOUND + +//Path to a file. +QT_QTOPENGL_INCLUDE_DIR:PATH=/usr/include/QtOpenGL + +//The Qt QTOPENGL library +QT_QTOPENGL_LIBRARY:STRING=optimized;/usr/lib64/libQtOpenGL.so;debug;/usr/lib64/libQtOpenGL_debug.so + +//Path to a library. +QT_QTOPENGL_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtOpenGL_debug.so + +//Path to a library. +QT_QTOPENGL_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtOpenGL.so + +//Path to a library. +QT_QTRACEGRAPHICSSYSTEM_PLUGIN_DEBUG:FILEPATH=QT_QTRACEGRAPHICSSYSTEM_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTRACEGRAPHICSSYSTEM_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/graphicssystems/libqtracegraphicssystem.so + +//Path to a library. +QT_QTSCRIPTDBUS_PLUGIN_DEBUG:FILEPATH=QT_QTSCRIPTDBUS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTSCRIPTDBUS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/script/libqtscriptdbus.so + +//Path to a file. +QT_QTSCRIPTTOOLS_INCLUDE_DIR:PATH=/usr/include/QtScriptTools + +//The Qt QTSCRIPTTOOLS library +QT_QTSCRIPTTOOLS_LIBRARY:STRING=optimized;/usr/lib64/libQtScriptTools.so;debug;/usr/lib64/libQtScriptTools_debug.so + +//Path to a library. +QT_QTSCRIPTTOOLS_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtScriptTools_debug.so + +//Path to a library. +QT_QTSCRIPTTOOLS_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtScriptTools.so + +//Path to a file. +QT_QTSCRIPT_INCLUDE_DIR:PATH=/usr/include/QtScript + +//The Qt QTSCRIPT library +QT_QTSCRIPT_LIBRARY:STRING=optimized;/usr/lib64/libQtScript.so;debug;/usr/lib64/libQtScript_debug.so + +//Path to a library. +QT_QTSCRIPT_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtScript_debug.so + +//Path to a library. +QT_QTSCRIPT_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtScript.so + +//Path to a file. +QT_QTSQL_INCLUDE_DIR:PATH=/usr/include/QtSql + +//The Qt QTSQL library +QT_QTSQL_LIBRARY:STRING=optimized;/usr/lib64/libQtSql.so;debug;/usr/lib64/libQtSql_debug.so + +//Path to a library. +QT_QTSQL_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtSql_debug.so + +//Path to a library. +QT_QTSQL_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtSql.so + +//Path to a file. +QT_QTSVG_INCLUDE_DIR:PATH=/usr/include/QtSvg + +//The Qt QTSVG library +QT_QTSVG_LIBRARY:STRING=optimized;/usr/lib64/libQtSvg.so;debug;/usr/lib64/libQtSvg_debug.so + +//Path to a library. +QT_QTSVG_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtSvg_debug.so + +//Path to a library. +QT_QTSVG_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtSvg.so + +//Path to a file. +QT_QTTEST_INCLUDE_DIR:PATH=/usr/include/QtTest + +//The Qt QTTEST library +QT_QTTEST_LIBRARY:STRING=optimized;/usr/lib64/libQtTest.so;debug;/usr/lib64/libQtTest_debug.so + +//Path to a library. +QT_QTTEST_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtTest_debug.so + +//Path to a library. +QT_QTTEST_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtTest.so + +//Path to a file. +QT_QTUITOOLS_INCLUDE_DIR:PATH=/usr/include/QtUiTools + +//The Qt QTUITOOLS library +QT_QTUITOOLS_LIBRARY:STRING=optimized;/usr/lib64/libQtUiTools.a;debug;/usr/lib64/libQtUiTools_debug.a + +//Path to a library. +QT_QTUITOOLS_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtUiTools_debug.a + +//Path to a library. +QT_QTUITOOLS_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtUiTools.a + +//Path to a library. +QT_QTWCODECS_PLUGIN_DEBUG:FILEPATH=QT_QTWCODECS_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QTWCODECS_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/codecs/libqtwcodecs.so + +//Path to a file. +QT_QTWEBKIT_INCLUDE_DIR:PATH=/usr/include/QtWebKit + +//The Qt QTWEBKIT library +QT_QTWEBKIT_LIBRARY:STRING=optimized;/usr/lib64/libQtWebKit.so;debug;/usr/lib64/libQtWebKit_debug.so + +//Path to a library. +QT_QTWEBKIT_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtWebKit_debug.so + +//Path to a library. +QT_QTWEBKIT_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtWebKit.so + +//Path to a file. +QT_QTXMLPATTERNS_INCLUDE_DIR:PATH=/usr/include/QtXmlPatterns + +//The Qt QTXMLPATTERNS library +QT_QTXMLPATTERNS_LIBRARY:STRING=optimized;/usr/lib64/libQtXmlPatterns.so;debug;/usr/lib64/libQtXmlPatterns_debug.so + +//Path to a library. +QT_QTXMLPATTERNS_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtXmlPatterns_debug.so + +//Path to a library. +QT_QTXMLPATTERNS_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtXmlPatterns.so + +//Path to a file. +QT_QTXML_INCLUDE_DIR:PATH=/usr/include/QtXml + +//The Qt QTXML library +QT_QTXML_LIBRARY:STRING=optimized;/usr/lib64/libQtXml.so;debug;/usr/lib64/libQtXml_debug.so + +//Path to a library. +QT_QTXML_LIBRARY_DEBUG:FILEPATH=/usr/lib64/libQtXml_debug.so + +//Path to a library. +QT_QTXML_LIBRARY_RELEASE:FILEPATH=/usr/lib64/libQtXml.so + +//Path to a library. +QT_QWEBVIEW_PLUGIN_DEBUG:FILEPATH=QT_QWEBVIEW_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QWEBVIEW_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libqwebview.so + +//Path to a library. +QT_QWSTSLIBMOUSEHANDLER_PLUGIN_DEBUG:FILEPATH=QT_QWSTSLIBMOUSEHANDLER_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_QWSTSLIBMOUSEHANDLER_PLUGIN_RELEASE:FILEPATH=QT_QWSTSLIBMOUSEHANDLER_PLUGIN_RELEASE-NOTFOUND + +//Path to a program. +QT_RCC_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/rcc + +//Path to a library. +QT_TASKMENUEXTENSION_PLUGIN_DEBUG:FILEPATH=QT_TASKMENUEXTENSION_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_TASKMENUEXTENSION_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libtaskmenuextension.so + +//The location of the Qt translations +QT_TRANSLATIONS_DIR:PATH=/usr/share/qt4/translations + +//Path to a program. +QT_UIC3_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/uic3 + +//Path to a program. +QT_UIC_EXECUTABLE:FILEPATH=/usr/lib64/qt4/bin/uic-qt4 + +//Path to a library. +QT_WORLDTIMECLOCKPLUGIN_PLUGIN_DEBUG:FILEPATH=QT_WORLDTIMECLOCKPLUGIN_PLUGIN_DEBUG-NOTFOUND + +//Path to a library. +QT_WORLDTIMECLOCKPLUGIN_PLUGIN_RELEASE:FILEPATH=/usr/lib64/qt4/plugins/designer/libworldtimeclockplugin.so + //Enable CGAL component Core WITH_CGAL_Core:BOOL=ON //Enable CGAL component ImageIO -WITH_CGAL_ImageIO:BOOL=OFF +WITH_CGAL_ImageIO:BOOL=ON //Enable CGAL component Qt3 -WITH_CGAL_Qt3:BOOL=OFF +WITH_CGAL_Qt3:BOOL=ON //Enable CGAL component Qt4 -WITH_CGAL_Qt4:BOOL=OFF +WITH_CGAL_Qt4:BOOL=ON //Use the GMP number types if available. WITH_GMP:BOOL=ON @@ -323,6 +953,168 @@ WITH_demos:BOOL=OFF //Select examples WITH_examples:BOOL=OFF +//Path to a file. +X11_ICE_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_ICE_LIB:FILEPATH=X11_ICE_LIB-NOTFOUND + +//Path to a library. +X11_SM_LIB:FILEPATH=X11_SM_LIB-NOTFOUND + +//Path to a file. +X11_X11_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_X11_LIB:FILEPATH=X11_X11_LIB-NOTFOUND + +//Path to a file. +X11_XShm_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_XTest_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_XTest_LIB:FILEPATH=X11_XTest_LIB-NOTFOUND + +//Path to a file. +X11_Xaccessrules_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xaccessstr_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xau_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xau_LIB:FILEPATH=X11_Xau_LIB-NOTFOUND + +//Path to a file. +X11_Xcomposite_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xcomposite_LIB:FILEPATH=X11_Xcomposite_LIB-NOTFOUND + +//Path to a file. +X11_Xcursor_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xcursor_LIB:FILEPATH=X11_Xcursor_LIB-NOTFOUND + +//Path to a file. +X11_Xdamage_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xdamage_LIB:FILEPATH=X11_Xdamage_LIB-NOTFOUND + +//Path to a file. +X11_Xdmcp_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xdmcp_LIB:FILEPATH=X11_Xdmcp_LIB-NOTFOUND + +//Path to a library. +X11_Xext_LIB:FILEPATH=X11_Xext_LIB-NOTFOUND + +//Path to a file. +X11_Xfixes_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xfixes_LIB:FILEPATH=X11_Xfixes_LIB-NOTFOUND + +//Path to a file. +X11_Xft_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xft_LIB:FILEPATH=X11_Xft_LIB-NOTFOUND + +//Path to a file. +X11_Xi_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xi_LIB:FILEPATH=X11_Xi_LIB-NOTFOUND + +//Path to a file. +X11_Xinerama_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xinerama_LIB:FILEPATH=X11_Xinerama_LIB-NOTFOUND + +//Path to a file. +X11_Xinput_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xinput_LIB:FILEPATH=X11_Xinput_LIB-NOTFOUND + +//Path to a file. +X11_Xkb_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xkblib_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xlib_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xpm_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xpm_LIB:FILEPATH=X11_Xpm_LIB-NOTFOUND + +//Path to a file. +X11_Xrandr_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xrandr_LIB:FILEPATH=X11_Xrandr_LIB-NOTFOUND + +//Path to a file. +X11_Xrender_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xrender_LIB:FILEPATH=X11_Xrender_LIB-NOTFOUND + +//Path to a file. +X11_Xscreensaver_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xscreensaver_LIB:FILEPATH=X11_Xscreensaver_LIB-NOTFOUND + +//Path to a file. +X11_Xshape_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xt_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xt_LIB:FILEPATH=X11_Xt_LIB-NOTFOUND + +//Path to a file. +X11_Xutil_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_Xv_INCLUDE_PATH:PATH=/usr/include + +//Path to a library. +X11_Xv_LIB:FILEPATH=X11_Xv_LIB-NOTFOUND + +//Path to a library. +X11_Xxf86misc_LIB:FILEPATH=X11_Xxf86misc_LIB-NOTFOUND + +//Path to a file. +X11_dpms_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_xf86misc_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +X11_xf86vmode_INCLUDE_PATH:PATH=/usr/include + +//Path to a file. +ZLIB_INCLUDE_DIR:PATH=/usr/include + +//Path to a library. +ZLIB_LIBRARY:FILEPATH=ZLIB_LIBRARY-NOTFOUND + ######################## # INTERNAL cache entries @@ -480,12 +1272,11 @@ CGAL_Core_LIBRARY-ADVANCED:INTERNAL=1 CGAL_Core_LIBRARY_NAME:INTERNAL=libCGAL_Core.so CGAL_EXECUTABLE_TARGETS:INTERNAL= CGAL_ImageIO_3RD_PARTY_DEFINITIONS:INTERNAL= -CGAL_ImageIO_3RD_PARTY_INCLUDE_DIRS:INTERNAL= -CGAL_ImageIO_3RD_PARTY_LIBRARIES:INTERNAL= +CGAL_ImageIO_3RD_PARTY_INCLUDE_DIRS:INTERNAL=/usr/include +CGAL_ImageIO_3RD_PARTY_LIBRARIES:INTERNAL=/usr/lib/libGLU.so;/usr/lib/libGL.so CGAL_ImageIO_3RD_PARTY_LIBRARIES_DIRS:INTERNAL= //ADVANCED property for variable: CGAL_ImageIO_LIBRARY CGAL_ImageIO_LIBRARY-ADVANCED:INTERNAL=1 -CGAL_ImageIO_LIBRARY:INTERNAL= //Variable hidden from user CGAL_ImageIO_LIBRARY_NAME:INTERNAL=libCGAL_ImageIO.so CGAL_ImageIO_USE_ZLIB:INTERNAL=ON @@ -493,22 +1284,20 @@ CGAL_ImageIO_USE_ZLIB:INTERNAL=ON CGAL_LIBRARY:INTERNAL=/home/lrineau/trunk/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/lib/libCGAL.so //Variable hidden from user CGAL_LIBRARY_NAME:INTERNAL=libCGAL.so -CGAL_Qt3_3RD_PARTY_DEFINITIONS:INTERNAL= -CGAL_Qt3_3RD_PARTY_INCLUDE_DIRS:INTERNAL= -CGAL_Qt3_3RD_PARTY_LIBRARIES:INTERNAL= +CGAL_Qt3_3RD_PARTY_DEFINITIONS:INTERNAL=-DQT_SHARED;-DQT_NO_DEBUG;-DQT_THREAD_SUPPORT;-D_REENTRANT +CGAL_Qt3_3RD_PARTY_INCLUDE_DIRS:INTERNAL=/usr/lib/qt-3.3/include;/usr/include +CGAL_Qt3_3RD_PARTY_LIBRARIES:INTERNAL=/usr/lib/qt-3.3/lib/libqassistantclient.a;/usr/lib/qt-3.3/lib/libqt-mt.so;dl;-lpthread;/usr/lib/libGLU.so;/usr/lib/libGL.so CGAL_Qt3_3RD_PARTY_LIBRARIES_DIRS:INTERNAL= //ADVANCED property for variable: CGAL_Qt3_LIBRARY CGAL_Qt3_LIBRARY-ADVANCED:INTERNAL=1 -CGAL_Qt3_LIBRARY:INTERNAL= //Variable hidden from user CGAL_Qt3_LIBRARY_NAME:INTERNAL=libCGAL_Qt3.so CGAL_Qt4_3RD_PARTY_DEFINITIONS:INTERNAL= -CGAL_Qt4_3RD_PARTY_INCLUDE_DIRS:INTERNAL= -CGAL_Qt4_3RD_PARTY_LIBRARIES:INTERNAL= +CGAL_Qt4_3RD_PARTY_INCLUDE_DIRS:INTERNAL=/usr/include;/usr/include +CGAL_Qt4_3RD_PARTY_LIBRARIES:INTERNAL=optimized;/usr/lib64/libQtOpenGL.so;debug;/usr/lib64/libQtOpenGL_debug.so;optimized;/usr/lib64/libQtGui.so;debug;/usr/lib64/libQtGui_debug.so;optimized;/usr/lib64/libQtCore.so;debug;/usr/lib64/libQtCore_debug.so;/usr/lib/libGLU.so;/usr/lib/libGL.so CGAL_Qt4_3RD_PARTY_LIBRARIES_DIRS:INTERNAL= //ADVANCED property for variable: CGAL_Qt4_LIBRARY CGAL_Qt4_LIBRARY-ADVANCED:INTERNAL=1 -CGAL_Qt4_LIBRARY:INTERNAL= //Variable hidden from user CGAL_Qt4_LIBRARY_NAME:INTERNAL=libCGAL_Qt4.so //ADVANCED property for variable: CGAL_SONAME_VERSION @@ -572,7 +1361,7 @@ CMAKE_DETERMINE_CXX_ABI_COMPILED:INTERNAL=TRUE //Result of TRY_COMPILE CMAKE_DETERMINE_C_ABI_COMPILED:INTERNAL=TRUE //Path to cache edit program executable. -CMAKE_EDIT_COMMAND:INTERNAL=/usr/bin/cmake-gui +CMAKE_EDIT_COMMAND:INTERNAL=/usr/bin/ccmake //Executable file format CMAKE_EXECUTABLE_FORMAT:INTERNAL=ELF //ADVANCED property for variable: CMAKE_EXE_LINKER_FLAGS @@ -625,7 +1414,7 @@ CMAKE_MODULE_LINKER_FLAGS_RELWITHDEBINFO-ADVANCED:INTERNAL=1 //ADVANCED property for variable: CMAKE_NM CMAKE_NM-ADVANCED:INTERNAL=1 //number of local generators -CMAKE_NUMBER_OF_LOCAL_GENERATORS:INTERNAL=4 +CMAKE_NUMBER_OF_LOCAL_GENERATORS:INTERNAL=7 //ADVANCED property for variable: CMAKE_OBJCOPY CMAKE_OBJCOPY-ADVANCED:INTERNAL=1 //ADVANCED property for variable: CMAKE_OBJDUMP @@ -650,7 +1439,7 @@ CMAKE_SKIP_RPATH-ADVANCED:INTERNAL=1 CMAKE_STRIP-ADVANCED:INTERNAL=1 //Suppress Warnings that are meant for the author of the CMakeLists.txt // files. -CMAKE_SUPPRESS_DEVELOPER_WARNINGS:INTERNAL=FALSE +CMAKE_SUPPRESS_DEVELOPER_WARNINGS:INTERNAL=TRUE //uname command CMAKE_UNAME:INTERNAL=/bin/uname //ADVANCED property for variable: CMAKE_USE_RELATIVE_PATHS @@ -659,8 +1448,10 @@ CMAKE_USE_RELATIVE_PATHS-ADVANCED:INTERNAL=1 CMAKE_VERBOSE_MAKEFILE-ADVANCED:INTERNAL=1 //Variable hidden from user EXECUTABLE_OUTPUT_PATH:INTERNAL= +//Details about finding OpenGL +FIND_PACKAGE_MESSAGE_DETAILS_OpenGL:INTERNAL=[/usr/lib/libGL.so][v()] //Details about finding Threads -FIND_PACKAGE_MESSAGE_DETAILS_Threads:INTERNAL=[TRUE] +FIND_PACKAGE_MESSAGE_DETAILS_Threads:INTERNAL=[TRUE][v()] //Details about finding X11 FIND_PACKAGE_MESSAGE_DETAILS_X11:INTERNAL=[/usr/lib64/libX11.so][/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include;/usr/include] //Details about finding ZLIB @@ -680,16 +1471,438 @@ MPFR_COMPILE_RES:INTERNAL=TRUE //Result of TRY_RUN MPFR_RUN_RES:INTERNAL=0 //Result of TRY_COMPILE -OPENGL_COMPILE_RES:INTERNAL=FALSE +OPENGL_COMPILE_RES:INTERNAL=TRUE +//ADVANCED property for variable: OPENGL_INCLUDE_DIR +OPENGL_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//Result of TRY_RUN +OPENGL_RUN_RES:INTERNAL=0 +//ADVANCED property for variable: OPENGL_gl_LIBRARY +OPENGL_gl_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: OPENGL_glu_LIBRARY +OPENGL_glu_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: OPENGL_xmesa_INCLUDE_DIR +OPENGL_xmesa_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT3_INCLUDE_DIR +QT3_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT3_MOC_EXECUTABLE +QT3_MOC_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT3_QASSISTANTCLIENT_LIBRARY +QT3_QASSISTANTCLIENT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT3_QT_LIBRARY +QT3_QT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT3_UIC_EXECUTABLE +QT3_UIC_EXECUTABLE-ADVANCED:INTERNAL=1 //Result of TRY_COMPILE -QT4_COMPILE_RES:INTERNAL=FALSE +QT4_COMPILE_RES:INTERNAL=TRUE +//Result of TRY_RUN +QT4_RUN_RES:INTERNAL=0 +//ADVANCED property for variable: QT_ARTHURPLUGIN_PLUGIN_DEBUG +QT_ARTHURPLUGIN_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_ARTHURPLUGIN_PLUGIN_RELEASE +QT_ARTHURPLUGIN_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 QT_BINARY_DIR:INTERNAL=/usr/lib64/qt4/bin //Result of TRY_COMPILE -QT_COMPILE_RES:INTERNAL=FALSE +QT_COMPILE_RES:INTERNAL=TRUE +//ADVANCED property for variable: QT_CONTAINEREXTENSION_PLUGIN_DEBUG +QT_CONTAINEREXTENSION_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_CONTAINEREXTENSION_PLUGIN_RELEASE +QT_CONTAINEREXTENSION_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_CUSTOMWIDGETPLUGIN_PLUGIN_DEBUG +QT_CUSTOMWIDGETPLUGIN_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_CUSTOMWIDGETPLUGIN_PLUGIN_RELEASE +QT_CUSTOMWIDGETPLUGIN_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_DBUSCPP2XML_EXECUTABLE +QT_DBUSCPP2XML_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_DBUSXML2CPP_EXECUTABLE +QT_DBUSXML2CPP_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_DESIGNER_EXECUTABLE +QT_DESIGNER_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_DOC_DIR +QT_DOC_DIR-ADVANCED:INTERNAL=1 QT_HEADERS_DIR:INTERNAL=/usr/include +//ADVANCED property for variable: QT_IMPORTS_DIR +QT_IMPORTS_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_LIBRARY_DIR +QT_LIBRARY_DIR-ADVANCED:INTERNAL=1 +//Qt library dir +QT_LIBRARY_DIR:INTERNAL=/usr/lib64 +//ADVANCED property for variable: QT_LINGUIST_EXECUTABLE +QT_LINGUIST_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_LRELEASE_EXECUTABLE +QT_LRELEASE_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_LUPDATE_EXECUTABLE +QT_LUPDATE_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_MKSPECS_DIR +QT_MKSPECS_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_MOC_EXECUTABLE +QT_MOC_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONONWIDGETS_PLUGIN_DEBUG +QT_PHONONWIDGETS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONONWIDGETS_PLUGIN_RELEASE +QT_PHONONWIDGETS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_INCLUDE_DIR +QT_PHONON_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_LIBRARY +QT_PHONON_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_LIBRARY_DEBUG +QT_PHONON_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_LIBRARY_RELEASE +QT_PHONON_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_QT7_PLUGIN_DEBUG +QT_PHONON_QT7_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PHONON_QT7_PLUGIN_RELEASE +QT_PHONON_QT7_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_PLUGINS_DIR +QT_PLUGINS_DIR-ADVANCED:INTERNAL=1 //Have symbol _POSIX_TIMERS QT_POSIX_TIMERS:INTERNAL=1 -QT_QMAKE_EXECUTABLE_LAST:INTERNAL=/usr/lib64/qt-3.3/bin/qmake +//ADVANCED property for variable: QT_QCNCODECS_PLUGIN_DEBUG +QT_QCNCODECS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QCNCODECS_PLUGIN_RELEASE +QT_QCNCODECS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QCOLLECTIONGENERATOR_EXECUTABLE +QT_QCOLLECTIONGENERATOR_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QCOREWLANBEARER_PLUGIN_DEBUG +QT_QCOREWLANBEARER_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QCOREWLANBEARER_PLUGIN_RELEASE +QT_QCOREWLANBEARER_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECLARATIVEVIEW_PLUGIN_DEBUG +QT_QDECLARATIVEVIEW_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECLARATIVEVIEW_PLUGIN_RELEASE +QT_QDECLARATIVEVIEW_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECORATIONDEFAULT_PLUGIN_DEBUG +QT_QDECORATIONDEFAULT_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECORATIONDEFAULT_PLUGIN_RELEASE +QT_QDECORATIONDEFAULT_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECORATIONWINDOWS_PLUGIN_DEBUG +QT_QDECORATIONWINDOWS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QDECORATIONWINDOWS_PLUGIN_RELEASE +QT_QDECORATIONWINDOWS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGENERICBEARER_PLUGIN_DEBUG +QT_QGENERICBEARER_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGENERICBEARER_PLUGIN_RELEASE +QT_QGENERICBEARER_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGIF_PLUGIN_DEBUG +QT_QGIF_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGIF_PLUGIN_RELEASE +QT_QGIF_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGLGRAPHICSSYSTEM_PLUGIN_DEBUG +QT_QGLGRAPHICSSYSTEM_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QGLGRAPHICSSYSTEM_PLUGIN_RELEASE +QT_QGLGRAPHICSSYSTEM_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QICO_PLUGIN_DEBUG +QT_QICO_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QICO_PLUGIN_RELEASE +QT_QICO_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QIMSW_MULTI_PLUGIN_DEBUG +QT_QIMSW_MULTI_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QIMSW_MULTI_PLUGIN_RELEASE +QT_QIMSW_MULTI_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QJPCODECS_PLUGIN_DEBUG +QT_QJPCODECS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QJPCODECS_PLUGIN_RELEASE +QT_QJPCODECS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QJPEG_PLUGIN_DEBUG +QT_QJPEG_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QJPEG_PLUGIN_RELEASE +QT_QJPEG_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QKRCODECS_PLUGIN_DEBUG +QT_QKRCODECS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QKRCODECS_PLUGIN_RELEASE +QT_QKRCODECS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +QT_QMAKE_EXECUTABLE_LAST:INTERNAL=/usr/bin/qmake-qt4 +//ADVANCED property for variable: QT_QMNG_PLUGIN_DEBUG +QT_QMNG_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QMNG_PLUGIN_RELEASE +QT_QMNG_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLDB2_PLUGIN_DEBUG +QT_QSQLDB2_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLDB2_PLUGIN_RELEASE +QT_QSQLDB2_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLIBASE_PLUGIN_DEBUG +QT_QSQLIBASE_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLIBASE_PLUGIN_RELEASE +QT_QSQLIBASE_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLITE2_PLUGIN_DEBUG +QT_QSQLITE2_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLITE2_PLUGIN_RELEASE +QT_QSQLITE2_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLITE_PLUGIN_DEBUG +QT_QSQLITE_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLITE_PLUGIN_RELEASE +QT_QSQLITE_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLMYSQL_PLUGIN_DEBUG +QT_QSQLMYSQL_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLMYSQL_PLUGIN_RELEASE +QT_QSQLMYSQL_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLOCI_PLUGIN_DEBUG +QT_QSQLOCI_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLOCI_PLUGIN_RELEASE +QT_QSQLOCI_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLODBC_PLUGIN_DEBUG +QT_QSQLODBC_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLODBC_PLUGIN_RELEASE +QT_QSQLODBC_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLPSQL_PLUGIN_DEBUG +QT_QSQLPSQL_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLPSQL_PLUGIN_RELEASE +QT_QSQLPSQL_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLTDS_PLUGIN_DEBUG +QT_QSQLTDS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSQLTDS_PLUGIN_RELEASE +QT_QSQLTDS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSVGICON_PLUGIN_DEBUG +QT_QSVGICON_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSVGICON_PLUGIN_RELEASE +QT_QSVGICON_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSVG_PLUGIN_DEBUG +QT_QSVG_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QSVG_PLUGIN_RELEASE +QT_QSVG_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORTWIDGETS_PLUGIN_DEBUG +QT_QT3SUPPORTWIDGETS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORTWIDGETS_PLUGIN_RELEASE +QT_QT3SUPPORTWIDGETS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORT_INCLUDE_DIR +QT_QT3SUPPORT_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORT_LIBRARY +QT_QT3SUPPORT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORT_LIBRARY_DEBUG +QT_QT3SUPPORT_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QT3SUPPORT_LIBRARY_RELEASE +QT_QT3SUPPORT_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_DEBUG +QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_RELEASE +QT_QTACCESSIBLECOMPATWIDGETS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTACCESSIBLEWIDGETS_PLUGIN_DEBUG +QT_QTACCESSIBLEWIDGETS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTACCESSIBLEWIDGETS_PLUGIN_RELEASE +QT_QTACCESSIBLEWIDGETS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANTCLIENT_INCLUDE_DIR +QT_QTASSISTANTCLIENT_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANTCLIENT_LIBRARY +QT_QTASSISTANTCLIENT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANTCLIENT_LIBRARY_DEBUG +QT_QTASSISTANTCLIENT_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANTCLIENT_LIBRARY_RELEASE +QT_QTASSISTANTCLIENT_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANT_INCLUDE_DIR +QT_QTASSISTANT_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANT_LIBRARY +QT_QTASSISTANT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANT_LIBRARY_DEBUG +QT_QTASSISTANT_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTASSISTANT_LIBRARY_RELEASE +QT_QTASSISTANT_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCLUCENE_LIBRARY +QT_QTCLUCENE_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCLUCENE_LIBRARY_DEBUG +QT_QTCLUCENE_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCLUCENE_LIBRARY_RELEASE +QT_QTCLUCENE_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCORE_INCLUDE_DIR +QT_QTCORE_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCORE_LIBRARY +QT_QTCORE_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCORE_LIBRARY_DEBUG +QT_QTCORE_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTCORE_LIBRARY_RELEASE +QT_QTCORE_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDBUS_INCLUDE_DIR +QT_QTDBUS_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDBUS_LIBRARY +QT_QTDBUS_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDBUS_LIBRARY_DEBUG +QT_QTDBUS_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDBUS_LIBRARY_RELEASE +QT_QTDBUS_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDECLARATIVE_INCLUDE_DIR +QT_QTDECLARATIVE_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDECLARATIVE_LIBRARY +QT_QTDECLARATIVE_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDECLARATIVE_LIBRARY_DEBUG +QT_QTDECLARATIVE_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDECLARATIVE_LIBRARY_RELEASE +QT_QTDECLARATIVE_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNERCOMPONENTS_INCLUDE_DIR +QT_QTDESIGNERCOMPONENTS_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNERCOMPONENTS_LIBRARY +QT_QTDESIGNERCOMPONENTS_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNERCOMPONENTS_LIBRARY_DEBUG +QT_QTDESIGNERCOMPONENTS_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNERCOMPONENTS_LIBRARY_RELEASE +QT_QTDESIGNERCOMPONENTS_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNER_INCLUDE_DIR +QT_QTDESIGNER_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNER_LIBRARY +QT_QTDESIGNER_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNER_LIBRARY_DEBUG +QT_QTDESIGNER_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTDESIGNER_LIBRARY_RELEASE +QT_QTDESIGNER_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTGUI_INCLUDE_DIR +QT_QTGUI_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTGUI_LIBRARY +QT_QTGUI_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTGUI_LIBRARY_DEBUG +QT_QTGUI_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTGUI_LIBRARY_RELEASE +QT_QTGUI_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTHELP_INCLUDE_DIR +QT_QTHELP_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTHELP_LIBRARY +QT_QTHELP_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTHELP_LIBRARY_DEBUG +QT_QTHELP_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTHELP_LIBRARY_RELEASE +QT_QTHELP_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTIFF_PLUGIN_DEBUG +QT_QTIFF_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTIFF_PLUGIN_RELEASE +QT_QTIFF_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTMULTIMEDIA_INCLUDE_DIR +QT_QTMULTIMEDIA_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTMULTIMEDIA_LIBRARY +QT_QTMULTIMEDIA_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTMULTIMEDIA_LIBRARY_DEBUG +QT_QTMULTIMEDIA_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTMULTIMEDIA_LIBRARY_RELEASE +QT_QTMULTIMEDIA_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNETWORK_INCLUDE_DIR +QT_QTNETWORK_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNETWORK_LIBRARY +QT_QTNETWORK_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNETWORK_LIBRARY_DEBUG +QT_QTNETWORK_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNETWORK_LIBRARY_RELEASE +QT_QTNETWORK_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNSPLUGIN_INCLUDE_DIR +QT_QTNSPLUGIN_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNSPLUGIN_LIBRARY +QT_QTNSPLUGIN_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNSPLUGIN_LIBRARY_DEBUG +QT_QTNSPLUGIN_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTNSPLUGIN_LIBRARY_RELEASE +QT_QTNSPLUGIN_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTOPENGL_INCLUDE_DIR +QT_QTOPENGL_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTOPENGL_LIBRARY +QT_QTOPENGL_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTOPENGL_LIBRARY_DEBUG +QT_QTOPENGL_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTOPENGL_LIBRARY_RELEASE +QT_QTOPENGL_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTRACEGRAPHICSSYSTEM_PLUGIN_DEBUG +QT_QTRACEGRAPHICSSYSTEM_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTRACEGRAPHICSSYSTEM_PLUGIN_RELEASE +QT_QTRACEGRAPHICSSYSTEM_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTDBUS_PLUGIN_DEBUG +QT_QTSCRIPTDBUS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTDBUS_PLUGIN_RELEASE +QT_QTSCRIPTDBUS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTTOOLS_INCLUDE_DIR +QT_QTSCRIPTTOOLS_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTTOOLS_LIBRARY +QT_QTSCRIPTTOOLS_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTTOOLS_LIBRARY_DEBUG +QT_QTSCRIPTTOOLS_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPTTOOLS_LIBRARY_RELEASE +QT_QTSCRIPTTOOLS_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPT_INCLUDE_DIR +QT_QTSCRIPT_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPT_LIBRARY +QT_QTSCRIPT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPT_LIBRARY_DEBUG +QT_QTSCRIPT_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSCRIPT_LIBRARY_RELEASE +QT_QTSCRIPT_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSQL_INCLUDE_DIR +QT_QTSQL_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSQL_LIBRARY +QT_QTSQL_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSQL_LIBRARY_DEBUG +QT_QTSQL_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSQL_LIBRARY_RELEASE +QT_QTSQL_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSVG_INCLUDE_DIR +QT_QTSVG_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSVG_LIBRARY +QT_QTSVG_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSVG_LIBRARY_DEBUG +QT_QTSVG_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTSVG_LIBRARY_RELEASE +QT_QTSVG_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTTEST_INCLUDE_DIR +QT_QTTEST_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTTEST_LIBRARY +QT_QTTEST_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTTEST_LIBRARY_DEBUG +QT_QTTEST_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTTEST_LIBRARY_RELEASE +QT_QTTEST_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTUITOOLS_INCLUDE_DIR +QT_QTUITOOLS_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTUITOOLS_LIBRARY +QT_QTUITOOLS_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTUITOOLS_LIBRARY_DEBUG +QT_QTUITOOLS_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTUITOOLS_LIBRARY_RELEASE +QT_QTUITOOLS_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWCODECS_PLUGIN_DEBUG +QT_QTWCODECS_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWCODECS_PLUGIN_RELEASE +QT_QTWCODECS_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWEBKIT_INCLUDE_DIR +QT_QTWEBKIT_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWEBKIT_LIBRARY +QT_QTWEBKIT_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWEBKIT_LIBRARY_DEBUG +QT_QTWEBKIT_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTWEBKIT_LIBRARY_RELEASE +QT_QTWEBKIT_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXMLPATTERNS_INCLUDE_DIR +QT_QTXMLPATTERNS_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXMLPATTERNS_LIBRARY +QT_QTXMLPATTERNS_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXMLPATTERNS_LIBRARY_DEBUG +QT_QTXMLPATTERNS_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXMLPATTERNS_LIBRARY_RELEASE +QT_QTXMLPATTERNS_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXML_INCLUDE_DIR +QT_QTXML_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXML_LIBRARY +QT_QTXML_LIBRARY-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXML_LIBRARY_DEBUG +QT_QTXML_LIBRARY_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QTXML_LIBRARY_RELEASE +QT_QTXML_LIBRARY_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QWEBVIEW_PLUGIN_DEBUG +QT_QWEBVIEW_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QWEBVIEW_PLUGIN_RELEASE +QT_QWEBVIEW_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QWSTSLIBMOUSEHANDLER_PLUGIN_DEBUG +QT_QWSTSLIBMOUSEHANDLER_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_QWSTSLIBMOUSEHANDLER_PLUGIN_RELEASE +QT_QWSTSLIBMOUSEHANDLER_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_RCC_EXECUTABLE +QT_RCC_EXECUTABLE-ADVANCED:INTERNAL=1 +//Result of TRY_RUN +QT_RUN_RES:INTERNAL=0 +//ADVANCED property for variable: QT_TASKMENUEXTENSION_PLUGIN_DEBUG +QT_TASKMENUEXTENSION_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_TASKMENUEXTENSION_PLUGIN_RELEASE +QT_TASKMENUEXTENSION_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_TRANSLATIONS_DIR +QT_TRANSLATIONS_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_UIC3_EXECUTABLE +QT_UIC3_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_UIC_EXECUTABLE +QT_UIC_EXECUTABLE-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_WORLDTIMECLOCKPLUGIN_PLUGIN_DEBUG +QT_WORLDTIMECLOCKPLUGIN_PLUGIN_DEBUG-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: QT_WORLDTIMECLOCKPLUGIN_PLUGIN_RELEASE +QT_WORLDTIMECLOCKPLUGIN_PLUGIN_RELEASE-ADVANCED:INTERNAL=1 //Have symbol Q_WS_MAC Q_WS_MAC:INTERNAL= //Have symbol Q_WS_QWS @@ -710,12 +1923,126 @@ Qt_widget_history_h:INTERNAL=/home/lrineau/CGAL/CGAL-I/include/CGAL/IO/Qt_widget Qt_widget_layer_h:INTERNAL=/home/lrineau/CGAL/CGAL-I/include/CGAL/IO/Qt_widget_layer.h //hide this Qt_widget_standard_toolbar_h:INTERNAL=/home/lrineau/CGAL/CGAL-I/include/CGAL/IO/Qt_widget_standard_toolbar.h +//MODIFIED property for variable: WITH_CGAL_ImageIO +WITH_CGAL_ImageIO-MODIFIED:INTERNAL=ON +//MODIFIED property for variable: WITH_CGAL_Qt3 +WITH_CGAL_Qt3-MODIFIED:INTERNAL=ON +//MODIFIED property for variable: WITH_CGAL_Qt4 +WITH_CGAL_Qt4-MODIFIED:INTERNAL=ON +//ADVANCED property for variable: X11_ICE_INCLUDE_PATH +X11_ICE_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_ICE_LIB +X11_ICE_LIB-ADVANCED:INTERNAL=1 //Have library dnet X11_LIB_DNET_HAS_DNET_NTOA:INTERNAL= //Have library dnet_stub X11_LIB_DNET_STUB_HAS_DNET_NTOA:INTERNAL= //Have library /usr/lib64/libX11.so;/usr/lib64/libXext.so X11_LIB_X11_SOLO:INTERNAL= +//ADVANCED property for variable: X11_SM_LIB +X11_SM_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_X11_INCLUDE_PATH +X11_X11_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_X11_LIB +X11_X11_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_XShm_INCLUDE_PATH +X11_XShm_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_XTest_INCLUDE_PATH +X11_XTest_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_XTest_LIB +X11_XTest_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xaccessrules_INCLUDE_PATH +X11_Xaccessrules_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xaccessstr_INCLUDE_PATH +X11_Xaccessstr_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xau_INCLUDE_PATH +X11_Xau_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xau_LIB +X11_Xau_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xcomposite_INCLUDE_PATH +X11_Xcomposite_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xcomposite_LIB +X11_Xcomposite_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xcursor_INCLUDE_PATH +X11_Xcursor_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xcursor_LIB +X11_Xcursor_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xdamage_INCLUDE_PATH +X11_Xdamage_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xdamage_LIB +X11_Xdamage_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xdmcp_INCLUDE_PATH +X11_Xdmcp_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xdmcp_LIB +X11_Xdmcp_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xext_LIB +X11_Xext_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xfixes_INCLUDE_PATH +X11_Xfixes_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xfixes_LIB +X11_Xfixes_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xft_INCLUDE_PATH +X11_Xft_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xft_LIB +X11_Xft_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xi_INCLUDE_PATH +X11_Xi_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xi_LIB +X11_Xi_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xinerama_INCLUDE_PATH +X11_Xinerama_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xinerama_LIB +X11_Xinerama_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xinput_INCLUDE_PATH +X11_Xinput_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xinput_LIB +X11_Xinput_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xkb_INCLUDE_PATH +X11_Xkb_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xkblib_INCLUDE_PATH +X11_Xkblib_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xlib_INCLUDE_PATH +X11_Xlib_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xpm_INCLUDE_PATH +X11_Xpm_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xpm_LIB +X11_Xpm_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xrandr_INCLUDE_PATH +X11_Xrandr_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xrandr_LIB +X11_Xrandr_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xrender_INCLUDE_PATH +X11_Xrender_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xrender_LIB +X11_Xrender_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xscreensaver_INCLUDE_PATH +X11_Xscreensaver_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xscreensaver_LIB +X11_Xscreensaver_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xshape_INCLUDE_PATH +X11_Xshape_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xt_INCLUDE_PATH +X11_Xt_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xt_LIB +X11_Xt_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xutil_INCLUDE_PATH +X11_Xutil_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xv_INCLUDE_PATH +X11_Xv_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xv_LIB +X11_Xv_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_Xxf86misc_LIB +X11_Xxf86misc_LIB-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_dpms_INCLUDE_PATH +X11_dpms_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_xf86misc_INCLUDE_PATH +X11_xf86misc_INCLUDE_PATH-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: X11_xf86vmode_INCLUDE_PATH +X11_xf86vmode_INCLUDE_PATH-ADVANCED:INTERNAL=1 //Result of TRY_COMPILE ZLIB_COMPILE_RES:INTERNAL=FALSE +//ADVANCED property for variable: ZLIB_INCLUDE_DIR +ZLIB_INCLUDE_DIR-ADVANCED:INTERNAL=1 +//ADVANCED property for variable: ZLIB_LIBRARY +ZLIB_LIBRARY-ADVANCED:INTERNAL=1 diff --git a/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/setup b/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/setup index f485590893d..9f47f45add3 100644 --- a/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/setup +++ b/Maintenance/infrastructure/matisse.geometryfactory.com/reference-platforms/x86-64_Linux-2.6_g++-4.5.1_F14-m32/setup @@ -1,2 +1,6 @@ export QTDIR=/usr/lib/qt-3.3 + CXXFLAGS=-m32 +CFLAGS=-m32 +export CXXFLAGS +export CFLAGS diff --git a/Mesh_3/demo/Mesh_3/Io_implicit_function_plugin.cpp b/Mesh_3/demo/Mesh_3/Io_implicit_function_plugin.cpp index 2651d825754..7f4d381e142 100644 --- a/Mesh_3/demo/Mesh_3/Io_implicit_function_plugin.cpp +++ b/Mesh_3/demo/Mesh_3/Io_implicit_function_plugin.cpp @@ -164,7 +164,14 @@ Io_implicit_function_plugin:: load_function_plugins() { QDir pluginsDir(qApp->applicationDirPath()); - if ( !pluginsDir.cd("implicit_functions") ) { return; } + QString dirname = pluginsDir.dirName(); + if ( !pluginsDir.cd("implicit_functions") ) { + // In that case, dirname may be "Debug" or "Release" and one has to + // search in ../implicit_functions/Debug or + // ../implicit_functions/Release + QString newDir = QString("../implicit_functions/") + dirname; + if( !pluginsDir.cd(newDir) ) return; + } Q_FOREACH (QString fileName, pluginsDir.entryList(QDir::Files)) { diff --git a/Mesh_3/demo/Mesh_3/MainWindow.cpp b/Mesh_3/demo/Mesh_3/MainWindow.cpp index e89b340687a..e275bc4122e 100644 --- a/Mesh_3/demo/Mesh_3/MainWindow.cpp +++ b/Mesh_3/demo/Mesh_3/MainWindow.cpp @@ -18,6 +18,7 @@ #include #include #include +#include #include #include @@ -550,3 +551,27 @@ void MainWindow::setAddKeyFrameKeyboardModifiers(::Qt::KeyboardModifiers m) { viewer->setAddKeyFrameKeyboardModifiers(m); } + +void MainWindow::on_actionCopy_snapshot_triggered() +{ + // copy snapshot to clipboard + QApplication::setOverrideCursor(Qt::WaitCursor); + QClipboard *qb = QApplication::clipboard(); + viewer->makeCurrent(); + viewer->raise(); + QImage snapshot = viewer->grabFrameBuffer(true); + qb->setImage(snapshot); + QApplication::restoreOverrideCursor(); +} + +void MainWindow::on_actionSave_snapshot_triggered() +{ + // save snapshot to file + QApplication::setOverrideCursor(Qt::WaitCursor); + QString filename = QFileDialog::getSaveFileName(this,tr("Save snapshot to file..."),"snapshot00.png","*.png"); + viewer->saveSnapshot(filename); + QApplication::restoreOverrideCursor(); +} + + + diff --git a/Mesh_3/demo/Mesh_3/MainWindow.h b/Mesh_3/demo/Mesh_3/MainWindow.h index a345ae1eb21..48d9612fc84 100644 --- a/Mesh_3/demo/Mesh_3/MainWindow.h +++ b/Mesh_3/demo/Mesh_3/MainWindow.h @@ -62,6 +62,10 @@ protected slots: void readSettings(); void writeSettings(); + // snapshot + void on_actionCopy_snapshot_triggered(); + void on_actionSave_snapshot_triggered(); + // load, erase, duplicate void on_actionEraseAll_triggered(); void on_actionLoad_triggered(); diff --git a/Mesh_3/demo/Mesh_3/ui_files/MainWindow.ui b/Mesh_3/demo/Mesh_3/ui_files/MainWindow.ui index 551a8eee278..b6d6dcc1aed 100644 --- a/Mesh_3/demo/Mesh_3/ui_files/MainWindow.ui +++ b/Mesh_3/demo/Mesh_3/ui_files/MainWindow.ui @@ -14,7 +14,7 @@ CGAL 3D mesh generator demo - + :/cgal/icons/resources/cgal_logo.xpm:/cgal/icons/resources/cgal_logo.xpm @@ -37,7 +37,7 @@ 0 0 978 - 22 + 21 @@ -59,6 +59,9 @@ + + + @@ -125,7 +128,7 @@ + - + :/cgal/icons/plus:/cgal/icons/plus @@ -136,7 +139,7 @@ - - + :/cgal/icons/minus:/cgal/icons/minus @@ -147,7 +150,7 @@ ... - + :/cgal/icons/duplicate:/cgal/icons/duplicate @@ -312,7 +315,7 @@ - + :/cgal/icons/plus:/cgal/icons/plus @@ -324,7 +327,7 @@ - + :/cgal/icons/minus:/cgal/icons/minus @@ -336,7 +339,7 @@ - + :/cgal/icons/duplicate:/cgal/icons/duplicate @@ -498,7 +501,7 @@ - Odt-smoothing + ODT-smoothing @@ -521,12 +524,22 @@ toto + + + Copy snapshot + + + + + Save snapshot + + Viewer QWidget -
CGAL_demo/Viewer.h
+
CGAL_demo/Viewer.h
diff --git a/Mesh_3/include/CGAL/Mesh_3/Mesh_complex_3_in_triangulation_3_base.h b/Mesh_3/include/CGAL/Mesh_3/Mesh_complex_3_in_triangulation_3_base.h index c43f3db6768..5cdc8062033 100644 --- a/Mesh_3/include/CGAL/Mesh_3/Mesh_complex_3_in_triangulation_3_base.h +++ b/Mesh_3/include/CGAL/Mesh_3/Mesh_complex_3_in_triangulation_3_base.h @@ -112,6 +112,11 @@ public: /// Removes facet \c facet from 2D complex void remove_from_complex(const Facet& facet); + /// Removes facet(\c cell, \c i) from 2D complex + void remove_from_complex(const Cell_handle& c, const int i) { + remove_from_complex(Facet(c, i)); + } + /// Sets surface index of facet \c facet to \c index void set_surface_patch_index(const Facet& f, const Surface_patch_index& index) { @@ -294,19 +299,20 @@ private: class Facet_iterator_not_in_complex { - const Self& c3t3_; - const Surface_patch_index index_; + const Self* c3t3_; + Surface_patch_index index_; //need by SWIG: should be const Surface_patch_index public: + Facet_iterator_not_in_complex(){} //need by SWIG Facet_iterator_not_in_complex(const Self& c3t3, const Surface_patch_index& index = Surface_patch_index()) - : c3t3_(c3t3) + : c3t3_(&c3t3) , index_(index) { } template bool operator()(Iterator it) const { - if ( index_ == Surface_patch_index() ) { return ! c3t3_.is_in_complex(*it); } - else { return c3t3_.surface_patch_index(*it) != index_; } + if ( index_ == Surface_patch_index() ) { return ! c3t3_->is_in_complex(*it); } + else { return c3t3_->surface_patch_index(*it) != index_; } } }; @@ -317,8 +323,9 @@ private: class Cell_not_in_complex { const Self* r_self_; - Subdomain_index index_; + Subdomain_index index_;//needed by SWIG, should be const Subdomain_index public: + Cell_not_in_complex(){}//needed by SWIG Cell_not_in_complex(const Self& self, const Subdomain_index& index = Subdomain_index()) : r_self_(&self) @@ -388,7 +395,7 @@ public: Self operator++(int) { Self tmp(*this); ++(*this); return tmp; } Self operator--(int) { Self tmp(*this); --(*this); return tmp; } - operator Cell_handle() { return Cell_handle(this->base()); } + operator Cell_handle() const { return Cell_handle(this->base()); } }; // end class Cells_in_complex_iterator @@ -423,7 +430,7 @@ public: typedef Surface_patch_index Surface_index; void set_surface_index(const Facet& f, const Surface_index& index) - { set_surface_patch_index(f.first, index); } + { set_surface_patch_index(f, index); } void set_surface_index(const Cell_handle& c, const int i, const Surface_index& index) { set_surface_patch_index(c,i,index); } diff --git a/Mesh_3/test/Mesh_3/test_c3t3.cpp b/Mesh_3/test/Mesh_3/test_c3t3.cpp index cec0c72e963..c2f37f463c9 100644 --- a/Mesh_3/test/Mesh_3/test_c3t3.cpp +++ b/Mesh_3/test/Mesh_3/test_c3t3.cpp @@ -301,11 +301,19 @@ struct Tester c3t3.set_subdomain_index(ch, subdomain_index_bis); c3t3.set_surface_patch_index(f2, surface_patch_index_bis); +#ifndef CGAL_MESH_3_NO_DEPRECATED_SURFACE_INDEX + c3t3.set_surface_index(f2, surface_patch_index_bis); + c3t3.set_surface_index(f2.first, f2.second, surface_patch_index_bis); +#endif c3t3.set_dimension(vh, 1); c3t3.set_index(vh, vertex_index); assert(c3t3.subdomain_index(ch) == subdomain_index_bis); assert(c3t3.surface_patch_index(f2) == surface_patch_index_bis); +#ifndef CGAL_MESH_3_NO_DEPRECATED_SURFACE_INDEX + assert(c3t3.surface_index(f2) == surface_patch_index_bis); + assert(c3t3.surface_index(f2.first, f2.second) == surface_patch_index_bis); +#endif assert(c3t3.in_dimension(vh) == 1); assert(c3t3.index(vh) == vertex_index); diff --git a/Number_types/include/CGAL/Lazy_exact_nt.h b/Number_types/include/CGAL/Lazy_exact_nt.h index cb6a753fcfd..ce1374e28b6 100644 --- a/Number_types/include/CGAL/Lazy_exact_nt.h +++ b/Number_types/include/CGAL/Lazy_exact_nt.h @@ -1121,6 +1121,7 @@ public: CGAL_DEFINE_COERCION_TRAITS_FOR_SELF_TEM(Lazy_exact_nt, class ET) +CGAL_DEFINE_COERCION_TRAITS_FROM_TO_TEM(ET,Lazy_exact_nt,class ET) template struct Coercion_traits< Lazy_exact_nt, Lazy_exact_nt > diff --git a/Point_set_processing_3/include/CGAL/compute_average_spacing.h b/Point_set_processing_3/include/CGAL/compute_average_spacing.h index a364e0decef..02808557dfd 100644 --- a/Point_set_processing_3/include/CGAL/compute_average_spacing.h +++ b/Point_set_processing_3/include/CGAL/compute_average_spacing.h @@ -136,12 +136,10 @@ compute_average_spacing( // precondition: at least 2 nearest neighbors CGAL_point_set_processing_precondition(k >= 2); - InputIterator it; - // Instanciate a KD-tree search. // Note: We have to convert each input iterator to Point_3. std::vector kd_tree_points; - for(it = first; it != beyond; it++) + for(InputIterator it = first; it != beyond; it++) { Point point = get(point_pmap, it); kd_tree_points.push_back(point); @@ -152,7 +150,7 @@ compute_average_spacing( // vectors (already normalized) FT sum_spacings = (FT)0.0; unsigned int nb_points = 0; - for(it = first; it != beyond; it++) + for(InputIterator it = first; it != beyond; it++) { sum_spacings += internal::compute_average_spacing(get(point_pmap,it),tree,k); nb_points++; diff --git a/STL_Extension/include/CGAL/is_iterator.h b/STL_Extension/include/CGAL/is_iterator.h index 920805ee06e..a094078ed8a 100644 --- a/STL_Extension/include/CGAL/is_iterator.h +++ b/STL_Extension/include/CGAL/is_iterator.h @@ -41,13 +41,18 @@ template struct is_iterator_type_ : //boost::is_base_of::iterator_category> boost::is_convertible::iterator_category,U> {}; + +template struct decay_array { typedef T type; }; +template struct decay_array { typedef T* type; }; +template struct decay_array { typedef T* type; }; } +// NOTE: we don't want the real std::decay or functions are included template struct is_iterator : - internal::is_iterator_::type> {}; + internal::is_iterator_::type>::type>::type> {}; template struct is_iterator_type : - internal::is_iterator_type_::type,Tag> {}; + internal::is_iterator_type_::type>::type>::type,Tag> {}; } diff --git a/Scripts/developer_scripts/clean_up_branch.sh b/Scripts/developer_scripts/clean_up_branch.sh new file mode 100644 index 00000000000..e1a695993a2 --- /dev/null +++ b/Scripts/developer_scripts/clean_up_branch.sh @@ -0,0 +1,85 @@ +#!/bin/bash +# +# usage: bash clean_up_branch.sh directory [rm] +# +# lists all files that should be removed from a branch. +# directory is the path to the repository. +# If additional rm option is passed, files will be deleted. +# + +REPO_DIR=. +DELETE=0 + +if [ $# -gt 0 ] ; then + REPO_DIR=$1 +fi + +if [ ! -e $REPO_DIR/.svn/entries ]; then + echo "$REPO_DIR is not a working copy" + exit 1 +fi; + +if [ $# -gt 1 ]; then + if [ "$2" == "rm" ]; then + DELETE=1 + else + echo "Unknown option $2" + exit 1 + fi +fi; + +echo Cleaning $REPO_DIR + +#define regular expression to match generated files +REGEXP='ProgramOutput\.|CMakeFiles|CMakeLists.txt|\.moc$|CMakeCache\.txt|error\.txt|cmake_install\.cmake|Makefile|doc_html|doc_pdf|\.pdflg$|\.ilg$|\.cgallog$|\.blg$|\.bak$|\.hax$|\.aux$|\.maf$|\.hlg$|\.out$|demo.*\/qrc_.*\.cxx|demo.*\/ui_.*\.h' + + +INITIAL=`svn status --no-ignore $1| awk '{if ($1 =="?" || $1=="I" ) print $2 }'` + + +#first get executable files +EXECS='' +DIRS='' +KNOWN='' +OTHER='' + +for i in $INITIAL; do + if [ -x $REPO_DIR/$i -a ! -d $REPO_DIR/$i ]; then + EXECS="$EXECS $i" + elif [[ "$i" =~ $REGEXP ]]; then + KNOWN="$KNOWN $i" + else + OTHER="$OTHER $i" + fi; +done + +if [ "$EXECS" ]; then + echo "#Cleaning executables" + echo rm -rf $EXECS +fi + +if [ "$KNOWN" ]; then + echo "#Cleaning known generated files" + echo rm -rf $KNOWN +fi + +if [ "$OTHER" ]; then +echo "#No predefined behavior" +echo "# $OTHER" +fi + + +if [ $DELETE -eq 1 ]; then + if [ "$EXECS" -o "$KNOWN" ]; then + echo "Are you sure you want to execute the printed commands? [YES/NO]" + read ANSWER + if [ "$ANSWER" == "YES" ]; then + for i in $EXECS $KNOWN; do + rm -rf $REPO_DIR/$i + done + fi + else + echo "Nothing to do" + fi +fi + diff --git a/Surface_reconstruction_points_3/doc_tex/Surface_reconstruction_points_3_ref/Poisson_reconstruction_function.tex b/Surface_reconstruction_points_3/doc_tex/Surface_reconstruction_points_3_ref/Poisson_reconstruction_function.tex index c61e5420daf..251b7d09a80 100644 --- a/Surface_reconstruction_points_3/doc_tex/Surface_reconstruction_points_3_ref/Poisson_reconstruction_function.tex +++ b/Surface_reconstruction_points_3/doc_tex/Surface_reconstruction_points_3_ref/Poisson_reconstruction_function.tex @@ -4,8 +4,8 @@ % | 07.09.2007 Pierre Alliez, Laurent Saboret, Gael Guennebaud % | Package: Surface_reconstruction_points_3 % | -\RCSdef{\RCSPoissonreconstructionfunctionRev}{$Id$} -\RCSdefDate{\RCSPoissonreconstructionfunctionDate}{$Date$} +%\RCSdef{\RCSPoissonreconstructionfunctionRev}{$Id$} +%\RCSdefDate{\RCSPoissonreconstructionfunctionDate}{$Date$} % | \ccRefPageBegin %%RefPage: end of header, begin of main body @@ -143,7 +143,9 @@ The function \ccc{compute_implicit_function}() must be called after the insertio \ccGlue \ccMethod{FT operator()(const Point& p) const;} { -\ccc{ImplicitFunction} interface: evaluates the implicit function at a given 3D query point. +\ccc{ImplicitFunction} interface: evaluates the implicit function at a +given 3D query point. The function \ccc{compute_implicit_function} must be +called before the first call to \ccc{operator()}. } \ccGlue \ccMethod{Point get_inner_point() const;} @@ -156,7 +158,7 @@ Returns a point located inside the inferred surface. \ccExample -See \ccc{poisson_reconstruction_example.cpp}. +See \ccReferToExampleCode{Surface_reconstruction_points_3/poisson_reconstruction_example.cpp}. \end{ccRefClass} diff --git a/Triangulation_3/doc_tex/Triangulation_3/Triang3.tex b/Triangulation_3/doc_tex/Triangulation_3/Triang3.tex index 23b5fe82f1d..6f65dff391a 100644 --- a/Triangulation_3/doc_tex/Triangulation_3/Triang3.tex +++ b/Triangulation_3/doc_tex/Triangulation_3/Triang3.tex @@ -841,7 +841,11 @@ In 2009, Sylvain Pion simplified the design of the Delaunay hierarchy so that it became the simple \ccc{Fast_location} policy in release~3.6. In 2010, Pedro de Castro and Olivier Devillers added the point -displacement. +displacement in release 3.7. + +In 2011, Pedro de Castro and Olivier Devillers implemented in release +3.8 the +structural filtering method, improving the efficiency of point location. A new demo of this package was introduced in CGAL 3.8, coded by Fei (Sophie) Che, who was co-mentored by Manuel Caroli and Monique