]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use prefix ++ universally. 16403/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 2 Jan 2024 17:31:54 +0000 (10:31 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 4 Jan 2024 00:26:08 +0000 (17:26 -0700)
42 files changed:
examples/step-32/step-32.cc
examples/step-75/step-75.cc
include/deal.II/base/partitioner.templates.h
include/deal.II/base/vectorization.h
include/deal.II/grid/connectivity.h
include/deal.II/hp/collection.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_qmrs.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/matrix_free/constraint_info.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/optimization/line_minimization.h
include/deal.II/optimization/solver_bfgs.h
include/deal.II/trilinos/nox.templates.h
source/base/data_out_base.cc
source/base/function_signed_distance.cc
source/base/mpi_compute_index_owner_internal.cc
source/dofs/dof_handler.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/grid/grid_generator.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/grid_tools_topology.cc
source/grid/tria.cc
source/lac/petsc_communication_pattern.cc
source/lac/solver_control.cc
source/lac/trilinos_sparse_matrix.cc
source/matrix_free/task_info.cc
source/numerics/data_out_resample.cc
source/numerics/matrix_tools_once.cc
source/numerics/point_value_history.cc
source/particles/particle_handler.cc
source/sundials/ida.cc

index ff6fef3edacd60c0f5dfddfc58a38dc7ed51f2f2..e8376c9bac7538f2a62a6d339a33d3efab49cb12 100644 (file)
@@ -3221,7 +3221,7 @@ namespace Step32
     data_out.write_vtu_with_pvtu_record(
       "./", "solution", out_index, MPI_COMM_WORLD, 5);
 
-    out_index++;
+    ++out_index;
   }
 
 
index 417819f0e90bfec2861597da80d16fe6d028af23..3a0416154b5636c40297991604413ecfe522137a 100644 (file)
@@ -733,7 +733,7 @@ namespace Step75
               {
                 if (cell->is_locally_owned())
                   cell->set_active_fe_index(cell_other->active_fe_index());
-                cell_other++;
+                ++cell_other;
               }
           }
         else // coarse level
@@ -758,7 +758,7 @@ namespace Step75
 
                     cell->set_active_fe_index(fe_index_for_degree[next_degree]);
                   }
-                cell_other++;
+                ++cell_other;
               }
           }
 
index 86132a20dc5ba14923f3594e07dcbe3606c09bfe..c4643a6d069b70fd70218c508811767e04fd98dc 100644 (file)
@@ -709,7 +709,7 @@ namespace Utilities
                       locally_owned_array[j] =
                         internal::get_min(*read_position,
                                           locally_owned_array[j]);
-                      read_position++;
+                      ++read_position;
                     }
               else if (vector_operation == VectorOperation::max)
                 for (const auto &import_range : import_indices_data)
@@ -720,7 +720,7 @@ namespace Utilities
                       locally_owned_array[j] =
                         internal::get_max(*read_position,
                                           locally_owned_array[j]);
-                      read_position++;
+                      ++read_position;
                     }
               else
                 for (const auto &import_range : import_indices_data)
index fc9019b3357e49b5d6ce08521a6352c9cb6e1654..ea0bb552bc8210b8d3868d9d17e937a9be517880 100644 (file)
@@ -173,7 +173,7 @@ public:
   operator++()
   {
     AssertIndexRange(lane + 1, T::size() + 1);
-    lane++;
+    ++lane;
     return *this;
   }
 
index 2bdfff98a0b72e2f2a4673526d90cc0c44633b1d..94a6c36a55dbf229f023c98b5e4e6fddabb3f6a9 100644 (file)
@@ -1120,7 +1120,7 @@ namespace internal
                 {
                   ref_key = std::get<0>(keys[i]);
 
-                  n_unique_entities++;
+                  ++n_unique_entities;
                   n_unique_entity_vertices +=
                     cell_types[static_cast<types::geometric_entity_type>(
                                  ad_entity_types[offset_i])]
@@ -1151,7 +1151,7 @@ namespace internal
           if (ref_key != std::get<0>(keys[i]))
             {
               // new key: default orientation is correct
-              counter++;
+              ++counter;
               ref_key     = std::get<0>(keys[i]);
               ref_indices = ad_entity_vertices[offset_i];
 
index 8c342ea5b63f2e82e5bbc356f064c9e1ee460d78..e6374a96afc887946a630b54e94a1d785a688be7 100644 (file)
@@ -104,7 +104,7 @@ namespace hp
     operator++()
     {
       AssertIndexRange(index + 1, data->size() + 1);
-      index++;
+      ++index;
       return *this;
     }
 
index fe265b85946310a8151ffd57688409403d59c7f2..2fba32511cfb4ceebb9a9086075b508f7d56a7f7 100644 (file)
@@ -427,7 +427,7 @@ namespace internal
 
       for (const auto &i : constrained_indices_by_ranks)
         if (i.first != my_rank)
-          n_rec_ranks++;
+          ++n_rec_ranks;
 
       for (unsigned int i = 0; i < n_rec_ranks; ++i)
         {
@@ -3246,7 +3246,7 @@ namespace internal
       Assert(i >= n_inhomogeneous_rows, ExcInternalError());
       std::swap(total_row_indices[n_active_rows + i],
                 total_row_indices[n_active_rows + n_inhomogeneous_rows]);
-      n_inhomogeneous_rows++;
+      ++n_inhomogeneous_rows;
     }
 
 
index d71908552663872b9f5dab94f9ffa508228a461a..ffacac419fd791cdb83bd17c2a4906f737abcadf 100644 (file)
@@ -2179,8 +2179,8 @@ BlockVectorBase<VectorType>::extract_subvector_to(
   while (indices_begin != indices_end)
     {
       *values_begin = operator()(*indices_begin);
-      indices_begin++;
-      values_begin++;
+      ++indices_begin;
+      ++values_begin;
     }
 }
 
index 215de86a869f1c07889c01727e55275f439a4747..688c4226863e359a426b97e68a1fa912d52a095e 100644 (file)
@@ -1687,8 +1687,8 @@ namespace LinearAlgebra
       while (indices_begin != indices_end)
         {
           *values_begin = operator()(*indices_begin);
-          indices_begin++;
-          values_begin++;
+          ++indices_begin;
+          ++values_begin;
         }
     }
 
index f715bfdac63a11630cf5f1251bcf239c491f6f4c..dd5a750ec12880a25b3f887337d04258ad5b9623 100644 (file)
@@ -1373,7 +1373,7 @@ namespace PETScWrappers
               {
                 column_indices[n_columns] = col_indices[j];
                 column_values[n_columns]  = value;
-                n_columns++;
+                ++n_columns;
               }
           }
         AssertIndexRange(n_columns, n_cols + 1);
@@ -1517,7 +1517,7 @@ namespace PETScWrappers
               {
                 column_indices[n_columns] = col_indices[j];
                 column_values[n_columns]  = value;
-                n_columns++;
+                ++n_columns;
               }
           }
         AssertIndexRange(n_columns, n_cols + 1);
index 0fae3f43c0f7db9491ba0ccfdda753acbcbbb975..8effad5f4eaa19e93fb9a014ca95f1557ae1c7ad 100644 (file)
@@ -1063,8 +1063,8 @@ namespace LinearAlgebra
     while (indices_begin != indices_end)
       {
         *values_begin = operator()(*indices_begin);
-        indices_begin++;
-        values_begin++;
+        ++indices_begin;
+        ++values_begin;
       }
   }
 
index fc2c5485a88ac546eb1650fb728bbc420bfa700f..2da1ef44b8add81bb18a3e56d213f9f1a3ff51b9 100644 (file)
@@ -1298,7 +1298,7 @@ SolverCG<VectorType>::solve(const MatrixType         &A,
 
   while (solver_state == SolverControl::iterate)
     {
-      it++;
+      ++it;
 
       worker.do_iteration(it);
 
index 1e05d8e59c9c99cac6529965459b0ce29dc59536..dd4f42753f001b0dd4357e7d080e0fa12663799c 100644 (file)
@@ -371,8 +371,8 @@ SolverQMRS<VectorType>::iterate(const MatrixType         &A,
 
   while (state == SolverControl::iterate)
     {
-      step++;
-      it++;
+      ++step;
+      ++it;
       //--------------------------------------------------------------
       // Step 1: apply the system matrix and compute one inner product
       //--------------------------------------------------------------
index 20347cc1b405886794b1ddd89fda1554af0541a6..fdf33ee8666daf9920d5d637192274f8e866adcf 100644 (file)
@@ -1573,8 +1573,8 @@ namespace TrilinosWrappers
       while (indices_begin != indices_end)
         {
           *values_begin = operator()(*indices_begin);
-          indices_begin++;
-          values_begin++;
+          ++indices_begin;
+          ++values_begin;
         }
     }
 
index 60ece3d0aaea90337d94ac5b24d939bfa12b4a19..36b9fefc2b40383b5eb1aac2f126570120a55181 100644 (file)
@@ -1255,8 +1255,8 @@ Vector<Number>::extract_subvector_to(ForwardIterator       indices_begin,
   while (indices_begin != indices_end)
     {
       *values_begin = operator()(*indices_begin);
-      indices_begin++;
-      values_begin++;
+      ++indices_begin;
+      ++values_begin;
     }
 }
 
index d3c7d7727c6bab61895bac625c1de72573143050..77afa5b41df196c13b7b627bd91a9861daf87f25 100644 (file)
@@ -641,7 +641,7 @@ namespace internal
                                              value);
 
               operation.post_constraints(value, local_vector[ind_local][v]);
-              ind_local++;
+              ++ind_local;
             }
 
           AssertIndexRange(ind_local, n_dofs_per_cell + 1);
index 92a43ad4a856456519ea3eb9c982374255372ed9..6f42a6809d43d125c542b1fe92ec366273d4de0f 100644 (file)
@@ -3631,7 +3631,7 @@ FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
               for (unsigned int comp = 0; comp < n_components; ++comp)
                 operation.post_constraints(value[comp],
                                            values_dofs[comp][ind_local][v]);
-              ind_local++;
+              ++ind_local;
             }
 
           AssertIndexRange(ind_local, dofs_per_component + 1);
@@ -3687,7 +3687,7 @@ FEEvaluationBase<dim, n_components_, Number, is_face, VectorizedArrayType>::
 
                   operation.post_constraints(value,
                                              values_dofs[comp][ind_local][v]);
-                  ind_local++;
+                  ++ind_local;
                 }
 
               AssertIndexRange(ind_local, dofs_per_component + 1);
index 82227fa59c0e6b374e3bc082a0ed06a6e60da0cc..6e682aa6c331747fdc123fcefef12f0e07b150f5 100644 (file)
@@ -596,7 +596,7 @@ namespace LineMinimization
           const auto fgi = func(ai);
           fi             = fgi.first;
           gi             = fgi.second;
-          i++;
+          ++i;
 
           if (debug_output)
             deallog << "Bracketing phase: " << i << std::endl
@@ -704,7 +704,7 @@ namespace LineMinimization
         const std::pair<NumberType, NumberType> fgi = func(ai);
         fi                                          = fgi.first;
         gi                                          = fgi.second;
-        i++;
+        ++i;
 
         if (debug_output)
           deallog << "Sectioning phase: " << i << std::endl
index 81a21d771fe094514633ddca78c2dddeb5dde3b6..4822a128f0dc71b51172f44989f9cc3398c247e8 100644 (file)
@@ -372,7 +372,7 @@ SolverBFGS<VectorType>::solve(
         deallog << "Line search a=" << alpha << " f=" << f << std::endl;
 
       // 3. Check convergence
-      k++;
+      ++k;
       const Number g_l2 = g.l2_norm();
       conv              = this->iteration_status(k, g_l2, x);
       if (conv != SolverControl::iterate)
index fca727f2b175027e0390c172f1d3385fea712d1c..6d86f03462dd612424a12f51d5f6eae2d1dd0337 100644 (file)
@@ -985,7 +985,7 @@ namespace TrilinosWrappers
           ExcMessage(
             "No residual function has been attached to the NOXSolver object."));
 
-        n_residual_evaluations++;
+        ++n_residual_evaluations;
 
         // evaluate residual
         return internal::NOXWrappers::call_and_possibly_capture_exception(
index b0f60a5e829efa8bfd2f53ca7c55c21628f8b069..78863bb8878f97f75a704ee6dab9981832eca16a 100644 (file)
@@ -7174,7 +7174,7 @@ namespace DataOutBase
                 << "\" style=\"stroke:black; fill:url(#" << triangle_counter
                 << "); stroke-width:" << flags.line_thickness << "\"/>" << '\n';
 
-            triangle_counter++;
+            ++triangle_counter;
           }
       }
 
@@ -8593,7 +8593,7 @@ DataOutBase::write_filtered_data(
       // Advance n_th_vector to at least the current data set we are on
       while (n_th_vector < nonscalar_data_ranges.size() &&
              std::get<0>(nonscalar_data_ranges[n_th_vector]) < data_set)
-        n_th_vector++;
+        ++n_th_vector;
 
       // Determine the dimension of this data
       if (n_th_vector < nonscalar_data_ranges.size() &&
index a7de839c6324330206533d94c7bec54c45e0d161..d0d7ee6177e8815dfda224da46fe930f97e8590d 100644 (file)
@@ -269,7 +269,7 @@ namespace Functions
           t = std::min(numbers::PI_2, std::max(0.0, t));
           x = a * std::cos(t);
           y = b * std::sin(t);
-          iter++;
+          ++iter;
         }
       while (std::abs(delta_t) > tolerance && iter < max_iter);
       AssertIndexRange(iter, max_iter);
index a147963e3ee81a3629d77ab4ba10e5537f427760..ef3fd7300d1b031dc4f34d8f6e857268207589f0 100644 (file)
@@ -529,7 +529,7 @@ namespace Utilities
                   indices.first.push_back(i);
                   indices.second.push_back(index);
                 }
-              index++;
+              ++index;
             }
 
           Assert(targets.size() == indices_to_look_up_by_dict_rank.size(),
index 94bea20d698a293945bfab75c42f0dd740f7e16f..bd299bbe8a23c0a3c8255ab04970c948158f26e6 100644 (file)
@@ -761,7 +761,7 @@ namespace internal
                        ++fe)
                     if (vertex_fe_association[fe][v] == true)
                       {
-                        fe_slots_needed++;
+                        ++fe_slots_needed;
                         vertex_slots_needed +=
                           dof_handler.get_fe(fe).n_dofs_per_vertex();
                       }
@@ -1202,7 +1202,7 @@ namespace internal
                          ++fe)
                       if (line_fe_association[fe][line] == true)
                         {
-                          fe_slots_needed++;
+                          ++fe_slots_needed;
                           line_slots_needed +=
                             dof_handler.get_fe(fe).n_dofs_per_line();
                         }
index 518a2ecf6309896566ba62392aedc56c444dc514..baa9d26030eabf45f0f474d226b0433595cf8260 100644 (file)
@@ -2308,7 +2308,7 @@ namespace DoFTools
                     vector_dofs[fe.face_system_to_component_index(k, face_no)
                                   .first -
                                 first_vector_component] = k;
-                    n_found++;
+                    ++n_found;
                     if (n_found == dim)
                       break;
                   }
index ef72b4cd71a0a99b6ec36a4e8fb7fffc7c694867..bb5e976090709d1572faaa98837c36505743c845 100644 (file)
@@ -293,7 +293,7 @@ FE_Q_Bubbles<dim, spacedim>::get_name() const
           else
             points[index - 1] = unit_support_points[j](0);
 
-          index++;
+          ++index;
         }
     }
   // Do not consider the discontinuous node for dimension 1
index 5161c294dd5992fa7faf29dd37cf949d71e8bc08..e5e898233b0618b0797448ad052c92165fea8003 100644 (file)
@@ -119,7 +119,7 @@ FE_Q_DG0<dim, spacedim>::get_name() const
           else
             points[index - 1] = unit_support_points[j](0);
 
-          index++;
+          ++index;
         }
     }
   // Do not consider the discontinuous node for dimension 1
index 29656d165f8afd87562ef767afd609dde4d11cda..f598404ba2cfddb9e8cb54be800fb5e94bb8591a 100644 (file)
@@ -2909,7 +2909,7 @@ namespace GridGenerator
     unsigned int n_val_cells = 0;
     for (unsigned int i = 0; i < n_cells; ++i)
       if (material_id[i] != numbers::invalid_material_id)
-        n_val_cells++;
+        ++n_val_cells;
 
     std::vector<CellData<1>> cells(n_val_cells);
     unsigned int             id = 0;
@@ -2919,7 +2919,7 @@ namespace GridGenerator
           cells[id].vertices[0] = x;
           cells[id].vertices[1] = x + 1;
           cells[id].material_id = material_id[x];
-          id++;
+          ++id;
         }
     // create triangulation
     SubCellData t;
@@ -2978,7 +2978,7 @@ namespace GridGenerator
     for (unsigned int i = 0; i < material_id.size(0); ++i)
       for (unsigned int j = 0; j < material_id.size(1); ++j)
         if (material_id[i][j] != numbers::invalid_material_id)
-          n_val_cells++;
+          ++n_val_cells;
 
     std::vector<CellData<2>> cells(n_val_cells);
     unsigned int             id = 0;
@@ -2991,7 +2991,7 @@ namespace GridGenerator
             cells[id].vertices[2] = (y + 1) * (repetitions[0] + 1) + x;
             cells[id].vertices[3] = (y + 1) * (repetitions[0] + 1) + x + 1;
             cells[id].material_id = material_id[x][y];
-            id++;
+            ++id;
           }
 
     // create triangulation
@@ -3079,7 +3079,7 @@ namespace GridGenerator
       for (unsigned int j = 0; j < material_id.size(1); ++j)
         for (unsigned int k = 0; k < material_id.size(2); ++k)
           if (material_id[i][j][k] != numbers::invalid_material_id)
-            n_val_cells++;
+            ++n_val_cells;
 
     std::vector<CellData<dim>> cells(n_val_cells);
     unsigned int               id  = 0;
@@ -3099,7 +3099,7 @@ namespace GridGenerator
               cells[id].vertices[6] = (z + 1) * n_xy + (y + 1) * n_x + x;
               cells[id].vertices[7] = (z + 1) * n_xy + (y + 1) * n_x + x + 1;
               cells[id].material_id = material_id[x][y][z];
-              id++;
+              ++id;
             }
 
     // create triangulation
@@ -4215,12 +4215,12 @@ namespace GridGenerator
 
         cell->face(0)->set_boundary_id(0);
         cell->face(2)->set_boundary_id(1);
-        cell++;
+        ++cell;
 
         cell->face(1)->set_boundary_id(2);
         cell->face(2)->set_boundary_id(1);
         cell->face(3)->set_boundary_id(3);
-        cell++;
+        ++cell;
 
         cell->face(0)->set_boundary_id(0);
         cell->face(1)->set_boundary_id(4);
index 203083bc258d5ffc4414b3b0262d5387034b2de0..d29d6b21d214f7d76929ba90cdb3a6f778b152b2 100644 (file)
@@ -2213,7 +2213,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
               << "stroke:rgb(25,25,25); stroke-width:"
               << svg_flags.line_thickness << '}' << '\n';
 
-          labeling_index++;
+          ++labeling_index;
         }
     }
 
@@ -2956,7 +2956,7 @@ GridOut::write_svg(const Triangulation<2, 2> &tria, std::ostream &out) const
 
           out << "</text>" << '\n';
 
-          labeling_index++;
+          ++labeling_index;
         }
     }
 
@@ -3784,7 +3784,7 @@ GridOut::n_boundary_faces(const Triangulation<dim, spacedim> &tria) const
 
   for (const auto &face : tria.active_face_iterators())
     if ((face->at_boundary()) && (face->boundary_id() != 0))
-      n_faces++;
+      ++n_faces;
 
   return n_faces;
 }
index 43b778a793180454f6d028ef2b4ea5950a5c3653..4997ff17560be5d726a0968d4f96da1d850131bb 100644 (file)
@@ -3038,7 +3038,7 @@ namespace GridTools
             unsigned int boundary_face_counter = 0;
             for (auto f : cell->face_indices())
               if (cell->face(f)->at_boundary())
-                boundary_face_counter++;
+                ++boundary_face_counter;
             if (boundary_face_counter > dim)
               {
                 has_cells_with_more_than_dim_faces_on_boundary = true;
@@ -3050,14 +3050,14 @@ namespace GridTools
         if (has_cells_with_more_than_dim_faces_on_boundary)
           {
             tria.refine_global(1);
-            refinement_cycles++;
+            ++refinement_cycles;
           }
       }
 
     if (has_cells_with_dim_faces_on_boundary)
       {
         tria.refine_global(1);
-        refinement_cycles++;
+        ++refinement_cycles;
       }
     else
       {
@@ -5025,7 +5025,7 @@ namespace GridTools
             vertex_list_reduced[local_vertex_count] =
               vertex_list_all[new_line_table[configuration][i]];
             local_remap[new_line_table[configuration][i]] = local_vertex_count;
-            local_vertex_count++;
+            ++local_vertex_count;
           }
 
       // write back vertices
index ca9232c1d7a7c874c0818326c3c539a6ca865500..4c6d30cc3d843a20a4e9170efb8850b0b2e33929 100644 (file)
@@ -711,7 +711,7 @@ namespace GridTools
                     vertex_indices[count_vertex_indices].first = d;
                     vertex_indices[count_vertex_indices].second =
                       unit_point[d] > 0.5 ? 1 : 0;
-                    count_vertex_indices++;
+                    ++count_vertex_indices;
                   }
                 else
                   free_direction = d;
@@ -985,7 +985,7 @@ namespace GridTools
         {
           for (const unsigned int v : cell->vertex_indices())
             vertices_outside_subdomain[cell->vertex_index(v)] = true;
-          n_non_predicate_cells++;
+          ++n_non_predicate_cells;
         }
 
     // If all the active cells conform to the predicate
index 3e0b329e58ff0dcc11515f1a32d92f45c58734a2..a7a501d0db7bf6ea6a4966c68e7e9d3bbab45bee 100644 (file)
@@ -1684,7 +1684,7 @@ namespace GridTools
     while (continue_refinement && (iter < max_iterations))
       {
         if (max_iterations != numbers::invalid_unsigned_int)
-          iter++;
+          ++iter;
         continue_refinement = false;
 
         for (const auto &cell : tria.active_cell_iterators())
@@ -1718,7 +1718,7 @@ namespace GridTools
 
     while (continue_refinement && (iter < max_iterations))
       {
-        iter++;
+        ++iter;
         continue_refinement = false;
         for (const auto &cell : tria.active_cell_iterators())
           {
index 3db640cb6e06344847ed7b323640430cffbfd537..f1e48f669ca8d4bd84515ff472848eda512988ba 100644 (file)
@@ -3561,7 +3561,7 @@ namespace internal
                 subcell_object->vertices != key)
               continue;
 
-            counter++;
+            ++counter;
 
             // set manifold id
             manifold_id = subcell_object->manifold_id;
index 88a93ccfae8780a9ba00b404d5b51b6a54012962..563a1d2bef130d89017859d82d8722f17dbd597f 100644 (file)
@@ -129,7 +129,7 @@ namespace PETScWrappers
           }
         else
           has_invalid = true;
-        loc++;
+        ++loc;
       }
     if (!has_invalid)
       indices_has_loc.clear();
@@ -145,7 +145,7 @@ namespace PETScWrappers
           }
         else
           has_invalid = true;
-        loc++;
+        ++loc;
       }
     if (!has_invalid)
       indices_want_loc.clear();
@@ -215,7 +215,7 @@ namespace PETScWrappers
           }
         remotes[cnt].rank  = owner;
         remotes[cnt].index = idx - ranges[owner];
-        cnt++;
+        ++cnt;
       }
 
     AssertPETSc(PetscSFCreate(communicator, &sf2));
index ecf626a743ea9741bdf5b686badc2c82c1cb2ba6..074e21e53a2f5dd3ccb8002057f39dcdb7c1159c 100644 (file)
@@ -401,7 +401,7 @@ ConsecutiveControl::check(const unsigned int step, const double check_value)
   // check if we need to override the success:
   if (state == success)
     {
-      n_converged_iterations++;
+      ++n_converged_iterations;
       if (n_converged_iterations == n_consecutive_iterations)
         {
           return success;
index 231e9e3f836567f6156029846da8bdf6e3e11391..4de2f286ae54532ee3e13ee0a1c11604d1d58133 100644 (file)
@@ -1455,7 +1455,7 @@ namespace TrilinosWrappers
               {
                 local_index_array[n_columns] = col_indices[j];
                 local_value_array[n_columns] = value;
-                n_columns++;
+                ++n_columns;
               }
           }
 
index ab3090bc14637a2d889f270376258236d8dcd048..936b5eef134f12b7e4114aff82e3f9f6f8cc4111 100644 (file)
@@ -473,12 +473,12 @@ namespace internal
                                                slice_index,
                                                *this,
                                                false);
-                      slice_index++;
+                      ++slice_index;
                       for (; slice_index < partition_row_index[part + 1];
                            slice_index++)
                         {
                           worker[worker_index]->set_ref_count(1);
-                          worker_index++;
+                          ++worker_index;
                           worker[worker_index] =
                             new (worker[worker_index - 1]->allocate_child())
                               color::PartitionWork(funct,
@@ -492,7 +492,7 @@ namespace internal
                           blocked_worker[(part - 1) / 2]->dummy =
                             new (worker[worker_index]->allocate_child())
                               tbb::empty_task;
-                          worker_index++;
+                          ++worker_index;
                           if (spawn_index_child == -1)
                             tbb::task::spawn(*blocked_worker[(part - 1) / 2]);
                           else
@@ -509,7 +509,7 @@ namespace internal
                             new (worker[worker_index]->allocate_child())
                               MPICommunication(funct, false);
                           tbb::task::spawn(*worker_dist);
-                          worker_index++;
+                          ++worker_index;
                         }
                       part += 1;
                       if (part < partition_row_index.size() - 1)
@@ -522,7 +522,7 @@ namespace internal
                                                        slice_index,
                                                        *this,
                                                        true);
-                              slice_index++;
+                              ++slice_index;
                               if (slice_index < partition_row_index[part + 1])
                                 {
                                   blocked_worker[part / 2]->set_ref_count(1);
@@ -532,7 +532,7 @@ namespace internal
                                                          slice_index,
                                                          *this,
                                                          false);
-                                  slice_index++;
+                                  ++slice_index;
                                 }
                               else
                                 {
@@ -546,7 +546,7 @@ namespace internal
                               if (slice_index > partition_row_index[part])
                                 {
                                   worker[worker_index]->set_ref_count(1);
-                                  worker_index++;
+                                  ++worker_index;
                                 }
                               worker[worker_index] =
                                 new (worker[worker_index - 1]->allocate_child())
@@ -556,7 +556,7 @@ namespace internal
                                                        false);
                             }
                           spawn_index_child = worker_index;
-                          worker_index++;
+                          ++worker_index;
                         }
                       else
                         {
@@ -1778,7 +1778,7 @@ namespace internal
                             partition_list[start_up]);
                           partition_partition_list[counter++] =
                             partition_list[start_up];
-                          start_up++;
+                          ++start_up;
                           break;
                         }
                   }
@@ -1805,7 +1805,7 @@ namespace internal
                                   neighbor_it->column());
                                 partition_partition_list[counter++] =
                                   neighbor_it->column();
-                                partition_counter++;
+                                ++partition_counter;
                               }
                           }
                       }
@@ -1862,7 +1862,7 @@ namespace internal
                           if (remaining_per_cell_batch[0] != 0)
                             {
                               filled = false;
-                              missing_macros++;
+                              ++missing_macros;
                             }
                         }
                       missing_macros =
@@ -1928,8 +1928,8 @@ namespace internal
                                           .push_back(neighbor->column());
                                       partition_partition_list[counter] =
                                         neighbor->column();
-                                      counter++;
-                                      partition_counter++;
+                                      ++counter;
+                                      ++partition_counter;
                                       if (remaining_per_cell_batch
                                               [this_index] == 0 &&
                                           missing_macros > 0)
@@ -1992,7 +1992,7 @@ namespace internal
                             {
                               irregular_cells[n_cell_batches_before] =
                                 partition_counter % vectorization_length;
-                              n_cell_batches_before++;
+                              ++n_cell_batches_before;
                             }
                         }
                     }
@@ -2072,7 +2072,7 @@ namespace internal
           for (unsigned int color = 0; color <= max_color; ++color)
             {
               cell_partition_data.push_back(color_counter);
-              index_counter++;
+              ++index_counter;
               for (unsigned int k = partition_size[part];
                    k < partition_size[part + 1];
                    k++)
@@ -2179,7 +2179,7 @@ namespace internal
               neighbor_list.push_back(start_up);
               partition_list[counter++] = start_up;
               partition_size.back()++;
-              start_up++;
+              ++start_up;
               remainder--;
               if (remainder == cluster_size)
                 remainder = 0;
@@ -2223,7 +2223,7 @@ namespace internal
 
           while (neighbor_list.size() > 0)
             {
-              partition++;
+              ++partition;
 
               // counter for number of cells so far in current partition
               unsigned int partition_counter = 0;
@@ -2251,7 +2251,7 @@ namespace internal
                           // use as neighbors in next partition
                           neighbor_neighbor_list.push_back(neighbor->column());
                           partition_list[counter++] = neighbor->column();
-                          partition_counter++;
+                          ++partition_counter;
                         }
                     }
                 }
@@ -2315,7 +2315,7 @@ namespace internal
               }
         }
       if (remainder != 0)
-        partition++;
+        ++partition;
 
       AssertDimension(partition_size[partition], n_blocks);
     }
index df7f7abf8e9a69792355eb7446f29159b65870c1..9a0166f1ddeaf6e1441f39059f69c0da76779039 100644 (file)
@@ -185,7 +185,7 @@ DataOutResample<dim, patch_dim, spacedim>::build_patches(
             DataOut_DoFData<patch_dim, patch_dim, spacedim, spacedim>::
               DataVectorType::type_dof_data);
 
-          counter++;
+          ++counter;
         }
     }
 
index 92d3b25d724b6014f69a7ac952ce6bb0714d842e..60052d37778a17e55af475d42fff974d6aaa0276 100644 (file)
@@ -186,7 +186,7 @@ namespace MatrixTools
           if (boundary_value.first >= matrix.block(block, 0).m() + offset)
             {
               offset += matrix.block(block, 0).m();
-              block++;
+              ++block;
             }
           const types::global_dof_index index = boundary_value.first - offset;
           block_boundary_values[block].insert(
@@ -368,7 +368,7 @@ namespace MatrixTools
               if (boundary_value.first >= matrix.block(block, 0).m() + offset)
                 {
                   offset += matrix.block(block, 0).m();
-                  block++;
+                  ++block;
                 }
               const types::global_dof_index index =
                 boundary_value.first - offset;
index 9d36090e6653ee87f01e74a78a75860df4b76ce9..a9c260e980496b32bc139a582188c7bfdde04934 100644 (file)
@@ -633,7 +633,7 @@ PointValueHistory<dim>::evaluate_field(const std::string &vector_name,
                 .push_back(
                   internal::ElementAccess<VectorType>::get(solution,
                                                            solution_index));
-              store_index++;
+              ++store_index;
             }
         }
     }
@@ -864,7 +864,7 @@ PointValueHistory<dim>::evaluate_field(
                   data_store_field
                     ->second[data_store_index * n_stored + store_index]
                     .push_back(computed_quantities[0](comp));
-                  store_index++;
+                  ++store_index;
                 }
             }
         }
@@ -952,7 +952,7 @@ PointValueHistory<dim>::evaluate_field_at_requested_location(
               data_store_field
                 ->second[data_store_index * n_stored + store_index]
                 .push_back(value(comp));
-              store_index++;
+              ++store_index;
             }
         }
     }
index 197bcb853c079c59370bdc1ced182d19ad086898..f0e21a920f14b4c792885b3c3e0d7eb932f581b4 100644 (file)
@@ -1851,7 +1851,7 @@ namespace Particles
                         parallel_triangulation->get_communicator(),
                         &(requests[send_ops]));
             AssertThrowMPI(ierr);
-            send_ops++;
+            ++send_ops;
           }
 
       for (unsigned int i = 0; i < n_neighbors; ++i)
@@ -1866,7 +1866,7 @@ namespace Particles
                         parallel_triangulation->get_communicator(),
                         &(requests[send_ops + recv_ops]));
             AssertThrowMPI(ierr);
-            recv_ops++;
+            ++recv_ops;
           }
       const int ierr =
         MPI_Waitall(send_ops + recv_ops, requests.data(), MPI_STATUSES_IGNORE);
@@ -2009,7 +2009,7 @@ namespace Particles
                         parallel_triangulation->get_communicator(),
                         &(requests[send_ops]));
             AssertThrowMPI(ierr);
-            send_ops++;
+            ++send_ops;
           }
 
       for (unsigned int i = 0; i < neighbors.size(); ++i)
@@ -2024,7 +2024,7 @@ namespace Particles
                         parallel_triangulation->get_communicator(),
                         &(requests[send_ops + recv_ops]));
             AssertThrowMPI(ierr);
-            recv_ops++;
+            ++recv_ops;
           }
       const int ierr =
         MPI_Waitall(send_ops + recv_ops, requests.data(), MPI_STATUSES_IGNORE);
index 6d57319cb7a4c3550fdffa159fbabac907e3ad06..bac6cab4594c869f7f04f4c6e3188fcbc8bdcc19 100644 (file)
@@ -166,7 +166,7 @@ namespace SUNDIALS
         while (solver_should_restart(t, solution, solution_dot))
           reset(t, h, solution, solution_dot);
 
-        step_number++;
+        ++step_number;
 
         output_step(t, solution, solution_dot, step_number);
       }

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.