]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use readability-qualified-auto clang-tidy check
authorDaniel Arndt <arndtd@ornl.gov>
Mon, 10 Jul 2023 15:58:20 +0000 (11:58 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Tue, 11 Jul 2023 14:51:30 +0000 (10:51 -0400)
26 files changed:
.clang-tidy
examples/step-1/step-1.cc
examples/step-12/step-12.cc
examples/step-2/step-2.cc
examples/step-47/step-47.cc
examples/step-50/step-50.cc
include/deal.II/base/patterns.h
include/deal.II/base/tensor.h
include/deal.II/base/utilities.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_tpetra_vector.templates.h
include/deal.II/lac/vector_element_access.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
source/base/data_out_base.cc
source/base/mpi.cc
source/base/parameter_acceptor.cc
source/base/subscriptor.cc
source/distributed/solution_transfer.cc
source/fe/fe_system.cc
source/grid/grid_generator.cc
source/lac/petsc_precondition.cc
source/particles/property_pool.cc

index d41b0cef4994c74b44e45ddae64d463e366204ad..46c3e9a24a59a5c8fcff6a8d7222dd563d9d0e79 100644 (file)
@@ -34,6 +34,7 @@ Checks: >
   mpi-*,
   performance-*,
   -performance-inefficient-string-concatenation,
-  -performance-no-automatic-move
+  -performance-no-automatic-move,
+  readability-qualified-auto
 
 WarningsAsErrors: '*'
index 262d4ee25739de0ea5d8df5b093a3cce764bcf72..8c31217eda482c5057337a138db113d959bc2219 100644 (file)
@@ -191,7 +191,7 @@ void second_grid()
       // <a href="http://en.cppreference.com/w/cpp/language/range-for">range-
       // based for loops</a>, which wrap up all of the syntax shown above into a
       // much shorter form:
-      for (auto &cell : triangulation.active_cell_iterators())
+      for (const auto &cell : triangulation.active_cell_iterators())
         {
           // @note See @ref Iterators for more information about the iterator
           // classes used in deal.II, and @ref CPP11 for more information about
index 9d4228ea6fa4fc2fb6cd7bf7241fa7e0408e60d8..796bf858edf8ede1e04fef06d4f0e6eaa2320390 100644 (file)
@@ -430,7 +430,7 @@ namespace Step12
                                              system_matrix,
                                              right_hand_side);
 
-      for (auto &cdf : c.face_data)
+      for (const auto &cdf : c.face_data)
         {
           constraints.distribute_local_to_global(cdf.cell_matrix,
                                                  cdf.joint_dof_indices,
index 0d6f86d4ab27cfc9ac7f1782b45d68e1e7632776..5fa3aacfde0ca19d9c683f5d6877c13a267be1b6 100644 (file)
@@ -84,7 +84,7 @@ void make_grid(Triangulation<2> &triangulation)
 
   for (unsigned int step = 0; step < 3; ++step)
     {
-      for (auto &cell : triangulation.active_cell_iterators())
+      for (const auto &cell : triangulation.active_cell_iterators())
         for (const auto v : cell->vertex_indices())
           {
             const double distance_from_center =
index ec6522be4cfeacd127461e2dc75c6a142167f02a..c2494c32e4b776a59c1e1611d4039d6a70b10439 100644 (file)
@@ -702,7 +702,7 @@ namespace Step47
                                              system_matrix,
                                              system_rhs);
 
-      for (auto &cdf : copy_data.face_data)
+      for (const auto &cdf : copy_data.face_data)
         {
           constraints.distribute_local_to_global(cdf.cell_matrix,
                                                  cdf.joint_dof_indices,
index bfa022496f9a8fa9b4c10dca6727d9f46f6483e7..5749c9a8bb4c5109b4b0c652cc7fd61bc687ddbf 100644 (file)
@@ -1358,7 +1358,7 @@ void LaplaceProblem<dim, degree>::estimate()
     if (copy_data.cell_index != numbers::invalid_unsigned_int)
       estimated_error_square_per_cell[copy_data.cell_index] += copy_data.value;
 
-    for (auto &cdf : copy_data.face_data)
+    for (const auto &cdf : copy_data.face_data)
       for (unsigned int j = 0; j < 2; ++j)
         estimated_error_square_per_cell[cdf.cell_indices[j]] += cdf.values[j];
   };
index 01a762a2e59c8d96bfd77186601fd7c414afe259..95e3026057e244086144c9048152dcee8e79a29e 100644 (file)
@@ -1777,7 +1777,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a "
                                "string to a List type."));
@@ -1805,7 +1805,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List type."));
@@ -1848,7 +1848,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::Map *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::Map *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a Map pattern to convert a string to "
                                "a Map compatible type."));
@@ -1879,7 +1879,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::Map *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::Map *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a Map pattern to convert a "
                                "string to a Map compatible type."));
@@ -1927,7 +1927,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a "
                                "string to a std::array."));
@@ -1955,7 +1955,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a std::array."));
@@ -1994,7 +1994,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2020,7 +2020,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2091,7 +2091,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2114,7 +2114,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2188,7 +2188,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2212,7 +2212,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::List *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::List *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a List pattern to convert a string "
                                "to a List compatible type."));
@@ -2316,7 +2316,7 @@ namespace Patterns
         const T &                    t,
         const Patterns::PatternBase &pattern = *Convert<T>::to_pattern())
       {
-        auto p = dynamic_cast<const Patterns::Tuple *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::Tuple *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a Tuple pattern to convert a tuple "
                                "to a string."));
@@ -2336,7 +2336,7 @@ namespace Patterns
       {
         AssertThrow(pattern.match(s), ExcNoMatch(s, pattern.description()));
 
-        auto p = dynamic_cast<const Patterns::Tuple *>(&pattern);
+        const auto *p = dynamic_cast<const Patterns::Tuple *>(&pattern);
         AssertThrow(p,
                     ExcMessage("I need a Tuple pattern to convert a string "
                                "to a tuple type."));
index bd0f6d33172e525661a32ebdfc07f663fdb39673..df6bfc87626994790c68c2986b55539c251d2d8f 100644 (file)
@@ -1793,7 +1793,7 @@ Iterator
 Tensor<rank_, dim, Number>::unroll_recursion(const Iterator current,
                                              const Iterator end) const
 {
-  auto next = current;
+  Iterator next = current;
   for (unsigned int i = 0; i < dim; ++i)
     next = values[i].unroll_recursion(next, end);
   return next;
index 28c6ebf92739f2f009d18c7d877bec6720fe66be..1b12d95c2e6146cc1dbc53b7566cefc26fed78af 100644 (file)
@@ -1286,9 +1286,9 @@ namespace Utilities
       object.clear();
       if (vector_size > 0)
         {
-          const auto buffer_data_begin =
+          const auto *const buffer_data_begin =
             reinterpret_cast<const T *>(&*cbegin + sizeof(vector_size));
-          const auto buffer_data_end = buffer_data_begin + vector_size;
+          const auto *const buffer_data_end = buffer_data_begin + vector_size;
           object.insert(object.end(), buffer_data_begin, buffer_data_end);
         }
     }
index ffb891f61bc16cabe756eaf1e2b7250ef9586415..8d7a3d79ac7ee47446ed5f9343b2a42e6d70a292 100644 (file)
@@ -2289,7 +2289,7 @@ namespace internal
       using ExecutionSpace =
         MemorySpace::Default::kokkos_space::execution_space;
       ExecutionSpace exec;
-      auto           local_values = vec.get_values();
+      auto *         local_values = vec.get_values();
       Kokkos::parallel_for(
         "dealii::set_zero_parallel",
         Kokkos::RangePolicy<ExecutionSpace>(exec, 0, n_constraints),
index 4c8a0c75acbe64c244d31acebf361703e1ff97a0..0478e0a98f056b0038b45a5590d6a7ca466f1aa2 100644 (file)
@@ -422,9 +422,9 @@ namespace internal
       const LinearAlgebra::distributed::Vector<Number, MemorySpace::Host>
         &diagonal)
     {
-      const auto dst_ptr      = dst.begin();
-      const auto src_ptr      = src.begin();
-      const auto diagonal_ptr = diagonal.begin();
+      auto *const       dst_ptr      = dst.begin();
+      const auto *const src_ptr      = src.begin();
+      const auto *const diagonal_ptr = diagonal.begin();
 
       DEAL_II_OPENMP_SIMD_PRAGMA
       for (unsigned int i = 0; i < src.locally_owned_size(); ++i)
index f80784cbd27f6351bdc99a4c2e990f5ba0c1f7e0..44a9921e37e50797c577263b760a2414aaebf41a 100644 (file)
@@ -192,8 +192,8 @@ namespace LinearAlgebra
       import_elements(
         const ReadWriteVector<Number> &V,
         VectorOperation::values        operation,
-        std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
-          communication_pattern = {});
+        const std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
+          &communication_pattern = {});
 
       /**
        * @deprecated Use import_elements() instead.
index 67076259ff9b882add8f2a6d8cdc16054d934a7c..78ce85ce04fb9ac7b68060a1d8bc6ea3da11fe98 100644 (file)
@@ -201,8 +201,8 @@ namespace LinearAlgebra
     Vector<Number>::import_elements(
       const ReadWriteVector<Number> &V,
       VectorOperation::values        operation,
-      std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
-        communication_pattern)
+      const std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
+        &communication_pattern)
     {
       // If no communication pattern is given, create one. Otherwise, use the
       // one given.
@@ -563,8 +563,9 @@ namespace LinearAlgebra
     MPI_Comm
     Vector<Number>::get_mpi_communicator() const
     {
-      const auto tpetra_comm = dynamic_cast<const Teuchos::MpiComm<int> *>(
-        vector->getMap()->getComm().get());
+      const auto *const tpetra_comm =
+        dynamic_cast<const Teuchos::MpiComm<int> *>(
+          vector->getMap()->getComm().get());
       Assert(tpetra_comm != nullptr, ExcInternalError());
       return *(tpetra_comm->getRawMpiComm())();
     }
index 274b609968d246c2b2c394d475aa6fa68b9b60eb..fbc849e1b93daf2761d4dfea64a8e4982ae3ad51 100644 (file)
@@ -228,8 +228,8 @@ namespace internal
     const types::global_dof_index                            i)
   {
     // Extract local indices in the vector.
-    Tpetra::Vector<NumberType, int, types::signed_global_dof_index> vector =
-      V.trilinos_vector();
+    const Tpetra::Vector<NumberType, int, types::signed_global_dof_index>
+      &                               vector = V.trilinos_vector();
     TrilinosWrappers::types::int_type trilinos_i =
       vector.getMap()->getLocalElement(
         static_cast<TrilinosWrappers::types::int_type>(i));
index 49f5607cd268c0e94afefe80f466c6d025d8d7a4..9ed4bc5f6705e78d9e1335b4a9d5ee91303b342f 100644 (file)
@@ -853,9 +853,9 @@ namespace internal
 
     if (evaluation_flag & EvaluationFlags::values)
       {
-        const auto shape_values    = shape_data.front().shape_values.data();
-        auto       values_quad_ptr = fe_eval.begin_values();
-        auto       values_dofs_actual_ptr = values_dofs_actual;
+        const auto *const shape_values = shape_data.front().shape_values.data();
+        auto *            values_quad_ptr        = fe_eval.begin_values();
+        const auto *      values_dofs_actual_ptr = values_dofs_actual;
 
         Eval eval(shape_values, nullptr, nullptr, n_dofs, n_q_points);
         for (unsigned int c = 0; c < n_components; ++c)
@@ -870,9 +870,10 @@ namespace internal
 
     if (evaluation_flag & EvaluationFlags::gradients)
       {
-        const auto shape_gradients = shape_data.front().shape_gradients.data();
-        auto       gradients_quad_ptr     = fe_eval.begin_gradients();
-        auto       values_dofs_actual_ptr = values_dofs_actual;
+        const auto *const shape_gradients =
+          shape_data.front().shape_gradients.data();
+        auto *      gradients_quad_ptr     = fe_eval.begin_gradients();
+        const auto *values_dofs_actual_ptr = values_dofs_actual;
 
         for (unsigned int c = 0; c < n_components; ++c)
           {
@@ -925,9 +926,9 @@ namespace internal
 
     if (integration_flag & EvaluationFlags::values)
       {
-        const auto shape_values    = shape_data.front().shape_values.data();
-        auto       values_quad_ptr = fe_eval.begin_values();
-        auto       values_dofs_actual_ptr = values_dofs_actual;
+        const auto *const shape_values = shape_data.front().shape_values.data();
+        auto *            values_quad_ptr        = fe_eval.begin_values();
+        auto *            values_dofs_actual_ptr = values_dofs_actual;
 
         Eval eval(shape_values, nullptr, nullptr, n_dofs, n_q_points);
         for (unsigned int c = 0; c < n_components; ++c)
@@ -946,9 +947,10 @@ namespace internal
 
     if (integration_flag & EvaluationFlags::gradients)
       {
-        const auto shape_gradients = shape_data.front().shape_gradients.data();
-        auto       gradients_quad_ptr     = fe_eval.begin_gradients();
-        auto       values_dofs_actual_ptr = values_dofs_actual;
+        const auto *const shape_gradients =
+          shape_data.front().shape_gradients.data();
+        auto *gradients_quad_ptr     = fe_eval.begin_gradients();
+        auto *values_dofs_actual_ptr = values_dofs_actual;
 
         for (unsigned int c = 0; c < n_components; ++c)
           {
@@ -4100,11 +4102,11 @@ namespace internal
 
           if (evaluation_flag & EvaluationFlags::values)
             {
-              const auto shape_values =
+              const auto *const shape_values =
                 &shape_data.shape_values_face(face_no, face_orientation, 0);
 
-              auto values_quad_ptr        = fe_eval.begin_values();
-              auto values_dofs_actual_ptr = values_dofs;
+              auto *values_quad_ptr        = fe_eval.begin_values();
+              auto *values_dofs_actual_ptr = values_dofs;
 
               Eval eval(shape_values, nullptr, nullptr, n_dofs, n_q_points);
               for (unsigned int c = 0; c < n_components; ++c)
@@ -4119,8 +4121,8 @@ namespace internal
 
           if (evaluation_flag & EvaluationFlags::gradients)
             {
-              auto gradients_quad_ptr     = fe_eval.begin_gradients();
-              auto values_dofs_actual_ptr = values_dofs;
+              auto *      gradients_quad_ptr     = fe_eval.begin_gradients();
+              const auto *values_dofs_actual_ptr = values_dofs;
 
               std::array<const Number2 *, dim> shape_gradients;
               for (unsigned int d = 0; d < dim; ++d)
@@ -4339,11 +4341,11 @@ namespace internal
 
           if (integration_flag & EvaluationFlags::values)
             {
-              const auto shape_values =
+              const auto *const shape_values =
                 &shape_data.shape_values_face(face_no, face_orientation, 0);
 
-              auto values_quad_ptr        = fe_eval.begin_values();
-              auto values_dofs_actual_ptr = values_dofs;
+              auto *values_quad_ptr        = fe_eval.begin_values();
+              auto *values_dofs_actual_ptr = values_dofs;
 
               Eval eval(shape_values, nullptr, nullptr, n_dofs, n_q_points);
               for (unsigned int c = 0; c < n_components; ++c)
@@ -4358,8 +4360,8 @@ namespace internal
 
           if (integration_flag & EvaluationFlags::gradients)
             {
-              auto gradients_quad_ptr     = fe_eval.begin_gradients();
-              auto values_dofs_actual_ptr = values_dofs;
+              auto *gradients_quad_ptr     = fe_eval.begin_gradients();
+              auto *values_dofs_actual_ptr = values_dofs;
 
               std::array<const Number2 *, dim> shape_gradients;
               for (unsigned int d = 0; d < dim; ++d)
@@ -5833,10 +5835,10 @@ namespace internal
           const Number *in  = in_array + d * n_q_points;
           Number *      out = out_array + d * dofs_per_component;
 
-          auto temp_1 = do_inplace ? out : fe_eval.get_scratch_data().begin();
-          auto temp_2 = do_inplace ?
-                          out :
-                          (temp_1 + std::max(n_q_points, dofs_per_component));
+          auto *temp_1 = do_inplace ? out : fe_eval.get_scratch_data().begin();
+          auto *temp_2 = do_inplace ?
+                           out :
+                           (temp_1 + std::max(n_q_points, dofs_per_component));
 
           if (dim == 3)
             {
index 7df4cef54f0cb015fc7440667e629738dc38a42d..d40f45cae642baadf02cf6c11d8f6600b0744070 100644 (file)
@@ -574,9 +574,9 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::copy_from_mg(
       if (ghosted_level_vector[level].size() > 0)
         ghosted_vector = src[level];
 
-      const auto ghosted_vector_ptr = (ghosted_level_vector[level].size() > 0) ?
-                                        &ghosted_vector :
-                                        &src[level];
+      const auto *const ghosted_vector_ptr =
+        (ghosted_level_vector[level].size() > 0) ? &ghosted_vector :
+                                                   &src[level];
 
       ghosted_vector_ptr->update_ghost_values();
 
index e0589e3989a09c0e86a567f8b94ca51104f875ee..10d136d34bd3d1da649da8e0b2e4fb197e225e4b 100644 (file)
@@ -2597,13 +2597,13 @@ MGTwoLevelTransferBase<LinearAlgebra::distributed::Vector<Number>>::
     LinearAlgebra::distributed::Vector<Number> &      dst,
     const LinearAlgebra::distributed::Vector<Number> &src) const
 {
-  const bool use_dst_inplace = this->vec_fine.size() == 0;
-  const auto vec_fine_ptr    = use_dst_inplace ? &dst : &this->vec_fine;
+  const bool  use_dst_inplace = this->vec_fine.size() == 0;
+  auto *const vec_fine_ptr    = use_dst_inplace ? &dst : &this->vec_fine;
   Assert(vec_fine_ptr->get_partitioner().get() == this->partitioner_fine.get(),
          ExcInternalError());
 
-  const bool use_src_inplace = this->vec_coarse.size() == 0;
-  const auto vec_coarse_ptr  = use_src_inplace ? &src : &this->vec_coarse;
+  const bool        use_src_inplace = this->vec_coarse.size() == 0;
+  const auto *const vec_coarse_ptr = use_src_inplace ? &src : &this->vec_coarse;
   Assert(vec_coarse_ptr->get_partitioner().get() ==
            this->partitioner_coarse.get(),
          ExcInternalError());
@@ -2764,13 +2764,13 @@ MGTwoLevelTransferBase<LinearAlgebra::distributed::Vector<Number>>::
   restrict_and_add(LinearAlgebra::distributed::Vector<Number> &      dst,
                    const LinearAlgebra::distributed::Vector<Number> &src) const
 {
-  const bool use_src_inplace = this->vec_fine.size() == 0;
-  const auto vec_fine_ptr    = use_src_inplace ? &src : &this->vec_fine;
+  const bool        use_src_inplace = this->vec_fine.size() == 0;
+  const auto *const vec_fine_ptr    = use_src_inplace ? &src : &this->vec_fine;
   Assert(vec_fine_ptr->get_partitioner().get() == this->partitioner_fine.get(),
          ExcInternalError());
 
-  const bool use_dst_inplace = this->vec_coarse.size() == 0;
-  const auto vec_coarse_ptr  = use_dst_inplace ? &dst : &this->vec_coarse;
+  const bool  use_dst_inplace = this->vec_coarse.size() == 0;
+  auto *const vec_coarse_ptr  = use_dst_inplace ? &dst : &this->vec_coarse;
   Assert(vec_coarse_ptr->get_partitioner().get() ==
            this->partitioner_coarse.get(),
          ExcInternalError());
@@ -2943,13 +2943,13 @@ MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>>::
 {
   const unsigned int n_lanes = VectorizedArrayType::size();
 
-  const bool use_src_inplace = this->vec_fine.size() == 0;
-  const auto vec_fine_ptr    = use_src_inplace ? &src : &this->vec_fine;
+  const bool        use_src_inplace = this->vec_fine.size() == 0;
+  const auto *const vec_fine_ptr    = use_src_inplace ? &src : &this->vec_fine;
   Assert(vec_fine_ptr->get_partitioner().get() == this->partitioner_fine.get(),
          ExcInternalError());
 
-  const bool use_dst_inplace = this->vec_coarse.size() == 0;
-  const auto vec_coarse_ptr  = use_dst_inplace ? &dst : &this->vec_coarse;
+  const bool  use_dst_inplace = this->vec_coarse.size() == 0;
+  auto *const vec_coarse_ptr  = use_dst_inplace ? &dst : &this->vec_coarse;
   Assert(vec_coarse_ptr->get_partitioner().get() ==
            this->partitioner_coarse.get(),
          ExcInternalError());
@@ -3633,10 +3633,10 @@ namespace internal
                       if (dof_processed[local_dof_idx] == false)
                         {
                           if (!constraint.is_constrained(global_dof_idx))
-                            support_point_dofs.emplace_back(std::make_pair(
+                            support_point_dofs.emplace_back(
                               partitioner_support_points.global_to_local(
                                 support_point_indices[i]),
-                              global_dof_idx));
+                              global_dof_idx);
 
                           dof_processed[local_dof_idx] = true;
                         }
index 912e1cf2fcad3345150cfe1be9ad721fd51d5d7b..0fff50e0ec159d0e947013ae0f05b757e2d75255 100644 (file)
@@ -178,7 +178,7 @@ namespace
           static_cast<std::uint32_t>(
             compressed_data_length)}; /* list of compressed sizes of blocks */
 
-        const auto header_start =
+        const auto *const header_start =
           reinterpret_cast<const unsigned char *>(&compression_header[0]);
 
         return (Utilities::encode_base64(
index 909590a782bf24d8590e4a7df610474a77eec90e..61e68014616eece094c9d0631e9e77f67fc858fc 100644 (file)
@@ -795,7 +795,7 @@ namespace Utilities
         // likely did not intend. As a consequence, filter out this specific
         // flag.
         std::vector<char *> argv_new;
-        for (const auto arg : make_array_view(&argv[0], &argv[0] + argc))
+        for (auto *const arg : make_array_view(&argv[0], &argv[0] + argc))
           if (strcmp(arg, "--help") != 0)
             argv_new.push_back(arg);
 
@@ -976,7 +976,7 @@ namespace Utilities
 
 #ifdef DEAL_II_WITH_MPI
       // Before exiting, wait for nonblocking communication to complete:
-      for (auto request : requests)
+      for (auto *request : requests)
         {
           const int ierr = MPI_Wait(request, MPI_STATUS_IGNORE);
           AssertThrowMPI(ierr);
index 0d898efd6c4050629ffd8b69dc91a2b7886b025f..c56f409248634842dc40a27a86f1296f6d2b25f9 100644 (file)
@@ -199,7 +199,7 @@ ParameterAcceptor::get_section_path() const
            acceptor_it != class_list.rend();
            ++acceptor_it)
         {
-          const auto acceptor = *acceptor_it;
+          auto *const acceptor = *acceptor_it;
           if (acceptor->get_acceptor_id() >= get_acceptor_id())
             continue;
           bool has_trailing  = acceptor->get_section_name().back() == sep;
index 352124ca2a2cf56773b81d331c6a59b65718e080..a60bd7ed7f41c7a9c62749c9e62c14c0b60cb033 100644 (file)
@@ -34,7 +34,7 @@ Subscriptor::Subscriptor(Subscriptor &&subscriptor) noexcept
   : counter(0)
   , object_info(subscriptor.object_info)
 {
-  for (const auto validity_ptr : subscriptor.validity_pointers)
+  for (auto *const validity_ptr : subscriptor.validity_pointers)
     *validity_ptr = false;
   subscriptor.validity_pointers.clear();
 }
@@ -43,7 +43,7 @@ Subscriptor::Subscriptor(Subscriptor &&subscriptor) noexcept
 
 Subscriptor::~Subscriptor()
 {
-  for (const auto validity_ptr : validity_pointers)
+  for (auto *const validity_ptr : validity_pointers)
     *validity_ptr = false;
   object_info = nullptr;
 }
@@ -123,7 +123,7 @@ Subscriptor::check_no_subscribers() const noexcept
 Subscriptor &
 Subscriptor::operator=(Subscriptor &&s) noexcept
 {
-  for (const auto validity_ptr : s.validity_pointers)
+  for (auto *const validity_ptr : s.validity_pointers)
     *validity_ptr = false;
   s.validity_pointers.clear();
   object_info = s.object_info;
index 6018dcd97da3537a791a4153e82e7f2e8c2501e0..f389a711dc93dcd87b3aac79c89c9d89c08ca79e 100644 (file)
@@ -247,7 +247,7 @@ namespace parallel
       Assert(tria != nullptr, ExcInternalError());
 
       if (average_values)
-        for (const auto vec : all_out)
+        for (auto *const vec : all_out)
           *vec = 0.0;
 
       VectorType valence;
@@ -277,7 +277,7 @@ namespace parallel
                             (Number(1.0) / static_cast<Number>(valence[i])));
           valence.compress(VectorOperation::insert);
 
-          for (const auto vec : all_out)
+          for (auto *const vec : all_out)
             {
               // compress and weight with valence
               vec->compress(VectorOperation::add);
@@ -286,7 +286,7 @@ namespace parallel
         }
       else
         {
-          for (const auto vec : all_out)
+          for (auto *const vec : all_out)
             vec->compress(VectorOperation::insert);
         }
 
index d7a6627c379512dba1e15ac6e0173c6c5f141947..dfd97f7ddb61d526437b70f73721e0a0d50af189 100644 (file)
@@ -2698,9 +2698,9 @@ FESystem<dim, spacedim>::convert_generalized_support_point_values_to_dof_values(
 
                   // we have to extract the correct slice out of the global
                   // vector of values:
-                  const auto begin =
+                  const auto *const begin =
                     std::begin(point_values[n]) + current_vector_component;
-                  const auto end = begin + n_base_components;
+                  const auto *const end = begin + n_base_components;
                   std::copy(begin, end, std::begin(base_point_values[j]));
                 }
 
index 7450ec245b7d204abb36394569818bd0aa521497..ea614d93052634fdcba9d793b1502a6ab252abd7 100644 (file)
@@ -977,7 +977,7 @@ namespace GridGenerator
                                                 std::sin(gamma) * edge_length);
 
           // loop over vertices of all cells
-          for (auto &cell : tria.cell_iterators())
+          for (const auto &cell : tria.cell_iterators())
             for (const unsigned int v : GeometryInfo<2>::vertex_indices())
               {
                 // vertex has been already processed: nothing to do
@@ -1168,11 +1168,11 @@ namespace GridGenerator
       MeshGenerator mesh_generator(additional_data);
       // Cast the triangulation to the right type so that the right
       // specialization of the function create_triangulation is picked up.
-      if (auto parallel_tria =
+      if (auto *parallel_tria =
             dynamic_cast<dealii::parallel::distributed::Triangulation<2, 2> *>(
               &tria))
         mesh_generator.create_triangulation(*parallel_tria, periodic_faces);
-      else if (auto parallel_tria = dynamic_cast<
+      else if (auto *parallel_tria = dynamic_cast<
                  dealii::parallel::fullydistributed::Triangulation<2, 2> *>(
                  &tria))
         mesh_generator.create_triangulation(*parallel_tria, periodic_faces);
@@ -2092,7 +2092,7 @@ namespace GridGenerator
     tria.reset_all_manifolds();
     tria.set_all_manifold_ids(0);
 
-    for (auto &cell : tria.cell_iterators())
+    for (const auto &cell : tria.cell_iterators())
       {
         // identify faces on torus surface and set manifold to 1
         for (const unsigned int f : GeometryInfo<3>::face_indices())
index 8cd9966e052ed0c4cf467e616d830e633f6710bb..2e51d0cdfe29b6c9876e0ed02bc6d677d4f32dc8 100644 (file)
@@ -1125,7 +1125,7 @@ namespace PETScWrappers
     PetscFunctionBeginUser;
     PetscCall(PCShellGetContext(ppc, &ctx));
 
-    auto user = static_cast<PreconditionShell *>(ctx);
+    auto *user = static_cast<PreconditionShell *>(ctx);
     if (!user->vmult)
       SETERRQ(
         PetscObjectComm((PetscObject)ppc),
@@ -1166,7 +1166,7 @@ namespace PETScWrappers
     PetscFunctionBeginUser;
     PetscCall(PCShellGetContext(ppc, &ctx));
 
-    auto user = static_cast<PreconditionShell *>(ctx);
+    auto *user = static_cast<PreconditionShell *>(ctx);
     if (!user->vmultT)
       SETERRQ(
         PetscObjectComm((PetscObject)ppc),
index 2aa595f23250337cee0d9a3494f8ae1b850c9966..5abbd313072ad16051b2305bedcdd43004cd3c2b 100644 (file)
@@ -205,7 +205,7 @@ namespace Particles
     sorted_ids.reserve(ids.size());
     sorted_properties.reserve(properties.size());
 
-    for (auto &handle : handles_to_sort)
+    for (const auto &handle : handles_to_sort)
       {
         Assert(handle != invalid_handle,
                ExcMessage(

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.