]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Replaced std::min(b, std::max(x,a)) by std::clamp(x, a, b). 18256/head
authorXiaoming Cao <cax@ad.unc.edu>
Sun, 22 Dec 2024 18:13:27 +0000 (13:13 -0500)
committerXiaoming Cao <cax@ad.unc.edu>
Tue, 18 Mar 2025 20:50:34 +0000 (16:50 -0400)
Amended issue #17722 from suggestions.

Patched Clamp semicolon issue.

fixed switched lo, hi, in std::clamp(v, lo, hi)

Replace std::clamp with max(min()) for special case.

Replaced std::min(b, std::max(x,a)) by std::clamp(x, a, b).

Amended issue #17722 from suggestions.

Patched Clamp semicolon issue.

fixed switched lo, hi, in std::clamp(v, lo, hi)

Replace std::clamp with max(min()) for special case.

patched proccess_grid.cc
patched proccess_grid.cc

examples/step-21/step-21.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-79/step-79.cc
include/deal.II/base/geometry_info.h
source/base/function_lib.cc
source/base/function_signed_distance.cc
source/base/process_grid.cc

index 6dfcb06fb72514a7ef84f5a573292b3f9706c14e..2bd5406143d22c96da2a71ddaecc960e7989b68e 100644 (file)
@@ -343,7 +343,7 @@ namespace Step21
                                        (0.05 * 0.05));
 
             const double normalized_permeability =
-              std::min(std::max(permeability, 0.01), 4.);
+              std::clamp(permeability, 0.01, 4.);
 
             for (unsigned int d = 0; d < dim; ++d)
               values[p][d][d] = 1. / normalized_permeability;
index 5c49b038b3f2e725c3c15020d69542728c9705e2..1866f46475c121d1cae1019e69418f3c6e51c54a 100644 (file)
@@ -492,11 +492,11 @@ namespace Step42
     template <int dim>
     double BitmapFile<dim>::get_value(const double x, const double y) const
     {
-      const int ix = std::min(std::max(static_cast<int>(x / hx), 0), nx - 2);
-      const int iy = std::min(std::max(static_cast<int>(y / hy), 0), ny - 2);
+      const int ix = std::clamp(static_cast<int>(x / hx), 0, nx - 2);
+      const int iy = std::clamp(static_cast<int>(y / hy), 0, ny - 2);
 
-      const double xi  = std::min(std::max((x - ix * hx) / hx, 1.), 0.);
-      const double eta = std::min(std::max((y - iy * hy) / hy, 1.), 0.);
+      const double xi  = std::clamp((x - ix * hx) / hx, 0., 1.);
+      const double eta = std::clamp((y - iy * hy) / hy, 0., 1.);
 
       return ((1 - xi) * (1 - eta) * get_pixel_value(ix, iy) +
               xi * (1 - eta) * get_pixel_value(ix + 1, iy) +
index e3babd3dc3538a62439b68ea2851d5f895327638..6e20db98671322a75cd6a3d9b035d9787f96a258 100644 (file)
@@ -254,7 +254,7 @@ namespace Step43
               std::exp(-(points[p] - centers[i]).norm_square() / (0.05 * 0.05));
 
           const double normalized_permeability =
-            std::min(std::max(permeability, 0.01), 4.);
+            std::clamp(permeability, 0.01, 4.);
 
           for (unsigned int d = 0; d < dim; ++d)
             values[p][d][d] = 1. / normalized_permeability;
index 59969e61a003052ca9ca815f086a5470da36d6b9..1e3125e52d1963b33406c8ab04293b69224d6538 100644 (file)
@@ -2420,9 +2420,9 @@ namespace SAND
         const double barrier_size_exponent   = 1.2;
 
         barrier_size =
-          std::max(std::min(barrier_size * barrier_size_multiplier,
-                            std::pow(barrier_size, barrier_size_exponent)),
-                   min_barrier_size);
+          std::clamp(barrier_size * barrier_size_multiplier,
+                     min_barrier_size,
+                     std::pow(barrier_size, barrier_size_exponent));
 
         std::cout << std::endl;
       }
index fa6d2cf6b5efd3288810e75e2e243c2093443d92..8543184b0b20563e8e92ab3ece7ae15ce1516db2 100644 (file)
@@ -814,7 +814,8 @@ public:
    * mapping from the symbolic flags defined in the RefinementPossibilities
    * base class to actual numerical values (the array indices).
    */
-  DEAL_II_HOST_DEVICE operator std::uint8_t() const;
+  DEAL_II_HOST_DEVICE
+  operator std::uint8_t() const;
 
   /**
    * Return the union of the refinement flags represented by the current
index d64a9271839c3db4fd9390ddc09790e6e1b310c2..4dba5de0853caacae6ceee1b10b341fdd4e6b53a 100644 (file)
@@ -2604,11 +2604,11 @@ namespace Functions
     // above to accommodate points that may lie outside the range
     Point<dim> p_unit;
     for (unsigned int d = 0; d < dim; ++d)
-      p_unit[d] = std::max(std::min((p[d] - coordinate_values[d][ix[d]]) /
-                                      (coordinate_values[d][ix[d] + 1] -
-                                       coordinate_values[d][ix[d]]),
-                                    1.),
-                           0.);
+      p_unit[d] = std::clamp((p[d] - coordinate_values[d][ix[d]]) /
+                               (coordinate_values[d][ix[d] + 1] -
+                                coordinate_values[d][ix[d]]),
+                             0.,
+                             1.);
 
     return interpolate(data_values, ix, p_unit);
   }
@@ -2636,8 +2636,7 @@ namespace Functions
     Point<dim> p_unit;
     for (unsigned int d = 0; d < dim; ++d)
       p_unit[d] =
-        std::max(std::min((p[d] - coordinate_values[d][ix[d]]) / dx[d], 1.),
-                 0.0);
+        std::clamp((p[d] - coordinate_values[d][ix[d]]) / dx[d], 0., 1.);
 
     return gradient_interpolate(data_values, ix, p_unit, dx);
   }
@@ -2729,11 +2728,12 @@ namespace Functions
         const double delta_x =
           ((interval_endpoints[d].second - interval_endpoints[d].first) /
            n_subintervals[d]);
-        p_unit[d] = std::max(std::min((p[d] - interval_endpoints[d].first -
-                                       ix[d] * delta_x) /
-                                        delta_x,
-                                      1.),
-                             0.);
+
+        p_unit[d] =
+          std::clamp((p[d] - interval_endpoints[d].first - ix[d] * delta_x) /
+                       delta_x,
+                     0.,
+                     1.);
       }
 
     return interpolate(data_values, ix, p_unit);
@@ -2778,12 +2778,11 @@ namespace Functions
         delta_x[d] = ((this->interval_endpoints[d].second -
                        this->interval_endpoints[d].first) /
                       this->n_subintervals[d]);
-        p_unit[d] =
-          std::max(std::min((p[d] - this->interval_endpoints[d].first -
-                             ix[d] * delta_x[d]) /
-                              delta_x[d],
-                            1.),
-                   0.);
+        p_unit[d]  = std::clamp((p[d] - this->interval_endpoints[d].first -
+                                ix[d] * delta_x[d]) /
+                                 delta_x[d],
+                               0.,
+                               1.);
       }
 
     return gradient_interpolate(this->data_values, ix, p_unit, delta_x);
index 752826da17e8a2200b46ed5d99308bfcb6b58d29..e396e417ca072c97578022dc6345c36fd4b90151 100644 (file)
@@ -265,7 +265,7 @@ namespace Functions
           delta_t = delta_c / std::sqrt(a * a + b * b - x * x - y * y);
           t += delta_t;
           // make sure the angle stays in first quadrant
-          t = std::min(numbers::PI_2, std::max(0.0, t));
+          t = std::clamp(t, 0.0, numbers::PI_2);
           x = a * std::cos(t);
           y = b * std::sin(t);
           ++iter;
index 09979c863344d626f13d60c7e6cbfcc819231e9c..eb9114fd802f09792d6c0d389130776351e73019 100644 (file)
@@ -71,7 +71,6 @@ namespace
     //  ++Pc;
     // but this affects the grid shape dramatically, i.e. 10 cores 3x3 becomes
     // 2x5.
-
     // limit our estimate to be in [2, Np]
     int n_process_columns = std::min(Np, std::max(2, Pc));
     // finally, get the rows:

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.