diff --git a/AABB_tree/demo/AABB_tree/Scene.cpp b/AABB_tree/demo/AABB_tree/Scene.cpp index f5807c419a5..b362f854c16 100644 --- a/AABB_tree/demo/AABB_tree/Scene.cpp +++ b/AABB_tree/demo/AABB_tree/Scene.cpp @@ -857,8 +857,8 @@ void Scene::update_grid_size() } void Scene::generate_points_in(const unsigned int nb_points, - const double min, - const double max) + const double vmin, + const double vmax) { if(m_pPolyhedron == NULL) { @@ -877,7 +877,7 @@ void Scene::generate_points_in(const unsigned int nb_points, CGAL::Timer timer; timer.start(); std::cout << "Generate " << nb_points << " points in interval [" - << min << ";" << max << "]"; + << vmin << ";" << vmax << "]"; unsigned int nb_trials = 0; Vector vec = random_vector(); @@ -894,8 +894,8 @@ void Scene::generate_points_in(const unsigned int nb_points, if(nb_intersections % 2 != 0) signed_distance *= -1.0; - if(signed_distance >= min && - signed_distance <= max) + if(signed_distance >= vmin && + signed_distance <= vmax) { m_points.push_back(p); if(m_points.size()%(nb_points/10) == 0) diff --git a/AABB_tree/demo/AABB_tree/Scene.h b/AABB_tree/demo/AABB_tree/Scene.h index aad62368874..4e9fabd735b 100644 --- a/AABB_tree/demo/AABB_tree/Scene.h +++ b/AABB_tree/demo/AABB_tree/Scene.h @@ -192,7 +192,7 @@ public: void generate_boundary_points(const unsigned int nb_points); void generate_boundary_segments(const unsigned int nb_slices); void generate_points_in(const unsigned int nb_points, - const double min, const double max); + const double vmin, const double vmax); // algorithms/refine void refine_loop(); diff --git a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ArrangementDemoGraphicsView.cpp b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ArrangementDemoGraphicsView.cpp index 30aa393ac22..8510bdd5e0d 100644 --- a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ArrangementDemoGraphicsView.cpp +++ b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ArrangementDemoGraphicsView.cpp @@ -118,10 +118,10 @@ QRectF ArrangementDemoGraphicsView::getViewportRect( ) const QPointF p1 = this->mapToScene( 0, 0 ); QPointF p2 = this->mapToScene( this->width( ), this->height( ) ); - double xmin = std::min( p1.x( ), p2.x( ) ); - double xmax = std::max( p1.x( ), p2.x( ) ); - double ymin = std::min( p1.y( ), p2.y( ) ); - double ymax = std::max( p1.y( ), p2.y( ) ); + double xmin = (std::min)( p1.x( ), p2.x( ) ); + double xmax = (std::max)( p1.x( ), p2.x( ) ); + double ymin = (std::min)( p1.y( ), p2.y( ) ); + double ymax = (std::max)( p1.y( ), p2.y( ) ); QRectF res = QRectF( QPointF( xmin, ymin ), QPointF( xmax, ymax ) ); diff --git a/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/Arc_2.h b/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/Arc_2.h index 3430fd31dfc..ded1c5fb5a7 100644 --- a/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/Arc_2.h +++ b/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/Arc_2.h @@ -3031,8 +3031,8 @@ public: y_dapprox = y_interval_for_curve_end(*this, CGAL::ARR_MIN_END, prec); // adapt y-interval - ymin = CGAL::min(ymin, y_dapprox.first); - ymax = CGAL::max(ymax, y_dapprox.second); + ymin = (CGAL::min)(ymin, y_dapprox.first); + ymax = (CGAL::max)(ymax, y_dapprox.second); // right end @@ -3112,9 +3112,9 @@ public: (curr_xy, prec); // adapt y-interval - ymin = CGAL::min(ymin, + ymin = (CGAL::min)(ymin, CGAL::to_double(xy_approx.first)); - ymax = CGAL::max(ymax, + ymax = (CGAL::max)(ymax, CGAL::to_double(xy_approx.second)); } } diff --git a/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/gfx/Curve_renderer_2.h b/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/gfx/Curve_renderer_2.h index da1e45c73f7..edcbefdb1c4 100644 --- a/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/gfx/Curve_renderer_2.h +++ b/Arrangement_on_surface_2/include/CGAL/Curved_kernel_via_analysis_2/gfx/Curve_renderer_2.h @@ -581,7 +581,7 @@ void draw(const Arc_2& arc, ref_bound = engine.pixel_h_r/CGAL_REFINE_X; #ifdef CGAL_CKVA_RENDER_WITH_REFINEMENT - ref_bound = std::min(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); + ref_bound = (std::min)(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); #endif Gfx_OUT("computing y-coordinates\n"); @@ -921,7 +921,7 @@ bool draw(const Point_2& pt, Coord_2& coord) { const Coordinate_1& x0 = pt.x(); Rational ref_bound = engine.pixel_w_r / 2; #ifdef CGAL_CKVA_RENDER_WITH_REFINEMENT - ref_bound = std::min(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); + ref_bound = (std::min)(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); #endif typename Curve_kernel_2::Algebraic_kernel_d_1::Approximate_relative_1 @@ -941,7 +941,7 @@ bool draw(const Point_2& pt, Coord_2& coord) { ref_bound = engine.pixel_h_r / CGAL_REFINE_X; #ifdef CGAL_CKVA_RENDER_WITH_REFINEMENT - ref_bound = std::min(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); + ref_bound = (std::min)(ref_bound, Rational(CGAL_REFINE_DOUBLE_APPROX)); #endif Coordinate_2 xy(x0, pt.curve(), pt.arcno()); diff --git a/Bounding_volumes/archive/test_extensive/stability/stability.cpp b/Bounding_volumes/archive/test_extensive/stability/stability.cpp index 419c50460c8..7b3c8673926 100644 --- a/Bounding_volumes/archive/test_extensive/stability/stability.cpp +++ b/Bounding_volumes/archive/test_extensive/stability/stability.cpp @@ -17,8 +17,8 @@ int nr = 0; double rerr(double exact,double approx) { const double e = std::abs((exact-approx)/exact); - mine = std::min(mine,e); - maxe = std::max(maxe,e); + mine = (std::min)(mine,e); + maxe = (std::max)(maxe,e); avge += e; ++nr; return e; diff --git a/CGAL_ipelets/demo/CGAL_ipelets/alpha_shapes.cpp b/CGAL_ipelets/demo/CGAL_ipelets/alpha_shapes.cpp index 2b7d9d7e334..deafa59d0a1 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/alpha_shapes.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/alpha_shapes.cpp @@ -103,7 +103,7 @@ void ASphapeIpelet::protected_run(int fn) } - A.set_alpha(alpha==0?std::max(std::numeric_limits::epsilon(),A.get_nth_alpha(0)/2.): + A.set_alpha(alpha==0?(std::max)(std::numeric_limits::epsilon(),A.get_nth_alpha(0)/2.): (std::size_t) alpha==A.number_of_alphas()?A.get_nth_alpha(alpha-1)+1:A.get_nth_alpha(alpha-1)/2.+A.get_nth_alpha(alpha)/2.); for ( Alpha_shape_2::Alpha_shape_edges_iterator it=A.alpha_shape_edges_begin();it!=A.alpha_shape_edges_end();++it) draw_in_ipe(A.segment(*it)); diff --git a/CGAL_ipelets/demo/CGAL_ipelets/diagrams.cpp b/CGAL_ipelets/demo/CGAL_ipelets/diagrams.cpp index 00c27acb5d3..71359b23149 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/diagrams.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/diagrams.cpp @@ -144,8 +144,8 @@ void diagrammeIpelet::protected_run(int fn) Kernel::FT incr_len=(fn<2)?50:75; //slightly increase the size of the Bbox - bbox=Iso_rectangle_2(bbox.min()+Kernel::Vector_2(-incr_len,-incr_len), - bbox.max()+Kernel::Vector_2(incr_len,incr_len)); + bbox=Iso_rectangle_2((bbox.min)()+Kernel::Vector_2(-incr_len,-incr_len), + (bbox.max)()+Kernel::Vector_2(incr_len,incr_len)); diff --git a/CGAL_ipelets/demo/CGAL_ipelets/mesh_2.cpp b/CGAL_ipelets/demo/CGAL_ipelets/mesh_2.cpp index c2ff8f5ed43..f6a0be55aff 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/mesh_2.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/mesh_2.cpp @@ -99,8 +99,8 @@ void IpeletMesh2::protected_run(int fn) double alpha=0; - int x=static_cast( floor(bbox.max().x()-bbox.min().x()) ); - int y=static_cast( floor(bbox.max().y()-bbox.min().y()) ); + int x=static_cast( floor((bbox.max)().x()-(bbox.min)().x()) ); + int y=static_cast( floor((bbox.max)().y()-(bbox.min)().y()) ); int ret_val; boost::tie(ret_val,alpha)=request_value_from_user((boost::format("Max edge length (BBox %1%x%2%)") % x % y).str() ); diff --git a/CGAL_ipelets/demo/CGAL_ipelets/minkowski.cpp b/CGAL_ipelets/demo/CGAL_ipelets/minkowski.cpp index 00275d343ea..9aba996ff5d 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/minkowski.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/minkowski.cpp @@ -85,7 +85,7 @@ void SubSelectIpelet::protected_run(int fn) for (std::list::iterator it=cir_list.begin();it!=cir_list.end();++it) r_offsets.push_back(sqrt(CGAL::to_double(it->squared_radius()))); - IpeMatrix tfm (1,0,0,1,-CGAL::to_double(bbox.min().x()),-CGAL::to_double(bbox.min().y())); + IpeMatrix tfm (1,0,0,1,-CGAL::to_double((bbox.min)().x()),-CGAL::to_double((bbox.min)().y())); for (std::list::iterator it=pol_list.begin();it!=pol_list.end();++it) if(!it->is_simple()){ diff --git a/CGAL_ipelets/demo/CGAL_ipelets/multi_regular.cpp b/CGAL_ipelets/demo/CGAL_ipelets/multi_regular.cpp index e01c92b5230..834bb5c3d92 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/multi_regular.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/multi_regular.cpp @@ -104,8 +104,8 @@ void MregularIpelet::protected_run(int fn) draw_in_ipe(rt); else{//Draw kth Power diagram double incr_len=75; - bbox=Iso_rectangle_2(bbox.min()+Kernel::Vector_2(-incr_len,-incr_len), - bbox.max()+Kernel::Vector_2(incr_len,incr_len)); + bbox=Iso_rectangle_2((bbox.min)()+Kernel::Vector_2(-incr_len,-incr_len), + (bbox.max)()+Kernel::Vector_2(incr_len,incr_len)); draw_dual_in_ipe(rt,bbox); //draw Voronoi Diagram } } diff --git a/CGAL_ipelets/demo/CGAL_ipelets/skeleton.cpp b/CGAL_ipelets/demo/CGAL_ipelets/skeleton.cpp index c4f2df8b14e..56998fcc75e 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/skeleton.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/skeleton.cpp @@ -114,7 +114,7 @@ void SkeletonIpelet::protected_run(int fn) std::list offsets; //~ "Interior skeleton", "Exterior skeleton","Interior offset","Exterior offset","Interior offsets","Exterior offsets", "Help" SkeletonPtr ss; - double max_edge=std::max((bbox.xmax()-bbox.xmin()),(bbox.ymax()-bbox.ymin())); + double max_edge=(std::max)((bbox.xmax()-bbox.xmin()),(bbox.ymax()-bbox.ymin())); double dist=0.; int ret_val=-1; switch(fn){ diff --git a/CGAL_ipelets/demo/CGAL_ipelets/svdlinf.cpp b/CGAL_ipelets/demo/CGAL_ipelets/svdlinf.cpp index 9bef1fbe29c..392fffb7aa0 100644 --- a/CGAL_ipelets/demo/CGAL_ipelets/svdlinf.cpp +++ b/CGAL_ipelets/demo/CGAL_ipelets/svdlinf.cpp @@ -96,8 +96,8 @@ namespace CGAL_svdlinf { Kernel::FT incr_len = 75; // slightly increase the size of the bbox bbox = Iso_rectangle_2( - bbox.min()+Kernel::Vector_2(-incr_len,-incr_len), - bbox.max()+Kernel::Vector_2(incr_len,incr_len)); + (bbox.min)()+Kernel::Vector_2(-incr_len,-incr_len), + (bbox.max)()+Kernel::Vector_2(incr_len,incr_len)); for (std::list::iterator sit = sg_list.begin(); diff --git a/CGAL_ipelets/include/CGAL/CGAL_Ipelet_base_v6.h b/CGAL_ipelets/include/CGAL/CGAL_Ipelet_base_v6.h index edf08338541..19e8049ec48 100644 --- a/CGAL_ipelets/include/CGAL/CGAL_Ipelet_base_v6.h +++ b/CGAL_ipelets/include/CGAL/CGAL_Ipelet_base_v6.h @@ -265,8 +265,8 @@ public: _page->DeselectAll(); Iso_rectangle_2 bbox_cgal( - static_cast(bbox_ipe.Min().iX),static_cast(bbox_ipe.Min().iY), - static_cast(bbox_ipe.Max().iX),static_cast(bbox_ipe.Max().iY) + static_cast((bbox_ipe.Min)().iX),static_cast((bbox_ipe.Min)().iY), + static_cast((bbox_ipe.Max)().iX),static_cast((bbox_ipe.Max)().iY) ); return bbox_cgal; diff --git a/Classification/include/CGAL/Classification/Feature/Cluster_vertical_extent.h b/Classification/include/CGAL/Classification/Feature/Cluster_vertical_extent.h index 939c3792534..205d39e5496 100644 --- a/Classification/include/CGAL/Classification/Feature/Cluster_vertical_extent.h +++ b/Classification/include/CGAL/Classification/Feature/Cluster_vertical_extent.h @@ -67,8 +67,8 @@ public: m_values.reserve (clusters.size()); for (std::size_t i = 0; i < clusters.size(); ++ i) { - float min_z = std::numeric_limits::max(); - float max_z = -std::numeric_limits::min(); + float min_z = (std::numeric_limits::max)(); + float max_z = -(std::numeric_limits::min)(); for (std::size_t j = 0; j < clusters[i].size(); ++ j) { diff --git a/Classification/include/CGAL/Classification/Feature/Elevation.h b/Classification/include/CGAL/Classification/Feature/Elevation.h index 3df9a378b09..117409491de 100644 --- a/Classification/include/CGAL/Classification/Feature/Elevation.h +++ b/Classification/include/CGAL/Classification/Feature/Elevation.h @@ -97,7 +97,7 @@ public: Image_float dem(grid.width(),grid.height()); z_max = 0.f; - z_min = std::numeric_limits::max(); + z_min = (std::numeric_limits::max)(); for (std::size_t j = 0; j < grid.height(); ++ j) for (std::size_t i = 0; i < grid.width(); ++ i) @@ -109,8 +109,8 @@ public: for (typename Grid::iterator it = grid.indices_begin(i,j); it != end; ++ it) { float z = float(get(point_map, *(input.begin()+(*it))).z()); - z_min = (std::min(z_min, z)); - z_max = (std::max(z_max, z)); + z_min = ((std::min)(z_min, z)); + z_max = ((std::max)(z_max, z)); mean += z; ++ nb; } diff --git a/Classification/include/CGAL/Classification/Feature/Height_above.h b/Classification/include/CGAL/Classification/Feature/Height_above.h index f3dff5d0e0e..2beb6ad7898 100644 --- a/Classification/include/CGAL/Classification/Feature/Height_above.h +++ b/Classification/include/CGAL/Classification/Feature/Height_above.h @@ -90,13 +90,13 @@ public: for (std::size_t i = 0; i < grid.width(); ++ i) if (grid.has_points(i,j)) { - float z_max = -std::numeric_limits::max(); + float z_max = -(std::numeric_limits::max)(); typename Grid::iterator end = grid.indices_end(i,j); for (typename Grid::iterator it = grid.indices_begin(i,j); it != end; ++ it) { float z = float(get(point_map, *(input.begin()+(*it))).z()); - z_max = (std::max(z_max, z)); + z_max = ((std::max)(z_max, z)); } dtm(i,j) = z_max; diff --git a/Classification/include/CGAL/Classification/Feature/Height_below.h b/Classification/include/CGAL/Classification/Feature/Height_below.h index 8f209c1f209..0574ac5524b 100644 --- a/Classification/include/CGAL/Classification/Feature/Height_below.h +++ b/Classification/include/CGAL/Classification/Feature/Height_below.h @@ -90,13 +90,13 @@ public: for (std::size_t i = 0; i < grid.width(); ++ i) if (grid.has_points(i,j)) { - float z_min = std::numeric_limits::max(); + float z_min = (std::numeric_limits::max)(); typename Grid::iterator end = grid.indices_end(i,j); for (typename Grid::iterator it = grid.indices_begin(i,j); it != end; ++ it) { float z = float(get(point_map, *(input.begin()+(*it))).z()); - z_min = (std::min(z_min, z)); + z_min = ((std::min)(z_min, z)); } dtm(i,j) = z_min; diff --git a/Classification/include/CGAL/Classification/Feature/Vertical_range.h b/Classification/include/CGAL/Classification/Feature/Vertical_range.h index e5dacbb8aae..0780dcbee75 100644 --- a/Classification/include/CGAL/Classification/Feature/Vertical_range.h +++ b/Classification/include/CGAL/Classification/Feature/Vertical_range.h @@ -90,15 +90,15 @@ public: for (std::size_t i = 0; i < grid.width(); ++ i) if (grid.has_points(i,j)) { - float z_max = -std::numeric_limits::max(); - float z_min = std::numeric_limits::max(); + float z_max = -(std::numeric_limits::max)(); + float z_min = (std::numeric_limits::max)(); typename Grid::iterator end = grid.indices_end(i,j); for (typename Grid::iterator it = grid.indices_begin(i,j); it != end; ++ it) { float z = float(get(point_map, *(input.begin()+(*it))).z()); - z_max = (std::max(z_max, z)); - z_min = (std::min(z_min, z)); + z_max = ((std::max)(z_max, z)); + z_min = ((std::min)(z_min, z)); } dtm(i,j) = z_max - z_min; diff --git a/Classification/include/CGAL/Classification/compressed_float.h b/Classification/include/CGAL/Classification/compressed_float.h index 4e06c8dfb4f..6520f76a6ac 100644 --- a/Classification/include/CGAL/Classification/compressed_float.h +++ b/Classification/include/CGAL/Classification/compressed_float.h @@ -49,15 +49,15 @@ typedef unsigned short compressed_float; typedef unsigned char compressed_float; # endif -inline compressed_float compress_float (const float& f, const float& min = 0.f, const float& max = 1.f) +inline compressed_float compress_float (const float& f, const float& fmin = 0.f, const float& fmax = 1.f) { return static_cast - (float(std::numeric_limits::max()) * (f - min) / (max - min)); + (float((std::numeric_limits::max)()) * (f - fmin) / (fmax - fmin)); } -inline float decompress_float (const compressed_float& t, const float& min = 0.f, const float& max = 1.f) +inline float decompress_float (const compressed_float& t, const float& fmin = 0.f, const float& fmax = 1.f) { - return ((max - min) * (t / float(std::numeric_limits::max())) + min); + return ((fmax - fmin) * (t / float((std::numeric_limits::max)())) + fmin); } #endif diff --git a/Filtered_kernel/include/CGAL/internal/Static_filters/Coplanar_side_of_bounded_circle_3.h b/Filtered_kernel/include/CGAL/internal/Static_filters/Coplanar_side_of_bounded_circle_3.h index 69661b62aad..f946f334159 100644 --- a/Filtered_kernel/include/CGAL/internal/Static_filters/Coplanar_side_of_bounded_circle_3.h +++ b/Filtered_kernel/include/CGAL/internal/Static_filters/Coplanar_side_of_bounded_circle_3.h @@ -135,7 +135,7 @@ public: if (maxz < arz) maxz = arz; if (maxz < atz) maxz = atz; - double d = std::max(maxx, std::max(maxy, maxz)); + double d = (std::max)(maxx, (std::max)(maxy, maxz)); double eps = 3.27418e-11 * d * d * d * d * d * d; if (det > eps) return ON_BOUNDED_SIDE; diff --git a/Heat_method_3/examples/Heat_method_3/heat_method_surface_mesh.cpp b/Heat_method_3/examples/Heat_method_3/heat_method_surface_mesh.cpp index 99387734ff0..20555030c91 100644 --- a/Heat_method_3/examples/Heat_method_3/heat_method_surface_mesh.cpp +++ b/Heat_method_3/examples/Heat_method_3/heat_method_surface_mesh.cpp @@ -39,20 +39,20 @@ int main(int argc, char* argv[]) Point_3 sp = tm.point(source); std::cout << "source: " << sp << " " << source << std::endl; - vertex_descriptor far; + vertex_descriptor vfar; double sdistance = 0; BOOST_FOREACH(vertex_descriptor vd , vertices(tm)){ std::cout << vd << " is at distance " << get(vertex_distance, vd) << " to " << source << std::endl; if(get(vertex_distance, vd) > sdistance){ - far = vd; + vfar = vd; sdistance = get(vertex_distance, vd); } } - std::cout << "far: " << tm.point(far) << " " << far << std::endl; + std::cout << "vfar: " << tm.point(vfar) << " " << vfar << std::endl; - hm.add_source(far); + hm.add_source(vfar); hm.estimate_geodesic_distances(vertex_distance); BOOST_FOREACH(vertex_descriptor vd , vertices(tm)){ diff --git a/Heat_method_3/test/Heat_method_3/heat_method_concept.cpp b/Heat_method_3/test/Heat_method_3/heat_method_concept.cpp index 6d0380520aa..717b54a2e66 100644 --- a/Heat_method_3/test/Heat_method_3/heat_method_concept.cpp +++ b/Heat_method_3/test/Heat_method_3/heat_method_concept.cpp @@ -43,19 +43,19 @@ int main() //Point_3 sp = sm.point(source); - vertex_descriptor far; + vertex_descriptor vfar; // double sdistance = 0; BOOST_FOREACH(vertex_descriptor vd , vertices(sm)){ std::cout << vd << " is at distance " << get(heat_intensity, vd) << " from " << source << std::endl; /* if(squared_distance(sp,sm.point(vd)) > sdistance){ - far = vd; + vfar = vd; sdistance = squared_distance(sp,sm.point(vd)); } */ } - hm.add_source(far); + hm.add_source(vfar); hm.estimate_geodesic_distances(heat_intensity); BOOST_FOREACH(vertex_descriptor vd , vertices(sm)){ diff --git a/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_direct_test.cpp b/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_direct_test.cpp index 22ee8fa083c..7118e73dbbc 100644 --- a/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_direct_test.cpp +++ b/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_direct_test.cpp @@ -37,19 +37,19 @@ int main(int argc, char* argv[]) Point_3 sp = sm.point(source); std::cout << "source: " << sp << " " << source << std::endl; - vertex_descriptor far; + vertex_descriptor vfar; double sdistance = 0; BOOST_FOREACH(vertex_descriptor vd , vertices(sm)){ if(get(vertex_distance,vd) > sdistance){ - far = vd; + vfar = vd; sdistance = get(vertex_distance,vd); } } assert(sdistance > 2.9); assert(sdistance < CGAL_PI); - hm.add_source(far); + hm.add_source(vfar); assert(hm.sources().size() == 2); hm.estimate_geodesic_distances(vertex_distance); @@ -63,7 +63,7 @@ int main(int argc, char* argv[]) assert(sdistance > 1.4); assert(sdistance < CGAL_PI/2.0); - hm.remove_source(far); + hm.remove_source(vfar); assert(hm.sources().size() == 1); hm.clear_sources(); @@ -71,7 +71,7 @@ int main(int argc, char* argv[]) // add range of sources std::vector vrange; vrange.push_back(source); - vrange.push_back(far); + vrange.push_back(vfar); hm.add_sources(vrange); assert(hm.sources().size() == 2); hm.estimate_geodesic_distances(vertex_distance); diff --git a/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_test.cpp b/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_test.cpp index 2cec29f4fda..f5c53f18df3 100644 --- a/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_test.cpp +++ b/Heat_method_3/test/Heat_method_3/heat_method_surface_mesh_test.cpp @@ -37,19 +37,19 @@ int main(int argc, char* argv[]) Point_3 sp = sm.point(source); std::cout << "source: " << sp << " " << source << std::endl; - vertex_descriptor far; + vertex_descriptor vfar; double sdistance = 0; BOOST_FOREACH(vertex_descriptor vd , vertices(sm)){ if(get(vertex_distance,vd) > sdistance){ - far = vd; + vfar = vd; sdistance = get(vertex_distance,vd); } } assert(sdistance > 2.9); assert(sdistance < CGAL_PI); - hm.add_source(far); + hm.add_source(vfar); assert(hm.sources().size() == 2); hm.estimate_geodesic_distances(vertex_distance); @@ -63,7 +63,7 @@ int main(int argc, char* argv[]) assert(sdistance > 1.4); assert(sdistance < CGAL_PI/2.0); - hm.remove_source(far); + hm.remove_source(vfar); assert(hm.sources().size() == 1); hm.clear_sources(); @@ -71,7 +71,7 @@ int main(int argc, char* argv[]) // add range of sources std::vector vrange; vrange.push_back(source); - vrange.push_back(far); + vrange.push_back(vfar); hm.add_sources(vrange); assert(hm.sources().size() == 2); hm.estimate_geodesic_distances(vertex_distance); diff --git a/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/HDT2.cpp b/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/HDT2.cpp index 135d3ee7148..980f10ae422 100644 --- a/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/HDT2.cpp +++ b/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/HDT2.cpp @@ -319,7 +319,7 @@ MainWindow::on_actionInsertRandomPoints_triggered() tr("Enter number of random points"), 100, 0, - std::numeric_limits::max(), + (std::numeric_limits::max)(), 1, &ok); diff --git a/Installation/cmake/modules/config/testfiles/CGAL_CFG_NO_LIMITS.cpp b/Installation/cmake/modules/config/testfiles/CGAL_CFG_NO_LIMITS.cpp index 57fbb21aac1..2ac65ba230a 100644 --- a/Installation/cmake/modules/config/testfiles/CGAL_CFG_NO_LIMITS.cpp +++ b/Installation/cmake/modules/config/testfiles/CGAL_CFG_NO_LIMITS.cpp @@ -32,7 +32,7 @@ int main() { double d = std::numeric_limits::denorm_min(); - double e = std::numeric_limits::min(); + double e = (std::numeric_limits::min)(); // Note : denorm_min == min is actually not necessarily a bug. // So a better test should be found. if (d == 0 || d == e) diff --git a/Kernel_23/include/CGAL/Dimension.h b/Kernel_23/include/CGAL/Dimension.h index b1125b02456..d0175539977 100644 --- a/Kernel_23/include/CGAL/Dimension.h +++ b/Kernel_23/include/CGAL/Dimension.h @@ -34,7 +34,7 @@ namespace CGAL { #ifdef CGAL_EIGEN3_ENABLED const int UNKNOWN_DIMENSION=Eigen::Dynamic; #elif defined CGAL_CXX11 -const int UNKNOWN_DIMENSION=std::numeric_limits::max(); +const int UNKNOWN_DIMENSION=(std::numeric_limits::max)(); #else const int UNKNOWN_DIMENSION=(unsigned)-1/2; #endif diff --git a/Kernel_d/test/Kernel_d/Iso_box_d_with_Cartesian.cpp b/Kernel_d/test/Kernel_d/Iso_box_d_with_Cartesian.cpp index 0ea94fb0992..38b9ec62d7d 100644 --- a/Kernel_d/test/Kernel_d/Iso_box_d_with_Cartesian.cpp +++ b/Kernel_d/test/Kernel_d/Iso_box_d_with_Cartesian.cpp @@ -91,8 +91,8 @@ int main() { assert(b1.bounded_side(qq1)==CGAL::ON_BOUNDARY); assert(b1.bounded_side(qq4)==CGAL::ON_UNBOUNDED_SIDE); assert(b1.bounded_side(mm1)==CGAL::ON_BOUNDED_SIDE); - // std::cout << "b1.min()=" << b1.min() << std::endl; - // std::cout << "b1.max()=" << b1.max() << std::endl; + // std::cout << "(b1.min)()=" << (b1.min)() << std::endl; + // std::cout << "(b1.max)()=" << (b1.max)() << std::endl; std::cout << "volume of b1=" << b1.volume() << std::endl; std::cout << "volume of b4=" << b4.volume() << std::endl; std::cout << "volume of b5=" << b5.volume() << std::endl; diff --git a/Kernel_d/test/Kernel_d/Iso_box_d_with_homogeneous.cpp b/Kernel_d/test/Kernel_d/Iso_box_d_with_homogeneous.cpp index 8af8cbc3fad..8db8c7ddc7b 100644 --- a/Kernel_d/test/Kernel_d/Iso_box_d_with_homogeneous.cpp +++ b/Kernel_d/test/Kernel_d/Iso_box_d_with_homogeneous.cpp @@ -94,8 +94,8 @@ int main() { assert(b1.bounded_side(qq1)==CGAL::ON_BOUNDARY); assert(b1.bounded_side(qq4)==CGAL::ON_UNBOUNDED_SIDE); assert(b1.bounded_side(mm1)==CGAL::ON_BOUNDED_SIDE); - // std::cout << "b1.min()=" << b1.min() << std::endl; - // std::cout << "b1.max()=" << b1.max() << std::endl; + // std::cout << "(b1.min)()=" << (b1.min)() << std::endl; + // std::cout << "(b1.max)()=" << (b1.max)() << std::endl; std::cout << "volume of b1=" << b1.volume() << std::endl; std::cout << "volume of b4=" << b4.volume() << std::endl; std::cout << "volume of b5=" << b5.volume() << std::endl; diff --git a/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/IO_off.cpp b/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/IO_off.cpp index 3f77147c898..e89b6ae570f 100644 --- a/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/IO_off.cpp +++ b/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/IO_off.cpp @@ -71,7 +71,7 @@ bool read_off_ascii(Surface_mesh& mesh, // #Vertice, #Faces, #Edges items = fscanf(in, "%d %d %d\n", (int*)&nV, (int*)&nF, (int*)&nE); mesh.clear(); - mesh.reserve(nV, std::max(3*nV, nE), nF); + mesh.reserve(nV, (std::max)(3*nV, nE), nF); // read vertices: pos [normal] [color] [texcoord] @@ -186,7 +186,7 @@ bool read_off_binary(Surface_mesh& mesh, read(in, nF); read(in, nE); mesh.clear(); - mesh.reserve(nV, std::max(3*nV, nE), nF); + mesh.reserve(nV, (std::max)(3*nV, nE), nF); // read vertices: pos [normal] [color] [texcoord] diff --git a/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/Vector.h b/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/Vector.h index e35ec734e06..205b880c23d 100644 --- a/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/Vector.h +++ b/Linear_cell_complex/benchmark/Linear_cell_complex_2/surface_mesh/Vector.h @@ -223,7 +223,7 @@ public: Vector& normalize() { Scalar n = norm(*this); - if (n > std::numeric_limits::min()) + if (n > (std::numeric_limits::min)()) *this *= 1.0/n; return *this; } @@ -513,7 +513,7 @@ public: Vector& normalize() { Scalar n = norm(*this); - n = (n > std::numeric_limits::min()) ? 1.0/n : 0.0; + n = (n > (std::numeric_limits::min)()) ? 1.0/n : 0.0; x *= n; y *= n; z *= n; diff --git a/Linear_cell_complex/benchmark/Linear_cell_complex_3/cgogn_performance_3.h b/Linear_cell_complex/benchmark/Linear_cell_complex_3/cgogn_performance_3.h index b780ccd231d..fd91d3dde0a 100644 --- a/Linear_cell_complex/benchmark/Linear_cell_complex_3/cgogn_performance_3.h +++ b/Linear_cell_complex/benchmark/Linear_cell_complex_3/cgogn_performance_3.h @@ -63,7 +63,7 @@ private: Dart getShortestEdge() { - double weight = std::numeric_limits::max(); + double weight = (std::numeric_limits::max)(); Dart dart = NIL; bool boundary=false; diff --git a/Linear_cell_complex/benchmark/Linear_cell_complex_3/lcc_performance_3.h b/Linear_cell_complex/benchmark/Linear_cell_complex_3/lcc_performance_3.h index f8f7f40b876..2ec36b617d9 100644 --- a/Linear_cell_complex/benchmark/Linear_cell_complex_3/lcc_performance_3.h +++ b/Linear_cell_complex/benchmark/Linear_cell_complex_3/lcc_performance_3.h @@ -319,7 +319,7 @@ private: Dart_handle getShortestEdge() { - double weight = std::numeric_limits::max(); + double weight = (std::numeric_limits::max)(); Dart_handle dart = lcc.null_dart_handle; int m=lcc.get_new_mark(); diff --git a/Linear_cell_complex/benchmark/Linear_cell_complex_3/openvolumemesh_performance.h b/Linear_cell_complex/benchmark/Linear_cell_complex_3/openvolumemesh_performance.h index 929d9ff8313..f9a30b83476 100644 --- a/Linear_cell_complex/benchmark/Linear_cell_complex_3/openvolumemesh_performance.h +++ b/Linear_cell_complex/benchmark/Linear_cell_complex_3/openvolumemesh_performance.h @@ -129,7 +129,7 @@ private: // Find the mesh's shortest edge EdgeHandle getShortestEdge() { - double max_weight = std::numeric_limits::max(); + double max_weight = (std::numeric_limits::max)(); EdgeHandle eh = Mesh::InvalidEdgeHandle; bool boundary=false; diff --git a/Mesh_3/archive/applications/CGAL/min_dihedral_angle.h b/Mesh_3/archive/applications/CGAL/min_dihedral_angle.h index 0be12960c89..267607232b1 100644 --- a/Mesh_3/archive/applications/CGAL/min_dihedral_angle.h +++ b/Mesh_3/archive/applications/CGAL/min_dihedral_angle.h @@ -41,15 +41,15 @@ class Compute_min_angle operator()(const Cell_handle ch) const { double min_quotient = compute_quotient(ch, 0, 1, 2, 3); - min_quotient = std::min(min_quotient, + min_quotient = (std::min)(min_quotient, compute_quotient(ch, 0, 2, 1, 3)); - min_quotient = std::min(min_quotient, + min_quotient = (std::min)(min_quotient, compute_quotient(ch, 0, 3, 1, 2)); - min_quotient = std::min(min_quotient, + min_quotient = (std::min)(min_quotient, compute_quotient(ch, 1, 2, 0, 3)); - min_quotient = std::min(min_quotient, + min_quotient = (std::min)(min_quotient, compute_quotient(ch, 1, 3, 0, 2)); - min_quotient = std::min(min_quotient, + min_quotient = (std::min)(min_quotient, compute_quotient(ch, 2, 3, 0, 1)); const double volume = CGAL::to_double(tr.tetrahedron(ch).volume()); @@ -128,19 +128,19 @@ namespace CGAL { min_dihedral_angle_aux_compute_quotient(p0, p1, p2, p3, k); min_quotient = - std::min(min_quotient, + (std::min)(min_quotient, min_dihedral_angle_aux_compute_quotient(p0, p2, p1, p3, k)); min_quotient = - std::min(min_quotient, + (std::min)(min_quotient, min_dihedral_angle_aux_compute_quotient(p0, p3, p1, p2, k)); min_quotient = - std::min(min_quotient, + (std::min)(min_quotient, min_dihedral_angle_aux_compute_quotient(p1, p2, p0, p3, k)); min_quotient = - std::min(min_quotient, + (std::min)(min_quotient, min_dihedral_angle_aux_compute_quotient(p1, p3, p0, p2, k)); min_quotient = - std::min(min_quotient, + (std::min)(min_quotient, min_dihedral_angle_aux_compute_quotient(p2, p3, p0, p1, k)); // std::cerr << CGAL::sqrt(min_quotient) << " - " diff --git a/Mesh_3/include/CGAL/Mesh_3/Sizing_grid.h b/Mesh_3/include/CGAL/Mesh_3/Sizing_grid.h index f90aab595b5..ff7f36b7694 100644 --- a/Mesh_3/include/CGAL/Mesh_3/Sizing_grid.h +++ b/Mesh_3/include/CGAL/Mesh_3/Sizing_grid.h @@ -452,7 +452,7 @@ private: pNode->ref_node(candidate.ref_node()); pNode->size() = candidate.size(); pNode->done() = true; - m_max_size = std::max(m_max_size,pNode->size()); + m_max_size = (std::max)(m_max_size,pNode->size()); // explore neighbors for(unsigned int index_neighbor = 0; diff --git a/Nef_3/archive/Visual_hull/Nef_3/visual_hull_creator.h b/Nef_3/archive/Visual_hull/Nef_3/visual_hull_creator.h index 244da5108ae..857c5af1736 100644 --- a/Nef_3/archive/Visual_hull/Nef_3/visual_hull_creator.h +++ b/Nef_3/archive/Visual_hull/Nef_3/visual_hull_creator.h @@ -87,9 +87,9 @@ class visual_hull_creator : public CGAL::Modifier_base { public: - visual_hull_creator(Point_3 min, Point_3 max, Point_3 position, + visual_hull_creator(Point_3 pmin, Point_3 pmax, Point_3 position, std::list > p) : - room_min(min), room_max(max), c_pos(position), polygon_list(p) { } + room_min(pmin), room_max(pmax), c_pos(position), polygon_list(p) { } /* void recompute_scene() { diff --git a/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h b/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h index 152df61e4b3..e2cc3a6e199 100644 --- a/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h +++ b/Nef_3/include/CGAL/Nef_3/Infimaximal_box.h @@ -384,24 +384,24 @@ class Infimaximal_box { C.create_vertices_of_box_with_plane(h, b); } - static void compute_min_max(const Plane_3& h, NT orth_coords[3], int& min, int& max) { + static void compute_min_max(const Plane_3& h, NT orth_coords[3], int& cmin, int& cmax) { Vector_3 orth = h.orthogonal_vector(); orth_coords[0] = CGAL_NTS abs(orth.hx()[0]); orth_coords[1] = CGAL_NTS abs(orth.hy()[0]); orth_coords[2] = CGAL_NTS abs(orth.hz()[0]); - max = 0; + cmax = 0; if(orth_coords[1] > orth_coords[0]) - max = 1; - if(orth_coords[2] > orth_coords[max]) - max = 2; + cmax = 1; + if(orth_coords[2] > orth_coords[cmax]) + cmax = 2; - min = 0; + cmin = 0; if(orth_coords[1] < orth_coords[0]) - min = 1; - if(orth_coords[2] < orth_coords[min]) - min = 2; + cmin = 1; + if(orth_coords[2] < orth_coords[cmin]) + cmin = 2; } template diff --git a/Number_types/include/CGAL/Quotient.h b/Number_types/include/CGAL/Quotient.h index ba42b3ebf53..c46588f7567 100644 --- a/Number_types/include/CGAL/Quotient.h +++ b/Number_types/include/CGAL/Quotient.h @@ -172,7 +172,7 @@ class Quotient } #ifdef CGAL_ROOT_OF_2_ENABLE_HISTOGRAM_OF_NUMBER_OF_DIGIT_ON_THE_COMPLEX_CONSTRUCTOR - int tam() const { return std::max(num.tam(), den.tam()); } + int tam() const { return (std::max)(num.tam(), den.tam()); } #endif public: diff --git a/Periodic_3_mesh_3/include/CGAL/Periodic_3_mesh_3/IO/File_medit.h b/Periodic_3_mesh_3/include/CGAL/Periodic_3_mesh_3/IO/File_medit.h index 0c1bbb339e5..6619151c819 100644 --- a/Periodic_3_mesh_3/include/CGAL/Periodic_3_mesh_3/IO/File_medit.h +++ b/Periodic_3_mesh_3/include/CGAL/Periodic_3_mesh_3/IO/File_medit.h @@ -52,9 +52,9 @@ canonicalize_triangle(const typename Triangulation::Periodic_triangle& pt) Offset o0 = pt[0].second; Offset o1 = pt[1].second; Offset o2 = pt[2].second; - int diffx = std::min(o0.x(), std::min(o1.x(), o2.x())); - int diffy = std::min(o0.y(), std::min(o1.y(), o2.y())); - int diffz = std::min(o0.z(), std::min(o1.z(), o2.z())); + int diffx = (std::min)(o0.x(), (std::min)(o1.x(), o2.x())); + int diffy = (std::min)(o0.y(), (std::min)(o1.y(), o2.y())); + int diffz = (std::min)(o0.z(), (std::min)(o1.z(), o2.z())); Offset diff_off(diffx, diffy, diffz); return CGAL::make_array(std::make_pair(pt[0].first, o0 - diff_off), @@ -73,9 +73,9 @@ canonicalize_tetrahedron(const typename Triangulation::Periodic_tetrahedron& pt) Offset o2 = pt[2].second; Offset o3 = pt[3].second; - int diffx = std::min(std::min(o0.x(), o1.x()), std::min(o2.x(), o3.x())); - int diffy = std::min(std::min(o0.y(), o1.y()), std::min(o2.y(), o3.y())); - int diffz = std::min(std::min(o0.z(), o1.z()), std::min(o2.z(), o3.z())); + int diffx = (std::min)((std::min)(o0.x(), o1.x()), (std::min)(o2.x(), o3.x())); + int diffy = (std::min)((std::min)(o0.y(), o1.y()), (std::min)(o2.y(), o3.y())); + int diffz = (std::min)((std::min)(o0.z(), o1.z()), (std::min)(o2.z(), o3.z())); Offset diff_off(diffx, diffy, diffz); return CGAL::make_array(std::make_pair(pt[0].first, o0 - diff_off), diff --git a/Periodic_3_mesh_3/test/Periodic_3_mesh_3/test_triply_periodic_minimal_surfaces.cpp b/Periodic_3_mesh_3/test/Periodic_3_mesh_3/test_triply_periodic_minimal_surfaces.cpp index e7ff3beeacb..812fde428ba 100644 --- a/Periodic_3_mesh_3/test/Periodic_3_mesh_3/test_triply_periodic_minimal_surfaces.cpp +++ b/Periodic_3_mesh_3/test/Periodic_3_mesh_3/test_triply_periodic_minimal_surfaces.cpp @@ -184,18 +184,18 @@ struct Segments_function Segments_function() : segments(), nb_evals(0) { - const FT min = 1, max = 3; - const FT mid = 0.5 * (min + max); + const FT vmin = 1, vmax = 3; + const FT mid = 0.5 * (vmin + vmax); const Point pmid(mid, mid, mid); - segments.push_back(Segment(Point(min, mid, min), pmid)); - segments.push_back(Segment(Point(max, mid, min), pmid)); - segments.push_back(Segment(Point(min, mid, max), pmid)); - segments.push_back(Segment(Point(max, mid, max), pmid)); - segments.push_back(Segment(Point(mid, min, min), pmid)); - segments.push_back(Segment(Point(mid, max, min), pmid)); - segments.push_back(Segment(Point(mid, min, max), pmid)); - segments.push_back(Segment(Point(mid, max, max), pmid)); + segments.push_back(Segment(Point(vmin, mid, vmin), pmid)); + segments.push_back(Segment(Point(vmax, mid, vmin), pmid)); + segments.push_back(Segment(Point(vmin, mid, vmax), pmid)); + segments.push_back(Segment(Point(vmax, mid, vmax), pmid)); + segments.push_back(Segment(Point(mid, vmin, vmin), pmid)); + segments.push_back(Segment(Point(mid, vmax, vmin), pmid)); + segments.push_back(Segment(Point(mid, vmin, vmax), pmid)); + segments.push_back(Segment(Point(mid, vmax, vmax), pmid)); } FT operator()(const Point& p) @@ -204,7 +204,7 @@ struct Segments_function FT min_distance = 1000000; for (Segments::const_iterator si = segments.begin(); si != segments.end(); ++si) - min_distance = std::min(CGAL::squared_distance(p, *si), min_distance); + min_distance = (std::min)(CGAL::squared_distance(p, *si), min_distance); return min_distance - 0.01; // Change the squared beam radius here } diff --git a/Periodic_3_triangulation_3/test/Periodic_3_triangulation_3/include/CGAL/_test_periodic_3_static_filters.h b/Periodic_3_triangulation_3/test/Periodic_3_triangulation_3/include/CGAL/_test_periodic_3_static_filters.h index 2177fbf51b7..6dfb3273e4d 100644 --- a/Periodic_3_triangulation_3/test/Periodic_3_triangulation_3/include/CGAL/_test_periodic_3_static_filters.h +++ b/Periodic_3_triangulation_3/test/Periodic_3_triangulation_3/include/CGAL/_test_periodic_3_static_filters.h @@ -70,17 +70,17 @@ Point my_rand_p3() } // Random int in [0;256). -int my_rand_int(int min, int max) +int my_rand_int(int imin, int imax) { - return r->get_int(min, max+1); + return r->get_int(imin, imax+1); } // Random offset -Offset my_rand_o3(int min, int max) +Offset my_rand_o3(int imin, int imax) { - int x = my_rand_int(min,max); - int y = my_rand_int(min,max); - int z = my_rand_int(min,max); + int x = my_rand_int(imin,imax); + int y = my_rand_int(imin,imax); + int z = my_rand_int(imin,imax); return Offset(x, y, z); } diff --git a/Periodic_4_hyperbolic_triangulation_2/demo/Periodic_4_hyperbolic_triangulation_2/P4HDT2.cpp b/Periodic_4_hyperbolic_triangulation_2/demo/Periodic_4_hyperbolic_triangulation_2/P4HDT2.cpp index ffaf11c3eff..9df877ad6e0 100644 --- a/Periodic_4_hyperbolic_triangulation_2/demo/Periodic_4_hyperbolic_triangulation_2/P4HDT2.cpp +++ b/Periodic_4_hyperbolic_triangulation_2/demo/Periodic_4_hyperbolic_triangulation_2/P4HDT2.cpp @@ -351,7 +351,7 @@ MainWindow::on_actionInsertRandomPoints_triggered() tr("Enter number of random points"), 100, 0, - std::numeric_limits::max(), + (std::numeric_limits::max)(), 1, &ok); diff --git a/Periodic_4_hyperbolic_triangulation_2/include/CGAL/Periodic_4_hyperbolic_triangulation_2.h b/Periodic_4_hyperbolic_triangulation_2/include/CGAL/Periodic_4_hyperbolic_triangulation_2.h index 5590147bd85..6785c06cca6 100644 --- a/Periodic_4_hyperbolic_triangulation_2/include/CGAL/Periodic_4_hyperbolic_triangulation_2.h +++ b/Periodic_4_hyperbolic_triangulation_2/include/CGAL/Periodic_4_hyperbolic_triangulation_2.h @@ -617,15 +617,15 @@ protected: } // Now we know that all vertices lie in different regions. - Hyperbolic_translation min(7, 2, 5); + Hyperbolic_translation vmin(7, 2, 5); Hyperbolic_translation trans; for(int i=0; i<3; ++i) { int j = (i + 1) % 3; // the index of the 'next' vertex Hyperbolic_translation tmp = fh->translation(i).inverse() * fh->translation(j); - if(tmp < min) + if(tmp < vmin) { - min = tmp; + vmin = tmp; trans = fh->translation(i).inverse(); } } diff --git a/Point_set_shape_detection_3/test/Point_set_shape_detection_3/generators.h b/Point_set_shape_detection_3/test/Point_set_shape_detection_3/generators.h index 7162250c8a9..9c62844b859 100644 --- a/Point_set_shape_detection_3/test/Point_set_shape_detection_3/generators.h +++ b/Point_set_shape_detection_3/test/Point_set_shape_detection_3/generators.h @@ -10,8 +10,8 @@ template -fl_t random_float(fl_t min, fl_t max) { - return fl_t(CGAL::get_default_random().get_double(min, max)); +fl_t random_float(fl_t fmin, fl_t fmax) { + return fl_t(CGAL::get_default_random().get_double(fmin, fmax)); } template diff --git a/Polygon_mesh_processing/benchmark/Polygon_mesh_processing/polygon_mesh_slicer.cpp b/Polygon_mesh_processing/benchmark/Polygon_mesh_processing/polygon_mesh_slicer.cpp index 5a1f7298352..1815bce393c 100644 --- a/Polygon_mesh_processing/benchmark/Polygon_mesh_processing/polygon_mesh_slicer.cpp +++ b/Polygon_mesh_processing/benchmark/Polygon_mesh_processing/polygon_mesh_slicer.cpp @@ -107,9 +107,9 @@ int main(int argc, char* argv[]) t.start(); std::cerr << "bbox"<< std::endl; Iso_cuboid_3 ic = CGAL::bounding_box(points(m).begin(), points(m).end()); - Point_3 p = midpoint(ic.min(), ic.max()); - double zmin = ic.min().z(); - double zmax = ic.max().z(); + Point_3 p = midpoint((ic.min)(), (ic.max)()); + double zmin = (ic.min)().z(); + double zmax = (ic.max)().z(); double delta = (zmax - zmin)/N; std::cerr << "slicer"<< std::endl; diff --git a/Polygon_mesh_processing/include/CGAL/Polygon_mesh_processing/internal/AABB_traversal_traits_with_transformation.h b/Polygon_mesh_processing/include/CGAL/Polygon_mesh_processing/internal/AABB_traversal_traits_with_transformation.h index 818b9c038d8..f2ef71f3623 100644 --- a/Polygon_mesh_processing/include/CGAL/Polygon_mesh_processing/internal/AABB_traversal_traits_with_transformation.h +++ b/Polygon_mesh_processing/include/CGAL/Polygon_mesh_processing/internal/AABB_traversal_traits_with_transformation.h @@ -61,9 +61,9 @@ class Traversal_traits_with_transformation_helper AK::Aff_transformation_3 a_at = c2f(at); - AK::FT xtrm[6] = { c2f(bbox.min(0)), c2f(bbox.max(0)), - c2f(bbox.min(1)), c2f(bbox.max(1)), - c2f(bbox.min(2)), c2f(bbox.max(2)) }; + AK::FT xtrm[6] = { c2f((bbox.min)(0)), c2f((bbox.max)(0)), + c2f((bbox.min)(1)), c2f((bbox.max)(1)), + c2f((bbox.min)(2)), c2f((bbox.max)(2)) }; typename AK::Point_3 ps[8]; ps[0] = a_at( AK::Point_3(xtrm[0], xtrm[2], xtrm[4]) ); @@ -93,9 +93,9 @@ class Traversal_traits_with_transformation_helper AK::Aff_transformation_3 a_at = c2f(at); - AK::FT xtrm[6] = { c2f(bbox.min(0)), c2f(bbox.max(0)), - c2f(bbox.min(1)), c2f(bbox.max(1)), - c2f(bbox.min(2)), c2f(bbox.max(2)) }; + AK::FT xtrm[6] = { c2f((bbox.min)(0)), c2f((bbox.max)(0)), + c2f((bbox.min)(1)), c2f((bbox.max)(1)), + c2f((bbox.min)(2)), c2f((bbox.max)(2)) }; typename AK::Point_3 ps[2]; ps[0] = a_at( AK::Point_3(xtrm[0], xtrm[2], xtrm[4]) ); diff --git a/Polygon_mesh_processing/test/Polygon_mesh_processing/test_repair_polygon_soup.cpp b/Polygon_mesh_processing/test/Polygon_mesh_processing/test_repair_polygon_soup.cpp index eec039ec43e..dd1ac38d01a 100644 --- a/Polygon_mesh_processing/test/Polygon_mesh_processing/test_repair_polygon_soup.cpp +++ b/Polygon_mesh_processing/test/Polygon_mesh_processing/test_repair_polygon_soup.cpp @@ -19,7 +19,7 @@ typedef CGAL::Exact_predicates_inexact_constructions_kernel K; typedef K::Point_3 Point_3; typedef CGAL::Surface_mesh Mesh; -typedef std::vector Polygon; +typedef std::vector CGAL_polygon; void test_polygon_canonicalization(const bool verbose = false) { @@ -34,8 +34,8 @@ void test_polygon_canonicalization(const bool verbose = false) points.push_back(Point_3(1,1,-2)); // #5 // empty - Polygon polygon; - Polygon canonical_polygon = PMP::internal::construct_canonical_polygon(points, polygon, K()); + CGAL_polygon polygon; + CGAL_polygon canonical_polygon = PMP::internal::construct_canonical_polygon(points, polygon, K()); assert(canonical_polygon.empty()); // 1 point @@ -76,7 +76,7 @@ void test_polygon_canonicalization(const bool verbose = false) // all cyclic permutations for(std::size_t i=0, end=polygon.size(); i points; - std::vector polygons; + std::vector polygons; // empty std::size_t res = PMP::merge_duplicate_points_in_polygon_soup(points, polygons); @@ -126,7 +126,7 @@ void test_merge_duplicate_points(const bool /*verbose*/ = false) points.push_back(Point_3(1,1,0)); // #5 // identical to #2 points.push_back(Point_3(0,0,0)); // #6 // idental to #0 - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(1); polygon.push_back(2); polygons.push_back(polygon); @@ -146,7 +146,7 @@ void test_merge_duplicate_points(const bool /*verbose*/ = false) for(std::size_t i=0, psn=polygons.size(); i points; - std::vector polygons; + std::vector polygons; points.push_back(Point_3(0,0,0)); // #0 points.push_back(Point_3(1,0,0)); // #1 @@ -180,7 +180,7 @@ void test_merge_duplicate_polygons(const bool /*verbose*/ = false) // ------------------------------------------------------- // 1 polygon - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(1); polygon.push_back(2); polygons.push_back(polygon); @@ -257,7 +257,7 @@ void test_merge_duplicate_polygons(const bool /*verbose*/ = false) assert(all_duplicate_polygons[0].size() == 2 && all_duplicate_polygons[1].size() == 3); // Keep one for each duplicate - std::vector polygons_copy(polygons); + std::vector polygons_copy(polygons); res = PMP::merge_duplicate_polygons_in_polygon_soup(points, polygons_copy, params::all_default()); assert(res == 3 && polygons_copy.size() == 3); @@ -281,7 +281,7 @@ void test_simplify_polygons(const bool /*verbose*/ = false) std::cout << "test simplify_polygons... " << std::endl; std::vector points; - std::vector polygons; + std::vector polygons; points.push_back(Point_3(0,0,0)); // #0 points.push_back(Point_3(1,2,0)); // #1 @@ -292,7 +292,7 @@ void test_simplify_polygons(const bool /*verbose*/ = false) points.push_back(Point_3(0,0,0)); // #6 // ------ - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(2); polygon.push_back(4); polygons.push_back(polygon); @@ -355,13 +355,13 @@ void test_remove_invalid_polygons(const bool /*verbose*/ = false) // points are not actually needed since only the size of the polygons is considered std::vector points; - std::vector polygons; + std::vector polygons; std::size_t res = PMP::internal::remove_invalid_polygons_in_polygon_soup(points, polygons); assert(res == 0 && polygons.size() == 0); // non-trivial polygon - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(2); polygon.push_back(4); polygons.push_back(polygon); @@ -431,7 +431,7 @@ void test_remove_isolated_points(const bool verbose = false) std::cout << "test remove_isolated_points... " << std::endl; std::vector points; - std::vector polygons; + std::vector polygons; // everything empty std::size_t res = test_remove_isolated_points_data_set(points, polygons, verbose); @@ -449,7 +449,7 @@ void test_remove_isolated_points(const bool verbose = false) res = test_remove_isolated_points_data_set(points_copy, polygons, verbose); assert(res == 6 && points_copy.empty() && polygons.empty()); - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(2); polygon.push_back(4); polygons.push_back(polygon); @@ -467,7 +467,7 @@ void test_slit_pinched_polygons(const bool /*verbose*/ = false) std::cout << "test split_pinched_polygons... " << std::endl; std::vector points; - std::vector polygons; + std::vector polygons; // everything empty std::size_t res = PMP::internal::split_pinched_polygons_in_polygon_soup(points, polygons); @@ -481,7 +481,7 @@ void test_slit_pinched_polygons(const bool /*verbose*/ = false) points.push_back(Point_3(1,1,0)); // #5 // no pinch - Polygon polygon; + CGAL_polygon polygon; polygon.push_back(0); polygon.push_back(2); polygon.push_back(4); polygons.push_back(polygon); diff --git a/Polyhedron/demo/Polyhedron/MainWindow.cpp b/Polyhedron/demo/Polyhedron/MainWindow.cpp index f02434647b5..5bc7025933b 100644 --- a/Polyhedron/demo/Polyhedron/MainWindow.cpp +++ b/Polyhedron/demo/Polyhedron/MainWindow.cpp @@ -965,7 +965,6 @@ void MainWindow::updateViewerBBox(bool recenter = true) for(int i=0; i<3; ++i) { offset[i] = -bbox_center[i]; - } if(offset != viewer->offset()) { diff --git a/Polyhedron/demo/Polyhedron/Plugins/AABB_tree/Do_trees_intersect_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/AABB_tree/Do_trees_intersect_plugin.cpp index b1b325c12e4..59ce040ba4e 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/AABB_tree/Do_trees_intersect_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/AABB_tree/Do_trees_intersect_plugin.cpp @@ -103,9 +103,9 @@ private Q_SLOTS: connect(item, &Scene_surface_mesh_item::aboutToBeDestroyed, this, &DoTreesIntersectplugin::cleanup); - CGAL::qglviewer::Vec pos((item->bbox().min(0) + item->bbox().max(0))/2.0, - (item->bbox().min(1) + item->bbox().max(1))/2.0, - (item->bbox().min(2) + item->bbox().max(2))/2.0); + CGAL::qglviewer::Vec pos(((item->bbox().min)(0) + (item->bbox().max)(0))/2.0, + ((item->bbox().min)(1) + (item->bbox().max)(1))/2.0, + ((item->bbox().min)(2) + (item->bbox().max)(2))/2.0); Scene_movable_sm_item* mov_item = new Scene_movable_sm_item(pos,item->face_graph(),""); connect(mov_item->manipulatedFrame(), &CGAL::qglviewer::ManipulatedFrame::modified, diff --git a/Polyhedron/demo/Polyhedron/Plugins/Classification/Cluster_classification.cpp b/Polyhedron/demo/Polyhedron/Plugins/Classification/Cluster_classification.cpp index 42102db77fa..3f77fe4efff 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Classification/Cluster_classification.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Classification/Cluster_classification.cpp @@ -527,7 +527,7 @@ void Cluster_classification::change_color (int index, float* vmin, float* vmax) int cid = m_cluster_id[*it]; if (cid != -1) { - float v = std::max (0.f, std::min(1.f, m_label_probabilities[corrected_index][cid])); + float v = std::max (0.f, (std::min)(1.f, m_label_probabilities[corrected_index][cid])); m_points->point_set()->set_color(*it, ramp.r(v) * 255, ramp.g(v) * 255, ramp.b(v) * 255); } else @@ -546,8 +546,8 @@ void Cluster_classification::change_color (int index, float* vmin, float* vmax) Feature_handle feature = m_features[corrected_index]; - float min = std::numeric_limits::max(); - float max = -std::numeric_limits::max(); + float min = (std::numeric_limits::max)(); + float max = -(std::numeric_limits::max)(); if (vmin != NULL && vmax != NULL && *vmin != std::numeric_limits::infinity() diff --git a/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.cpp b/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.cpp index 2d1d0e007f7..fb9f5d9e75f 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.cpp @@ -429,7 +429,7 @@ void Point_set_item_classification::change_color (int index, float* vmin, float* for (Point_set::const_iterator it = m_points->point_set()->begin(); it != m_points->point_set()->first_selected(); ++ it) { - float v = std::max (0.f, std::min(1.f, m_label_probabilities[corrected_index][*it])); + float v = (std::max)(0.f, (std::min)(1.f, m_label_probabilities[corrected_index][*it])); m_points->point_set()->set_color(*it, ramp.r(v) * 255, ramp.g(v) * 255, ramp.b(v) * 255); } } @@ -444,8 +444,8 @@ void Point_set_item_classification::change_color (int index, float* vmin, float* } Feature_handle feature = m_features[corrected_index]; - float min = std::numeric_limits::max(); - float max = -std::numeric_limits::max(); + float min = (std::numeric_limits::max)(); + float max = -(std::numeric_limits::max)(); if (vmin != NULL && vmax != NULL && *vmin != std::numeric_limits::infinity() diff --git a/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.h b/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.h index 4811a071c58..03b470278b2 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.h +++ b/Polyhedron/demo/Polyhedron/Plugins/Classification/Point_set_item_classification.h @@ -125,8 +125,8 @@ class Point_set_item_classification : public Item_classification_base for (std::size_t i = 0; i < m_features.size(); ++ i) { - float vmin = std::numeric_limits::max(); - float vmax = -std::numeric_limits::max(); + float vmin = (std::numeric_limits::max)(); + float vmax = -(std::numeric_limits::max)(); float vmean = 0.f; std::size_t nb = 0; diff --git a/Polyhedron/demo/Polyhedron/Plugins/Classification/Surface_mesh_item_classification.cpp b/Polyhedron/demo/Polyhedron/Plugins/Classification/Surface_mesh_item_classification.cpp index 8ce32e699cd..1d033c02fdb 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Classification/Surface_mesh_item_classification.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Classification/Surface_mesh_item_classification.cpp @@ -151,7 +151,7 @@ void Surface_mesh_item_classification::change_color (int index, float* vmin, flo { BOOST_FOREACH(face_descriptor fd, faces(*(m_mesh->polyhedron()))) { - float v = std::max (0.f, std::min(1.f, m_label_probabilities[corrected_index][fd])); + float v = std::max (0.f, (std::min)(1.f, m_label_probabilities[corrected_index][fd])); m_color[fd] = CGAL::Color((unsigned char)(ramp.r(v) * 255), (unsigned char)(ramp.g(v) * 255), (unsigned char)(ramp.b(v) * 255)); @@ -169,8 +169,8 @@ void Surface_mesh_item_classification::change_color (int index, float* vmin, flo Feature_handle feature = m_features[corrected_index]; - float min = std::numeric_limits::max(); - float max = -std::numeric_limits::max(); + float min = (std::numeric_limits::max)(); + float max = -(std::numeric_limits::max)(); if (vmin != NULL && vmax != NULL && *vmin != std::numeric_limits::infinity() diff --git a/Polyhedron/demo/Polyhedron/Plugins/PCA/Affine_transform_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/PCA/Affine_transform_plugin.cpp index 9c8e074aebf..d65db7c9dd9 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/PCA/Affine_transform_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/PCA/Affine_transform_plugin.cpp @@ -407,12 +407,12 @@ void Polyhedron_demo_affine_transform_plugin::grid() Scene_item::Bbox b = item->bbox(); - double x_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3(b.min(0), b.min(1), b.min(2)), - Kernel::Point_3(b.max(0), b.min(1), b.min(2))))), - y_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3(b.min(0), b.min(1), b.min(2)), - Kernel::Point_3(b.min(0), b.max(1), b.min(2))))), - z_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3(b.min(0), b.min(1), b.min(2)), - Kernel::Point_3(b.min(0), b.min(1), b.max(2))))); + double x_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3((b.min)(0), (b.min)(1), (b.min)(2)), + Kernel::Point_3((b.max)(0), (b.min)(1), (b.min)(2))))), + y_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3((b.min)(0), (b.min)(1), (b.min)(2)), + Kernel::Point_3((b.min)(0), (b.max)(1), (b.min)(2))))), + z_t(CGAL::sqrt(CGAL::squared_distance(Kernel::Point_3((b.min)(0), (b.min)(1), (b.min)(2)), + Kernel::Point_3((b.min)(0), (b.min)(1), (b.max)(2))))); GridDialog dialog(mw); dialog.x_space_doubleSpinBox->setValue(x_t); diff --git a/Polyhedron/demo/Polyhedron/Plugins/PCA/Create_bbox_mesh_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/PCA/Create_bbox_mesh_plugin.cpp index 57b23a66f33..13bf84315e3 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/PCA/Create_bbox_mesh_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/PCA/Create_bbox_mesh_plugin.cpp @@ -116,9 +116,9 @@ bool Create_bbox_mesh_plugin::bbox(bool extended) bbox.zmax() + delta_z); } - if(bbox.min(0) > bbox.max(0) || - bbox.min(1) > bbox.max(1) || - bbox.min(2) > bbox.max(2)) + if((bbox.min)(0) > (bbox.max)(0) || + (bbox.min)(1) > (bbox.max)(1) || + (bbox.min)(2) > (bbox.max)(2)) { return false; } diff --git a/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_edit_box_item.cpp b/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_edit_box_item.cpp index 8f391dd1213..94ff02436e1 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_edit_box_item.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_edit_box_item.cpp @@ -540,16 +540,15 @@ void Scene_edit_box_item::compute_bbox() const const CGAL::qglviewer::Vec offset = static_cast(CGAL::QGLViewer::QGLViewerPool().first())->offset(); - QVector3D min(d->pool[0], d->pool[1], d->pool[2]); - QVector3D max(d->pool[3], d->pool[4], d->pool[5]); + QVector3D vmin(d->pool[0], d->pool[1], d->pool[2]); + QVector3D vmax(d->pool[3], d->pool[4], d->pool[5]); for(int i=0; i< 3; ++i) { - min[i] += d->frame->translation()[i]-d->center_[i]-offset[i]; - max[i] += d->frame->translation()[i]-d->center_[i]-offset[i]; + vmin[i] += d->frame->translation()[i]-d->center_[i]-offset[i]; + vmax[i] += d->frame->translation()[i]-d->center_[i]-offset[i]; } - - _bbox = Scene_item::Bbox(min.x(),min.y(),min.z(),max.x(),max.y(),max.z()); + _bbox = Scene_item::Bbox(vmin.x(),vmin.y(),vmin.z(),vmax.x(),vmax.y(),vmax.z()); } diff --git a/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_facegraph_transform_item.cpp b/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_facegraph_transform_item.cpp index 8c29c867b57..13a253bfa1a 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_facegraph_transform_item.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/PCA/Scene_facegraph_transform_item.cpp @@ -150,10 +150,10 @@ Scene_facegraph_transform_item::compute_bbox() const { ++it) { bbox = bbox + get(vpmap, *it).bbox(); } - CGAL::qglviewer::Vec min(bbox.xmin(),bbox.ymin(),bbox.zmin()); - CGAL::qglviewer::Vec max(bbox.xmax(),bbox.ymax(),bbox.zmax()); - _bbox = Bbox(min.x,min.y,min.z, - max.x,max.y,max.z); + CGAL::qglviewer::Vec vmin(bbox.xmin(),bbox.ymin(),bbox.zmin()); + CGAL::qglviewer::Vec vmax(bbox.xmax(),bbox.ymax(),bbox.zmax()); + _bbox = Bbox(vmin.x,vmin.y,vmin.z, + vmax.x,vmax.y,vmax.z); } diff --git a/Polyhedron/demo/Polyhedron/Plugins/PMP/Engrave_text_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/PMP/Engrave_text_plugin.cpp index 27412ec9cb4..783f321416b 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/PMP/Engrave_text_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/PMP/Engrave_text_plugin.cpp @@ -485,10 +485,10 @@ public Q_SLOTS: } std::cout << "Parameterized with ARAP (SM) computed." << std::endl; - xmin = std::numeric_limits::max(); - xmax = std::numeric_limits::min(); - ymin = std::numeric_limits::max(); - ymax = std::numeric_limits::min(); + xmin = (std::numeric_limits::max)(); + xmax = (std::numeric_limits::min)(); + ymin = (std::numeric_limits::max)(); + ymax = (std::numeric_limits::min)(); uv_map_3 = sm->add_property_map("v:uv3").first; for(SMesh::Vertex_index v : sm->vertices()) diff --git a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_segmentation_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_segmentation_plugin.cpp index 4d2a8197bb2..54725385fd4 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_segmentation_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_segmentation_plugin.cpp @@ -306,7 +306,7 @@ void Polyhedron_demo_mesh_segmentation_plugin::apply_Partition_button_clicked(Fa faces(*pair->first->face_graph())) { if(sdf_pmap[f] != -1 - && sdf_pmap[f] != std::numeric_limits::max()) + && sdf_pmap[f] != (std::numeric_limits::max)()) { has_sdf_values = true; break; diff --git a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_simplification_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_simplification_plugin.cpp index 4fbef08e1cc..94b2278a79a 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_simplification_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Mesh_simplification_plugin.cpp @@ -150,7 +150,7 @@ void Polyhedron_demo_mesh_simplification_plugin::on_actionSimplify_triggered() : 0), (ui.m_use_edge_length->isChecked() ? ui.m_edge_length->value() - : std::numeric_limits::max())); + : (std::numeric_limits::max)())); if (selection_item) { diff --git a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Parameterization_plugin.cpp b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Parameterization_plugin.cpp index d565ed23cd3..edb9cbca364 100644 --- a/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Parameterization_plugin.cpp +++ b/Polyhedron/demo/Polyhedron/Plugins/Surface_mesh/Parameterization_plugin.cpp @@ -899,7 +899,7 @@ void Polyhedron_demo_parameterization_plugin::parameterize(const Parameterizatio } //end for each component QApplication::restoreOverrideCursor(); - QPointF min(FLT_MAX, FLT_MAX), max(-FLT_MAX, -FLT_MAX); + QPointF pmin(FLT_MAX, FLT_MAX), pmax(-FLT_MAX, -FLT_MAX); SMesh::Property_map > uv; uv = tMesh.add_property_map >("h:uv",std::make_pair(0.0f,0.0f)).first; @@ -912,14 +912,14 @@ void Polyhedron_demo_parameterization_plugin::parameterize(const Parameterizatio FT u = uv_pm[target(hd, sMesh)].x(); FT v = uv_pm[target(hd, sMesh)].y(); put(uv, *it, std::make_pair(static_cast(u),static_cast(v))); - if(umax.x()) - max.setX(u); - if(vmax.y()) - max.setY(v); + if(upmax.x()) + pmax.setX(u); + if(vpmax.y()) + pmax.setY(v); } Components* components = new Components(0); @@ -934,7 +934,7 @@ void Polyhedron_demo_parameterization_plugin::parameterize(const Parameterizatio } Scene_textured_facegraph_item* new_item = new Scene_textured_facegraph_item(tMesh); - UVItem *projection = new UVItem(components,new_item->textured_face_graph(), uv_borders, QRectF(min, max)); + UVItem *projection = new UVItem(components,new_item->textured_face_graph(), uv_borders, QRectF(pmin, pmax)); projection->set_item_name(new_item_name); new_item->setName(new_item_name); diff --git a/Polyhedron/demo/Polyhedron/Scene_c3t3_item.cpp b/Polyhedron/demo/Polyhedron/Scene_c3t3_item.cpp index ce32dc1aa98..d2c0f2de15e 100644 --- a/Polyhedron/demo/Polyhedron/Scene_c3t3_item.cpp +++ b/Polyhedron/demo/Polyhedron/Scene_c3t3_item.cpp @@ -438,10 +438,10 @@ struct Scene_c3t3_item_priv { void invalidate_stats() { - min_edges_length = std::numeric_limits::max(); + min_edges_length = (std::numeric_limits::max)(); max_edges_length = 0; mean_edges_length = 0; - min_dihedral_angle = std::numeric_limits::max(); + min_dihedral_angle = (std::numeric_limits::max)(); max_dihedral_angle = 0; mean_dihedral_angle = 0; nb_subdomains = 0; @@ -449,8 +449,8 @@ struct Scene_c3t3_item_priv { nb_cnc = 0; nb_vertices = 0; nb_tets = 0; - smallest_radius_radius = std::numeric_limits::max(); - smallest_edge_radius = std::numeric_limits::max(); + smallest_radius_radius = (std::numeric_limits::max)(); + smallest_edge_radius = (std::numeric_limits::max)(); biggest_v_sma_cube = 0; computed_stats = false; } diff --git a/Polyhedron/demo/Polyhedron/Scene_polylines_item.cpp b/Polyhedron/demo/Polyhedron/Scene_polylines_item.cpp index f2f21725831..36a9105b21c 100644 --- a/Polyhedron/demo/Polyhedron/Scene_polylines_item.cpp +++ b/Polyhedron/demo/Polyhedron/Scene_polylines_item.cpp @@ -30,7 +30,7 @@ struct Scene_polylines_item_private { { nb_vertices = 0; nb_edges = 0; - min_length = std::numeric_limits::max(); + min_length = (std::numeric_limits::max)(); max_length = 0; mean_length = 0; computed_stats = false; diff --git a/Polynomial/include/CGAL/Polynomial/bezout_matrix.h b/Polynomial/include/CGAL/Polynomial/bezout_matrix.h index 1c2528cee90..4105a0a9cf3 100644 --- a/Polynomial/include/CGAL/Polynomial/bezout_matrix.h +++ b/Polynomial/include/CGAL/Polynomial/bezout_matrix.h @@ -118,8 +118,8 @@ hybrid_bezout_matrix(typename Polynomial_traits_d::Polynomial_d f, B[i-sub-1][j-1] = s; } } - for (i = std::max(m+1, 1+sub); i <= n; i++) { - for (j = i-m; j <= std::min(i, n-sub); j++) { + for (i = (std::max)(m+1, 1+sub); i <= n; i++) { + for (j = i-m; j <= (std::min)(i, n-sub); j++) { B[i-sub-1][j-1] = coeff(g,i-j); } } diff --git a/Straight_skeleton_2/include/CGAL/Straight_skeleton_2/test.h b/Straight_skeleton_2/include/CGAL/Straight_skeleton_2/test.h index f0aa2dffea5..d6da26057a6 100644 --- a/Straight_skeleton_2/include/CGAL/Straight_skeleton_2/test.h +++ b/Straight_skeleton_2/include/CGAL/Straight_skeleton_2/test.h @@ -146,8 +146,8 @@ inline bool is_time_clearly_not_within_possibly_inexact_bisector_time_interval( { FT lSrcT = aBisector->opposite()->vertex()->time() ; FT lTgtT = aBisector->vertex()->time() ; - FT lLoT = std::min(lSrcT,lTgtT); - FT lHiT = std::max(lSrcT,lTgtT); + FT lLoT = (std::min)(lSrcT,lTgtT); + FT lHiT = (std::max)(lSrcT,lTgtT); return ( aT < lLoT || aT > lHiT ) && is_possibly_inexact_time_clearly_not_equal_to(aT,lLoT) @@ -159,8 +159,8 @@ inline bool is_time_clearly_within_possibly_inexact_bisector_time_interval( FT c { FT lSrcT = aBisector->opposite()->vertex()->time() ; FT lTgtT = aBisector->vertex()->time() ; - FT lLoT = std::min(lSrcT,lTgtT); - FT lHiT = std::max(lSrcT,lTgtT); + FT lLoT = (std::min)(lSrcT,lTgtT); + FT lHiT = (std::max)(lSrcT,lTgtT); return ( lLoT < aT && aT < lHiT ) && is_possibly_inexact_time_clearly_not_equal_to(aT,lLoT) diff --git a/Surface_mesh/include/CGAL/Surface_mesh/Properties.h b/Surface_mesh/include/CGAL/Surface_mesh/Properties.h index b3733031b9a..38d209f78a1 100644 --- a/Surface_mesh/include/CGAL/Surface_mesh/Properties.h +++ b/Surface_mesh/include/CGAL/Surface_mesh/Properties.h @@ -449,7 +449,7 @@ public: { for (std::size_t i=0; ireserve(n); - capacity_ = std::max(n, capacity_); + capacity_ = (std::max)(n, capacity_); } // resize all arrays to size n @@ -474,7 +474,7 @@ public: for (std::size_t i=0; ipush_back(); ++size_; - capacity_ = (std::max(size_, capacity_)); + capacity_ = ((std::max)(size_, capacity_)); } // reset element to its default property values diff --git a/Surface_mesh/include/CGAL/Surface_mesh/Surface_mesh.h b/Surface_mesh/include/CGAL/Surface_mesh/Surface_mesh.h index 395312d7e3d..80d6d49f318 100644 --- a/Surface_mesh/include/CGAL/Surface_mesh/Surface_mesh.h +++ b/Surface_mesh/include/CGAL/Surface_mesh/Surface_mesh.h @@ -74,17 +74,17 @@ namespace CGAL { typedef boost::uint32_t size_type; /// Constructor. %Default construction creates an invalid index. /// We write -1, which is - /// std::numeric_limits::max() + /// (std::numeric_limits::max)() /// as `size_type` is an unsigned type. explicit SM_Index(size_type _idx=(std::numeric_limits::max)()) : idx_(_idx) {} /// Get the underlying index of this index operator size_type() const { return idx_; } - /// reset index to be invalid (index=std::numeric_limits::max()) + /// reset index to be invalid (index=(std::numeric_limits::max)()) void reset() { idx_=(std::numeric_limits::max)(); } - /// return whether the index is valid, i.e., the index is not equal to `%std::numeric_limits::max()`. + /// return whether the index is valid, i.e., the index is not equal to `%(std::numeric_limits::max)()`. bool is_valid() const { size_type inf = (std::numeric_limits::max)(); return idx_ != inf; @@ -222,10 +222,10 @@ namespace CGAL { // compatibility with OpenMesh handles size_type idx() const { return (size_type)halfedge_ / 2; } - // resets index to be invalid (index=std::numeric_limits::max()) + // resets index to be invalid (index=(std::numeric_limits::max)()) void reset() { halfedge_.reset(); } - // returns whether the index is valid, i.e., the index is not equal to std::numeric_limits::max(). + // returns whether the index is valid, i.e., the index is not equal to (std::numeric_limits::max)(). bool is_valid() const { return halfedge_.is_valid(); } // Are two indices equal? diff --git a/Surface_mesh_approximation/include/CGAL/Variational_shape_approximation.h b/Surface_mesh_approximation/include/CGAL/Variational_shape_approximation.h index 6dd715ff50a..9b2be7c7ac8 100644 --- a/Surface_mesh_approximation/include/CGAL/Variational_shape_approximation.h +++ b/Surface_mesh_approximation/include/CGAL/Variational_shape_approximation.h @@ -64,7 +64,7 @@ #include #endif -#define CGAL_VSA_INVALID_TAG std::numeric_limits::max() +#define CGAL_VSA_INVALID_TAG (std::numeric_limits::max)() namespace CGAL { diff --git a/Surface_mesh_shortest_path/benchmark/Surface_mesh_shortest_path/benchmark_shortest_paths.cpp b/Surface_mesh_shortest_path/benchmark/Surface_mesh_shortest_path/benchmark_shortest_paths.cpp index 00465148257..412d7ed844f 100644 --- a/Surface_mesh_shortest_path/benchmark/Surface_mesh_shortest_path/benchmark_shortest_paths.cpp +++ b/Surface_mesh_shortest_path/benchmark/Surface_mesh_shortest_path/benchmark_shortest_paths.cpp @@ -99,8 +99,8 @@ public: } else { - m_minimum = std::min(m_minimum, sample); - m_maximum = std::max(m_maximum, sample); + m_minimum = (std::min)(m_minimum, sample); + m_maximum = (std::max)(m_maximum, sample); } m_sum += sample; ++m_numSamples; @@ -227,7 +227,7 @@ void run_benchmarks(CGAL::Random& rand, size_t numTrials, size_t numSources, siz outData.constructionTime.add_sample(elapsed.wall); #if !defined(NDEBUG) - outData.peakMemoryUsage.add_sample(std::max(shortestPaths.peak_memory_usage(), shortestPaths.current_memory_usage())); + outData.peakMemoryUsage.add_sample((std::max)(shortestPaths.peak_memory_usage(), shortestPaths.current_memory_usage())); #endif for (size_t j = 0; j < numQueries; ++j) @@ -333,4 +333,4 @@ int main(int argc, char* argv[]) } return EXIT_SUCCESS; -} \ No newline at end of file +} diff --git a/Surface_mesh_shortest_path/include/CGAL/Surface_mesh_shortest_path/Surface_mesh_shortest_path.h b/Surface_mesh_shortest_path/include/CGAL/Surface_mesh_shortest_path/Surface_mesh_shortest_path.h index 4b7f8cb5d3d..6fc2b2567d7 100644 --- a/Surface_mesh_shortest_path/include/CGAL/Surface_mesh_shortest_path/Surface_mesh_shortest_path.h +++ b/Surface_mesh_shortest_path/include/CGAL/Surface_mesh_shortest_path/Surface_mesh_shortest_path.h @@ -422,7 +422,7 @@ public: + (sizeof(Cone_expansion_event) + (sizeof(Cone_expansion_event*)) * m_peakQueueSize) + (sizeof(Cone_tree_node) * m_nodesAtPeakQueue); - return std::max(peakNodeUsage, peakQueueUsage); + return (std::max)(peakNodeUsage, peakQueueUsage); } /// \endcond diff --git a/Surface_mesher/archive/include/CGAL/enriched_polyhedron.h b/Surface_mesher/archive/include/CGAL/enriched_polyhedron.h index 2025d1a503f..52da4bec21c 100644 --- a/Surface_mesher/archive/include/CGAL/enriched_polyhedron.h +++ b/Surface_mesher/archive/include/CGAL/enriched_polyhedron.h @@ -332,13 +332,13 @@ public : { const Point& p = pVertex->point(); - xmin = std::min(xmin,p.x()); - ymin = std::min(ymin,p.y()); - zmin = std::min(zmin,p.z()); + xmin = (std::min)(xmin,p.x()); + ymin = (std::min)(ymin,p.y()); + zmin = (std::min)(zmin,p.z()); - xmax = std::max(xmax,p.x()); - ymax = std::max(ymax,p.y()); - zmax = std::max(zmax,p.z()); + xmax = (std::max)(xmax,p.x()); + ymax = (std::max)(ymax,p.y()); + zmax = (std::max)(zmax,p.z()); } m_bbox = Iso_cuboid(xmin,ymin,zmin, xmax,ymax,zmax); diff --git a/Surface_mesher/include/CGAL/vtkSurfaceMesherContourFilter.h b/Surface_mesher/include/CGAL/vtkSurfaceMesherContourFilter.h index e4c04b534ca..c14fe6789b7 100644 --- a/Surface_mesher/include/CGAL/vtkSurfaceMesherContourFilter.h +++ b/Surface_mesher/include/CGAL/vtkSurfaceMesherContourFilter.h @@ -139,8 +139,8 @@ int vtkCGALSurfaceMesherContourFilter::RequestData( return 0; Gray_level_image gray_level_image(image, Value); - GT::FT radius = std::max(image.xdim() * image.vx(), - std::max(image.ydim() * image.vy(), + GT::FT radius = (std::max)(image.xdim() * image.vx(), + (std::max)(image.ydim() * image.vy(), image.zdim() * image.vz()) ); GT::Sphere_3 bounding_sphere(GT::Point_3(image.xdim() * image.vx()/2., diff --git a/Triangulation/include/CGAL/internal/Combination_enumerator.h b/Triangulation/include/CGAL/internal/Combination_enumerator.h index c949e8e66ad..e8598410d50 100644 --- a/Triangulation/include/CGAL/internal/Combination_enumerator.h +++ b/Triangulation/include/CGAL/internal/Combination_enumerator.h @@ -46,11 +46,11 @@ public: // For generating all the combinations of |k| distinct elements in the // interval [min, max] (both included) - Combination_enumerator(const int k, const int min, const int max) - : combi_(k), k_(k), min_(min), max_(max), max_at_pos_0_(max + 1 - k) + Combination_enumerator(const int k, const int imin, const int imax) + : combi_(k), k_(k), min_(imin), max_(imax), max_at_pos_0_(imax + 1 - k) { - CGAL_assertion_msg( min <= max, "min is larger than max"); - CGAL_assertion_msg( 1 <= k && k <= ( max - min + 1 ), "wrong value of k"); + CGAL_assertion_msg( imin <= imax, "min is larger than max"); + CGAL_assertion_msg( 1 <= k && k <= ( imax - imin + 1 ), "wrong value of k"); init(); }