]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Change post- to pre-increment statements in foor loops (examples/).
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 15 Aug 2021 23:12:40 +0000 (17:12 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 15 Aug 2021 23:12:40 +0000 (17:12 -0600)
examples/step-18/doc/results.dox
examples/step-29/step-29.cc
examples/step-33/step-33.cc
examples/step-41/step-41.cc
examples/step-57/step-57.cc
examples/step-62/step-62.cc
examples/step-75/step-75.cc
examples/step-78/step-78.cc

index 4d0f61e8cb0e33aa97584a9caaff64bbe6897bff..7bc78a1a1aafee8855fdeac5ddb10afa2cce42c3 100644 (file)
@@ -527,8 +527,8 @@ general approach to this would go like this:
                  local_history_values_at_qpoints (dim, std::vector< Vector<double> >(dim)),
                  local_history_fe_values (dim, std::vector< Vector<double> >(dim));
 
-    for (unsigned int i=0; i<dim; i++)
-      for (unsigned int j=0; j<dim; j++)
+    for (unsigned int i=0; i<dim; ++i)
+      for (unsigned int j=0; j<dim; ++j)
       {
         history_field[i][j].reinit(history_dof_handler.n_dofs());
         local_history_values_at_qpoints[i][j].reinit(quadrature.size());
@@ -557,8 +557,8 @@ general approach to this would go like this:
         Assert (local_quadrature_points_history < &quadrature_point_history.back(),
                 ExcInternalError());
 
-        for (unsigned int i=0; i<dim; i++)
-          for (unsigned int j=0; j<dim; j++)
+        for (unsigned int i=0; i<dim; ++i)
+          for (unsigned int j=0; j<dim; ++j)
           {
             for (unsigned int q=0; q<quadrature.size(); ++q)
               local_history_values_at_qpoints[i][j](q)
@@ -602,8 +602,8 @@ general approach to this would go like this:
       Assert (local_quadrature_points_history < &quadrature_point_history.back(),
               ExcInternalError());
 
-      for (unsigned int i=0; i<dim; i++)
-        for (unsigned int j=0; j<dim; j++)
+      for (unsigned int i=0; i<dim; ++i)
+        for (unsigned int j=0; j<dim; ++j)
         {
           dg_cell->get_dof_values (history_field[i][j],
                                    local_history_fe_values[i][j]);
index 544faddc6b6684a32521151c45b8dd9ff62e8049..03a3f0479f6e59e93b8e4b8ac05d06c7a818ddbe 100644 (file)
@@ -339,7 +339,7 @@ namespace Step29
     // should return the <i>square</i> of the absolute value --
     // thereby not satisfying the properties mathematicians require of
     // something called a "norm".)
-    for (unsigned int i = 0; i < computed_quantities.size(); i++)
+    for (unsigned int i = 0; i < computed_quantities.size(); ++i)
       {
         Assert(computed_quantities[i].size() == 1,
                ExcDimensionMismatch(computed_quantities[i].size(), 1));
index aa64b0721a32fcb2b3ef6b00324ad54141f7e3af..7031b3af1fcbe3b187056b3efa7a8837b24c9711 100644 (file)
@@ -359,7 +359,7 @@ namespace Step33
                    const Vector<double> &boundary_values,
                    const DataVector &    Wminus)
     {
-      for (unsigned int c = 0; c < n_components; c++)
+      for (unsigned int c = 0; c < n_components; ++c)
         switch (boundary_kind[c])
           {
             case inflow_boundary:
@@ -409,7 +409,7 @@ namespace Step33
                 // orthogonal to the surface normal.  This creates sensitivities
                 // of across the velocity components.
                 typename DataVector::value_type vdotn = 0;
-                for (unsigned int d = 0; d < dim; d++)
+                for (unsigned int d = 0; d < dim; ++d)
                   {
                     vdotn += Wplus[d] * normal_vector[d];
                   }
@@ -1257,7 +1257,7 @@ namespace Step33
       {
         std::vector<std::string> expressions(EulerEquations<dim>::n_components,
                                              "0.0");
-        for (unsigned int di = 0; di < EulerEquations<dim>::n_components; di++)
+        for (unsigned int di = 0; di < EulerEquations<dim>::n_components; ++di)
           expressions[di] =
             prm.get("w_" + Utilities::int_to_string(di) + " value");
         initial_conditions.initialize(
@@ -1756,7 +1756,7 @@ namespace Step33
           W_old[q][c] +=
             old_solution(dof_indices[i]) * fe_v.shape_value_component(i, q, c);
 
-          for (unsigned int d = 0; d < dim; d++)
+          for (unsigned int d = 0; d < dim; ++d)
             {
               grad_W[q][c][d] += independent_local_dof_values[i] *
                                  fe_v.shape_grad_component(i, q, c)[d];
@@ -1855,14 +1855,14 @@ namespace Step33
                      fe_v.shape_value_component(i, point, component_i) *
                      fe_v.JxW(point);
 
-            for (unsigned int d = 0; d < dim; d++)
+            for (unsigned int d = 0; d < dim; ++d)
               R_i -=
                 (parameters.theta * flux[point][component_i][d] +
                  (1.0 - parameters.theta) * flux_old[point][component_i][d]) *
                 fe_v.shape_grad_component(i, point, component_i)[d] *
                 fe_v.JxW(point);
 
-            for (unsigned int d = 0; d < dim; d++)
+            for (unsigned int d = 0; d < dim; ++d)
               R_i +=
                 1.0 *
                 std::pow(fe_v.get_cell()->diameter(),
@@ -1923,14 +1923,14 @@ namespace Step33
     const unsigned int n_independent_variables =
       (external_face == false ? 2 * dofs_per_cell : dofs_per_cell);
 
-    for (unsigned int i = 0; i < dofs_per_cell; i++)
+    for (unsigned int i = 0; i < dofs_per_cell; ++i)
       {
         independent_local_dof_values[i] = current_solution(dof_indices[i]);
         independent_local_dof_values[i].diff(i, n_independent_variables);
       }
 
     if (external_face == false)
-      for (unsigned int i = 0; i < dofs_per_cell; i++)
+      for (unsigned int i = 0; i < dofs_per_cell; ++i)
         {
           independent_neighbor_dof_values[i] =
             current_solution(dof_indices_neighbor[i]);
@@ -2012,7 +2012,7 @@ namespace Step33
         parameters.boundary_conditions[boundary_id].values.vector_value_list(
           fe_v.get_quadrature_points(), boundary_values);
 
-        for (unsigned int q = 0; q < n_q_points; q++)
+        for (unsigned int q = 0; q < n_q_points; ++q)
           {
             EulerEquations<dim>::compute_Wminus(
               parameters.boundary_conditions[boundary_id].kind,
index b8ee77ee61dbd1d4b48977671f1a6083a624cc97..b52f55e544b7ce82be9ea16f47b9be7d736c08c2 100644 (file)
@@ -246,7 +246,7 @@ namespace Step41
     mass_matrix.reinit(dsp);
     assemble_mass_matrix_diagonal(mass_matrix);
     diagonal_of_mass_matrix.reinit(solution_index_set);
-    for (unsigned int j = 0; j < solution.size(); j++)
+    for (unsigned int j = 0; j < solution.size(); ++j)
       diagonal_of_mass_matrix(j) = mass_matrix.diag_element(j);
   }
 
index b1982db5aa814e61c54ee141edd010decf1f7bd9..d932aa48b346d3fa3c4e1e24863b4c88793a2ea1 100644 (file)
@@ -786,7 +786,7 @@ namespace Step57
         VectorTools::point_value(dof_handler, present_solution, p, tmp_vector);
         f << p(dim - 1);
 
-        for (int j = 0; j < dim; j++)
+        for (int j = 0; j < dim; ++j)
           f << " " << tmp_vector(j);
         f << std::endl;
       }
index ed8b8c64532030e15d56a42e187cdaf84193925f..6fbf85d8f6e4bbac1bf2681889082396f7186320 100644 (file)
@@ -564,7 +564,7 @@ namespace step62
     // height="200" />
     // where the brown color represents material_a and the green color
     // represents material_b.
-    for (unsigned int idx = 0; idx < nb_mirror_pairs; idx++)
+    for (unsigned int idx = 0; idx < nb_mirror_pairs; ++idx)
       {
         const double layer_transition_center =
           material_a_wavelength / 2 +
@@ -586,7 +586,7 @@ namespace step62
     // [subpixel
     // smoothing](https://meep.readthedocs.io/en/latest/Subpixel_Smoothing/)
     // which improves the precision of the simulation.
-    for (unsigned int idx = 0; idx < nb_mirror_pairs; idx++)
+    for (unsigned int idx = 0; idx < nb_mirror_pairs; ++idx)
       {
         const double layer_transition_center =
           material_a_wavelength / 2 +
@@ -612,7 +612,7 @@ namespace step62
       }
 
     // the material_a layers
-    for (unsigned int idx = 0; idx < nb_mirror_pairs; idx++)
+    for (unsigned int idx = 0; idx < nb_mirror_pairs; ++idx)
       {
         const double layer_center =
           material_a_wavelength / 2 +
@@ -627,7 +627,7 @@ namespace step62
       }
 
     // the material_b layers
-    for (unsigned int idx = 0; idx < nb_mirror_pairs; idx++)
+    for (unsigned int idx = 0; idx < nb_mirror_pairs; ++idx)
       {
         const double layer_center =
           material_a_wavelength / 2 +
index 951d173b0139cd542909835ff727b26186da94ad..56648232e02af28c578d55b49c8a459ac245026c 100644 (file)
@@ -573,7 +573,7 @@ namespace Step75
     MGLevelObject<typename SmootherType::AdditionalData> smoother_data(
       min_level, max_level);
 
-    for (unsigned int level = min_level; level <= max_level; level++)
+    for (unsigned int level = min_level; level <= max_level; ++level)
       {
         smoother_data[level].preconditioner =
           std::make_shared<SmootherPreconditionerType>();
index 1b3fc652a2b40b809c405ccd81f7876f9eda0418..1fb89ede07796cdb41344c6adb9990273c53a967 100644 (file)
@@ -707,7 +707,7 @@ namespace BlackScholesSolver
     Vector<double> vmult_result;
     Vector<double> forcing_terms;
 
-    for (unsigned int cycle = 0; cycle < n_cycles; cycle++)
+    for (unsigned int cycle = 0; cycle < n_cycles; ++cycle)
       {
         if (cycle != 0)
           {

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.