]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Mark loop indices as 'const' where possible. 15315/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 6 Jun 2023 14:21:06 +0000 (08:21 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 6 Jun 2023 14:31:11 +0000 (08:31 -0600)
57 files changed:
examples/step-11/step-11.cc
examples/step-15/step-15.cc
examples/step-51/step-51.cc
examples/step-60/step-60.cc
examples/step-72/step-72.cc
examples/step-79/step-79.cc
examples/step-85/step-85.cc
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/fe_data.h
include/deal.II/fe/fe_interface_values.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/loop.h
include/deal.II/non_matching/fe_values.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_rhs.templates.h
source/base/data_out_base.cc
source/base/partitioner.cc
source/base/polynomials_barycentric.cc
source/base/polynomials_bernardi_raugel.cc
source/base/qprojector.cc
source/dofs/dof_renumbering.cc
source/fe/fe_abf.cc
source/fe/fe_bernardi_raugel.cc
source/fe/fe_face.cc
source/fe/fe_raviart_thomas.cc
source/grid/grid_generator.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/matrix_free/task_info.cc
source/opencascade/utilities.cc
tests/dofs/n_boundary_dofs_03.cc
tests/feinterface/fe_interface_values_11.cc
tests/grid/closest_point.cc
tests/grid/grid_in_gmsh_04.cc
tests/grid/grid_tools_cache_04.cc
tests/grid/reference_cell_type_04.cc
tests/hp/n_boundary_dofs_03.cc
tests/matrix_free/parallel_multigrid_interleave.cc
tests/matrix_free/parallel_multigrid_interleave_renumber.cc
tests/matrix_free/solver_cg_interleave.cc
tests/mpi/mg_ghost_layer_periodic.cc
tests/multigrid/renumbering_05.cc
tests/multigrid/renumbering_06.cc
tests/multigrid/renumbering_07.cc
tests/multigrid/renumbering_08.cc
tests/non_matching/fe_interface_values.cc
tests/non_matching/fe_interface_values_non_standard_meshes.cc
tests/non_matching/mesh_classifier.cc
tests/performance/timing_mg_glob_coarsen.cc
tests/performance/timing_navier_stokes.cc
tests/performance/timing_step_37.cc

index 8e7df42e14c186d84bfeba551f54f57a91379f3b..0fd784bc2a9d09a4bead76d89c7236cc9d476290 100644 (file)
@@ -159,7 +159,7 @@ namespace Step11
     // of what is to come later:
     mean_value_constraints.clear();
     mean_value_constraints.add_line(first_boundary_dof);
-    for (types::global_dof_index i : boundary_dofs)
+    for (const types::global_dof_index i : boundary_dofs)
       if (i != first_boundary_dof)
         mean_value_constraints.add_entry(first_boundary_dof, i, -1);
     mean_value_constraints.close();
index 09e5c42693ca2f77cc123af2e4eb2507d2f51cea..f6f3567b66237038128e29823971f672d1d2736e 100644 (file)
@@ -561,7 +561,7 @@ namespace Step15
     // function from namespace DoFTools:
     hanging_node_constraints.condense(residual);
 
-    for (types::global_dof_index i :
+    for (const types::global_dof_index i :
          DoFTools::extract_boundary_dofs(dof_handler))
       residual(i) = 0;
 
index 05702de80707461245a3656c8de2417d05b9f57f..2b5dd127e05ac9e294547e6e266f9e72f651b98c 100644 (file)
@@ -544,14 +544,14 @@ namespace Step51
       , fe_support_on_face(GeometryInfo<dim>::faces_per_cell)
       , exact_solution()
     {
-      for (unsigned int face_no : GeometryInfo<dim>::face_indices())
+      for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
         for (unsigned int i = 0; i < fe_local.n_dofs_per_cell(); ++i)
           {
             if (fe_local.has_support_on_face(i, face_no))
               fe_local_support_on_face[face_no].push_back(i);
           }
 
-      for (unsigned int face_no : GeometryInfo<dim>::face_indices())
+      for (const unsigned int face_no : GeometryInfo<dim>::face_indices())
         for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i)
           {
             if (fe.has_support_on_face(i, face_no))
index b9d9d16d9391beefadbac193d2fa97d6b8bda080..290d0638940dd635751eb5db22b5514c43751707 100644 (file)
@@ -857,7 +857,7 @@ namespace Step60
     space_dh->distribute_dofs(*space_fe);
 
     DoFTools::make_hanging_node_constraints(*space_dh, constraints);
-    for (auto id : parameters.dirichlet_ids)
+    for (const types::boundary_id id : parameters.dirichlet_ids)
       {
         VectorTools::interpolate_boundary_values(
           *space_dh, id, embedding_dirichlet_boundary_function, constraints);
index 8b7a995dc7d3181f03b1b544949cba192e51b7de..ca3783e0a296f1743b0385561dccbc8c427d83b3 100644 (file)
@@ -959,7 +959,7 @@ namespace Step72
 
     hanging_node_constraints.condense(residual);
 
-    for (types::global_dof_index i :
+    for (const types::global_dof_index i :
          DoFTools::extract_boundary_dofs(dof_handler))
       residual(i) = 0;
 
index 7491db973ae6aee00cf4bdf812048b150efcf284..56af640b3fd619fb63444c4e4d101f1f15f03aec 100644 (file)
@@ -1772,7 +1772,7 @@ namespace SAND
       SolutionBlocks::density_lower_slack_multiplier,
       SolutionBlocks::density_upper_slack_multiplier};
     double constraint_norm = 0;
-    for (unsigned int multiplier_i : equality_constraint_multipliers)
+    for (const unsigned int multiplier_i : equality_constraint_multipliers)
       constraint_norm += system_rhs.block(multiplier_i).linfty_norm();
 
 
index 63466872b85c84816ac9a7f7c6676f004516f5bc..54e17869e7efbdf8f52b7bc6f6794aaada8a44f3 100644 (file)
@@ -481,7 +481,7 @@ namespace Step85
         // using FEInterfaceValues. Assembling in this we will traverse each
         // internal face in the mesh twice, so in order to get the penalty
         // constant we expect, we multiply the penalty term with a factor 1/2.
-        for (unsigned int f : cell->face_indices())
+        for (const unsigned int f : cell->face_indices())
           if (face_has_ghost_penalty(cell, f))
             {
               const unsigned int invalid_subface =
index d91099f8d1ca005eace651171e7d96a69d836f6f..d6e6e969aabecda83a406bdde31b324a6bfd832e 100644 (file)
@@ -1168,7 +1168,7 @@ namespace Differentiation
      *       // Add contribution from external energy:
      *       // Loop over faces and accumulate external energy into cell
      *       // total energy.
-     *       for (unsigned int face : ...)
+     *       for (const unsigned int face : ...)
      *         if (cell->face(face)->at_boundary())
      *           energy_ad += ...
      *
@@ -1498,7 +1498,7 @@ namespace Differentiation
      *       // linearized.
      *       // Loop over faces and accumulate external contributions into the
      *       // cell total residual.
-     *       for (unsigned int face : ...)
+     *       for (const unsigned int face : ...)
      *         if (cell->face(face)->at_boundary())
      *           residual_ad[I] += ...
      *
index dcbade4d6d5434ee1a537be4d832cd9bfe9de975..e07fd2da78ca75a9767edd18c5ec3ec8588c41c8 100644 (file)
@@ -2481,7 +2481,7 @@ DoFCellAccessor<dimension_, space_dimension_, level_dof_access>::
     GeometryInfo<dimension_>::faces_per_cell>
     face_iterators(this->n_faces());
 
-  for (unsigned int i : this->face_indices())
+  for (const unsigned int i : this->face_indices())
     face_iterators[i] =
       dealii::internal::DoFCellAccessorImplementation::get_face(
         *this, i, std::integral_constant<int, dimension_>());
index a7bf0907c88944dcc52f49a66c2558141db33ca8..3689d511d660e43cae9ae739b66537ade745af01 100644 (file)
@@ -986,7 +986,7 @@ internal::GenericDoFsPerObject::generate(const FiniteElementData<dim> &fe)
 
   unsigned int counter = 0;
 
-  for (unsigned int v : reference_cell.vertex_indices())
+  for (const unsigned int v : reference_cell.vertex_indices())
     {
       const auto c = fe.template n_dofs_per_object<0>(v);
 
@@ -998,7 +998,7 @@ internal::GenericDoFsPerObject::generate(const FiniteElementData<dim> &fe)
     }
 
   if (dim >= 2)
-    for (unsigned int l : reference_cell.line_indices())
+    for (const unsigned int l : reference_cell.line_indices())
       {
         const auto c = fe.template n_dofs_per_object<1>(l);
 
@@ -1011,7 +1011,7 @@ internal::GenericDoFsPerObject::generate(const FiniteElementData<dim> &fe)
       }
 
   if (dim == 3)
-    for (unsigned int f : reference_cell.face_indices())
+    for (const unsigned int f : reference_cell.face_indices())
       {
         const auto c = fe.template n_dofs_per_object<2>(f);
 
@@ -1040,7 +1040,7 @@ internal::GenericDoFsPerObject::generate(const FiniteElementData<dim> &fe)
     }
 
   result.first_object_index_on_face.resize(3);
-  for (unsigned int face_no : reference_cell.face_indices())
+  for (const unsigned int face_no : reference_cell.face_indices())
     {
       result.first_object_index_on_face[0].emplace_back(0);
 
index 0b0abe84ea69b70b6573ea5e2fb28a530161b3a9..ce27122f7df99bec3e7d26c360728dcef665308f 100644 (file)
@@ -3489,7 +3489,7 @@ namespace FEInterfaceViews
 
     AssertDimension(interface_dof_indices.size(), local_dof_values.size());
 
-    for (unsigned int i : this->fe_interface->dof_indices())
+    for (const unsigned int i : this->fe_interface->dof_indices())
       local_dof_values[i] = dof_values(interface_dof_indices[i]);
   }
 
@@ -4044,7 +4044,7 @@ namespace FEInterfaceViews
   {
     AssertDimension(hessians.size(), this->fe_interface->n_quadrature_points);
 
-    for (unsigned int dof_index : this->fe_interface->dof_indices())
+    for (const unsigned int dof_index : this->fe_interface->dof_indices())
       for (const auto q_index : this->fe_interface->quadrature_point_indices())
         {
           if (dof_index == 0)
@@ -4088,7 +4088,7 @@ namespace FEInterfaceViews
     AssertDimension(third_derivatives.size(),
                     this->fe_interface->n_quadrature_points);
 
-    for (unsigned int dof_index : this->fe_interface->dof_indices())
+    for (const unsigned int dof_index : this->fe_interface->dof_indices())
       for (const auto q_index : this->fe_interface->quadrature_point_indices())
         {
           if (dof_index == 0)
@@ -4681,7 +4681,7 @@ namespace FEInterfaceViews
   {
     AssertDimension(hessians.size(), this->fe_interface->n_quadrature_points);
 
-    for (unsigned int dof_index : this->fe_interface->dof_indices())
+    for (const unsigned int dof_index : this->fe_interface->dof_indices())
       for (const auto q_index : this->fe_interface->quadrature_point_indices())
         {
           if (dof_index == 0)
@@ -4725,7 +4725,7 @@ namespace FEInterfaceViews
     AssertDimension(third_derivatives.size(),
                     this->fe_interface->n_quadrature_points);
 
-    for (unsigned int dof_index : this->fe_interface->dof_indices())
+    for (const unsigned int dof_index : this->fe_interface->dof_indices())
       for (const auto q_index : this->fe_interface->quadrature_point_indices())
         {
           if (dof_index == 0)
index 958f8d49137df03a6db1e8caf29df607b9b6a86c..e92a89927195d762c205da35df1b51cc2a255740 100644 (file)
@@ -979,7 +979,7 @@ namespace internal
         // For 2d cells the access cell->line_orientation() is already
         // efficient
         std::array<unsigned int, 4> line_indices = {};
-        for (unsigned int line : cell.line_indices())
+        for (const unsigned int line : cell.line_indices())
           line_indices[line] = cell.line_index(line);
         return line_indices;
       }
@@ -1096,7 +1096,7 @@ namespace internal
         // For 2d cells the access cell->line_orientation() is already
         // efficient
         std::array<bool, 4> line_orientations = {};
-        for (unsigned int line : cell.line_indices())
+        for (const unsigned int line : cell.line_indices())
           line_orientations[line] = cell.line_orientation(line);
         return line_orientations;
       }
@@ -3508,7 +3508,7 @@ CellAccessor<dim, spacedim>::face_iterators() const
     GeometryInfo<dim>::faces_per_cell>
     face_iterators(this->n_faces());
 
-  for (unsigned int i : this->face_indices())
+  for (const unsigned int i : this->face_indices())
     face_iterators[i] =
       dealii::internal::CellAccessorImplementation::get_face(*this, i);
 
index ad4d51ae13aa12e1d8ce3b24d5cabcd118c61d98..da8c582607786cc1304a2ce4e930ad07c445f2c8 100644 (file)
@@ -431,7 +431,7 @@ namespace MeshWorker
     : cell(seed)
     , cell_valid(true)
   {
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         exterior[i]                = seed;
         interior[i]                = seed;
@@ -447,7 +447,7 @@ namespace MeshWorker
     : cell(other.cell)
     , cell_valid(other.cell_valid)
   {
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         exterior[i]                = other.exterior[i];
         interior[i]                = other.interior[i];
@@ -463,7 +463,7 @@ namespace MeshWorker
   {
     cell       = other.cell;
     cell_valid = other.cell_valid;
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         exterior[i]                = other.exterior[i];
         interior[i]                = other.interior[i];
@@ -479,7 +479,7 @@ namespace MeshWorker
   DoFInfoBox<dim, DOFINFO>::reset()
   {
     cell_valid = false;
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         interior_face_available[i] = false;
         exterior_face_available[i] = false;
@@ -496,7 +496,7 @@ namespace MeshWorker
       return;
 
     assembler.assemble(cell);
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         // Only do something if data available
         if (interior_face_available[i])
index 3f28a88d189855222e7323099f058466f4507215..db07dfdfd6dd81f636c8571bf1eab141fde7d87f 100644 (file)
@@ -454,7 +454,7 @@ namespace MeshWorker
     DoFInfoBox<dim, DOFINFO> dof_info(dinfo);
 
     assembler.initialize_info(dof_info.cell, false);
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       {
         assembler.initialize_info(dof_info.interior[i], true);
         assembler.initialize_info(dof_info.exterior[i], true);
index 1ca47ef735c2cdeb4c7088413a372d7e4b6b4def..bad04ef05a58b84c28cb3719b5480849c4f85f9d 100644 (file)
@@ -402,7 +402,7 @@ namespace NonMatching
    *
    *  for (const auto &cell : dof_handler.active_cell_iterators())
    *    {
-   *      for (unsigned int face_index : cell->face_indices())
+   *      for (const unsigned int face_index : cell->face_indices())
    *        {
    *          if (cell->at_boundary(face_index))
    *            fe_interface_values.reinit(cell, face_index);
index e10f9dd0b4a89c78a385d418acaf77912f352808..4c8302066611ea2df341574c766127436a3e78b2 100644 (file)
@@ -2405,7 +2405,7 @@ namespace VectorTools
     const hp::MappingCollection<dim> mapping_collection(mapping);
     hp::QCollection<dim>             quadrature_collection;
 
-    for (unsigned int face : GeometryInfo<dim>::face_indices())
+    for (const unsigned int face : GeometryInfo<dim>::face_indices())
       quadrature_collection.push_back(QProjector<dim>::project_to_face(
         ReferenceCells::get_hypercube<dim>(), face_quadrature, face));
 
@@ -2567,7 +2567,7 @@ namespace VectorTools
 
         face_quadrature_collection.push_back(quadrature);
 
-        for (unsigned int face : GeometryInfo<dim>::face_indices())
+        for (const unsigned int face : GeometryInfo<dim>::face_indices())
           quadrature_collection.push_back(QProjector<dim>::project_to_face(
             ReferenceCells::get_hypercube<dim>(), quadrature, face));
       }
index cc0472b56ae525f299d9a79799ee58ef71d55fbe..5c4de64eadb0bfcd359c669535c0e7dbd9bec9be 100644 (file)
@@ -68,7 +68,7 @@ namespace VectorTools
         std::vector<double> rhs_values(n_q_points);
 
         for (const auto &cell : dof_handler.active_cell_iterators())
-          for (unsigned int face : cell->face_indices())
+          for (const unsigned int face : cell->face_indices())
             if (cell->face(face)->at_boundary() &&
                 (boundary_ids.empty() ||
                  (boundary_ids.find(cell->face(face)->boundary_id()) !=
@@ -99,7 +99,7 @@ namespace VectorTools
                                                Vector<double>(n_components));
 
         for (const auto &cell : dof_handler.active_cell_iterators())
-          for (unsigned int face : cell->face_indices())
+          for (const unsigned int face : cell->face_indices())
             if (cell->face(face)->at_boundary() &&
                 (boundary_ids.empty() ||
                  (boundary_ids.find(cell->face(face)->boundary_id()) !=
@@ -207,7 +207,7 @@ namespace VectorTools
         std::vector<double> rhs_values;
 
         for (const auto &cell : dof_handler.active_cell_iterators())
-          for (unsigned int face : cell->face_indices())
+          for (const unsigned int face : cell->face_indices())
             if (cell->face(face)->at_boundary() &&
                 (boundary_ids.empty() ||
                  (boundary_ids.find(cell->face(face)->boundary_id()) !=
@@ -245,7 +245,7 @@ namespace VectorTools
         std::vector<Vector<double>> rhs_values;
 
         for (const auto &cell : dof_handler.active_cell_iterators())
-          for (unsigned int face : cell->face_indices())
+          for (const unsigned int face : cell->face_indices())
             if (cell->face(face)->at_boundary() &&
                 (boundary_ids.empty() ||
                  (boundary_ids.find(cell->face(face)->boundary_id()) !=
index 51319b8c7243050e7a6d1269097534cb3521f5d0..995b4ef53b62f436f14715101f755ca997c63871 100644 (file)
@@ -1775,7 +1775,7 @@ namespace DataOutBase
   // all the other data has a constructor of its own, except for the "neighbors"
   // field, which we set to invalid values.
   {
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       neighbors[i] = no_neighbor;
 
     AssertIndexRange(dim, spacedim + 1);
@@ -1797,7 +1797,7 @@ namespace DataOutBase
       if (vertices[i].distance(patch.vertices[i]) > epsilon)
         return false;
 
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       if (neighbors[i] != patch.neighbors[i])
         return false;
 
@@ -9343,7 +9343,7 @@ DataOutReader<dim, spacedim>::merge(const DataOutReader<dim, spacedim> &source)
 
   // adjust patch neighbors
   for (unsigned int i = old_n_patches; i < patches.size(); ++i)
-    for (unsigned int n : GeometryInfo<dim>::face_indices())
+    for (const unsigned int n : GeometryInfo<dim>::face_indices())
       if (patches[i].neighbors[n] !=
           dealii::DataOutBase::Patch<dim, spacedim>::no_neighbor)
         patches[i].neighbors[n] += old_n_patches;
@@ -9698,7 +9698,7 @@ namespace DataOutBase
       out << patch.vertices[i] << ' ';
     out << '\n';
 
-    for (unsigned int i : patch.reference_cell.face_indices())
+    for (const unsigned int i : patch.reference_cell.face_indices())
       out << patch.neighbors[i] << ' ';
     out << '\n';
 
@@ -9758,7 +9758,7 @@ namespace DataOutBase
     for (const unsigned int i : patch.reference_cell.vertex_indices())
       in >> patch.vertices[i];
 
-    for (unsigned int i : patch.reference_cell.face_indices())
+    for (const unsigned int i : patch.reference_cell.face_indices())
       in >> patch.neighbors[i];
 
     in >> patch.patch_index;
index 69b554daf44acf87279ed3cb1ceb0f5f88932741..0da3446be9f3047705f1c68ca8ae2db34b5e0610 100644 (file)
@@ -423,7 +423,7 @@ namespace Utilities
           // first translate tight ghost indices into indices within the large
           // set:
           std::vector<unsigned int> expanded_numbering;
-          for (dealii::IndexSet::size_type index : ghost_indices_data)
+          for (const dealii::IndexSet::size_type index : ghost_indices_data)
             {
               Assert(larger_ghost_index_set.is_element(index),
                      ExcMessage("The given larger ghost index set must contain "
index 51fca09d990ddf3197ce5d8187b1e8e758f591bd..50562c17a966aae1516a5892fbaa5d7e96513fc7 100644 (file)
@@ -71,18 +71,18 @@ BarycentricPolynomials<dim>::get_fe_p_basis(const unsigned int degree)
         break;
       case 1:
         {
-          for (unsigned int v : reference_cell.vertex_indices())
+          for (const unsigned int v : reference_cell.vertex_indices())
             polys.push_back(BarycentricPolynomial<dim, double>::monomial(v));
           break;
         }
       case 2:
         {
           // vertices, then lines:
-          for (unsigned int v : reference_cell.vertex_indices())
+          for (const unsigned int v : reference_cell.vertex_indices())
             polys.push_back(
               BarycentricPolynomial<dim, double>::monomial(v) *
               (2 * BarycentricPolynomial<dim, double>::monomial(v) - 1));
-          for (unsigned int l : reference_cell.line_indices())
+          for (const unsigned int l : reference_cell.line_indices())
             {
               const auto v0 = reference_cell.line_to_cell_vertices(l, 0);
               const auto v1 = reference_cell.line_to_cell_vertices(l, 1);
index c8da53b790361c81aaf20f6a4a66ef46a70810f4..66c608669edd25540115e49f492effbf8456c5d7 100644 (file)
@@ -121,7 +121,7 @@ PolynomialsBernardiRaugel<dim>::evaluate(
   // Normal vectors point in the +x, +y, and +z directions for
   // consistent orientation across edges
   std::vector<Tensor<1, dim>> normals;
-  for (unsigned int i : GeometryInfo<dim>::face_indices())
+  for (const unsigned int i : GeometryInfo<dim>::face_indices())
     {
       Tensor<1, dim> normal;
       normal[i / 2] = 1;
index 115534e5f738ea1086ef0ba2c127ec20ed6f7332..5598ae0a849f41d46ba9295e22c05f797201c6d5 100644 (file)
@@ -985,11 +985,11 @@ QProjector<3>::project_to_all_faces(const ReferenceCell &     reference_cell,
     {
       std::vector<std::vector<Point<3>>> face_vertex_locations(
         reference_cell.n_faces());
-      for (unsigned int f : reference_cell.face_indices())
+      for (const unsigned int f : reference_cell.face_indices())
         {
           face_vertex_locations[f].resize(
             reference_cell.face_reference_cell(f).n_vertices());
-          for (unsigned int v :
+          for (const unsigned int v :
                reference_cell.face_reference_cell(f).vertex_indices())
             face_vertex_locations[f][v] =
               reference_cell.face_vertex_location<3>(f, v);
index 27173191e8636e123d31edfa7785b29783b3f92b..49294ad25b94fb9f30d6ffbf1ff39f2bfcd824ba 100644 (file)
@@ -2766,7 +2766,7 @@ namespace DoFRenumbering
               // cell batch range that touched a particular dof)
               data.get_dof_info(component).get_dof_indices_on_cell_batch(
                 dofs_extracted, cell);
-              for (unsigned int dof_index : dofs_extracted)
+              for (const unsigned int dof_index : dofs_extracted)
                 if (dof_index < n_owned_dofs &&
                     last_touch_by_cell_batch_range[dof_index] !=
                       cell_range.first)
@@ -2847,7 +2847,7 @@ namespace DoFRenumbering
     // comparator for std::sort to then order the unknowns by the specified
     // matrix-free loop order
     const std::vector<unsigned int> &purely_local_dofs = dofs_by_rank_access[0];
-    for (unsigned int i : purely_local_dofs)
+    for (const unsigned int i : purely_local_dofs)
       if (local_numbering.second[i] == 1)
         new_numbers.push_back(i);
 
index 2a33a32501e20d490f166fa1fcbe7cf715693fe2..d2d77fb8d93f4e11fe7cf021e58867e883d527c8 100644 (file)
@@ -354,7 +354,7 @@ FE_ABF<dim>::initialize_restriction()
   const unsigned int n_face_points = q_base.size();
   // First, compute interpolation on
   // subfaces
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     {
       // The shape functions of the
       // child cell are evaluated
@@ -577,7 +577,7 @@ FE_ABF<dim>::convert_generalized_support_point_values_to_dof_values(
   std::fill(nodal_values.begin(), nodal_values.end(), 0.);
 
   const unsigned int n_face_points = boundary_weights.size(0);
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     for (unsigned int k = 0; k < n_face_points; ++k)
       for (unsigned int i = 0; i < boundary_weights.size(1); ++i)
         {
@@ -616,7 +616,7 @@ FE_ABF<dim>::convert_generalized_support_point_values_to_dof_values(
           support_point_values[k + start_cell_points][d];
 
   // Face integral of ABF terms
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     {
       const double n_orient = GeometryInfo<dim>::unit_normal_orientation[face];
       for (unsigned int fp = 0; fp < n_face_points; ++fp)
index 3e5948bcc423553395c47a63b3590ff2bc537224..96ed620b28230eb87c72f5492d3b04f105697220 100644 (file)
@@ -121,7 +121,7 @@ FE_BernardiRaugel<dim>::convert_generalized_support_point_values_to_dof_values(
          ExcDimensionMismatch(nodal_values.size(), this->n_dofs_per_cell()));
 
   std::vector<Tensor<1, dim>> normals;
-  for (unsigned int i : GeometryInfo<dim>::face_indices())
+  for (const unsigned int i : GeometryInfo<dim>::face_indices())
     {
       Tensor<1, dim> normal;
       normal[i / 2] = 1;
index f6224e8b128416f8c8081b73b8be79aef02c4d3c..7b717d281ab64e30dcdbc164ba2f7ee3aeb27c66 100644 (file)
@@ -994,7 +994,7 @@ std::pair<Table<2, bool>, std::vector<unsigned int>>
 FE_FaceP<dim, spacedim>::get_constant_modes() const
 {
   Table<2, bool> constant_modes(1, this->n_dofs_per_cell());
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     constant_modes(0, face * this->n_dofs_per_face(face)) = true;
   return std::pair<Table<2, bool>, std::vector<unsigned int>>(
     constant_modes, std::vector<unsigned int>(1, 0));
index feec5a9f7adac48cdc6d22e524d6359fb9bff556..97690fed0495b62d33be816b9cca95e25c10c57d 100644 (file)
@@ -446,7 +446,7 @@ FE_RaviartThomas<dim>::initialize_restriction()
   const unsigned int n_face_points = q_base.size();
   // First, compute interpolation on
   // subfaces
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     {
       // The shape functions of the
       // child cell are evaluated
@@ -681,7 +681,7 @@ FE_RaviartThomas<dim>::convert_generalized_support_point_values_to_dof_values(
   std::fill(nodal_values.begin(), nodal_values.end(), 0.);
 
   const unsigned int n_face_points = boundary_weights.size(0);
-  for (unsigned int face : GeometryInfo<dim>::face_indices())
+  for (const unsigned int face : GeometryInfo<dim>::face_indices())
     for (unsigned int k = 0; k < n_face_points; ++k)
       for (unsigned int i = 0; i < boundary_weights.size(1); ++i)
         {
index 24f41c29076f315dcbff1fca8dff0b7b1c43c7bc..6379bf1d90854ea511d1505948984deb97c3e265 100644 (file)
@@ -917,7 +917,7 @@ namespace GridGenerator
         set_boundary_ids(Triangulation<2> &tria)
         {
           for (auto cell : tria.active_cell_iterators())
-            for (unsigned int f : GeometryInfo<2>::face_indices())
+            for (const unsigned int f : GeometryInfo<2>::face_indices())
               {
                 if (cell->face(f)->at_boundary() == false)
                   continue;
@@ -1463,7 +1463,7 @@ namespace GridGenerator
       Triangulation<3>::cell_iterator cell = tria.begin();
 
       for (; cell != tria.end(); ++cell)
-        for (unsigned int f : GeometryInfo<3>::face_indices())
+        for (const unsigned int f : GeometryInfo<3>::face_indices())
           {
             if (!cell->face(f)->at_boundary())
               continue;
@@ -2096,7 +2096,7 @@ namespace GridGenerator
     for (auto &cell : tria.cell_iterators())
       {
         // identify faces on torus surface and set manifold to 1
-        for (unsigned int f : GeometryInfo<3>::face_indices())
+        for (const unsigned int f : GeometryInfo<3>::face_indices())
           {
             // faces 4 and 5 are those with normal vector aligned with torus
             // centerline
@@ -3016,7 +3016,7 @@ namespace GridGenerator
         for (; cell != endc; ++cell)
           {
             Point<2> cell_center = cell->center();
-            for (unsigned int f : GeometryInfo<2>::face_indices())
+            for (const unsigned int f : GeometryInfo<2>::face_indices())
               if (cell->face(f)->boundary_id() == 0)
                 {
                   Point<2> face_center = cell->face(f)->center();
@@ -3847,7 +3847,7 @@ namespace GridGenerator
 
     std::vector<Point<spacedim>> points;
     unsigned int                 n_cells = 1;
-    for (unsigned int i : GeometryInfo<dim>::face_indices())
+    for (const unsigned int i : GeometryInfo<dim>::face_indices())
       n_cells += sizes[i];
 
     std::vector<CellData<dim>> cells(n_cells);
@@ -4567,7 +4567,7 @@ namespace GridGenerator
 
     while (cell != end)
       {
-        for (unsigned int i : GeometryInfo<dim>::face_indices())
+        for (const unsigned int i : GeometryInfo<dim>::face_indices())
           {
             if (cell->face(i)->boundary_id() ==
                 numbers::internal_face_boundary_id)
@@ -4634,7 +4634,7 @@ namespace GridGenerator
 
     while (cell != end)
       {
-        for (unsigned int i : GeometryInfo<2>::face_indices())
+        for (const unsigned int i : GeometryInfo<2>::face_indices())
           {
             if (cell->face(i)->boundary_id() ==
                 numbers::internal_face_boundary_id)
@@ -5582,7 +5582,7 @@ namespace GridGenerator
     const double tolerance = 1e-5 * std::min(radius, half_length);
 
     for (const auto &cell : tria.cell_iterators())
-      for (unsigned int i : GeometryInfo<3>::face_indices())
+      for (const unsigned int i : GeometryInfo<3>::face_indices())
         if (cell->at_boundary(i))
           {
             if (cell->face(i)->center()(0) > half_length - tolerance)
@@ -5691,7 +5691,7 @@ namespace GridGenerator
     tria.set_all_manifold_ids_on_boundary(0);
     while (cell != end)
       {
-        for (unsigned int i : GeometryInfo<dim>::face_indices())
+        for (const unsigned int i : GeometryInfo<dim>::face_indices())
           {
             if (cell->face(i)->boundary_id() ==
                 numbers::internal_face_boundary_id)
@@ -5801,7 +5801,7 @@ namespace GridGenerator
     // set to one
     while (cell != end)
       {
-        for (unsigned int i : GeometryInfo<3>::face_indices())
+        for (const unsigned int i : GeometryInfo<3>::face_indices())
           {
             if (!cell->at_boundary(i))
               continue;
@@ -5900,7 +5900,7 @@ namespace GridGenerator
         for (const auto &cell : tria_copy.cell_iterators())
           {
             CellData<dim> data;
-            for (unsigned int v : GeometryInfo<dim>::vertex_indices())
+            for (const unsigned int v : GeometryInfo<dim>::vertex_indices())
               data.vertices[v] = cell->vertex_index(v);
             data.material_id = cell->material_id();
             data.manifold_id = cell->manifold_id();
@@ -6281,7 +6281,7 @@ namespace GridGenerator
         // to all faces in a first step.
         Triangulation<3>::cell_iterator cell = tria.begin();
         for (; cell != tria.end(); ++cell)
-          for (unsigned int i : GeometryInfo<3>::face_indices())
+          for (const unsigned int i : GeometryInfo<3>::face_indices())
             if (cell->at_boundary(i))
               cell->face(i)->set_all_boundary_ids(2);
 
@@ -6290,7 +6290,7 @@ namespace GridGenerator
         // boundary. Then decide whether the center is nearer to the inner
         // or outer boundary to set the correct boundary id.
         for (cell = tria.begin(); cell != tria.end(); ++cell)
-          for (unsigned int i : GeometryInfo<3>::face_indices())
+          for (const unsigned int i : GeometryInfo<3>::face_indices())
             if (cell->at_boundary(i))
               {
                 const Triangulation<3>::face_iterator face = cell->face(i);
@@ -8341,7 +8341,7 @@ namespace GridGenerator
            volume_mesh.begin(0);
          cell != volume_mesh.end(0);
          ++cell)
-      for (unsigned int i : GeometryInfo<dim>::face_indices())
+      for (const unsigned int i : GeometryInfo<dim>::face_indices())
         {
           const typename MeshType<dim, spacedim>::face_iterator face =
             cell->face(i);
index 24e456b551a280dfc631654a62d77afa1911062b..8fcb229b8d143bfc70dd569a8edbfa63a65afb9b 100644 (file)
@@ -83,7 +83,7 @@ namespace
     Triangulation<1, spacedim> &triangulation)
   {
     for (auto &cell : triangulation.active_cell_iterators())
-      for (unsigned int face_no : ReferenceCells::Line.face_indices())
+      for (const unsigned int face_no : ReferenceCells::Line.face_indices())
         if (cell->face(face_no)->at_boundary())
           for (const auto &pair : boundary_ids)
             if (cell->face(face_no)->vertex(0) == pair.first)
@@ -3902,7 +3902,7 @@ GridIn<dim, spacedim>::read_exodusii(
            elem_n += n_nodes_per_element)
         {
           CellData<dim> cell(type.n_vertices());
-          for (unsigned int i : type.vertex_indices())
+          for (const unsigned int i : type.vertex_indices())
             {
               cell.vertices[type.exodusii_vertex_to_deal_vertex(i)] =
                 connection[elem_n + i] - 1;
index 0525c8ddafe976c8ed533328f105e33aa281ef9d..99979ddf11e629788bc975c76ec20e8872ca88a6 100644 (file)
@@ -924,7 +924,7 @@ GridOut::write_dx(const Triangulation<dim, spacedim> &tria,
       for (const auto &cell : tria.active_cell_iterators())
         {
           // Little trick to get -1 for the interior
-          for (unsigned int f : GeometryInfo<dim>::face_indices())
+          for (const unsigned int f : GeometryInfo<dim>::face_indices())
             {
               out << ' '
                   << static_cast<std::make_signed<types::boundary_id>::type>(
@@ -3913,7 +3913,7 @@ GridOut::write_msh_faces(const Triangulation<dim, spacedim> &tria,
             << static_cast<unsigned int>(face->boundary_id()) << ' '
             << face->n_vertices();
         // note: vertex numbers are 1-base
-        for (unsigned int vertex : face->vertex_indices())
+        for (const unsigned int vertex : face->vertex_indices())
           {
             if (face->reference_cell() == ReferenceCells::Quadrilateral)
               out << ' '
index a889087b29fdb7398785b0310c01bbd66b12ac02..e3efdb2e1ca9eb1459fd1e9913e24dcd26824ac3 100644 (file)
@@ -611,7 +611,7 @@ namespace GridTools
                     line->manifold_id() != numbers::flat_manifold_id)
                   {
                     CellData<1> line_cell_data(line->n_vertices());
-                    for (unsigned int vertex_n : line->vertex_indices())
+                    for (const unsigned int vertex_n : line->vertex_indices())
                       line_cell_data.vertices[vertex_n] =
                         line->vertex_index(vertex_n);
                     line_cell_data.boundary_id = line->boundary_id();
@@ -2357,7 +2357,7 @@ namespace GridTools
       endc = tria.end();
     for (; cell != endc; ++cell)
       {
-        for (unsigned int i : cell->face_indices())
+        for (const unsigned int i : cell->face_indices())
           {
             const typename Triangulation<dim, spacedim>::face_iterator &face =
               cell->face(i);
@@ -3404,7 +3404,7 @@ namespace GridTools
     cell = triangulation.begin_active();
     for (; cell != endc; ++cell)
       {
-        for (unsigned int i : cell->face_indices())
+        for (const unsigned int i : cell->face_indices())
           {
             if ((cell->at_boundary(i) == false) &&
                 (cell->neighbor(i)->is_active()))
@@ -3542,7 +3542,7 @@ namespace GridTools
         // received.
         if (cell->is_ghost())
           {
-            for (unsigned int i : cell->face_indices())
+            for (const unsigned int i : cell->face_indices())
               {
                 if (cell->at_boundary(i) == false)
                   {
index f205d46ccc15815816c012d4e38a3a261e3f7834..0f22fcbc981d67f9d128d8594d403ba2be63a093 100644 (file)
@@ -2265,7 +2265,7 @@ namespace GridTools
          cell != mesh.end(0);
          ++cell)
       {
-        for (unsigned int i : cell->face_indices())
+        for (const unsigned int i : cell->face_indices())
           {
             const typename MeshType::face_iterator face = cell->face(i);
             if (face->at_boundary() && face->boundary_id() == b_id1)
index 2890f0a60f79fb97e3f5b895476aec27640fdc18..9db558868d53b59af4773300d4c1fcc9fe8a8b9a 100644 (file)
@@ -10906,7 +10906,7 @@ namespace internal
           return true;
 
         const RefinementCase<dim> ref_case = cell->refinement_case();
-        for (unsigned int n : GeometryInfo<dim>::face_indices())
+        for (const unsigned int n : GeometryInfo<dim>::face_indices())
           {
             // if the cell is not refined along that face, coarsening
             // will not change anything, so do nothing. the same
@@ -14952,7 +14952,7 @@ void Triangulation<dim, spacedim>::execute_coarsening()
             const unsigned int n_lines = std::min(cell->n_lines(), 12u);
             for (unsigned int l = 0; l < n_lines; ++l)
               ++line_cell_count[line_indices[l]];
-            for (unsigned int q : cell->face_indices())
+            for (const unsigned int q : cell->face_indices())
               ++quad_cell_count[cell->face_index(q)];
           }
         else
@@ -15234,7 +15234,7 @@ namespace
     // count all neighbors that will be refined along the face of our
     // cell after the next step
     unsigned int count = 0;
-    for (unsigned int n : GeometryInfo<dim>::face_indices())
+    for (const unsigned int n : GeometryInfo<dim>::face_indices())
       {
         const typename Triangulation<dim, spacedim>::cell_iterator neighbor =
           cell->neighbor(n);
index ea92e51557533024ce75b54a4f8b40d46c4bdcac..38bd3f5bf29caf4ed87856e63968c276c0c58006 100644 (file)
@@ -1734,9 +1734,9 @@ TriaAccessor<3, 3, 3>::set_all_manifold_ids(
   // for hexes also set manifold_id
   // of bounding quads and lines
 
-  for (unsigned int i : this->face_indices())
+  for (const unsigned int i : this->face_indices())
     this->quad(i)->set_manifold_id(manifold_ind);
-  for (unsigned int i : this->line_indices())
+  for (const unsigned int i : this->line_indices())
     this->line(i)->set_manifold_id(manifold_ind);
 }
 
index d50e46ff85baf445c45ea3cb3ef53252587e1fad..707ae45890816f931efab7f01014bed124c76fdd 100644 (file)
@@ -923,7 +923,7 @@ namespace internal
           // categories) to the 'other_cells'. The cells with correct group
           // size are immediately appended to the temporary cell numbering
           auto group_it = grouped_cells.begin();
-          for (unsigned int length : n_cells_per_group)
+          for (const unsigned int length : n_cells_per_group)
             if (length < n_cells_per_parent)
               for (unsigned int j = 0; j < length; ++j)
                 other_cells.push_back((group_it++)->second);
index 0c5c34309338445df5d19c32ced2cd1d532ba30f..6b8b7a19e0f1b0e7271cf008d6d015fb0d1ecc24 100644 (file)
@@ -612,7 +612,7 @@ namespace OpenCASCADE
     unsigned int face_index;
 
     for (const auto &cell : triangulation.active_cell_iterators())
-      for (unsigned int f : GeometryInfo<2>::face_indices())
+      for (const unsigned int f : GeometryInfo<2>::face_indices())
         if (cell->face(f)->at_boundary())
           {
             // get global face and vertex indices
index f5ae94d0fa41cd00e862d5fe15521d4bc23d915a..0b785cbfac8e634d11eaa012b5170bf63be64776 100644 (file)
@@ -70,7 +70,7 @@ test()
 
   dof_handler.distribute_dofs(fe);
 
-  for (types::boundary_id b : {12, 13, 14, 15})
+  for (const types::boundary_id b : {12, 13, 14, 15})
     {
       const unsigned int N =
         dof_handler.n_boundary_dofs(std::set<types::boundary_id>{b});
index fb6c170963d649f2d5fdfa6ac93a92d171380480..ece5e60dfb6cb40d6939ed9156efaa003e2641c5 100644 (file)
@@ -162,8 +162,8 @@ int
 main()
 {
   initlog();
-  for (unsigned int p : {1, 2})
+  for (const unsigned int p : {1, 2})
     test<2>(p);
-  for (unsigned int p : {1})
+  for (const unsigned int p : {1})
     test<3>(p);
 }
index 51cd7422872d43deaaef0bb1baa6d8d4782cbf27..75d4455f13d5aced62c416ffecf4852a415166ae 100644 (file)
@@ -21,7 +21,7 @@ test(const ReferenceCell &reference_cell,
 
   // The distance we get should be at least as good as the distance to the
   // nearest vertex
-  for (unsigned int vertex_no : reference_cell.vertex_indices())
+  for (const unsigned int vertex_no : reference_cell.vertex_indices())
     AssertThrow(distance_square <=
                   p.distance_square(
                     reference_cell.template vertex<dim>(vertex_no)),
index f8eac02427629c735bc38faaef20c09a68ae3485..703073866ccd73553338c92cc26fce2b633bfb79 100644 (file)
@@ -38,7 +38,7 @@ print_mesh_info(const Triangulation<dim, spacedim> &triangulation,
   {
     std::map<types::boundary_id, unsigned int> boundary_count;
     for (const auto &cell : triangulation.active_cell_iterators())
-      for (unsigned int face_no : cell->face_indices())
+      for (const unsigned int face_no : cell->face_indices())
         if (cell->face(face_no)->at_boundary())
           boundary_count[cell->face(face_no)->boundary_id()]++;
 
index 023435d65f0cd9eab6dcac3d49c33c56bd8d38e0..2756ab23c266ba612a3e6c23c97037d4c4801351 100644 (file)
@@ -75,7 +75,7 @@ test(unsigned int n_points)
     {
       // We know the owner as we're working on a shared triangulation
       unsigned int cell_owner = cells[c]->subdomain_id();
-      for (unsigned int idx : maps[c])
+      for (const unsigned int idx : maps[c])
         {
           std::vector<std::pair<BoundingBox<dim>, unsigned int>> test_results;
           global_description.query(bgi::intersects(points[idx]),
index cbb8a9a2d6b980687ee6170e25563c7d9b13853a..4aada6a30efe5c1a65d77dce46b4f64b3340d85c 100644 (file)
@@ -36,7 +36,7 @@ test(const ReferenceCell &reference_cell)
   const unsigned int n_samples        = 200000;
 
   // sanity check: does the reference cell contain its own nodes?
-  for (unsigned int vertex_no : reference_cell.vertex_indices())
+  for (const unsigned int vertex_no : reference_cell.vertex_indices())
     AssertThrow(reference_cell.contains_point(
                   reference_cell.template vertex<dim>(vertex_no)),
                 ExcInternalError());
index b0739adbc82fd724fa75efc0607e60a891d15429..f8e20c49fb747772bfc4eb6e411cfb7cd018b0f6 100644 (file)
@@ -82,7 +82,7 @@ test()
 
   dof_handler.distribute_dofs(fe);
 
-  for (types::boundary_id b : {12, 13, 14, 15})
+  for (const types::boundary_id b : {12, 13, 14, 15})
     {
       const unsigned int N =
         dof_handler.n_boundary_dofs(std::set<types::boundary_id>{b});
index 12f8b3c7f51b5331fa49432f53e5572e9fc5aecb..c94541c38be9ed6625b6b7240e9b39d2c8294d63 100644 (file)
@@ -137,7 +137,7 @@ public:
         const LinearAlgebra::distributed::Vector<number> &src) const
   {
     data.cell_loop(&LaplaceOperator::local_apply, this, dst, src, true);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) = src.local_element(i);
   }
 
@@ -170,7 +170,7 @@ public:
             const LinearAlgebra::distributed::Vector<number> &src) const
   {
     data.cell_loop(&LaplaceOperator::local_apply, this, dst, src);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) += src.local_element(i);
   }
 
index 1068373e64b5a2b1d8c57670a0eab87630c2ec09..65acfca996b814207a67e421ad923fc362e9bcf0 100644 (file)
@@ -178,7 +178,7 @@ public:
         const LinearAlgebra::distributed::Vector<number> &src) const
   {
     data.cell_loop(&LaplaceOperator::local_apply, this, dst, src, true);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) = src.local_element(i);
   }
 
@@ -211,7 +211,7 @@ public:
             const LinearAlgebra::distributed::Vector<number> &src) const
   {
     data.cell_loop(&LaplaceOperator::local_apply, this, dst, src);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) += src.local_element(i);
   }
 
index 88f92e2a5dd1fc2af421f301c8da8d02713eeaf8..94a83a3da5bc26bda4d5d217cc277d01ce62d1bf 100644 (file)
@@ -85,7 +85,7 @@ public:
            const std::pair<unsigned int, unsigned int> &)>
       function = helmholtz_operator<dim, -1, VectorType, 0>;
     data.cell_loop(function, dst, src, true);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) = src.local_element(i);
   }
 
@@ -106,7 +106,7 @@ public:
       function = helmholtz_operator<dim, -1, VectorType, 0>;
     data.cell_loop(
       function, dst, src, operation_before_loop, operation_after_loop);
-    for (unsigned int i : data.get_constrained_dofs())
+    for (const unsigned int i : data.get_constrained_dofs())
       dst.local_element(i) = src.local_element(i);
   }
 
index a1402027b498ac1612a7f4b9ea26c6ebab6ece39..39fe14c09cf841f608fcd0b5d8b0b640f3fd143c 100644 (file)
@@ -37,7 +37,7 @@ test()
   GridGenerator::subdivided_hyper_cube(tria, 3, 0., 1.);
 
   for (const auto &cell : tria.cell_iterators())
-    for (unsigned int face_index : GeometryInfo<dim>::face_indices())
+    for (const unsigned int face_index : GeometryInfo<dim>::face_indices())
       {
         if (std::abs(cell->face(face_index)->center()(face_index / 2)) < 1e-12)
           cell->face(face_index)->set_all_boundary_ids(face_index);
@@ -65,7 +65,7 @@ test()
           {
             deallog << Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) << ' '
                     << cell->id() << " neighbor subdomain ids: ";
-            for (unsigned int f : GeometryInfo<dim>::face_indices())
+            for (const unsigned int f : GeometryInfo<dim>::face_indices())
               {
                 deallog << cell->neighbor_or_periodic_neighbor(f)->id() << ' ';
                 if (cell->is_active())
index 6fb39bb5ef18849ca39e2b4d4c55000e4ffc1f71..5a2fb854909e3f5afba4a0e4d8b6009bf37d33de 100644 (file)
@@ -43,7 +43,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
       {
         cell->get_dof_indices(dof_indices);
         deallog << "cell " << cell->id() << ": ";
-        for (types::global_dof_index i : dof_indices)
+        for (const types::global_dof_index i : dof_indices)
           deallog << i << ' ';
         deallog << std::endl;
       }
@@ -55,7 +55,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
           {
             cell->get_mg_dof_indices(dof_indices);
             deallog << "cell " << cell->id() << ": ";
-            for (types::global_dof_index i : dof_indices)
+            for (const types::global_dof_index i : dof_indices)
               deallog << i << ' ';
             deallog << std::endl;
           }
index 40765a0d27a5c2dd40dbbdaa17ad40b8aaacbe9a..ec6cb6f1fd4828c53015e9c9fd99a58423d2d4ad 100644 (file)
@@ -50,7 +50,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
       {
         cell->get_dof_indices(dof_indices);
         deallog << "cell " << cell->id() << ": ";
-        for (types::global_dof_index i : dof_indices)
+        for (const types::global_dof_index i : dof_indices)
           deallog << i << ' ';
         deallog << std::endl;
       }
@@ -62,7 +62,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
           {
             cell->get_mg_dof_indices(dof_indices);
             deallog << "cell " << cell->id() << ": ";
-            for (types::global_dof_index i : dof_indices)
+            for (const types::global_dof_index i : dof_indices)
               deallog << i << ' ';
             deallog << std::endl;
           }
index a328fae21de0240aaafbc77de1ad97bec248f21b..003dd9aac2ef4f789cfff146274648be26ef324f 100644 (file)
@@ -50,7 +50,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
       {
         cell->get_dof_indices(dof_indices);
         deallog << "cell " << cell->id() << ": ";
-        for (types::global_dof_index i : dof_indices)
+        for (const types::global_dof_index i : dof_indices)
           deallog << i << ' ';
         deallog << std::endl;
       }
@@ -62,7 +62,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
           {
             cell->get_mg_dof_indices(dof_indices);
             deallog << "cell " << cell->id() << ": ";
-            for (types::global_dof_index i : dof_indices)
+            for (const types::global_dof_index i : dof_indices)
               deallog << i << ' ';
             deallog << std::endl;
           }
index 229c9d9ef74fb5b459c39ec66c144c024342031c..bc58bd8bdb84a78cba8a81ffc5355d3abb40701b 100644 (file)
@@ -43,7 +43,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
       {
         cell->get_dof_indices(dof_indices);
         deallog << "cell " << cell->id() << ": ";
-        for (types::global_dof_index i : dof_indices)
+        for (const types::global_dof_index i : dof_indices)
           deallog << i << ' ';
         deallog << std::endl;
       }
@@ -55,7 +55,7 @@ print_dof_numbers(const DoFHandler<dim> &dof)
           {
             cell->get_mg_dof_indices(dof_indices);
             deallog << "cell " << cell->id() << ": ";
-            for (types::global_dof_index i : dof_indices)
+            for (const types::global_dof_index i : dof_indices)
               deallog << i << ' ';
             deallog << std::endl;
           }
index 6677f119bdc3f1218398be497c68521cf5f423b4..693f6a59e2e11300a2907f0df143a783bbd92377 100644 (file)
@@ -173,7 +173,7 @@ Test<dim>::print_which_optionals_have_values_on_cell_0(
 {
   const auto cell = dof_handler.begin_active();
 
-  for (unsigned int face_index : cell->face_indices())
+  for (const unsigned int face_index : cell->face_indices())
     {
       deallog << "face " << face_index << std::endl;
 
index fcfa25cde893e51a143402f7d0fa4415b02cae38..e44dda6fd38faef59dc3f6bff1977ad915dd278f 100644 (file)
@@ -115,7 +115,7 @@ void
 Test<dim>::print_quadrature_point_difference_on_both_sides(
   const dealii::FEInterfaceValues<dim> &fe_interface_values)
 {
-  for (unsigned int q : fe_interface_values.quadrature_point_indices())
+  for (const unsigned int q : fe_interface_values.quadrature_point_indices())
     {
       const Point<dim> &point_on_side_0 =
         fe_interface_values.get_fe_face_values(0).quadrature_point(q);
@@ -150,7 +150,7 @@ Test<dim>::run()
 
   // Test that the points agree only on the interface between the two cells,
   // which face this is depends on the incoming triangulation.
-  for (unsigned int face : cell->face_indices())
+  for (const unsigned int face : cell->face_indices())
     if (!cell->face(face)->at_boundary())
       {
         const unsigned int invalid_subface =
index 903b5608ff6811aced62adf25856ffcd9085f234..90c8f776cbaee5daf0d23fb3ad67c7e96afac93b 100644 (file)
@@ -77,7 +77,7 @@ print_cell_and_face_locations(
     classifier.location_to_level_set(cell);
   deallog << "cell " << location_to_string(cell_location) << std::endl;
 
-  for (unsigned int f : cell->face_indices())
+  for (const unsigned int f : cell->face_indices())
     {
       const NonMatching::LocationToLevelSet face_location =
         classifier.location_to_level_set(cell, f);
index f93a487f616344da229699aa76c9c10226a00219..ad76262fb18cc6be0339cfbb0d24da4498b22178 100644 (file)
@@ -739,7 +739,7 @@ LaplaceProblem<dim>::embed_solution_to_dg()
       dg_eval.gather_evaluate(dg_solution, EvaluationFlags::values);
       Solution<dim> solution;
       double        local_error = 0;
-      for (unsigned int q : dg_eval.quadrature_point_indices())
+      for (const unsigned int q : dg_eval.quadrature_point_indices())
         for (unsigned int v = 0;
              v <
              system_matrix.get_matrix_free().n_active_entries_per_cell_batch(
index 4480b17b2c49cabf2d0ebe7da7fc998f1e495d14..e521176a9a6cca5d0456cc9905822f757a035c8c 100644 (file)
@@ -1885,7 +1885,7 @@ namespace NavierStokes_DG
 
     GridGenerator::hyper_rectangle(triangulation, lower_left, upper_right);
     for (const auto &cell : triangulation.cell_iterators())
-      for (unsigned int face : cell->face_indices())
+      for (const unsigned int face : cell->face_indices())
         if (cell->at_boundary(face))
           cell->face(face)->set_boundary_id(face);
     std::vector<
index 314b8f10e90aed475e53a6aac8e395702b911f07..b7248afd7e792d28d1603bde55664f58660082ea 100644 (file)
@@ -170,7 +170,7 @@ LaplaceOperator<dim, fe_degree, number>::vmult(
   const LinearAlgebra::distributed::Vector<number> &src) const
 {
   this->data->cell_loop(&LaplaceOperator::local_apply, this, dst, src, true);
-  for (unsigned int i : this->data->get_constrained_dofs())
+  for (const unsigned int i : this->data->get_constrained_dofs())
     dst.local_element(i) = src.local_element(i);
 }
 
@@ -192,7 +192,7 @@ LaplaceOperator<dim, fe_degree, number>::vmult(
                         src,
                         operation_before_loop,
                         operation_after_loop);
-  for (unsigned int i : this->data->get_constrained_dofs())
+  for (const unsigned int i : this->data->get_constrained_dofs())
     dst.local_element(i) = src.local_element(i);
 }
 

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.