]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update physics tests to use cell DoF range based loop 9990/head
authorJean-Paul Pelteret <jppelteret@gmail.com>
Wed, 29 Apr 2020 20:54:30 +0000 (22:54 +0200)
committerJean-Paul Pelteret <jppelteret@gmail.com>
Wed, 6 May 2020 22:39:05 +0000 (00:39 +0200)
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/physics/step-44-standard_tensors-material_push_forward.cc
tests/physics/step-44-standard_tensors-spatial.cc
tests/physics/step-44.cc

index 9fce0e15a6e4576e468d251e6ab80cf72ed1e478..5449d1b3d6b2be9d1a9053f11969c28d03c024e1 100644 (file)
@@ -400,8 +400,8 @@ namespace Step18
           cell_matrix = 0;
           cell_rhs    = 0;
           fe_values.reinit(cell);
-          for (unsigned int i = 0; i < dofs_per_cell; ++i)
-            for (unsigned int j = 0; j < dofs_per_cell; ++j)
+          for (const unsigned int i : fe_values.dof_indices())
+            for (const unsigned int j : fe_values.dof_indices())
               for (const unsigned int q_point :
                    fe_values.quadrature_point_indices())
                 {
@@ -415,7 +415,7 @@ namespace Step18
             reinterpret_cast<PointHistory<dim> *>(cell->user_pointer());
           body_force.vector_value_list(fe_values.get_quadrature_points(),
                                        body_force_values);
-          for (unsigned int i = 0; i < dofs_per_cell; ++i)
+          for (const unsigned int i : fe_values.dof_indices())
             {
               const unsigned int component_i =
                 fe.system_to_component_index(i).first;
index cdda878fa0e3cbb1731c4cfafdb9c1edc5790bc1..82b686ba2974f476b4c23265de31436e2527e639 100644 (file)
@@ -416,8 +416,8 @@ namespace Step18
           cell_matrix = 0;
           cell_rhs    = 0;
           fe_values.reinit(cell);
-          for (unsigned int i = 0; i < dofs_per_cell; ++i)
-            for (unsigned int j = 0; j < dofs_per_cell; ++j)
+          for (const unsigned int i : fe_values.dof_indices())
+            for (const unsigned int j : fe_values.dof_indices())
               for (const unsigned int q_point :
                    fe_values.quadrature_point_indices())
                 {
@@ -431,7 +431,7 @@ namespace Step18
             reinterpret_cast<PointHistory<dim> *>(cell->user_pointer());
           body_force.vector_value_list(fe_values.get_quadrature_points(),
                                        body_force_values);
-          for (unsigned int i = 0; i < dofs_per_cell; ++i)
+          for (const unsigned int i : fe_values.dof_indices())
             {
               const unsigned int component_i =
                 fe.system_to_component_index(i).first;
index ddff955d077ff9808b5f2a9737a9f02a102bc9ba..f8c41893120e8ed1a7c37ace8b816227ee823bad 100644 (file)
@@ -1697,12 +1697,13 @@ namespace Step44
           scratch.symm_grad_Nx[q_point];
         const std::vector<Tensor<2, dim>> &grad_Nx = scratch.grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int component_i =
               fe.system_to_component_index(i).first;
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
-            for (unsigned int j = 0; j <= i; ++j)
+            for (const unsigned int j :
+                 scratch.fe_values_ref.dof_indices_ending_at(i))
               {
                 const unsigned int component_j =
                   fe.system_to_component_index(j).first;
@@ -1736,8 +1737,9 @@ namespace Step44
               }
           }
       }
-    for (unsigned int i = 0; i < dofs_per_cell; ++i)
-      for (unsigned int j = i + 1; j < dofs_per_cell; ++j)
+    for (const unsigned int i : scratch.fe_values_ref.dof_indices())
+      for (const unsigned int j :
+           scratch.fe_values_ref.dof_indices_starting_at(i + 1))
         data.cell_matrix(i, j) = data.cell_matrix(j, i);
   }
   template <int dim>
@@ -1820,7 +1822,7 @@ namespace Step44
         const std::vector<SymmetricTensor<2, dim>> &symm_grad_Nx =
           scratch.symm_grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
             if (i_group == u_dof)
@@ -1848,7 +1850,7 @@ namespace Step44
               const double         time_ramp = (time.current() / time.end());
               const double         pressure  = p0 * parameters.p_p0 * time_ramp;
               const Tensor<1, dim> traction  = pressure * N;
-              for (unsigned int i = 0; i < dofs_per_cell; ++i)
+              for (const unsigned int i : scratch.fe_values_ref.dof_indices())
                 {
                   const unsigned int i_group =
                     fe.system_to_base_index(i).first.first;
index ac83a20a5df296b1306c978aeb3c0df2035a6032..b5799bbf951674f41bec032d3dbc4cb2d8c162e3 100644 (file)
@@ -1497,12 +1497,13 @@ namespace Step44
           scratch.symm_grad_Nx[q_point];
         const std::vector<Tensor<2, dim>> &grad_Nx = scratch.grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int component_i =
               fe.system_to_component_index(i).first;
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
-            for (unsigned int j = 0; j <= i; ++j)
+            for (const unsigned int j :
+                 scratch.fe_values_ref.dof_indices_ending_at(i))
               {
                 const unsigned int component_j =
                   fe.system_to_component_index(j).first;
@@ -1536,8 +1537,9 @@ namespace Step44
               }
           }
       }
-    for (unsigned int i = 0; i < dofs_per_cell; ++i)
-      for (unsigned int j = i + 1; j < dofs_per_cell; ++j)
+    for (const unsigned int i : scratch.fe_values_ref.dof_indices())
+      for (const unsigned int j :
+           scratch.fe_values_ref.dof_indices_starting_at(i + 1))
         data.cell_matrix(i, j) = data.cell_matrix(j, i);
   }
   template <int dim>
@@ -1620,7 +1622,7 @@ namespace Step44
         const std::vector<SymmetricTensor<2, dim>> &symm_grad_Nx =
           scratch.symm_grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
             if (i_group == u_dof)
@@ -1648,7 +1650,7 @@ namespace Step44
               const double         time_ramp = (time.current() / time.end());
               const double         pressure  = p0 * parameters.p_p0 * time_ramp;
               const Tensor<1, dim> traction  = pressure * N;
-              for (unsigned int i = 0; i < dofs_per_cell; ++i)
+              for (const unsigned int i : scratch.fe_values_ref.dof_indices())
                 {
                   const unsigned int i_group =
                     fe.system_to_base_index(i).first.first;
index 0cbbecb2fb9a2500e901f3eb989c56141215220e..9c1dd702d88270dbc8efbf477aee76da1efbf7ca 100644 (file)
@@ -1510,12 +1510,13 @@ namespace Step44
           scratch.symm_grad_Nx[q_point];
         const std::vector<Tensor<2, dim>> &grad_Nx = scratch.grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int component_i =
               fe.system_to_component_index(i).first;
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
-            for (unsigned int j = 0; j <= i; ++j)
+            for (const unsigned int j :
+                 scratch.fe_values_ref.dof_indices_ending_at(i))
               {
                 const unsigned int component_j =
                   fe.system_to_component_index(j).first;
@@ -1547,8 +1548,9 @@ namespace Step44
               }
           }
       }
-    for (unsigned int i = 0; i < dofs_per_cell; ++i)
-      for (unsigned int j = i + 1; j < dofs_per_cell; ++j)
+    for (const unsigned int i : scratch.fe_values_ref.dof_indices())
+      for (const unsigned int j :
+           scratch.fe_values_ref.dof_indices_starting_at(i + 1))
         data.cell_matrix(i, j) = data.cell_matrix(j, i);
   }
   template <int dim>
@@ -1631,7 +1633,7 @@ namespace Step44
         const std::vector<SymmetricTensor<2, dim>> &symm_grad_Nx =
           scratch.symm_grad_Nx[q_point];
         const double JxW = scratch.fe_values_ref.JxW(q_point);
-        for (unsigned int i = 0; i < dofs_per_cell; ++i)
+        for (const unsigned int i : scratch.fe_values_ref.dof_indices())
           {
             const unsigned int i_group = fe.system_to_base_index(i).first.first;
             if (i_group == u_dof)
@@ -1659,7 +1661,7 @@ namespace Step44
               const double         time_ramp = (time.current() / time.end());
               const double         pressure  = p0 * parameters.p_p0 * time_ramp;
               const Tensor<1, dim> traction  = pressure * N;
-              for (unsigned int i = 0; i < dofs_per_cell; ++i)
+              for (const unsigned int i : scratch.fe_values_ref.dof_indices())
                 {
                   const unsigned int i_group =
                     fe.system_to_base_index(i).first.first;

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.