mirror of https://github.com/CGAL/cgal
Merge branch 'Poisson-use_parallel_mesh_3-GF' of github.com:janetournois/cgal into Poisson-use_parallel_mesh_3-GF
This commit is contained in:
commit
a1e11d0f60
|
|
@ -84,7 +84,7 @@ void poisson_reconstruction(const PointSet& points, const char* output)
|
|||
|
||||
// Computes average spacing
|
||||
FT average_spacing = CGAL::compute_average_spacing<Concurrency_tag>
|
||||
(points, 6 /* knn = 1 ring */, params::point_map (Point_map()));
|
||||
(points, 6 /* knn = 1 ring */, params::point_map(Point_map()));
|
||||
|
||||
time.stop();
|
||||
std::cout << "Average spacing : " << time.time() << " seconds." << std::endl;
|
||||
|
|
@ -113,9 +113,9 @@ void poisson_reconstruction(const PointSet& points, const char* output)
|
|||
time.start();
|
||||
|
||||
// Defines surface mesh generation criteria
|
||||
CGAL::Mesh_criteria_3<Tr> criteria(params::facet_angle = sm_angle,
|
||||
params::facet_size = sm_radius * average_spacing,
|
||||
params::facet_distance = sm_distance * average_spacing);
|
||||
Mesh_criteria criteria(params::facet_angle = sm_angle,
|
||||
params::facet_size = sm_radius * average_spacing,
|
||||
params::facet_distance = sm_distance * average_spacing);
|
||||
|
||||
Mesh_domain domain = Mesh_domain::create_implicit_mesh_domain(surface, sm_sphere,
|
||||
params::relative_error_bound(sm_dichotomy_error / sm_sphere_radius));
|
||||
|
|
@ -158,30 +158,30 @@ void poisson_reconstruction(const PointSet& points, const char* output)
|
|||
|
||||
int main(int argc, char* argv[])
|
||||
{
|
||||
const std::string file = (argc < 2) ? CGAL::data_file_path("points_3/kitten.xyz")
|
||||
: std::string(argv[1]);
|
||||
const std::string file = (argc > 1) ? std::string(argv[1])
|
||||
: CGAL::data_file_path("points_3/kitten.xyz");
|
||||
|
||||
// Reads the point set file in points[].
|
||||
// Note: read_points() requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
PointList points;
|
||||
if(!CGAL::IO::read_points(file, std::back_inserter(points),
|
||||
params::point_map(Point_map())
|
||||
.normal_map(Normal_map())))
|
||||
{
|
||||
std::cerr << "Error: cannot read file input file!" << std::endl;
|
||||
return EXIT_FAILURE;
|
||||
}
|
||||
// Reads the point set file in points[].
|
||||
// Note: read_points() requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
PointList points;
|
||||
if(!CGAL::IO::read_points(file, std::back_inserter(points),
|
||||
params::point_map(Point_map())
|
||||
.normal_map(Normal_map())))
|
||||
{
|
||||
std::cerr << "Error: cannot read file input file!" << std::endl;
|
||||
return EXIT_FAILURE;
|
||||
}
|
||||
|
||||
std::cout << "File " << file << " has been read, " << points.size() << " points." << std::endl;
|
||||
std::cout << "File " << file << " has been read, " << points.size() << " points." << std::endl;
|
||||
|
||||
std::cout << "\n\n### Sequential mode ###" << std::endl;
|
||||
poisson_reconstruction<CGAL::Sequential_tag>(points, "out_sequential.off");
|
||||
std::cout << "\n\n### Sequential mode ###" << std::endl;
|
||||
poisson_reconstruction<CGAL::Sequential_tag>(points, "out_sequential.off");
|
||||
|
||||
#ifdef CGAL_LINKED_WITH_TBB
|
||||
std::cout << "\n\n### Parallel mode ###" << std::endl;
|
||||
poisson_reconstruction<CGAL::Parallel_tag>(points, "out_parallel.off");
|
||||
std::cout << "\n\n### Parallel mode ###" << std::endl;
|
||||
poisson_reconstruction<CGAL::Parallel_tag>(points, "out_parallel.off");
|
||||
#endif
|
||||
|
||||
return EXIT_SUCCESS;
|
||||
return EXIT_SUCCESS;
|
||||
}
|
||||
|
|
|
|||
|
|
@ -36,105 +36,107 @@ typedef CGAL::Implicit_surface_3<Kernel, Poisson_reconstruction_function> Surfac
|
|||
|
||||
int main(int argc, char* argv[])
|
||||
{
|
||||
// Poisson options
|
||||
FT sm_angle = 20.0; // Min triangle angle in degrees.
|
||||
FT sm_radius = 100; // Max triangle size w.r.t. point set average spacing.
|
||||
FT sm_distance = 0.25; // Surface Approximation error w.r.t. point set average spacing.
|
||||
const std::string file = (argc > 1) ? std::string(argv[1])
|
||||
: CGAL::data_file_path("points_3/kitten.xyz");
|
||||
|
||||
// Reads the point set file in points[].
|
||||
// Note: read_points() requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
PointList points;
|
||||
char* filename = argv[1];
|
||||
if(!CGAL::IO::read_points(filename, std::back_inserter(points),
|
||||
CGAL::parameters::point_map(Point_map())
|
||||
.normal_map (Normal_map())))
|
||||
{
|
||||
std::cerr << "Error: cannot read file input file!" << std::endl;
|
||||
return EXIT_FAILURE;
|
||||
}
|
||||
// Reads the point set file in points[].
|
||||
// Note: read_points() requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
PointList points;
|
||||
if(!CGAL::IO::read_points(file, std::back_inserter(points),
|
||||
CGAL::parameters::point_map(Point_map())
|
||||
.normal_map(Normal_map())))
|
||||
{
|
||||
std::cerr << "Error: cannot read file input file!" << std::endl;
|
||||
return EXIT_FAILURE;
|
||||
}
|
||||
|
||||
CGAL::Real_timer total_time;
|
||||
total_time.start();
|
||||
// Poisson options
|
||||
FT sm_angle = 20.0; // Min triangle angle in degrees.
|
||||
FT sm_radius = 100; // Max triangle size w.r.t. point set average spacing.
|
||||
FT sm_distance = 0.25; // Surface Approximation error w.r.t. point set average spacing.
|
||||
|
||||
// Creates implicit function from the read points using the default solver.
|
||||
CGAL::Real_timer total_time;
|
||||
total_time.start();
|
||||
|
||||
// Note: this method requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
Poisson_reconstruction_function function(points.begin(), points.end(),
|
||||
Point_map(), Normal_map());
|
||||
// Creates implicit function from the read points using the default solver.
|
||||
|
||||
// Computes the Poisson indicator function f()
|
||||
// at each vertex of the triangulation.
|
||||
if ( ! function.compute_implicit_function() )
|
||||
return EXIT_FAILURE;
|
||||
// Note: this method requires an iterator over points
|
||||
// + property maps to access each point's position and normal.
|
||||
Poisson_reconstruction_function function(points.begin(), points.end(),
|
||||
Point_map(), Normal_map());
|
||||
|
||||
// Computes average spacing
|
||||
FT average_spacing = CGAL::compute_average_spacing<CGAL::Sequential_tag>
|
||||
(points, 6 /* knn = 1 ring */,
|
||||
CGAL::parameters::point_map (Point_map()));
|
||||
// Computes the Poisson indicator function f()
|
||||
// at each vertex of the triangulation.
|
||||
if (!function.compute_implicit_function())
|
||||
return EXIT_FAILURE;
|
||||
|
||||
// Gets one point inside the implicit surface
|
||||
// and computes implicit function bounding sphere radius.
|
||||
Point inner_point = function.get_inner_point();
|
||||
Sphere bsphere = function.bounding_sphere();
|
||||
FT radius = std::sqrt(bsphere.squared_radius());
|
||||
// Computes average spacing
|
||||
FT average_spacing = CGAL::compute_average_spacing<CGAL::Sequential_tag>
|
||||
(points, 6 /* knn = 1 ring */,
|
||||
CGAL::parameters::point_map (Point_map()));
|
||||
|
||||
std::cout << "inner_point = " << inner_point << std::endl;
|
||||
std::cout << "bsphere = " << bsphere.center()
|
||||
<< "\tsqr = " << bsphere.squared_radius() << std::endl;
|
||||
std::cout << "radius = " << radius << std::endl;
|
||||
// Gets one point inside the implicit surface
|
||||
// and computes implicit function bounding sphere radius.
|
||||
Point inner_point = function.get_inner_point();
|
||||
Sphere bsphere = function.bounding_sphere();
|
||||
FT radius = std::sqrt(bsphere.squared_radius());
|
||||
|
||||
// Defines the implicit surface: requires defining a
|
||||
// conservative bounding sphere centered at inner point.
|
||||
FT sm_sphere_radius = 5.0 * radius;
|
||||
FT sm_dichotomy_error = sm_distance*average_spacing/1000.0; // Dichotomy error must be << sm_distance
|
||||
std::cout << "dichotomy error = " << sm_dichotomy_error << std::endl;
|
||||
std::cout << "inner_point = " << inner_point << std::endl;
|
||||
std::cout << "bsphere = " << bsphere.center()
|
||||
<< "\tsqr = " << bsphere.squared_radius() << std::endl;
|
||||
std::cout << "radius = " << radius << std::endl;
|
||||
|
||||
Surface_3 surface(function,
|
||||
Sphere(inner_point,sm_sphere_radius*sm_sphere_radius),
|
||||
sm_dichotomy_error/sm_sphere_radius);
|
||||
// Defines the implicit surface: requires defining a
|
||||
// conservative bounding sphere centered at inner point.
|
||||
FT sm_sphere_radius = 5.0 * radius;
|
||||
FT sm_dichotomy_error = sm_distance*average_spacing/1000.0; // Dichotomy error must be << sm_distance
|
||||
std::cout << "dichotomy error = " << sm_dichotomy_error << std::endl;
|
||||
|
||||
std::cout << "Surface created." << std::endl;
|
||||
Surface_3 surface(function,
|
||||
Sphere(inner_point,sm_sphere_radius*sm_sphere_radius),
|
||||
sm_dichotomy_error/sm_sphere_radius);
|
||||
|
||||
// Defines surface mesh generation criteria
|
||||
CGAL::Surface_mesh_default_criteria_3<STr> criteria(sm_angle, // Min triangle angle (degrees)
|
||||
sm_radius*average_spacing, // Max triangle size
|
||||
sm_distance*average_spacing); // Approximation error
|
||||
std::cout << "Surface created." << std::endl;
|
||||
|
||||
// Generates surface mesh with manifold option
|
||||
STr tr; // 3D Delaunay triangulation for surface mesh generation
|
||||
C2t3 c2t3(tr); // 2D complex in 3D Delaunay triangulation
|
||||
CGAL::make_surface_mesh(c2t3, // reconstructed mesh
|
||||
surface, // implicit surface
|
||||
criteria, // meshing criteria
|
||||
CGAL::Manifold_with_boundary_tag()); // require manifold mesh
|
||||
// Defines surface mesh generation criteria
|
||||
CGAL::Surface_mesh_default_criteria_3<STr> criteria(sm_angle, // Min triangle angle (degrees)
|
||||
sm_radius*average_spacing, // Max triangle size
|
||||
sm_distance*average_spacing); // Approximation error
|
||||
|
||||
if(tr.number_of_vertices() == 0)
|
||||
return EXIT_FAILURE;
|
||||
// Generates surface mesh with manifold option
|
||||
STr tr; // 3D Delaunay triangulation for surface mesh generation
|
||||
C2t3 c2t3(tr); // 2D complex in 3D Delaunay triangulation
|
||||
CGAL::make_surface_mesh(c2t3, // reconstructed mesh
|
||||
surface, // implicit surface
|
||||
criteria, // meshing criteria
|
||||
CGAL::Manifold_with_boundary_tag()); // require manifold mesh
|
||||
|
||||
// saves reconstructed surface mesh
|
||||
std::ofstream out("kitten_poisson-20-30-0.375.off");
|
||||
Polyhedron output_mesh;
|
||||
CGAL::facets_in_complex_2_to_triangle_mesh(c2t3, output_mesh);
|
||||
if(tr.number_of_vertices() == 0)
|
||||
return EXIT_FAILURE;
|
||||
|
||||
total_time.stop();
|
||||
std::cout << "Total time : " << total_time.time() << " seconds." << std::endl;
|
||||
// saves reconstructed surface mesh
|
||||
std::ofstream out("poisson_surface.off");
|
||||
Polyhedron output_mesh;
|
||||
CGAL::facets_in_complex_2_to_triangle_mesh(c2t3, output_mesh);
|
||||
|
||||
out << output_mesh;
|
||||
total_time.stop();
|
||||
std::cout << "Total time : " << total_time.time() << " seconds." << std::endl;
|
||||
|
||||
/// [PMP_distance_snippet]
|
||||
// computes the approximation error of the reconstruction
|
||||
double max_dist =
|
||||
CGAL::Polygon_mesh_processing::approximate_max_distance_to_point_set
|
||||
(output_mesh,
|
||||
CGAL::make_range (boost::make_transform_iterator
|
||||
(points.begin(), CGAL::Property_map_to_unary_function<Point_map>()),
|
||||
boost::make_transform_iterator
|
||||
(points.end(), CGAL::Property_map_to_unary_function<Point_map>())),
|
||||
4000);
|
||||
std::cout << "Max distance to point_set: " << max_dist << std::endl;
|
||||
/// [PMP_distance_snippet]
|
||||
out << output_mesh;
|
||||
|
||||
return EXIT_SUCCESS;
|
||||
/// [PMP_distance_snippet]
|
||||
// computes the approximation error of the reconstruction
|
||||
double max_dist =
|
||||
CGAL::Polygon_mesh_processing::approximate_max_distance_to_point_set
|
||||
(output_mesh,
|
||||
CGAL::make_range (boost::make_transform_iterator
|
||||
(points.begin(), CGAL::Property_map_to_unary_function<Point_map>()),
|
||||
boost::make_transform_iterator
|
||||
(points.end(), CGAL::Property_map_to_unary_function<Point_map>())),
|
||||
4000);
|
||||
std::cout << "Max distance to point_set: " << max_dist << std::endl;
|
||||
/// [PMP_distance_snippet]
|
||||
|
||||
return EXIT_SUCCESS;
|
||||
}
|
||||
|
|
|
|||
Loading…
Reference in New Issue