diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/ARAP_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/ARAP_parameterizer_3.h index e21b6488bc9..9fe09b304ed 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/ARAP_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/ARAP_parameterizer_3.h @@ -202,31 +202,31 @@ private: // Private fields private: - /// %Object that maps (at least two) border vertices onto a 2D space + // %Object that maps (at least two) border vertices onto a 2D space Border_parameterizer m_borderParameterizer; - /// Traits object to solve a sparse linear system + // Traits object to solve a sparse linear system Solver_traits m_linearAlgebra; - /// Controlling parameters + // Controlling parameters const NT m_lambda; const NT m_lambda_tolerance; // used to determine when we switch to full ARAP - /// Energy minimization parameters + // Energy minimization parameters const unsigned int m_iterations; const NT m_tolerance; // Private accessors private: - /// Get the object that maps the surface's border onto a 2D space. + // Get the object that maps the surface's border onto a 2D space. Border_parameterizer& get_border_parameterizer() { return m_borderParameterizer; } - /// Get the sparse linear algebra (traits object to access the linear system). + // Get the sparse linear algebra (traits object to access the linear system). Solver_traits& get_linear_algebra_traits() { return m_linearAlgebra; } // Private utilities private: - /// Print the parameterized mesh. + // Print the parameterized mesh. template void output_uvmap(const std::string filename, @@ -240,7 +240,7 @@ private: IO::output_uvmap_to_off(mesh, vertices, faces, uvmap, vimap, out); } - /// Print the parameterized mesh. + // Print the parameterized mesh. template void output_uvmap(const std::string filename, @@ -257,7 +257,7 @@ private: output_uvmap_to_off(mesh, vertices, faces, uvmap, vimap, out); } - /// Copy the data from two vectors to the UVmap. + // Copy the data from two vectors to the UVmap. template void assign_solution(const Vector& Xu, @@ -276,7 +276,7 @@ private: // Private operations private: - /// Store the vertices and faces of the mesh in memory. + // Store the vertices and faces of the mesh in memory. Error_code initialize_containers(const TriangleMesh& mesh, halfedge_descriptor bhd, Vertex_set& vertices, @@ -294,7 +294,7 @@ private: return OK; } - /// Initialize the UV values with a first parameterization of the input. + // Initialize the UV values with a first parameterization of the input. template Error_code compute_initial_uv_map(TriangleMesh& mesh, @@ -330,8 +330,8 @@ private: return status; } - /// Parameterize the border. The number of fixed vertices depends on the value - /// of the parameter λ. + // Parameterize the border. The number of fixed vertices depends on the value + // of the parameter λ. template @@ -367,7 +367,7 @@ private: return status; } - /// Compute the cotangent of the angle between the vectors ij and ik. + // Compute the cotangent of the angle between the vectors ij and ik. void compute_cotangent_angle(const TriangleMesh& mesh, halfedge_descriptor hd, vertex_descriptor vi, @@ -387,7 +387,7 @@ private: put(ctmap, hd, cot); } - /// Fill the map 'ctmap' with the cotangents of the angles of the faces of 'mesh'. + // Fill the map 'ctmap' with the cotangents of the angles of the faces of 'mesh'. Error_code compute_cotangent_angles(const TriangleMesh& mesh, const Faces_vector& faces, Cot_map ctmap) const @@ -414,7 +414,7 @@ private: return OK; } - /// Compute w_ij = (i, j) coefficient of matrix A for j neighbor vertex of i. + // Compute w_ij = (i, j) coefficient of matrix A for j neighbor vertex of i. NT compute_w_ij(const TriangleMesh& mesh, halfedge_descriptor hd, const Cot_map ctmap) const @@ -433,13 +433,13 @@ private: return weight; } - /// Compute the line i of matrix A - /// - call compute_w_ij() to compute the A coefficient w_ij for each neighbor v_j. - /// - compute w_ii = - sum of w_ijs. - /// - /// \pre Vertices must be indexed. - /// \pre Vertex i musn't be already parameterized. - /// \pre Line i of A must contain only zeros. + // Compute the line i of matrix A + // - call compute_w_ij() to compute the A coefficient w_ij for each neighbor v_j. + // - compute w_ii = - sum of w_ijs. + // + // \pre Vertices must be indexed. + // \pre Vertex i musn't be already parameterized. + // \pre Line i of A must contain only zeros. template Error_code fill_linear_system_matrix(Matrix& A, const TriangleMesh& mesh, @@ -480,8 +480,8 @@ private: return OK; } - /// Initialize the (constant) matrix A in the linear system "A*X = B", - /// after (at least two) border vertices parameterization. + // Initialize the (constant) matrix A in the linear system "A*X = B", + // after (at least two) border vertices parameterization. template Error_code initialize_matrix_A(const TriangleMesh& mesh, @@ -510,7 +510,7 @@ private: return status; } - /// Solves the cubic equation a3 x^3 + a2 x^2 + a1 x + a0 = 0. + // Solves the cubic equation a3 x^3 + a2 x^2 + a1 x + a0 = 0. int solve_cubic_equation(const NT a3, const NT a2, const NT a1, const NT a0, std::vector& roots) const { @@ -529,7 +529,7 @@ private: return roots.size(); } - /// Solves the equation a3 x^3 + a2 x^2 + a1 x + a0 = 0, using CGAL's algeabric kernel. + // Solves the equation a3 x^3 + a2 x^2 + a1 x + a0 = 0, using CGAL's algeabric kernel. int solve_cubic_equation_with_AK(const NT a3, const NT a2, const NT a1, const NT a0, std::vector& roots) const @@ -573,10 +573,10 @@ private: return roots.size(); } - /// Solve the bivariate system - /// { C1 * a + 2 * lambda * a ( a^2 + b^2 - 1 ) = C2 - /// { C1 * b + 2 * lambda * b ( a^2 + b^2 - 1 ) = C3 - /// using CGAL's algeabric kernel. + // Solve the bivariate system + // { C1 * a + 2 * lambda * a ( a^2 + b^2 - 1 ) = C2 + // { C1 * b + 2 * lambda * b ( a^2 + b^2 - 1 ) = C3 + // using CGAL's algeabric kernel. int solve_bivariate_system(const NT C1, const NT C2, const NT C3, std::vector& a_roots, std::vector& b_roots) const { @@ -638,7 +638,7 @@ private: return a_roots.size(); } - /// Compute the root that gives the lowest face energy. + // Compute the root that gives the lowest face energy. template std::size_t compute_root_with_lowest_energy(const TriangleMesh& mesh, face_descriptor fd, @@ -665,7 +665,7 @@ private: return index_arg; } - /// Compute the root that gives the lowest face energy. + // Compute the root that gives the lowest face energy. template std::size_t compute_root_with_lowest_energy(const TriangleMesh& mesh, face_descriptor fd, @@ -691,7 +691,7 @@ private: return index_arg; } - /// Compute the optimal values of the linear transformation matrices Lt. + // Compute the optimal values of the linear transformation matrices Lt. template Error_code compute_optimal_Lt_matrices(const TriangleMesh& mesh, const Faces_vector& faces, @@ -792,8 +792,8 @@ private: return status; } - /// Computes the coordinates of the vertices p0, p1, p2 - /// in a local 2D orthonormal basis of the triangle's plane. + // Computes the coordinates of the vertices p0, p1, p2 + // in a local 2D orthonormal basis of the triangle's plane. void project_triangle(const Point_3& p0, const Point_3& p1, const Point_3& p2, // in Point_2& z0, Point_2& z1, Point_2& z2) const // out { @@ -821,7 +821,7 @@ private: z2 = Point_2(x2, y2); } - /// Compute the local parameterization (2D) of a face and store it in memory. + // Compute the local parameterization (2D) of a face and store it in memory. void project_face(const TriangleMesh& mesh, vertex_descriptor vi, vertex_descriptor vj, @@ -846,8 +846,8 @@ private: lp.push_back(pvk); } - /// Utility for fill_linear_system_rhs(): - /// Compute the local isometric parameterization (2D) of the faces of the mesh. + // Utility for fill_linear_system_rhs(): + // Compute the local isometric parameterization (2D) of the faces of the mesh. Error_code compute_local_parameterization(const TriangleMesh& mesh, const Faces_vector& faces, Local_points& lp, @@ -884,8 +884,8 @@ private: return OK; } - /// Compute the coefficient b_ij = (i, j) of the right hand side vector B, - /// for j neighbor vertex of i. + // Compute the coefficient b_ij = (i, j) of the right hand side vector B, + // for j neighbor vertex of i. void compute_b_ij(const TriangleMesh& mesh, halfedge_descriptor hd, const Cot_map ctmap, @@ -950,12 +950,12 @@ private: y += ct_l * ( -b_l * diff_l_x + a_l * diff_l_y ); } - /// Compute the line i of right hand side vectors Bu and Bv - /// - call compute_b_ij() for each neighbor v_j to compute the B coefficient b_i - /// - /// \pre Vertices must be indexed. - /// \pre Vertex i musn't be already parameterized. - /// \pre Lines i of Bu and Bv must be zero. + // Compute the line i of right hand side vectors Bu and Bv + // - call compute_b_ij() for each neighbor v_j to compute the B coefficient b_i + // + // \pre Vertices must be indexed. + // \pre Vertex i musn't be already parameterized. + // \pre Lines i of Bu and Bv must be zero. template Error_code fill_linear_system_rhs(const TriangleMesh& mesh, vertex_descriptor vertex, @@ -995,9 +995,9 @@ private: return OK; } - /// Compute the entries of the right hand side of the ARAP linear system. - /// - /// \pre Vertices must be indexed. + // Compute the entries of the right hand side of the ARAP linear system. + // + // \pre Vertices must be indexed. template @@ -1034,8 +1034,8 @@ private: return status; } - /// Compute the right hand side and solve the linear system to obtain the - /// new UV coordinates. + // Compute the right hand side and solve the linear system to obtain the + // new UV coordinates. template @@ -1093,7 +1093,7 @@ private: } - /// Compute the current energy of a face, given a linear transformation matrix. + // Compute the current energy of a face, given a linear transformation matrix. template NT compute_current_face_energy(const TriangleMesh& mesh, face_descriptor fd, @@ -1136,7 +1136,7 @@ private: return Ef; } - /// Compute the current energy of a face. + // Compute the current energy of a face. template NT compute_current_face_energy(const TriangleMesh& mesh, face_descriptor fd, @@ -1153,7 +1153,7 @@ private: return compute_current_face_energy(mesh, fd, ctmap, lp, lpmap, uvmap, a, b); } - /// Compute the current energy of the parameterization. + // Compute the current energy of the parameterization. template NT compute_current_energy(const TriangleMesh& mesh, const Faces_vector& faces, @@ -1176,8 +1176,8 @@ private: } // Post processing functions - /// Use the convex virtual boundary algorithm of Karni et al.[2005] to fix - /// the (hopefully few) flips in the result. + // Use the convex virtual boundary algorithm of Karni et al.[2005] to fix + // the (hopefully few) flips in the result. template Error_code post_process(const TriangleMesh& mesh, @@ -1339,7 +1339,7 @@ public: } public: - /// Constructor taking only the parameter λ. + /// Constructor taking only the parameter λ . ARAP_parameterizer_3(NT lambda) : m_borderParameterizer(Border_parameterizer()), diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Circular_border_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Circular_border_parameterizer_3.h index d96700a5c63..908c1c6d79e 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Circular_border_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Circular_border_parameterizer_3.h @@ -87,7 +87,7 @@ protected: // Private operations private: - /// Compute the total length of the border + // Compute the total length of the border NT compute_border_length(const TriangleMesh& mesh, halfedge_descriptor bhd) const { diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Fixed_border_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Fixed_border_parameterizer_3.h index af3e134ee0a..e4052a52cd6 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Fixed_border_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Fixed_border_parameterizer_3.h @@ -404,10 +404,10 @@ protected: // Fields private: - /// Object that maps the surface's border onto a 2D space. + // Object that maps the surface's border onto a 2D space. Border_parameterizer m_borderParameterizer; - /// Traits object to solve a sparse linear system + // Traits object to solve a sparse linear system Solver_traits m_linearAlgebra; }; diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/LSCM_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/LSCM_parameterizer_3.h index aee1a70bc78..d1d3ac17e17 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/LSCM_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/LSCM_parameterizer_3.h @@ -272,12 +272,12 @@ public: // Private operations private: - /// Initialize "A*X = B" linear system after - /// (at least two) border vertices are parameterized. - /// - /// \pre Vertices must be indexed. - /// \pre X and B must be allocated and empty. - /// \pre At least 2 border vertices must be parameterized. + // Initialize "A*X = B" linear system after + // (at least two) border vertices are parameterized. + // + // \pre Vertices must be indexed. + // \pre X and B must be allocated and empty. + // \pre At least 2 border vertices must be parameterized. template void initialize_system_from_mesh_border(LeastSquaresSolver& solver, const boost::unordered_set& ccvertices, @@ -306,9 +306,9 @@ private: } } - /// Utility for setup_triangle_relations(): - /// Computes the coordinates of the vertices of a triangle - /// in a local 2D orthonormal basis of the triangle's plane. + // Utility for setup_triangle_relations(): + // Computes the coordinates of the vertices of a triangle + // in a local 2D orthonormal basis of the triangle's plane. void project_triangle(const Point_3& p0, const Point_3& p1, const Point_3& p2, // in Point_2& z0, Point_2& z1, Point_2& z2) const // out { @@ -338,9 +338,10 @@ private: z2 = Point_2(x2, y2); } - /// Create two lines in the linear system per triangle (one for u, one for v). - /// - /// \pre vertices of `mesh` must be indexed. + // Create two lines in the linear system per triangle (one for u, one for v). + // + // \pre vertices of `mesh` must be indexed. + // // Implementation note: LSCM equation is: // (Z1 - Z0)(U2 - U0) = (Z2 - Z0)(U1 - U0) // where Uk = uk + i.v_k is the complex number corresponding to (u,v) coords @@ -427,18 +428,18 @@ private: // Private accessors private: - /// Get the object that maps the surface's border onto a 2D space. + // Get the object that maps the surface's border onto a 2D space. Border_parameterizer& get_border_parameterizer() { return m_borderParameterizer; } - /// Get the sparse linear algebra (traits object to access the linear system). + // Get the sparse linear algebra (traits object to access the linear system). Solver_traits& get_linear_algebra_traits() { return m_linearAlgebra; } // Fields private: - /// %Object that maps (at least two) border vertices onto a 2D space + // %Object that maps (at least two) border vertices onto a 2D space Border_parameterizer m_borderParameterizer; - /// Traits object to solve a sparse linear system + // Traits object to solve a sparse linear system Solver_traits m_linearAlgebra; }; diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/MVC_post_processor_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/MVC_post_processor_3.h index 0c0e9e336ca..e32b425fade 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/MVC_post_processor_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/MVC_post_processor_3.h @@ -57,7 +57,6 @@ namespace Surface_mesh_parameterization { // Declaration // ------------------------------------------------------------------------------------ -// /// \ingroup PkgSurfaceParameterizationMethods /// /// The class `MVC_post_processor_3` implements /// the *Free boundary linear Parameterization* algorithm \cgalCite{kami2005free}. @@ -149,16 +148,16 @@ private: // Private fields private: - /// Traits object to solve a sparse linear system + // Traits object to solve a sparse linear system Solver_traits m_linearAlgebra; // Private accessors private: - /// Get the sparse linear algebra (traits object to access the linear system). + // Get the sparse linear algebra (traits object to access the linear system). Solver_traits& get_linear_algebra_traits() { return m_linearAlgebra; } // Private utility - /// Print the exterior faces of the constrained triangulation. + // Print the exterior faces of the constrained triangulation. template void output_ct_exterior_faces(const CT& ct) const { @@ -178,7 +177,7 @@ private: out << std::endl; } - /// Copy the data from two vectors to the UVmap. + // Copy the data from two vectors to the UVmap. template void assign_solution(const Vector& Xu, @@ -197,7 +196,7 @@ private: // Private operations private: - /// Store the vertices and faces of the mesh in memory. + // Store the vertices and faces of the mesh in memory. void initialize_containers(const TriangleMesh& mesh, halfedge_descriptor bhd, Vertex_set& vertices, @@ -210,7 +209,7 @@ private: boost::make_function_output_iterator(fc)); } - /// Checks whether the polygon's border is simple. + // Checks whether the polygon's border is simple. template bool is_polygon_simple(const TriangleMesh& mesh, halfedge_descriptor bhd, @@ -240,8 +239,8 @@ private: return true; } - /// Spread the inside / outside coloring from a Face to its neighbors - /// depending on whether the common edge is constrained. + // Spread the inside / outside coloring from a Face to its neighbors + // depending on whether the common edge is constrained. template void spread(CT& ct, const typename CT::Face_handle fh) const @@ -277,7 +276,7 @@ private: } } - /// Triangulate the convex hull of the border of the parameterization. + // Triangulate the convex hull of the border of the parameterization. template Error_code triangulate_convex_hull(const TriangleMesh& mesh, @@ -311,7 +310,7 @@ private: return OK; } - /// Color the (finite) faces of the constrained triangulation with an outside (-1) tag + // Color the (finite) faces of the constrained triangulation with an outside (-1) tag template Error_code color_faces(CT& ct) const { @@ -352,8 +351,8 @@ private: return OK; } - // -> -> - /// Return angle (in radians) of of (P,Q,R) corner (i.e. QP,QR angle). + // -> -> + // Return angle (in radians) of of (P,Q,R) corner (i.e. QP,QR angle). double compute_angle_rad(const Point_2& P, const Point_2& Q, const Point_2& R) const @@ -368,7 +367,7 @@ private: return angle; } - /// Fix vertices that are on the convex hull. + // Fix vertices that are on the convex hull. template void fix_convex_hull_border(const CT& ct, @@ -440,8 +439,8 @@ private: A.add_coef(i, i, w_ii); } - /// Partially fill the matrix coefficients A(i,i), A(i,j) and A(i,k) - /// Precondition: i, j, and k are ordered counterclockwise + // Partially fill the matrix coefficients A(i,i), A(i,j) and A(i,k) + // Precondition: i, j, and k are ordered counterclockwise template @@ -558,8 +557,8 @@ private: uvmap, vimap, vpmap, A); } - /// Compute the matrix A in the MVC linear system using the exterior faces - /// of the constrained triangulation 'ct' and the graph 'mesh'. + // Compute the matrix A in the MVC linear system using the exterior faces + // of the constrained triangulation 'ct' and the graph 'mesh'. template @@ -624,7 +623,7 @@ private: } } - /// Solve the two linear systems A*Xu=Bu and A*Xv=Bv. + // Solve the two linear systems A*Xu=Bu and A*Xv=Bv. Error_code solve_mvc(const Matrix& A, const Vector& Bu, const Vector& Bv, Vector& Xu, Vector& Xv) @@ -640,7 +639,7 @@ private: return status; } - /// Color the faces with inside/outside information and fix the border. + // Color the faces with inside/outside information and fix the border. template Error_code prepare_CT_for_parameterization(CT& ct, VertexParameterizedMap vpmap) const @@ -658,7 +657,7 @@ private: return status; } - /// Run an MVC parameterization on the (2D) ARAP UV map and the convexified mesh. + // Run an MVC parameterization on the (2D) ARAP UV map and the convexified mesh. template Error_code check_cones(ConeMap cmap) const { @@ -192,8 +192,7 @@ private: return OK; } - // Linear system - /// Compute the number of linear constraints in the system. + // Compute the number of linear constraints in the system. int number_of_linear_constraints(const SeamMesh& mesh) const { if(orb_type == Parallelogram) { @@ -208,7 +207,7 @@ private: } } - /// Adds a positional constraint on a vertex x_ind, so that x_ind * w = rhs. + // Adds a positional constraint on a vertex x_ind, so that x_ind * w = rhs. void addConstraint(Matrix& M, Vector& B, int& id_r, int id_c, double w, Point_2 rhs) const { M.set_coef(2*id_r, 2*id_c, w, true /*new_coef*/); @@ -227,9 +226,9 @@ private: ++id_r; // current line index in A is increased } - /// Adds constraints so that T * x_sinds = x_tinds, where T is a 2x2 - /// matrix, and the Transformation T is modified to affine from - /// linear by requiring that T * x_si - x_ti = T * x_s1 - x_t1. + // Adds constraints so that T * x_sinds = x_tinds, where T is a 2x2 + // matrix, and the Transformation T is modified to affine from + // linear by requiring that T * x_si - x_ti = T * x_s1 - x_t1. void addTransConstraints(int s0, int t0, int s, int t, int& id_r, const std::vector& T, @@ -283,7 +282,7 @@ private: ++id_r; // current line index in M is increased } - /// Add the constraints from a seam segment to the linear system. + // Add the constraints from a seam segment to the linear system. void constrain_seam_segment(const std::vector >& seam_segment, NT ang, int& current_line_id_in_M, Matrix& M, Vector& B) const @@ -325,8 +324,8 @@ private: } } - /// Computes the rotational constraint on the border of the mesh. - /// Cone constraints are also added. + // Computes the rotational constraint on the border of the mesh. + // Cone constraints are also added. template void AddRotationalConstraint(const SeamMesh& mesh, @@ -448,8 +447,8 @@ private: return weight; } - /// Computes the coefficients of the mean value Laplacian matrix for the edge. - /// `ij` in the face `ijk` + // Computes the coefficients of the mean value Laplacian matrix for the edge. + // `ij` in the face `ijk` void fill_mvc_matrix(const Point_3& pi, int i, const Point_3& pj, int j, const Point_3& pk, int k, Matrix& M) const @@ -492,7 +491,7 @@ private: M.add_coef(2*i + 1, 2*i + 1, w_ii); } - /// Compute the mean value Laplacian matrix. + // Compute the mean value Laplacian matrix. template void mean_value_laplacian(const SeamMesh& mesh, VertexIndexMap vimap, @@ -519,7 +518,7 @@ private: } } - /// Compute the system weights using a Cotangent Laplacian. + // Compute the system weights using a Cotangent Laplacian. template void cotangent_laplacien(SeamMesh& mesh, VertexIndexMap vimap, @@ -565,7 +564,7 @@ private: } } - /// Copy the solution into the UV property map. + // Copy the solution into the UV property map. template void assign_solution(const SeamMesh& mesh, const Vector& X, @@ -583,7 +582,7 @@ private: } } - /// Solves the linear system. + // Solves the linear system. template Error_code computeFlattening(const SeamMesh& mesh, diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Square_border_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Square_border_parameterizer_3.h index c5d41f68b89..70b75b076bf 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Square_border_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Square_border_parameterizer_3.h @@ -102,7 +102,7 @@ protected: // Private operations private: - /// Compute the total length of the border. + // Compute the total length of the border. double compute_border_length(const TriangleMesh& mesh, halfedge_descriptor bhd) const { @@ -113,8 +113,8 @@ private: return len; } - /// Utility method for parameterize(). - /// Compute the mesh iterator whose offset is closest to 'value'. + // Utility method for parameterize(). + // Compute the mesh iterator whose offset is closest to 'value'. halfedge_around_face_iterator closest_iterator(const TriangleMesh& mesh, halfedge_descriptor bhd, Offset_map& offset, @@ -139,8 +139,8 @@ private: return best; } - /// Set the corners by splitting the border of the mesh in four - /// approximately equal segments. + // Set the corners by splitting the border of the mesh in four + // approximately equal segments. template halfedge_descriptor compute_offsets_without_given_vertices(const TriangleMesh& mesh, halfedge_descriptor bhd, @@ -185,9 +185,9 @@ private: return bhd; } - /// Compute the offset values for all the vertices of the border of - /// the mesh. The vertices between two given vertices vi and vj are - /// sent to the same side of the square. + // Compute the offset values for all the vertices of the border of + // the mesh. The vertices between two given vertices vi and vj are + // sent to the same side of the square. template halfedge_descriptor compute_offsets(const TriangleMesh& mesh, halfedge_descriptor bhd, diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Two_vertices_parameterizer_3.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Two_vertices_parameterizer_3.h index bd2f440cdd1..c581cf66be5 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Two_vertices_parameterizer_3.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/Two_vertices_parameterizer_3.h @@ -269,7 +269,6 @@ public: return OK; } - /// Map two extreme vertices of the 3D mesh and mark them as parameterized. /// /// \tparam VertexUVmap must be a model of `ReadWritePropertyMap` with diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/angles.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/angles.h index d3ed38629ba..9ed5d760a49 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/angles.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/angles.h @@ -30,8 +30,8 @@ namespace Surface_mesh_parameterization { namespace internal { -// -> -> -/// Return cotangent of (P,Q,R) corner (i.e. cotan of QP, QR angle). +// -> -> +// Return cotangent of (P,Q,R) corner (i.e. cotan of QP, QR angle). template typename K::FT cotangent(const typename K::Point_3& P, const typename K::Point_3& Q, @@ -52,8 +52,8 @@ typename K::FT cotangent(const typename K::Point_3& P, return 0.0; // undefined } -// -> -> -/// Return tangent of (P,Q,R) corner (i.e. tangent of QP, QR angle). +// -> -> +// Return tangent of (P,Q,R) corner (i.e. tangent of QP, QR angle). template typename K::FT tangent(const typename K::Point_3& P, const typename K::Point_3& Q, @@ -74,7 +74,7 @@ typename K::FT tangent(const typename K::Point_3& P, return 0.0; // undefined } -/// Fix sine to be within [-1;1]. +// Fix sine to be within [-1;1]. template typename K::FT fix_sine(typename K::FT sine) { @@ -86,8 +86,8 @@ typename K::FT fix_sine(typename K::FT sine) return sine; } -// -> -> -/// Return angle (in radians) of of (P,Q,R) corner (i.e. QP, QR angle). +// -> -> +// Return angle (in radians) of of (P,Q,R) corner (i.e. QP, QR angle). template typename K::FT compute_angle_rad(const typename K::Point_3& P, const typename K::Point_3& Q, diff --git a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/orbifold_cone_helper.h b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/orbifold_cone_helper.h index 92afac4cd93..a58db9639b7 100644 --- a/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/orbifold_cone_helper.h +++ b/Surface_mesh_parameterization/include/CGAL/Surface_mesh_parameterization/internal/orbifold_cone_helper.h @@ -149,7 +149,7 @@ bool are_cones_unique(const Cone_container& cones) return (n_of_cones == unique_cones.size()); } -/// Locate the cone tagged 'First_unique_cone' and its index in the seam mesh. +// Locate the cone tagged 'First_unique_cone' and its index in the seam mesh. template @@ -175,7 +175,7 @@ void find_start_cone(const ConeMap& cmap, CGAL_postcondition(false); } -/// Locate the cone tagged 'First_unique_cone' in the seam mesh. +// Locate the cone tagged 'First_unique_cone' in the seam mesh. template void find_start_cone(const ConeMap& cmap,