Merge remote-tracking branch 'origin/CGAL-Use_Simple_cartesian-GF'

Successfully tested in CGAL-4.3-Ic-168

Approved by the Release Manager.
This commit is contained in:
Laurent Rineau 2013-09-12 11:28:44 +02:00
commit c9474ed207
57 changed files with 140 additions and 172 deletions

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Polyhedron_items_with_id_3.h>
@ -9,7 +9,7 @@
#include <fstream>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_3 Point;
typedef CGAL::Polyhedron_3<Kernel,CGAL::Polyhedron_items_with_id_3> Polyhedron;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/boost/graph/graph_traits_Polyhedron_3.h>
@ -10,7 +10,7 @@
#include <boost/graph/kruskal_min_spanning_tree.hpp>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Vector_3 Vector;
typedef Kernel::Point_3 Point;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/Polyhedron_items_with_id_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
@ -10,7 +10,7 @@
#include <boost/graph/kruskal_min_spanning_tree.hpp>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_3 Point;
typedef CGAL::Polyhedron_3<Kernel,CGAL::Polyhedron_items_with_id_3> Polyhedron;

View File

@ -1,12 +1,11 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polygon_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/random_convex_set_2.h>
#include <CGAL/min_quadrilateral_2.h>
#include <iostream>
struct Kernel : public CGAL::Cartesian<double> {};
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_2 Point_2;
typedef Kernel::Line_2 Line_2;
typedef CGAL::Polygon_2<Kernel> Polygon_2;

View File

@ -1,11 +1,11 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polygon_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/random_convex_set_2.h>
#include <CGAL/min_quadrilateral_2.h>
#include <iostream>
struct Kernel : public CGAL::Cartesian<double> {};
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_2 Point_2;
typedef Kernel::Line_2 Line_2;

View File

@ -1,11 +1,11 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polygon_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/random_convex_set_2.h>
#include <CGAL/min_quadrilateral_2.h>
#include <iostream>
struct Kernel : public CGAL::Cartesian<double> {};
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_2 Point_2;
typedef Kernel::Line_2 Line_2;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/rectangular_p_center_2.h>
#include <CGAL/IO/Ostream_iterator.h>
@ -9,7 +9,7 @@
typedef double FT;
typedef CGAL::Cartesian<FT> Kernel;
typedef CGAL::Simple_cartesian<FT> Kernel;
typedef Kernel::Point_2 Point;
typedef std::vector<Point> Cont;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polygon_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/random_convex_set_2.h>
@ -8,7 +8,7 @@
typedef double FT;
typedef CGAL::Cartesian<FT> Kernel;
typedef CGAL::Simple_cartesian<FT> Kernel;
typedef Kernel::Point_2 Point;
typedef std::vector<int> Index_cont;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polygon_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/random_convex_set_2.h>
@ -8,7 +8,7 @@
typedef double FT;
typedef CGAL::Cartesian<FT> Kernel;
typedef CGAL::Simple_cartesian<FT> Kernel;
typedef Kernel::Point_2 Point;
typedef std::vector<int> Index_cont;

View File

@ -1,11 +1,11 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Iso_rectangle_2.h>
#include <CGAL/Largest_empty_iso_rectangle_2.h>
#include <fstream>
typedef double Number_Type;
typedef CGAL::Cartesian<Number_Type> K;
typedef CGAL::Simple_cartesian<Number_Type> K;
typedef CGAL::Largest_empty_iso_rectangle_2<K> Largest_empty_iso_rect_2;
typedef K::Iso_rectangle_2 Iso_rectangle_2;
typedef K::Point_2 Point_2;

View File

@ -1,5 +1,4 @@
/*!
\example Jet_fitting_3/Mesh_estimation.cpp
\example Jet_fitting_3/PolyhedralSurf.cpp
\example Jet_fitting_3/Single_estimation.cpp
*/

View File

@ -1,11 +1,10 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Monge_via_jet_fitting.h>
#include <CGAL/property_map.h>
#include <fstream>
#include <cassert>
#include <CGAL/property_map.h>
#ifdef CGAL_USE_BOOST_PROGRAM_OPTIONS
#include <boost/program_options.hpp>
namespace po = boost::program_options;
@ -19,7 +18,7 @@ using namespace std;
//Kernel of the PolyhedralSurf
typedef double DFT;
typedef CGAL::Cartesian<DFT> Data_Kernel;
typedef CGAL::Simple_cartesian<DFT> Data_Kernel;
typedef Data_Kernel::Point_3 DPoint;
typedef Data_Kernel::Vector_3 DVector;
@ -66,7 +65,7 @@ typedef boost::associative_property_map<Facet2normal_map_type> Facet_PM_type;
typedef T_PolyhedralSurf_facet_ops<PolyhedralSurf, Facet_PM_type> Poly_facet_ops;
typedef double LFT;
typedef CGAL::Cartesian<LFT> Local_Kernel;
typedef CGAL::Simple_cartesian<LFT> Local_Kernel;
typedef CGAL::Monge_via_jet_fitting<Data_Kernel> My_Monge_via_jet_fitting;
typedef My_Monge_via_jet_fitting::Monge_form My_Monge_form;
@ -305,5 +304,7 @@ int main()
out_verbose->close();
delete out_verbose;
}
std::cerr << "done" << std::endl;
return 0;
}

View File

@ -1,9 +0,0 @@
#include "PolyhedralSurf.h"
// Vector_3 PolyhedralSurf::getHalfedge_vector(Halfedge * h)
// {
// Vector_3 v = h->opposite()->vertex()->point() - h->vertex()->point();
// return v;
// }

View File

@ -1,7 +1,7 @@
#ifndef CGAL_POLYHEDRALSURF_H_
#define CGAL_POLYHEDRALSURF_H_
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
@ -180,7 +180,7 @@ struct Wrappers_VFH:public CGAL::Polyhedron_items_3 {
typedef double DFT;
typedef CGAL::Cartesian<DFT> Data_Kernel;
typedef CGAL::Simple_cartesian<DFT> Data_Kernel;
typedef CGAL::Polyhedron_3 < Data_Kernel, Wrappers_VFH > Polyhedron;
typedef Data_Kernel::Vector_3 Vector_3;

View File

@ -1,12 +1,11 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Monge_via_jet_fitting.h>
#include <fstream>
#include <vector>
#include <CGAL/Monge_via_jet_fitting.h>
typedef double DFT;
typedef CGAL::Cartesian<DFT> Data_Kernel;
typedef CGAL::Simple_cartesian<DFT> Data_Kernel;
typedef Data_Kernel::Point_3 DPoint;
typedef CGAL::Monge_via_jet_fitting<Data_Kernel> My_Monge_via_jet_fitting;
typedef My_Monge_via_jet_fitting::Monge_form My_Monge_form;

View File

@ -19,7 +19,7 @@
#ifndef CGAL_MONGE_VIA_JET_FITTING_H_
#define CGAL_MONGE_VIA_JET_FITTING_H_
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/circulator.h>
#include <CGAL/Linear_algebraCd.h>
#include <CGAL/eigen.h>
@ -46,10 +46,10 @@ unsigned int fact(unsigned int n){
////////////////////// CLASS Monge_via_jet_fitting ////////////////////////
#ifdef CGAL_EIGEN3_ENABLED
template < class DataKernel, class LocalKernel = Cartesian<double>, class SvdTraits = Eigen_svd >
template < class DataKernel, class LocalKernel = Simple_cartesian<double>, class SvdTraits = Eigen_svd >
#else
#ifdef CGAL_LAPACK_ENABLED
template < class DataKernel, class LocalKernel = Cartesian<double>, class SvdTraits = Lapack_svd>
template < class DataKernel, class LocalKernel = Simple_cartesian<double>, class SvdTraits = Lapack_svd>
#else
template < class DataKernel, class LocalKernel, class SvdTraits >
#endif

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <iostream>
@ -6,7 +6,7 @@
#include <vector>
#include <cmath>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Vector_3 Vector;
typedef Kernel::Point_3 Point;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <iostream>
@ -8,7 +8,7 @@
#include <cctype>
#include <cmath>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Vector_3 Vector;
typedef Kernel::Point_3 Point;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;
@ -188,6 +188,7 @@ int main( int argc, char* argv[]) {
}
Polyhedron P;
cin >> P;
for ( int i = 0; i != n; ++i) {
cerr << "Subdivision " << i+1 << " ..." << endl;
subdiv( P);

View File

@ -1,8 +1,8 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_traits_3.h>
#include <CGAL/Polyhedron_3.h>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_traits_3<Kernel> Traits;
typedef CGAL::Polyhedron_3<Traits> Polyhedron;
typedef Polyhedron::Halfedge_handle Halfedge_handle;

View File

@ -1,9 +1,9 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/HalfedgeDS_vector.h>
#include <CGAL/Polyhedron_3.h>
#include <iostream>
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef Kernel::Point_3 Point_3;
typedef CGAL::Polyhedron_3< Kernel,
CGAL::Polyhedron_items_3,

View File

@ -1,21 +1,21 @@
// Example program for the barycenter() function for 2D and 3D points.
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/barycenter.h>
#include <list>
#include <vector>
#include <iostream>
#include <utility>
typedef double FT;
typedef CGAL::Cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
typedef double FT;
typedef CGAL::Simple_cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
int main()
{
// barycenter of 2D weighted points
std::list<std::pair<Point_2, FT> > points_2;
std::vector<std::pair<Point_2, FT> > points_2;
points_2.push_back(std::make_pair(Point_2(1.0, 0.0), 1.0));
points_2.push_back(std::make_pair(Point_2(2.0, 2.0), 2.0));
points_2.push_back(std::make_pair(Point_2(3.0, 5.0), -2.0));
@ -24,7 +24,7 @@ int main()
std::cout << c2 << std::endl;
// barycenter of 3D weighted points
std::list<std::pair<Point_3, FT> > points_3;
std::vector<std::pair<Point_3, FT> > points_3;
points_3.push_back(std::make_pair(Point_3(1.0, 0.0, 0.5), 1.0));
points_3.push_back(std::make_pair(Point_3(2.0, 2.0, 1.2), 2.0));
points_3.push_back(std::make_pair(Point_3(3.0, 5.0, 4.5), -5.0));

View File

@ -1,20 +1,20 @@
// Example program for the bounding_box() function for 2D points and 3D points.
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/bounding_box.h>
#include <list>
#include <vector>
#include <iostream>
typedef double FT;
typedef CGAL::Cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
typedef double FT;
typedef CGAL::Simple_cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
int main()
{
// axis-aligned bounding box of 2D points
std::list<Point_2> points_2;
std::vector<Point_2> points_2;
points_2.push_back(Point_2(1.0, 0.0));
points_2.push_back(Point_2(2.0, 2.0));
points_2.push_back(Point_2(3.0, 5.0));
@ -23,7 +23,7 @@ int main()
std::cout << c2 << std::endl;
// axis-aligned bounding box of 3D points
std::list<Point_3> points_3;
std::vector<Point_3> points_3;
points_3.push_back(Point_3(1.0, 0.0, 0.5));
points_3.push_back(Point_3(2.0, 2.0, 1.2));
points_3.push_back(Point_3(3.0, 5.0, 4.5));

View File

@ -1,21 +1,21 @@
// Example program for the centroid() function for 2D points, 3D points and 3D triangles.
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/centroid.h>
#include <list>
#include <vector>
#include <iostream>
typedef double FT;
typedef CGAL::Cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
typedef K::Triangle_3 Triangle_3;
typedef double FT;
typedef CGAL::Simple_cartesian<FT> K;
typedef K::Point_2 Point_2;
typedef K::Point_3 Point_3;
typedef K::Triangle_3 Triangle_3;
int main()
{
// centroid of 2D points
std::list<Point_2> points_2;
std::vector<Point_2> points_2;
points_2.push_back(Point_2(1.0, 0.0));
points_2.push_back(Point_2(2.0, 2.0));
points_2.push_back(Point_2(3.0, 5.0));
@ -23,7 +23,7 @@ int main()
std::cout << c2 << std::endl;
// centroid of 3D points
std::list<Point_3> points_3;
std::vector<Point_3> points_3;
points_3.push_back(Point_3(1.0, 0.0, 0.5));
points_3.push_back(Point_3(2.0, 2.0, 1.2));
points_3.push_back(Point_3(3.0, 5.0, 4.5));

View File

@ -1,16 +1,16 @@
// Example program for linear least squares fitting of a 2D point set
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/linear_least_squares_fitting_2.h>
#include <list>
#include <vector>
typedef double FT;
typedef CGAL::Cartesian<FT> K;
typedef K::Line_2 Line;
typedef K::Point_2 Point;
typedef double FT;
typedef CGAL::Simple_cartesian<FT> K;
typedef K::Line_2 Line;
typedef K::Point_2 Point;
int main()
{
std::list<Point> points;
std::vector<Point> points;
points.push_back(Point(1.0,2.0));
points.push_back(Point(3.0,4.0));
points.push_back(Point(5.0,6.0));

View File

@ -1,19 +1,19 @@
// Example program for the linear_least_square_fitting function
// on a set of 3D triangles
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/linear_least_squares_fitting_3.h>
#include <list>
#include <vector>
typedef double FT;
typedef CGAL::Cartesian<FT> K;
typedef K::Line_3 Line;
typedef K::Plane_3 Plane;
typedef K::Point_3 Point;
typedef K::Triangle_3 Triangle;
typedef double FT;
typedef CGAL::Simple_cartesian<FT> K;
typedef K::Line_3 Line;
typedef K::Plane_3 Plane;
typedef K::Point_3 Point;
typedef K::Triangle_3 Triangle;
int main(void)
{
std::list<Triangle> triangles;
std::vector<Triangle> triangles;
Point a(1.0,2.0,3.0);
Point b(4.0,0.0,6.0);
Point c(7.0,8.0,9.0);

View File

@ -21,9 +21,8 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/Algebraic_structure_traits.h>
#include <CGAL/IO/io.h>
//#include <CGAL/Algebraic_structure_traits.h>
//#include <CGAL/IO/io.h>
#include <CGAL/linear_least_squares_fitting_points_2.h>
#include <CGAL/linear_least_squares_fitting_segments_2.h>
#include <CGAL/linear_least_squares_fitting_triangles_2.h>

View File

@ -21,9 +21,8 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/Algebraic_structure_traits.h>
#include <CGAL/IO/io.h>
//#include <CGAL/Algebraic_structure_traits.h>
//#include <CGAL/IO/io.h>
#include <CGAL/linear_least_squares_fitting_points_3.h>
#include <CGAL/linear_least_squares_fitting_segments_3.h>
@ -35,7 +34,6 @@
#include <CGAL/Dimension.h>
#include <iterator>
#include <list>
#include <string>
namespace CGAL {

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_CIRCLES_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen_2.h>
#include <CGAL/eigen.h>

View File

@ -21,14 +21,13 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_CUBOIDS_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
#include <CGAL/PCA_util.h>
#include <CGAL/linear_least_squares_fitting_points_3.h>
#include <CGAL/linear_least_squares_fitting_segments_3.h>
#include <list>
#include <iterator>
namespace CGAL {

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_POINTS_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen_2.h>

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_POINTS_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
#include <CGAL/PCA_util.h>

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_RECTANGLES_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen_2.h>
#include <CGAL/eigen.h>
@ -29,7 +28,7 @@
#include <CGAL/PCA_util.h>
#include <iterator>
#include <vector>
#include <list>
#include <cmath>
namespace CGAL {
@ -169,7 +168,6 @@ linear_least_squares_fitting_2(InputIterator first,
CGAL_precondition(first != beyond);
std::list<Segment_2> segments;
for(InputIterator it = first;
it != beyond;
it++)
@ -205,7 +203,6 @@ linear_least_squares_fitting_2(InputIterator first,
CGAL_precondition(first != beyond);
std::list<Point_2> points;
for(InputIterator it = first;
it != beyond;
it++)

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_SEGMENTS_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen_2.h>
#include <CGAL/eigen.h>
@ -29,7 +28,7 @@
#include <CGAL/PCA_util.h>
#include <iterator>
#include <vector>
#include <list>
#include <cmath>
namespace CGAL {

View File

@ -21,12 +21,12 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_SEGMENTS_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
#include <CGAL/PCA_util.h>
#include <CGAL/linear_least_squares_fitting_points_3.h>
#include <list>
#include <iterator>
namespace CGAL {

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_SPHERES_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
#include <CGAL/PCA_util.h>

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_TETRAHEDRA_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
@ -119,6 +118,7 @@ linear_least_squares_fitting_3(InputIterator first,
CGAL_precondition(first != beyond);
std::list<Segment> segments;
for(InputIterator it = first;
it != beyond;
it++)

View File

@ -21,7 +21,6 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_TRIANGLES_2_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen_2.h>
#include <CGAL/eigen.h>
@ -31,7 +30,6 @@
#include <iterator>
#include <vector>
#include <cmath>
#include <list>
namespace CGAL {

View File

@ -21,11 +21,11 @@
#define CGAL_LINEAR_LEAST_SQUARES_FITTING_TRIANGLES_3_H
#include <CGAL/basic.h>
#include <CGAL/Object.h>
#include <CGAL/centroid.h>
#include <CGAL/eigen.h>
#include <CGAL/PCA_util.h>
#include <list>
#include <iterator>
namespace CGAL {
@ -113,7 +113,6 @@ linear_least_squares_fitting_3(InputIterator first,
// precondition: at least one element in the container.
CGAL_precondition(first != beyond);
std::list<Point> points;
for(InputIterator it = first;
it != beyond;
@ -204,14 +203,13 @@ linear_least_squares_fitting_3(InputIterator first,
typename K::Point_3& c, // centroid
const typename K::Triangle_3*, // used for indirection
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::Triangle_3 Triangle;
typedef typename K::Point_3 Point;
// precondition: at least one element in the container.
CGAL_precondition(first != beyond);
std::list<Point> points;
for(InputIterator it = first;
it != beyond;

View File

@ -1,4 +1,8 @@
#include <CGAL/Cartesian.h>
//this is an enriched Polyhedron with facet normals
#include "PolyhedralSurf.h"
#include "PolyhedralSurf_rings.h"
#include <CGAL/Ridges.h>
#include <CGAL/Umbilics.h>
#include <CGAL/Monge_via_jet_fitting.h>
@ -12,9 +16,6 @@ namespace po = boost::program_options;
using namespace std;
//this is an enriched Polyhedron with facets' normal
#include "PolyhedralSurf.h"
#include "PolyhedralSurf_rings.h"
typedef PolyhedralSurf::Traits Kernel;
typedef Kernel::FT FT;

View File

@ -1,7 +1,7 @@
#ifndef CGAL_POLYHEDRALSURF_H_
#define CGAL_POLYHEDRALSURF_H_
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
@ -59,7 +59,7 @@ struct Wrappers_VFH:public CGAL::Polyhedron_items_3 {
//PolyhedralSurf with facet normal operations
//------------------------------------------------
typedef double FT;
typedef CGAL::Cartesian<FT> Kernel;
typedef CGAL::Simple_cartesian<FT> Kernel;
typedef CGAL::Polyhedron_3 < Kernel, Wrappers_VFH > Polyhedron;
typedef Kernel::Vector_3 Vector_3;

View File

@ -3,7 +3,7 @@
// Ti is the type of each dimension of the tree.
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Range_segment_tree_traits.h>
#include <CGAL/Range_tree_k.h>
#include <iostream>
@ -12,8 +12,8 @@
#include <iterator>
typedef CGAL::Cartesian<double> Representation;
typedef CGAL::Range_tree_map_traits_2<Representation, char> Traits;
typedef CGAL::Simple_cartesian<double> K;
typedef CGAL::Range_tree_map_traits_2<K, char> Traits;
typedef CGAL::Range_tree_2<Traits> Range_tree_2_type;
int main()

View File

@ -3,7 +3,7 @@
// Ti is the type of each dimension of the tree.
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Range_segment_tree_traits.h>
#include <CGAL/Range_tree_k.h>
#include <iostream>
@ -11,8 +11,8 @@
#include <vector>
#include <iterator>
typedef CGAL::Cartesian<double> Representation;
typedef CGAL::Range_segment_tree_set_traits_2<Representation> Traits;
typedef CGAL::Simple_cartesian<double> K;
typedef CGAL::Range_segment_tree_set_traits_2<K> Traits;
typedef CGAL::Range_tree_2<Traits> Range_tree_2_type;
int main()

View File

@ -7,14 +7,14 @@
#include <vector>
#include <iterator>
#include <list>
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Segment_tree_k.h>
#include <CGAL/Range_segment_tree_traits.h>
typedef CGAL::Cartesian<double> Representation;
typedef CGAL::Segment_tree_map_traits_2<Representation, char> Traits;
typedef CGAL::Simple_cartesian<double> K;
typedef CGAL::Segment_tree_map_traits_2<K, char> Traits;
typedef CGAL::Segment_tree_2<Traits > Segment_tree_2_type;
int main()

View File

@ -11,12 +11,12 @@
#include <vector>
#include <iterator>
#include <list>
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Segment_tree_k.h>
#include <CGAL/Range_segment_tree_traits.h>
typedef CGAL::Cartesian<double> Representation;
typedef CGAL::Range_segment_tree_set_traits_2<Representation> Traits;
typedef CGAL::Simple_cartesian<double> K;
typedef CGAL::Range_segment_tree_set_traits_2<K> Traits;
typedef CGAL::Segment_tree_2<Traits > Segment_tree_2_type;
int main()

View File

@ -6,12 +6,12 @@
#include <utility>
#include <iterator>
#include <list>
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Segment_tree_k.h>
#include <CGAL/Range_segment_tree_traits.h>
typedef CGAL::Cartesian<double> Representation;
typedef CGAL::Range_segment_tree_set_traits_3<Representation> Traits;
typedef CGAL::Simple_cartesian<double> K;
typedef CGAL::Range_segment_tree_set_traits_3<K> Traits;
typedef CGAL::Segment_tree_3<Traits > Segment_tree_3_type;
int main()

View File

@ -1,24 +1,25 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Kd_tree.h>
#include <CGAL/Search_traits_2.h>
#include <CGAL/point_generators_2.h>
#include <CGAL/algorithm.h>
#include <CGAL/Fuzzy_sphere.h>
typedef CGAL::Cartesian<double> K;
typedef CGAL::Simple_cartesian<double> K;
typedef K::Point_2 Point;
typedef CGAL::Random_points_in_square_2<Point> Random_points_iterator;
typedef CGAL::Counting_iterator<Random_points_iterator> N_Random_points_iterator;
typedef CGAL::Search_traits_2<K> Traits;
typedef CGAL::Fuzzy_sphere<Traits> Fuzzy_circle;
typedef CGAL::Kd_tree<Traits> Tree;
typedef CGAL::Random Random;
int main() {
const int N=1000;
// generator for random data points in the square ( (-1,-1), (1,1) )
Random_points_iterator rpit( 1.0);
Random rnd(0);
Random_points_iterator rpit(1.0, rnd);
// Insert also the N points in the tree
Tree tree(N_Random_points_iterator(rpit,0),

View File

@ -6,7 +6,6 @@
#include<boost/shared_ptr.hpp>
#include<CGAL/Cartesian.h>
#include<CGAL/Polygon_2.h>
#include<CGAL/Exact_predicates_inexact_constructions_kernel.h>
#include<CGAL/Straight_skeleton_builder_2.h>

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -14,7 +14,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -1,6 +1,4 @@
#include <CGAL/basic.h> // include basic.h before testing #defines
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -20,7 +18,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;
// Polyhedron adaptor

View File

@ -1,6 +1,4 @@
#include <CGAL/basic.h> // include basic.h before testing #defines
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -17,7 +15,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;
@ -67,6 +65,7 @@ int main(int argc, char * argv[])
typedef CGAL::Parameterization_polyhedron_adaptor_3<Polyhedron>
Parameterization_polyhedron_adaptor;
Parameterization_polyhedron_adaptor mesh_adaptor(mesh);
//***************************************
@ -88,6 +87,7 @@ int main(int argc, char * argv[])
Parameterizer;
Parameterizer::Error_code err = CGAL::parameterize(mesh_adaptor, Parameterizer());
switch(err) {
case Parameterizer::OK: // Success
break;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -13,7 +13,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;
// Polyhedron adaptor

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -12,7 +12,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -1,4 +1,4 @@
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -13,7 +13,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -1,6 +1,4 @@
#include <CGAL/basic.h> // include basic.h before testing #defines
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
#include <CGAL/Parameterization_polyhedron_adaptor_3.h>
@ -17,7 +15,7 @@
// Private types
// ----------------------------------------------------------------------------
typedef CGAL::Cartesian<double> Kernel;
typedef CGAL::Simple_cartesian<double> Kernel;
typedef CGAL::Polyhedron_3<Kernel> Polyhedron;

View File

@ -16,8 +16,6 @@
#ifndef MESH_CUTTER_H
#define MESH_CUTTER_H
#include <CGAL/Cartesian.h>
#include "Polyhedron_ex.h"
#include <list>

View File

@ -1,7 +1,7 @@
#ifndef POLYHEDRON_EX_H_INCLUDED
#define POLYHEDRON_EX_H_INCLUDED
#include <CGAL/Cartesian.h>
#include <CGAL/Simple_cartesian.h>
#include <CGAL/Polyhedron_3.h>
#include <CGAL/IO/Polyhedron_iostream.h>
@ -13,7 +13,7 @@
// CGAL kernel
typedef CGAL::Cartesian<double> My_kernel;
typedef CGAL::Simple_cartesian<double> My_kernel;
// compute facet center

View File

@ -30,7 +30,6 @@
// polyhedron_ex_parameterization -t lscm -b 2pts mesh.off mesh.obj
#include <CGAL/Cartesian.h>
#include <CGAL/Timer.h>
#include <CGAL/parameterize.h>
#include <CGAL/Parameterization_mesh_patch_3.h>