← Back to team overview

dorsal team mailing list archive

Re: Other problems building DOLFIN on Snow Leopard

 

Armadillo worked for me last time I checked (before adding Trilinos).

Garth mentioned something about the mpfr problem but I didn't
understand what the solution was.

I will check back later and do more testing during the day but will
have other things to do for the next few hours.

--
Anders


On Sat, Aug 21, 2010 at 12:47:51PM +0530, Harish Narayanan wrote:
> After commenting out Trilinos, I see the following problems while
> building DOLFIN. First, while configuring. Then, a ridiculously large
> mpfr/cgal error while linking.
>
> -------------------------------------------
> -- Performing Test ARMADILLO_TEST_RUNS
> -- Performing Test ARMADILLO_TEST_RUNS - Failed
> -- Armadillo could not be found. Be sure to set ARMADILLO_DIR.
> (missing:  ARMADILLO_TEST_RUNS)
> -- Found LibXml2: /opt/local/lib/libxml2.dylib
> -- NumPy headers found
> -- Python lib dir /usr/lib/libpython2.6.dylib
> -- Checking for package 'SCOTCH-PT'
> -- Found SCOTCH: /Users/harish/Work/FEniCS/test/include
> -- Checking for package 'UMFPACK'
> -- UMF  UMFPACK_INCLUDE_DIR-NOTFOUND
> -- Could NOT find CHOLMOD  (missing:  CHOLMOD_INCLUDES)
> -- Checking for package 'MTL4'
> -- Performing Test MTL4_TEST_RUNS
> -- Performing Test MTL4_TEST_RUNS - Failed
>    Unable to run test program for package 'MTL4'
> -- Could NOT find MTL4  (missing:  MTL4_INCLUDE_DIR)
> -- Checking for package 'PETSc'
> -- PETSC_DIR is /Users/harish/Work/FEniCS/test/src/petsc-3.1-p4
> -- PETSC_ARCH is darwin10.0.0-cxx-opt
> -- Found petscconf.h
> -- Performing Test PETSC_TEST_RUNS
> -- Performing Test PETSC_TEST_RUNS - Success
> -- PETSc test runs
> -- Found PETSc: /Users/harish/Work/FEniCS/test/src/petsc-3.1-p4
> -- SLEPC_DIR is /Users/harish/Work/FEniCS/test/src/slepc-3.1-p1
> -- Performing Test SLEPC_TEST_RUNS
> -- Performing Test SLEPC_TEST_RUNS - Success
> -- SLEPc test runs
>     use pkg-config --modversion cppunit ...
> -- checking for module 'cppunit'
> --   package 'cppunit' not found
> -- Test CPPUNIT_LIBRARY-NOTFOUND, cppunit
> -- Could NOT find CppUnit  (missing:  CPPUNIT_LIBRARY
> CPPUNIT_INCLUDE_DIR CPPUNIT_LIBRARY_DIRS)
> -- DEDS  =
> -DHAS_MPI;-DMPICH_IGNORE_CXX_SEEK;-DHAS_CGAL;-DHAS_PETSC;-DHAS_SLEPC;-DHAS_PARMETIS;-DHAS_SCOTCH;-DHAS_GMP
> -- FLAGS =  -DBOOST_UBLAS_NDEBUG
> Fatal Python error: Interpreter not initialized (version mismatch?)
> CMake Warning at dolfin/CMakeLists.txt:242 (message):
>   Unable to import UFC.  Install latest UFC or check that PYTHONPATH is set
>   appropriately.  Python will be disabled.
> --------------------------------------------------
>
>
> Linking CXX shared library libdolfin.dylib
> cd /Users/harish/Work/FEniCS/test/src/dolfin/dorsal_build_dir/dolfin &&
> /opt/local/bin/cmake -E cmake_link_script CMakeFiles/dolfin.dir/link.txt
> --verbose=1
> /usr/bin/mpic++   -DBOOST_UBLAS_NDEBUG -D_REENTRANT -frounding-math -O2
> -g -dynamiclib -headerpad_max_install_names -framework vecLib
> -current_version 0.9.8 -o libdolfin.0.9.8.dylib -install_name
> /Users/harish/Work/FEniCS/test/src/dolfin/dorsal_build_dir/dolfin/libdolfin.0.dylib
> CMakeFiles/dolfin.dir/ale/ALE.cpp.o
> CMakeFiles/dolfin.dir/ale/HarmonicSmoothing.cpp.o
> CMakeFiles/dolfin.dir/ale/TransfiniteInterpolation.cpp.o
> CMakeFiles/dolfin.dir/common/real.cpp.o
> CMakeFiles/dolfin.dir/common/timing.cpp.o
> CMakeFiles/dolfin.dir/common/utils.cpp.o
> CMakeFiles/dolfin.dir/common/Variable.cpp.o
> CMakeFiles/dolfin.dir/fem/assemble.cpp.o
> CMakeFiles/dolfin.dir/fem/Assembler.cpp.o
> CMakeFiles/dolfin.dir/fem/AssemblerTools.cpp.o
> CMakeFiles/dolfin.dir/fem/BoundaryCondition.cpp.o
> CMakeFiles/dolfin.dir/fem/DirichletBC.cpp.o
> CMakeFiles/dolfin.dir/fem/DofMap.cpp.o
> CMakeFiles/dolfin.dir/fem/DofMapBuilder.cpp.o
> CMakeFiles/dolfin.dir/fem/EqualityBC.cpp.o
> CMakeFiles/dolfin.dir/fem/FiniteElement.cpp.o
> CMakeFiles/dolfin.dir/fem/Form.cpp.o
> CMakeFiles/dolfin.dir/fem/PeriodicBC.cpp.o
> CMakeFiles/dolfin.dir/fem/SparsityPatternBuilder.cpp.o
> CMakeFiles/dolfin.dir/fem/SystemAssembler.cpp.o
> CMakeFiles/dolfin.dir/fem/UFC.cpp.o
> CMakeFiles/dolfin.dir/fem/VariationalProblem.cpp.o
> CMakeFiles/dolfin.dir/function/CoefficientAssigner.cpp.o
> CMakeFiles/dolfin.dir/function/Constant.cpp.o
> CMakeFiles/dolfin.dir/function/Data.cpp.o
> CMakeFiles/dolfin.dir/function/Expression.cpp.o
> CMakeFiles/dolfin.dir/function/Function.cpp.o
> CMakeFiles/dolfin.dir/function/FunctionSpace.cpp.o
> CMakeFiles/dolfin.dir/function/GenericFunction.cpp.o
> CMakeFiles/dolfin.dir/function/SpecialFunctions.cpp.o
> CMakeFiles/dolfin.dir/function/SubSpace.cpp.o
> CMakeFiles/dolfin.dir/graph/GraphBuilder.cpp.o
> CMakeFiles/dolfin.dir/graph/ParMETIS.cpp.o
> CMakeFiles/dolfin.dir/graph/SCOTCH.cpp.o
> CMakeFiles/dolfin.dir/io/base64.cpp.o
> CMakeFiles/dolfin.dir/io/BinaryFile.cpp.o
> CMakeFiles/dolfin.dir/io/File.cpp.o
> CMakeFiles/dolfin.dir/io/GenericFile.cpp.o
> CMakeFiles/dolfin.dir/io/MatlabFile.cpp.o
> CMakeFiles/dolfin.dir/io/MFile.cpp.o
> CMakeFiles/dolfin.dir/io/OctaveFile.cpp.o
> CMakeFiles/dolfin.dir/io/PythonFile.cpp.o
> CMakeFiles/dolfin.dir/io/RAWFile.cpp.o
> CMakeFiles/dolfin.dir/io/VTKFile.cpp.o
> CMakeFiles/dolfin.dir/io/VTKWriter.cpp.o
> CMakeFiles/dolfin.dir/io/XMLArray.cpp.o
> CMakeFiles/dolfin.dir/io/XMLDolfin.cpp.o
> CMakeFiles/dolfin.dir/io/XMLFile.cpp.o
> CMakeFiles/dolfin.dir/io/XMLFunctionPlotData.cpp.o
> CMakeFiles/dolfin.dir/io/XMLHandler.cpp.o
> CMakeFiles/dolfin.dir/io/XMLIndent.cpp.o
> CMakeFiles/dolfin.dir/io/XMLLocalMeshData.cpp.o
> CMakeFiles/dolfin.dir/io/XMLMap.cpp.o
> CMakeFiles/dolfin.dir/io/XMLMatrix.cpp.o
> CMakeFiles/dolfin.dir/io/XMLMesh.cpp.o
> CMakeFiles/dolfin.dir/io/XMLMeshData.cpp.o
> CMakeFiles/dolfin.dir/io/XMLMeshFunction.cpp.o
> CMakeFiles/dolfin.dir/io/XMLObject.cpp.o
> CMakeFiles/dolfin.dir/io/XMLParameters.cpp.o
> CMakeFiles/dolfin.dir/io/XMLSkipper.cpp.o
> CMakeFiles/dolfin.dir/io/XMLVector.cpp.o
> CMakeFiles/dolfin.dir/io/XMLVectorMapping.cpp.o
> CMakeFiles/dolfin.dir/io/XYZFile.cpp.o
> CMakeFiles/dolfin.dir/la/BlockMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/BlockVector.cpp.o
> CMakeFiles/dolfin.dir/la/CholmodCholeskySolver.cpp.o
> CMakeFiles/dolfin.dir/la/DefaultFactory.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraFactory.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraKrylovSolver.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraLUSolver.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraSparsityPattern.cpp.o
> CMakeFiles/dolfin.dir/la/EpetraVector.cpp.o
> CMakeFiles/dolfin.dir/la/GenericMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/ITLKrylovSolver.cpp.o
> CMakeFiles/dolfin.dir/la/KrylovSolver.cpp.o
> CMakeFiles/dolfin.dir/la/LinearSolver.cpp.o
> CMakeFiles/dolfin.dir/la/LUSolver.cpp.o
> CMakeFiles/dolfin.dir/la/MTL4Factory.cpp.o
> CMakeFiles/dolfin.dir/la/MTL4Matrix.cpp.o
> CMakeFiles/dolfin.dir/la/MTL4Vector.cpp.o
> CMakeFiles/dolfin.dir/la/PETScFactory.cpp.o
> CMakeFiles/dolfin.dir/la/PETScKrylovMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/PETScKrylovSolver.cpp.o
> CMakeFiles/dolfin.dir/la/PETScLUSolver.cpp.o
> CMakeFiles/dolfin.dir/la/PETScMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/PETScPreconditioner.cpp.o
> CMakeFiles/dolfin.dir/la/PETScUserPreconditioner.cpp.o
> CMakeFiles/dolfin.dir/la/PETScVector.cpp.o
> CMakeFiles/dolfin.dir/la/SingularSolver.cpp.o
> CMakeFiles/dolfin.dir/la/SLEPcEigenSolver.cpp.o
> CMakeFiles/dolfin.dir/la/solve.cpp.o
> CMakeFiles/dolfin.dir/la/SparsityPattern.cpp.o
> CMakeFiles/dolfin.dir/la/STLFactory.cpp.o
> CMakeFiles/dolfin.dir/la/STLMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/TrilinosPreconditioner.cpp.o
> CMakeFiles/dolfin.dir/la/uBLASDummyPreconditioner.cpp.o
> CMakeFiles/dolfin.dir/la/uBLASILUPreconditioner.cpp.o
> CMakeFiles/dolfin.dir/la/uBLASKrylovMatrix.cpp.o
> CMakeFiles/dolfin.dir/la/uBLASKrylovSolver.cpp.o
> CMakeFiles/dolfin.dir/la/uBLASVector.cpp.o
> CMakeFiles/dolfin.dir/la/UmfpackLUSolver.cpp.o
> CMakeFiles/dolfin.dir/log/Event.cpp.o
> CMakeFiles/dolfin.dir/log/log.cpp.o
> CMakeFiles/dolfin.dir/log/Logger.cpp.o
> CMakeFiles/dolfin.dir/log/LogManager.cpp.o
> CMakeFiles/dolfin.dir/log/LogStream.cpp.o
> CMakeFiles/dolfin.dir/log/Progress.cpp.o
> CMakeFiles/dolfin.dir/log/Table.cpp.o
> CMakeFiles/dolfin.dir/main/init.cpp.o
> CMakeFiles/dolfin.dir/main/MPI.cpp.o
> CMakeFiles/dolfin.dir/main/SubSystemsManager.cpp.o
> CMakeFiles/dolfin.dir/math/basic.cpp.o
> CMakeFiles/dolfin.dir/math/Lagrange.cpp.o
> CMakeFiles/dolfin.dir/math/Legendre.cpp.o
> CMakeFiles/dolfin.dir/mesh/BoundaryComputation.cpp.o
> CMakeFiles/dolfin.dir/mesh/BoundaryMesh.cpp.o
> CMakeFiles/dolfin.dir/mesh/Box.cpp.o
> CMakeFiles/dolfin.dir/mesh/CellType.cpp.o
> CMakeFiles/dolfin.dir/mesh/DynamicMeshEditor.cpp.o
> CMakeFiles/dolfin.dir/mesh/Edge.cpp.o
> CMakeFiles/dolfin.dir/mesh/Face.cpp.o
> CMakeFiles/dolfin.dir/mesh/Facet.cpp.o
> CMakeFiles/dolfin.dir/mesh/FacetCell.cpp.o
> CMakeFiles/dolfin.dir/mesh/IntersectionOperator.cpp.o
> CMakeFiles/dolfin.dir/mesh/Interval.cpp.o
> CMakeFiles/dolfin.dir/mesh/IntervalCell.cpp.o
> CMakeFiles/dolfin.dir/mesh/LocalMeshCoarsening.cpp.o
> CMakeFiles/dolfin.dir/mesh/LocalMeshData.cpp.o
> CMakeFiles/dolfin.dir/mesh/LocalMeshRefinement.cpp.o
> CMakeFiles/dolfin.dir/mesh/Mesh.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshConnectivity.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshData.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshEditor.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshEntity.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshEntityIterator.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshFunction.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshGeometry.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshHierarchy.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshHierarchyAlgorithms.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshOrdering.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshPartitioning.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshSmoothing.cpp.o
> CMakeFiles/dolfin.dir/mesh/MeshTopology.cpp.o
> CMakeFiles/dolfin.dir/mesh/Point.cpp.o
> CMakeFiles/dolfin.dir/mesh/PointCell.cpp.o
> CMakeFiles/dolfin.dir/mesh/PrimitiveIntersector.cpp.o
> CMakeFiles/dolfin.dir/mesh/Rectangle.cpp.o
> CMakeFiles/dolfin.dir/mesh/refine.cpp.o
> CMakeFiles/dolfin.dir/mesh/RivaraRefinement.cpp.o
> CMakeFiles/dolfin.dir/mesh/SubDomain.cpp.o
> CMakeFiles/dolfin.dir/mesh/SubMesh.cpp.o
> CMakeFiles/dolfin.dir/mesh/TetrahedronCell.cpp.o
> CMakeFiles/dolfin.dir/mesh/TopologyComputation.cpp.o
> CMakeFiles/dolfin.dir/mesh/Triangle_3_Tetrahedron_3_do_intersect_SCK.cpp.o
> CMakeFiles/dolfin.dir/mesh/TriangleCell.cpp.o
> CMakeFiles/dolfin.dir/mesh/UniformMeshRefinement.cpp.o
> CMakeFiles/dolfin.dir/mesh/UnitCircle.cpp.o
> CMakeFiles/dolfin.dir/mesh/UnitCube.cpp.o
> CMakeFiles/dolfin.dir/mesh/UnitInterval.cpp.o
> CMakeFiles/dolfin.dir/mesh/UnitSphere.cpp.o
> CMakeFiles/dolfin.dir/mesh/UnitSquare.cpp.o
> CMakeFiles/dolfin.dir/nls/NewtonSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/Adaptivity.cpp.o
> CMakeFiles/dolfin.dir/ode/Alloc.cpp.o
> CMakeFiles/dolfin.dir/ode/cGqMethod.cpp.o
> CMakeFiles/dolfin.dir/ode/ComplexODE.cpp.o
> CMakeFiles/dolfin.dir/ode/Controller.cpp.o
> CMakeFiles/dolfin.dir/ode/Dependencies.cpp.o
> CMakeFiles/dolfin.dir/ode/dGqMethod.cpp.o
> CMakeFiles/dolfin.dir/ode/Dual.cpp.o
> CMakeFiles/dolfin.dir/ode/Method.cpp.o
> CMakeFiles/dolfin.dir/ode/MonoAdaptiveFixedPointSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/MonoAdaptiveJacobian.cpp.o
> CMakeFiles/dolfin.dir/ode/MonoAdaptiveNewtonSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/MonoAdaptiveTimeSlab.cpp.o
> CMakeFiles/dolfin.dir/ode/MonoAdaptivity.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptiveFixedPointSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptiveJacobian.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptiveNewtonSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptivePreconditioner.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptiveTimeSlab.cpp.o
> CMakeFiles/dolfin.dir/ode/MultiAdaptivity.cpp.o
> CMakeFiles/dolfin.dir/ode/ODE.cpp.o
> CMakeFiles/dolfin.dir/ode/ODECollection.cpp.o
> CMakeFiles/dolfin.dir/ode/ODESolution.cpp.o
> CMakeFiles/dolfin.dir/ode/ODESolver.cpp.o
> CMakeFiles/dolfin.dir/ode/Partition.cpp.o
> CMakeFiles/dolfin.dir/ode/Sample.cpp.o
> CMakeFiles/dolfin.dir/ode/SORSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/StabilityAnalysis.cpp.o
> CMakeFiles/dolfin.dir/ode/TimeSlab.cpp.o
> CMakeFiles/dolfin.dir/ode/TimeSlabJacobian.cpp.o
> CMakeFiles/dolfin.dir/ode/TimeSlabSolver.cpp.o
> CMakeFiles/dolfin.dir/ode/TimeStepper.cpp.o
> CMakeFiles/dolfin.dir/ode/UpdatedMultiAdaptiveJacobian.cpp.o
> CMakeFiles/dolfin.dir/parameter/GlobalParameters.cpp.o
> CMakeFiles/dolfin.dir/parameter/Parameter.cpp.o
> CMakeFiles/dolfin.dir/parameter/Parameters.cpp.o
> CMakeFiles/dolfin.dir/adaptivity/Extrapolation.cpp.o
> CMakeFiles/dolfin.dir/adaptivity/TimeSeries.cpp.o
> CMakeFiles/dolfin.dir/plot/FunctionPlotData.cpp.o
> CMakeFiles/dolfin.dir/plot/plot.cpp.o
> CMakeFiles/dolfin.dir/quadrature/BarycenterQuadrature.cpp.o
> CMakeFiles/dolfin.dir/quadrature/GaussianQuadrature.cpp.o
> CMakeFiles/dolfin.dir/quadrature/GaussQuadrature.cpp.o
> CMakeFiles/dolfin.dir/quadrature/LobattoQuadrature.cpp.o
> CMakeFiles/dolfin.dir/quadrature/Quadrature.cpp.o
> CMakeFiles/dolfin.dir/quadrature/RadauQuadrature.cpp.o -L/opt/local/lib
> /opt/local/lib/libxml2.dylib
> /Users/harish/Work/FEniCS/test/lib/libarmadillo.dylib
> /opt/local/lib/libboost_filesystem.dylib
> /opt/local/lib/libboost_program_options.dylib
> /opt/local/lib/libboost_system.dylib /usr/lib/libmpi_cxx.dylib
> /usr/lib/libmpi.dylib /usr/lib/libopen-rte.dylib
> /usr/lib/libopen-pal.dylib -Wl,-u,_munmap -Wl,-multiply_defined,suppress
> /opt/local/lib/libCGAL.dylib
> -L/Users/harish/Work/FEniCS/test/src/petsc-3.1-p4/darwin10.0.0-cxx-opt/lib
> -L/Users/harish/Work/FEniCS/test/src/petsc-3.1-p4/darwin10.0.0-cxx-opt/lib
> -lpetsc -L/usr/X11R6/lib -lX11 -L/Users/harish/Work/FEniCS/test/lib
> -lparmetis -lmetis
> -L/Users/harish/Work/FEniCS/test/src/petsc-3.1-p4/darwin10.0.0-cxx-opt/lib
> -lumfpack -lamd -llapack -lblas -lmpi_cxx -lstdc++ -ldl
> -L/Users/harish/Work/FEniCS/test/src/slepc-3.1-p1/darwin10.0.0-cxx-opt/lib
> -L/Users/harish/Work/FEniCS/test/src/slepc-3.1-p1/darwin10.0.0-cxx-opt/lib
> -lslepc
> -L/Users/harish/Work/FEniCS/test/lib/petsc/darwin10.0.0-cxx-opt/lib
> -L/Users/harish/Work/FEniCS/test/lib/petsc/darwin10.0.0-cxx-opt/lib
> -lpetsc -L/usr/X11R6/lib -lX11 -L/Users/harish/Work/FEniCS/test/lib
> -lparmetis -lmetis
> -L/Users/harish/Work/FEniCS/test/src/petsc-3.1-p4/darwin10.0.0-cxx-opt/lib
> -lumfpack -lamd -llapack -lblas -lmpi_cxx -lstdc++ -ldl
> /Users/harish/Work/FEniCS/test/lib/libparmetis.a
> /opt/local/lib/libmetis.dylib
> /Users/harish/Work/FEniCS/test/lib/libscotch.a
> /Users/harish/Work/FEniCS/test/lib/libscotcherr.a
> /Users/harish/Work/FEniCS/test/lib/libptscotch.a
> /Users/harish/Work/FEniCS/test/lib/libptscotcherr.a
> /opt/local/lib/libgmp.dylib
> Undefined symbols:
>   "_mpfr_set_q", referenced from:
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
>   "boost::detail::set_tss_data(void const*,
> boost::shared_ptr<boost::detail::tss_cleanup_function>, void*, bool)",
> referenced from:
>       ___tcf_8 in BarycenterQuadrature.cpp.o
>       ___tcf_7 in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>   "operator>>(std::basic_istream<char, std::char_traits<char> >&,
> __mpf_struct*)", referenced from:
>
> dolfin::ODESolution::open_and_read_header(std::basic_ifstream<char,
> std::char_traits<char> >&, unsigned int)in ODESolution.cpp.o
>
> dolfin::ODESolution::open_and_read_header(std::basic_ifstream<char,
> std::char_traits<char> >&, unsigned int)in ODESolution.cpp.o
>
> dolfin::ODESolution::open_and_read_header(std::basic_ifstream<char,
> std::char_traits<char> >&, unsigned int)in ODESolution.cpp.o
>       dolfin::ODESolution::read_file(unsigned int)in ODESolution.cpp.o
>       dolfin::ODESolution::read_file(unsigned int)in ODESolution.cpp.o
>       dolfin::ODESolution::read_file(unsigned int)in ODESolution.cpp.o
>       dolfin::ODESolution::ODESolution(std::basic_string<char,
> std::char_traits<char>, std::allocator<char> >, unsigned int)in
> ODESolution.cpp.o
>       dolfin::ODESolution::ODESolution(std::basic_string<char,
> std::char_traits<char>, std::allocator<char> >, unsigned int)in
> ODESolution.cpp.o
>       dolfin::ODESolution::ODESolution(std::basic_string<char,
> std::char_traits<char>, std::allocator<char> >, unsigned int)in
> ODESolution.cpp.o
>   "operator<<(std::basic_ostream<char, std::char_traits<char> >&,
> __mpf_struct const*)", referenced from:
>       dolfin::PythonFile::operator<<(std::tr1::tuple<unsigned int,
> __gmp_expr<__mpf_struct [1], __mpf_struct [1]>, __gmp_expr<__mpf_struct
> [1], __mpf_struct [1]>*, std::tr1::_NullClass, std::tr1::_NullClass,
> std::tr1::_NullClass, std::tr1::_NullClass, std::tr1::_NullClass,
> std::tr1::_NullClass, std::tr1::_NullClass> const&)in PythonFile.cpp.o
>       dolfin::PythonFile::operator<<(std::tr1::tuple<unsigned int,
> __gmp_expr<__mpf_struct [1], __mpf_struct [1]>, __gmp_expr<__mpf_struct
> [1], __mpf_struct [1]>*, std::tr1::_NullClass, std::tr1::_NullClass,
> std::tr1::_NullClass, std::tr1::_NullClass, std::tr1::_NullClass,
> std::tr1::_NullClass, std::tr1::_NullClass> const&)in PythonFile.cpp.o
>       dolfin::PythonFile::operator<<(dolfin::Sample const&)in
> PythonFile.cpp.o
>       dolfin::PythonFile::operator<<(dolfin::Sample const&)in
> PythonFile.cpp.o
>       dolfin::PythonFile::operator<<(dolfin::Sample const&)in
> PythonFile.cpp.o
>       dolfin::PythonFile::operator<<(dolfin::Sample const&)in
> PythonFile.cpp.o
>       dolfin::cGqMethod::str(bool) constin cGqMethod.cpp.o
>       dolfin::cGqMethod::str(bool) constin cGqMethod.cpp.o
>       dolfin::dGqMethod::str(bool) constin dGqMethod.cpp.o
>       dolfin::dGqMethod::str(bool) constin dGqMethod.cpp.o
>       dolfin::MonoAdaptiveTimeSlab::str(bool) constin
> MonoAdaptiveTimeSlab.cpp.o
>       dolfin::MonoAdaptiveTimeSlab::str(bool) constin
> MonoAdaptiveTimeSlab.cpp.o
>       dolfin::ODESolution::save_to_file()      in ODESolution.cpp.o
>       dolfin::ODESolution::save_to_file()      in ODESolution.cpp.o
>       dolfin::ODESolution::save_to_file()      in ODESolution.cpp.o
>       dolfin::ODESolution::save_to_file()      in ODESolution.cpp.o
>       dolfin::ODESolution::save_to_file()      in ODESolution.cpp.o
>       dolfin::ODESolution::str(bool) constin ODESolution.cpp.o
>       dolfin::ODESolution::str(bool) constin ODESolution.cpp.o
>       dolfin::ODESolution::str(bool) constin ODESolution.cpp.o
>       dolfin::TimeSlab::write(unsigned int, __gmp_expr<__mpf_struct [1],
> __mpf_struct [1]> const*)in TimeSlab.cpp.o
>       dolfin::RealParameter::value_str() constin Parameter.cpp.o
>       dolfin::RealParameter::str() constin Parameter.cpp.o
>       dolfin::RealParameter::range_str() constin Parameter.cpp.o
>       dolfin::RealParameter::range_str() constin Parameter.cpp.o
>   "_METIS_mCPartGraphRecursive2", referenced from:
>       _ParMETIS_V3_PartKway in libparmetis.a(kmetis.o)
>       _Mc_InitPartition_RB__ in libparmetis.a(initpart.o)
>       _Mc_InitPartition_RB__ in libparmetis.a(initpart.o)
>       _PartitionSmallGraph__ in libparmetis.a(weird.o)
>       _Balance_Partition__ in libparmetis.a(initbalance.o)
>       _Balance_Partition__ in libparmetis.a(initbalance.o)
>   "_mpfr_clear", referenced from:
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
>   "_mpfr_get_d", referenced from:
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
>   "boost::detail::get_tss_data(void const*)", referenced from:
>
> CGAL::Lazy<CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Plane_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>
> CGAL::Lazy<CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >, CGAL::Point_3<CGAL::Simple_cartesian<CGAL::Gmpq> >, CGAL::Gmpq,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >::zero()in
> BarycenterQuadrature.cpp.o
>   "_mpfr_init2", referenced from:
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_x_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_y_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CartesianKernelFunctors::Compute_z_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Lazy_rep_1<CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >, CGAL::To_interval<CGAL::Gmpq>,
> CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >::update_exact()in BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::x()
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_c_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_b_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_a_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>       CGAL::Lazy_exact_nt<CGAL::Gmpq>
> CGAL::Lazy_construction_nt<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Interval_nt<false>
> > >,
> CGAL::CommonKernelFunctors::Compute_d_3<CGAL::Simple_cartesian<CGAL::Gmpq>
> >
> >::operator()<CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >
> >(CGAL::Plane_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > > const&)
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::z()
> constin BarycenterQuadrature.cpp.o
>
> CGAL::Point_3<CGAL::Lazy_kernel<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::Cartesian_converter<CGAL::Simple_cartesian<CGAL::Gmpq>,
> CGAL::Simple_cartesian<CGAL::Interval_nt<false> >,
> CGAL::NT_converter<CGAL::Gmpq, CGAL::Interval_nt<false> > > > >::y()
> constin BarycenterQuadrature.cpp.o
> ld: symbol(s) not found
> collect2: ld returned 1 exit status
> make[2]: *** [dolfin/libdolfin.0.9.8.dylib] Error 1
> make[1]: *** [dolfin/CMakeFiles/dolfin.dir/all] Error 2
>
> _______________________________________________
> Mailing list: https://launchpad.net/~dorsal
> Post to     : dorsal@xxxxxxxxxxxxxxxxxxx
> Unsubscribe : https://launchpad.net/~dorsal
> More help   : https://help.launchpad.net/ListHelp



Follow ups

References