From 79b30908d5d5595ab332b9ced337c9f54059a811 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Philipp=20M=C3=B6ller?= Date: Tue, 7 Aug 2012 11:04:32 +0000 Subject: [PATCH] WARNFIX: Silence a good part of unused variable/parameter warnings. Wextra results in a dreadful wall of yellow in the test-suite and is scary when using CGAL. Reduce some of the noise by silencing the obvious cases with CGAL_USE or comments. --- Alpha_shapes_2/include/CGAL/Alpha_shape_2.h | 2 +- Circulator/include/CGAL/circulator.h | 4 ++++ .../Reflex_vertex_searcher.h | 10 +++++----- .../bbox_other_do_intersect_test.cpp | 4 ++-- Kernel_d/include/CGAL/Cartesian_d.h | 2 +- Mesh_3/include/CGAL/IO/File_medit.h | 6 +++--- Mesh_3/include/CGAL/Mesh_cell_criteria_3.h | 2 +- Mesh_3/include/CGAL/Mesh_edge_criteria_3.h | 2 +- Mesh_3/include/CGAL/Mesh_facet_criteria_3.h | 2 +- Mesh_3/include/CGAL/make_mesh_3.h | 2 +- Nef_2/include/CGAL/Bounded_kernel.h | 16 ++++++++-------- Nef_2/include/CGAL/Nef_polyhedron_2.h | 2 +- Nef_3/include/CGAL/Nef_3/ID_support_handler.h | 2 +- Nef_3/include/CGAL/Nef_3/Infimaximal_box.h | 6 ++++-- Nef_3/include/CGAL/Nef_3/vertex_cycle_to_nef_3.h | 2 +- Nef_3/include/CGAL/Nef_polyhedron_3.h | 2 +- Nef_3/test/Nef_3/nef_union_error_llvm.cpp | 4 ++-- Nef_S2/include/CGAL/Nef_S2/SM_overlayer.h | 12 ++++++------ OpenNL/include/CGAL/OpenNL/blas.h | 8 ++++---- .../include/CGAL/Periodic_3_triangulation_3.h | 4 ++-- .../include/CGAL/mst_orient_normals.h | 6 ++++++ .../include/CGAL/QP_solver/QP_functions_impl.h | 2 +- STL_Extension/include/CGAL/iterator.h | 2 ++ .../CGAL/Segment_Delaunay_graph_simple_site_2.h | 8 ++++---- .../include/CGAL/Polyhedron_decorator_3.h | 2 +- .../include/CGAL/Subdivision_mask_3.h | 4 ++-- .../CGAL/Surface_mesh_default_criteria_3.h | 2 +- .../Adaptation_traits_functors.h | 2 +- .../Voronoi_diagram_2/Default_site_inserters.h | 2 +- .../Voronoi_diagram_2/Default_site_removers.h | 2 +- 30 files changed, 70 insertions(+), 56 deletions(-) diff --git a/Alpha_shapes_2/include/CGAL/Alpha_shape_2.h b/Alpha_shapes_2/include/CGAL/Alpha_shape_2.h index f2890937d1e..85b6fb811a8 100644 --- a/Alpha_shapes_2/include/CGAL/Alpha_shape_2.h +++ b/Alpha_shapes_2/include/CGAL/Alpha_shape_2.h @@ -680,7 +680,7 @@ public: } size_type - number_solid_components(const Type_of_alpha& alpha) const + number_solid_components(const Type_of_alpha& /* alpha */) const { return number_of_solid_components(get_alpha()); } diff --git a/Circulator/include/CGAL/circulator.h b/Circulator/include/CGAL/circulator.h index 6875ef8989b..ee9088d3adf 100644 --- a/Circulator/include/CGAL/circulator.h +++ b/Circulator/include/CGAL/circulator.h @@ -30,6 +30,7 @@ #include #include #include +#include // These are name redefinitions for backwards compatibility // with the pre iterator-traits style adaptors. @@ -743,6 +744,7 @@ public: // OPERATIONS bool operator==( Nullptr_t p) const { + CGAL_USE(p); CGAL_assertion( p == NULL); return (ctnr == NULL) || (ctnr->begin() == ctnr->end()); } @@ -876,6 +878,7 @@ public: // OPERATIONS bool operator==( Nullptr_t p) const { + CGAL_USE(p); CGAL_assertion( p == NULL); return (ctnr == NULL) || (ctnr->begin() == ctnr->end()); } @@ -1028,6 +1031,7 @@ public: // OPERATIONS bool operator==( Nullptr_t p) const { + CGAL_USE(p); CGAL_assertion( p == NULL); return empty; } diff --git a/Convex_decomposition_3/include/CGAL/Convex_decomposition_3/Reflex_vertex_searcher.h b/Convex_decomposition_3/include/CGAL/Convex_decomposition_3/Reflex_vertex_searcher.h index 6b45e737c91..9b250f6730b 100644 --- a/Convex_decomposition_3/include/CGAL/Convex_decomposition_3/Reflex_vertex_searcher.h +++ b/Convex_decomposition_3/include/CGAL/Convex_decomposition_3/Reflex_vertex_searcher.h @@ -72,11 +72,11 @@ class Reflex_vertex_searcher : public Modifier_basesource()->source()]==3) return; int isrse = is_reflex_sedge(se, dir); diff --git a/Intersections_3/test/Intersections_3/bbox_other_do_intersect_test.cpp b/Intersections_3/test/Intersections_3/bbox_other_do_intersect_test.cpp index 3a0586e41e9..35557916a07 100644 --- a/Intersections_3/test/Intersections_3/bbox_other_do_intersect_test.cpp +++ b/Intersections_3/test/Intersections_3/bbox_other_do_intersect_test.cpp @@ -62,7 +62,7 @@ template bool test_aux(const T& t, const std::string& name, const CGAL::Bbox_3& bbox, - bool expected, bool exact_predicates = false) + bool expected, bool /*exact_predicates*/ = false) { bool b = CGAL::do_intersect(t,bbox); @@ -660,7 +660,7 @@ bool test(bool exact_kernel = false) } template -bool test_kernel(bool exact_predicates = true, K k = K()) +bool test_kernel(bool exact_predicates = true, K /*k*/ = K()) { bool b = test(exact_predicates) && intensive_test(exact_predicates); diff --git a/Kernel_d/include/CGAL/Cartesian_d.h b/Kernel_d/include/CGAL/Cartesian_d.h index 2cc5bfbbcff..0a5a6e5b68e 100644 --- a/Kernel_d/include/CGAL/Cartesian_d.h +++ b/Kernel_d/include/CGAL/Cartesian_d.h @@ -342,7 +342,7 @@ public: static RT FT_numerator(const FT &r) { return r; } - static RT FT_denominator(const FT &r) + static RT FT_denominator(const FT & /*r*/) { return RT(1); } // special stuff for traits class character : diff --git a/Mesh_3/include/CGAL/IO/File_medit.h b/Mesh_3/include/CGAL/IO/File_medit.h index 1db396f6f6d..5123b62c7bc 100644 --- a/Mesh_3/include/CGAL/IO/File_medit.h +++ b/Mesh_3/include/CGAL/IO/File_medit.h @@ -343,7 +343,7 @@ class No_rebind_facet_pmap typedef unsigned int size_type; public: - No_rebind_facet_pmap(const C3T3& c3t3, const Cell_pmap& cell_pmap) + No_rebind_facet_pmap(const C3T3& c3t3, const Cell_pmap& /*cell_pmap*/) : r_c3t3_(c3t3) {} int surface_index(const Facet& f) const @@ -376,7 +376,7 @@ class No_rebind_facet_pmap_first typedef unsigned int size_type; public: - No_rebind_facet_pmap_first(const C3T3& c3t3, const Cell_pmap& cell_pmap) + No_rebind_facet_pmap_first(const C3T3& c3t3, const Cell_pmap& /*cell_pmap*/) : r_c3t3_(c3t3) {} int surface_index(const Facet& f) const @@ -410,7 +410,7 @@ class No_rebind_facet_pmap_second typedef unsigned int size_type; public: - No_rebind_facet_pmap_second(const C3T3& c3t3, const Cell_pmap& cell_pmap) + No_rebind_facet_pmap_second(const C3T3& c3t3, const Cell_pmap& /*cell_pmap*/) : r_c3t3_(c3t3) {} int surface_index(const Facet& f) const diff --git a/Mesh_3/include/CGAL/Mesh_cell_criteria_3.h b/Mesh_3/include/CGAL/Mesh_cell_criteria_3.h index 7c914bd213c..9da5b365da6 100644 --- a/Mesh_3/include/CGAL/Mesh_cell_criteria_3.h +++ b/Mesh_3/include/CGAL/Mesh_cell_criteria_3.h @@ -62,7 +62,7 @@ public: template Mesh_cell_criteria_3(const FT& radius_edge_bound, const Sizing_field& radius_bound, - typename Sizing_field::FT dummy = 0) + typename Sizing_field::FT /*dummy*/ = 0) { init_radius(radius_bound); diff --git a/Mesh_3/include/CGAL/Mesh_edge_criteria_3.h b/Mesh_3/include/CGAL/Mesh_edge_criteria_3.h index bf6424eb1c6..09810b8a54e 100644 --- a/Mesh_3/include/CGAL/Mesh_edge_criteria_3.h +++ b/Mesh_3/include/CGAL/Mesh_edge_criteria_3.h @@ -111,7 +111,7 @@ public: // as int. template < typename Sizing_field > Mesh_edge_criteria_3(const Sizing_field& size, - typename Sizing_field::FT dummy = 0 ) + typename Sizing_field::FT /*dummy*/ = 0 ) : p_size_(new internal::Mesh_3::Sizing_field_container(size)) {} diff --git a/Mesh_3/include/CGAL/Mesh_facet_criteria_3.h b/Mesh_3/include/CGAL/Mesh_facet_criteria_3.h index eb7762c2ebc..69057089f10 100644 --- a/Mesh_3/include/CGAL/Mesh_facet_criteria_3.h +++ b/Mesh_3/include/CGAL/Mesh_facet_criteria_3.h @@ -79,7 +79,7 @@ public: const FT& distance_bound, const Mesh_facet_topology topology = FACET_VERTICES_ON_SURFACE, - typename Sizing_field::FT dummy = 0) + typename Sizing_field::FT /*dummy*/ = 0) { if ( FT(0) != angle_bound ) init_aspect(angle_bound); diff --git a/Mesh_3/include/CGAL/make_mesh_3.h b/Mesh_3/include/CGAL/make_mesh_3.h index 3fffacf72e8..0e91240e125 100644 --- a/Mesh_3/include/CGAL/make_mesh_3.h +++ b/Mesh_3/include/CGAL/make_mesh_3.h @@ -106,7 +106,7 @@ namespace parameters { template < typename MeshDomain > inline internal::Features_options - features(const MeshDomain& domain) + features(const MeshDomain& /*domain*/) { typedef typename internal::Domain_features_generator< MeshDomain, diff --git a/Nef_2/include/CGAL/Bounded_kernel.h b/Nef_2/include/CGAL/Bounded_kernel.h index 7e67db4651e..cc7072ad429 100644 --- a/Nef_2/include/CGAL/Bounded_kernel.h +++ b/Nef_2/include/CGAL/Bounded_kernel.h @@ -105,8 +105,8 @@ public: SECORNER, RIGHTFRAME, NECORNER }; /*{\Xenum a type descriptor for extended points.}*/ - Point_2 epoint(const Standard_FT& m1, const Standard_FT& n1, - const Standard_FT& m2, const Standard_FT& n2) const + Point_2 epoint(const Standard_FT& /*m1*/, const Standard_FT& /*n1*/, + const Standard_FT& /*m2*/, const Standard_FT& /*n2*/) const { CGAL_error_msg( "Bounded_kernel::epoint(..) should not be called"); return Point_2(); @@ -130,7 +130,7 @@ public: Point_2 construct_point(const Standard_point_2& , const Standard_point_2& , - Point_type& t) const + Point_type& /*t*/) const { CGAL_error_msg( "Bounded_kernel::construct_point(Point,Point) should not be called"); return Point_2(); @@ -159,21 +159,21 @@ public: } Point_2 - construct_opposite_point(const Standard_line_2& l) const + construct_opposite_point(const Standard_line_2& /*l*/) const { CGAL_error_msg( "Bounded_kernel::construct_opposite_point(..) should not be called"); return Point_2(); } Point_type - type(const Point_2& p) const + type(const Point_2& /*p*/) const { return STANDARD; } bool - is_standard(const Point_2& p) const + is_standard(const Point_2& /*p*/) const { return true; } @@ -185,14 +185,14 @@ public: } Standard_line_2 - standard_line(const Point_2& p) const + standard_line(const Point_2& /*p*/) const { CGAL_error_msg( "Bounded_kernel::standard_line(..) should not be called"); return Standard_line_2(); } Standard_ray_2 - standard_ray(const Point_2& p) const + standard_ray(const Point_2& /*p*/) const { CGAL_error_msg( "Bounded_kernel::standard_ray(..) should not be called"); return Standard_ray_2(); diff --git a/Nef_2/include/CGAL/Nef_polyhedron_2.h b/Nef_2/include/CGAL/Nef_polyhedron_2.h index 95a13105f9b..8bfda72d577 100644 --- a/Nef_2/include/CGAL/Nef_polyhedron_2.h +++ b/Nef_2/include/CGAL/Nef_polyhedron_2.h @@ -234,7 +234,7 @@ protected: } bool - operator()(Halfedge_handle e, const Tag_false& ) const + operator()(Halfedge_handle /*e*/, const Tag_false& ) const { return false; } diff --git a/Nef_3/include/CGAL/Nef_3/ID_support_handler.h b/Nef_3/include/CGAL/Nef_3/ID_support_handler.h index 975f2fb3889..7e3e458cdf1 100644 --- a/Nef_3/include/CGAL/Nef_3/ID_support_handler.h +++ b/Nef_3/include/CGAL/Nef_3/ID_support_handler.h @@ -46,7 +46,7 @@ class ID_support_handler { int get_hash(int) { return 0; } template void initialize_hash(Handle /*h*/) {} - void initialize_hash(int i) {} + void initialize_hash(int /*i*/) {} void handle_support(SVertex_handle , SHalfedge_const_handle , SHalfedge_const_handle ) {} diff --git a/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h b/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h index 86fee171ad8..43d703b6f92 100644 --- a/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h +++ b/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h @@ -139,7 +139,9 @@ class Infimaximal_box { return NT(1); } - static void compute_min_max(const Plane_3& , NT orth_coords[3], int& /* min */, int& /* max */) { } + static void compute_min_max(const Plane_3& , NT orth_coords[3], int& /* min */, int& /* max */) { + (void)orth_coords; + } static Point_3 scale_infibox_vertex(const Point_3& ) { return Point_3(); @@ -163,7 +165,7 @@ class Infimaximal_box { return std::list(); } - static typename std::list::const_iterator segment_on_side(int side_of_point, + static typename std::list::const_iterator segment_on_side(int /*side_of_point*/, const std::list& segs) { return segs.begin(); } diff --git a/Nef_3/include/CGAL/Nef_3/vertex_cycle_to_nef_3.h b/Nef_3/include/CGAL/Nef_3/vertex_cycle_to_nef_3.h index cc94a91d4f6..297bbc6439b 100644 --- a/Nef_3/include/CGAL/Nef_3/vertex_cycle_to_nef_3.h +++ b/Nef_3/include/CGAL/Nef_3/vertex_cycle_to_nef_3.h @@ -106,7 +106,7 @@ template - void set_index(Handle h, Edge e) {} + void set_index(Handle /*h*/, Edge /*e*/) {} }; template diff --git a/Nef_3/include/CGAL/Nef_polyhedron_3.h b/Nef_3/include/CGAL/Nef_polyhedron_3.h index 7644f202392..d1e3d2eda18 100644 --- a/Nef_3/include/CGAL/Nef_polyhedron_3.h +++ b/Nef_3/include/CGAL/Nef_polyhedron_3.h @@ -1839,7 +1839,7 @@ protected: /*{\Moperations 3 1 }*/ - bool contains(Object_handle h) const + bool contains(Object_handle /*h*/) const /*{\Mop returns true iff the object |h| is contained in the set represented by |\Mvar|.}*/ // { SNC_point_locator PL(snc()); return PL.mark(h);} diff --git a/Nef_3/test/Nef_3/nef_union_error_llvm.cpp b/Nef_3/test/Nef_3/nef_union_error_llvm.cpp index 5d828e3e4a1..bca9fec0243 100644 --- a/Nef_3/test/Nef_3/nef_union_error_llvm.cpp +++ b/Nef_3/test/Nef_3/nef_union_error_llvm.cpp @@ -13,7 +13,7 @@ typedef CGAL::Nef_polyhedron_3 Nef_polyhedron; typedef Kernel::Vector_3 Vector_3; typedef Kernel::Aff_transformation_3 Aff_transformation_3; -int main(int argc, char** argv) { +int main(int, char**) { Polyhedron P1; Polyhedron P2; Polyhedron P3; @@ -37,4 +37,4 @@ int main(int argc, char** argv) { N1.closure().convert_to_polyhedron(P3); return 0; -} \ No newline at end of file +} diff --git a/Nef_S2/include/CGAL/Nef_S2/SM_overlayer.h b/Nef_S2/include/CGAL/Nef_S2/SM_overlayer.h index f4277148e8b..021c8b0d4d9 100644 --- a/Nef_S2/include/CGAL/Nef_S2/SM_overlayer.h +++ b/Nef_S2/include/CGAL/Nef_S2/SM_overlayer.h @@ -336,12 +336,12 @@ void link_as_target_and_append(SVertex_handle v, SHalfedge_handle e) SHalfedge_handle new_halfedge_pair_at_source(SVertex_handle v) { return G.new_shalfedge_pair_at_source(v,Graph::BEFORE); } -void supporting_segment(SHalfedge_handle e, ITERATOR it) {} -void halfedge_below(SVertex_handle v, SHalfedge_handle e) {} -void trivial_segment(SVertex_handle v, ITERATOR it) {} -void starting_segment(SVertex_handle v, ITERATOR it) {} -void passing_segment(SVertex_handle v, ITERATOR it) {} -void ending_segment(SVertex_handle v, ITERATOR it) {} +void supporting_segment(SHalfedge_handle /*e*/, ITERATOR /*it*/) {} +void halfedge_below(SVertex_handle /*v*/, SHalfedge_handle /*e*/) {} +void trivial_segment(SVertex_handle /*v*/, ITERATOR /*it*/) {} +void starting_segment(SVertex_handle /*v*/, ITERATOR /*it*/) {} +void passing_segment(SVertex_handle /*v*/, ITERATOR /*it*/) {} +void ending_segment(SVertex_handle /*v*/, ITERATOR /*it*/) {} }; // SMO_decorator diff --git a/OpenNL/include/CGAL/OpenNL/blas.h b/OpenNL/include/CGAL/OpenNL/blas.h index ced9e2b9ceb..b5aa3722848 100644 --- a/OpenNL/include/CGAL/OpenNL/blas.h +++ b/OpenNL/include/CGAL/OpenNL/blas.h @@ -47,22 +47,22 @@ public: typedef typename VECTOR::CoeffType CoeffType ; /** y <- y + a*x */ - static void axpy(CoeffType a, const VectorType& x, VectorType& y) { + static void axpy(CoeffType /*a*/, const VectorType& /*x*/, VectorType& /*y*/) { CGAL_error(); } /** x <- a*x */ - static void scal(CoeffType a, VectorType& x) { + static void scal(CoeffType /*a*/, VectorType& /*x*/) { CGAL_error(); } /** y <- x */ - static void copy(const VectorType& x, VectorType& y) { + static void copy(const VectorType& /*x*/, VectorType& /*y*/) { CGAL_error(); } /** returns x^t * y */ - static CoeffType dot(const VectorType& x, const VectorType& y) { + static CoeffType dot(const VectorType& /*x*/, const VectorType& /*y*/) { CGAL_error(); } } ; diff --git a/Periodic_3_triangulation_3/include/CGAL/Periodic_3_triangulation_3.h b/Periodic_3_triangulation_3/include/CGAL/Periodic_3_triangulation_3.h index 4d9b1720a0f..a9af1f4fff5 100644 --- a/Periodic_3_triangulation_3/include/CGAL/Periodic_3_triangulation_3.h +++ b/Periodic_3_triangulation_3/include/CGAL/Periodic_3_triangulation_3.h @@ -817,8 +817,8 @@ private: Point_hider &hider, Vertex_handle vh = Vertex_handle()); template - void periodic_sort(Point_iterator p_begin, Point_iterator p_end, - Offset_iterator o_begin, Offset_iterator o_end) const { + void periodic_sort(Point_iterator /*p_begin*/, Point_iterator /*p_end*/, + Offset_iterator /*o_begin*/, Offset_iterator /*o_end*/) const { std::cout << "Periodic_sort not yet implemented" << std::endl; } diff --git a/Point_set_processing_3/include/CGAL/mst_orient_normals.h b/Point_set_processing_3/include/CGAL/mst_orient_normals.h index fe6d80853bc..db3fd373efe 100644 --- a/Point_set_processing_3/include/CGAL/mst_orient_normals.h +++ b/Point_set_processing_3/include/CGAL/mst_orient_normals.h @@ -28,6 +28,7 @@ #include #include #include +#include #include #include @@ -417,6 +418,11 @@ create_mst_graph( const Riemannian_graph& riemannian_graph, ///< graph connecting each vertex to its knn ForwardIterator source_point) ///< source point (with an oriented normal) { + // prevents warnings + CGAL_USE(point_pmap); + CGAL_USE(k); + CGAL_USE(kernel); + // Bring private stuff to scope using namespace internal; diff --git a/QP_solver/include/CGAL/QP_solver/QP_functions_impl.h b/QP_solver/include/CGAL/QP_solver/QP_functions_impl.h index 3f9286cbeff..c9442e8884e 100644 --- a/QP_solver/include/CGAL/QP_solver/QP_functions_impl.h +++ b/QP_solver/include/CGAL/QP_solver/QP_functions_impl.h @@ -46,7 +46,7 @@ namespace QP_functions_detail { // type of LinearInequalitySystem must be convertible to ET template bool has_linearly_independent_equations - (const Ar& ar, const ET& dummy) { + (const Ar& ar, const ET& /*dummy*/) { // we solve the following auxiliary LP, using exact type ET: // -------- // min 0 diff --git a/STL_Extension/include/CGAL/iterator.h b/STL_Extension/include/CGAL/iterator.h index 28ba59bd001..8198f63aa2f 100644 --- a/STL_Extension/include/CGAL/iterator.h +++ b/STL_Extension/include/CGAL/iterator.h @@ -29,6 +29,7 @@ #include #include +#include #include #include #include @@ -318,6 +319,7 @@ public: Iterator current_iterator() const { return nt;} bool operator==( Nullptr_t p) const { + CGAL_USE(p); CGAL_assertion( p == 0); return empty; } diff --git a/Segment_Delaunay_graph_2/include/CGAL/Segment_Delaunay_graph_simple_site_2.h b/Segment_Delaunay_graph_2/include/CGAL/Segment_Delaunay_graph_simple_site_2.h index ae305225b19..edb0870ac1b 100644 --- a/Segment_Delaunay_graph_2/include/CGAL/Segment_Delaunay_graph_simple_site_2.h +++ b/Segment_Delaunay_graph_2/include/CGAL/Segment_Delaunay_graph_simple_site_2.h @@ -77,8 +77,8 @@ public: public: // these "constructors" are defined in order to conform with the // specs; they will produce a run-time error if used - static Self construct_site_2(const Point_2& p1, const Point_2& p2, - const Point_2& q1, const Point_2& q2) { + static Self construct_site_2(const Point_2& /*p1*/, const Point_2& /*p2*/, + const Point_2& /*q1*/, const Point_2& /*q2*/) { no_constructor_support(); return Self(); } @@ -125,12 +125,12 @@ public: // the following four methods do not really make any sense but have // been added in order for this class to be a model of the // SegmentDelaunayGraphSite_2 concept. - const Point_2& source_of_supporting_site(unsigned int i) const { + const Point_2& source_of_supporting_site(unsigned int /*i*/) const { CGAL_precondition( is_point() && !is_input() ); return p_[0]; } - const Point_2& target_of_supporting_site(unsigned int i) const { + const Point_2& target_of_supporting_site(unsigned int /*i*/) const { CGAL_precondition( is_point() && !is_input() ); return p_[0]; } diff --git a/Subdivision_method_3/include/CGAL/Polyhedron_decorator_3.h b/Subdivision_method_3/include/CGAL/Polyhedron_decorator_3.h index 42ff1e7dbe6..d359f65c5ae 100644 --- a/Subdivision_method_3/include/CGAL/Polyhedron_decorator_3.h +++ b/Subdivision_method_3/include/CGAL/Polyhedron_decorator_3.h @@ -116,7 +116,7 @@ public: a <----------> b H is the return halfedge connecting vertex a to b. */ - static Halfedge* insert_edge(Polyhedron& p, Vertex* a, Vertex* b) { + static Halfedge* insert_edge(Polyhedron& /*p*/, Vertex* a, Vertex* b) { return insert_edge(Vertex_handle(a), Vertex_handle(b)).ptr(); } // diff --git a/Subdivision_method_3/include/CGAL/Subdivision_mask_3.h b/Subdivision_method_3/include/CGAL/Subdivision_mask_3.h index b63cfe6fd35..cdb4614cef5 100644 --- a/Subdivision_method_3/include/CGAL/Subdivision_mask_3.h +++ b/Subdivision_method_3/include/CGAL/Subdivision_mask_3.h @@ -104,7 +104,7 @@ public: pt = vertex->point(); } // - void border_node(Halfedge_handle edge, Point& ept, Point& vpt){ + void border_node(Halfedge_handle edge, Point& ept, Point& /*vpt*/){ edge_node(edge, ept); } }; @@ -279,7 +279,7 @@ public: public: // - void corner_node(Halfedge_handle edge, Point& pt) {}; + void corner_node(Halfedge_handle /*edge*/, Point& /*pt*/) {}; }; diff --git a/Surface_mesher/include/CGAL/Surface_mesh_default_criteria_3.h b/Surface_mesher/include/CGAL/Surface_mesh_default_criteria_3.h index fcded9e59ff..cd7c78fe43b 100644 --- a/Surface_mesher/include/CGAL/Surface_mesh_default_criteria_3.h +++ b/Surface_mesher/include/CGAL/Surface_mesh_default_criteria_3.h @@ -76,7 +76,7 @@ private: template std::ostream& operator<<(std::ostream& os, - const typename Surface_mesh_default_criteria_3::Quality& q) + const typename Surface_mesh_default_criteria_3::Quality& /*q*/) { return os << "q"; } diff --git a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Adaptation_traits_functors.h b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Adaptation_traits_functors.h index ed02ee7ed0e..41d2f641275 100644 --- a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Adaptation_traits_functors.h +++ b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Adaptation_traits_functors.h @@ -33,7 +33,7 @@ namespace VoronoiDiagram_2 { namespace Internal { struct Null_functor { Null_functor() {} - template Null_functor(T t) {} + template Null_functor(T /*t*/) {} }; //========================================================================= diff --git a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_inserters.h b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_inserters.h index b73075eea4d..014b5feeb71 100644 --- a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_inserters.h +++ b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_inserters.h @@ -127,7 +127,7 @@ class Default_caching_site_inserter { public: Default_caching_site_inserter() {} - template Default_caching_site_inserter(T t) {} + template Default_caching_site_inserter(T /*t*/) {} }; //=========================================================================== diff --git a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_removers.h b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_removers.h index 593f7632c69..dedece6a6d5 100644 --- a/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_removers.h +++ b/Voronoi_diagram_2/include/CGAL/Voronoi_diagram_2/Default_site_removers.h @@ -105,7 +105,7 @@ class Default_caching_site_remover { public: Default_caching_site_remover() {} - template Default_caching_site_remover(T t) {} + template Default_caching_site_remover(T /*t*/) {} }; //===========================================================================