]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix formating 11421/head
authorPeter Munch <peterrmuench@gmail.com>
Sat, 26 Dec 2020 20:06:46 +0000 (21:06 +0100)
committerPeter Munch <peterrmuench@gmail.com>
Sat, 26 Dec 2020 20:06:46 +0000 (21:06 +0100)
include/deal.II/fe/fe_tools.templates.h

index 4a72f1d9cd6f91860040fdf784a2198e77d29ba2..7833e04cbaf9157dddb8d0467c9c2baca72d119f 100644 (file)
@@ -2196,11 +2196,7 @@ namespace FETools
       const std::vector<double> &JxW = coarse.get_JxW_values();
       for (unsigned int i = 0; i < n; ++i)
         for (unsigned int j = 0; j < n; ++j)
-          if (fe.
-
-              is_primitive()
-
-          )
+          if (fe.is_primitive())
             {
               const double *coarse_i = &coarse.shape_value(i, 0);
               const double *coarse_j = &coarse.shape_value(j, 0);
@@ -2220,13 +2216,11 @@ namespace FETools
             }
 
       // invert mass matrix
-      mass.
-
-        gauss_jordan();
+      mass.gauss_jordan();
     }
 
 
-    auto compute_one_case =
+    const auto compute_one_case =
       [&fe, &q_fine, n, nd, nq](const unsigned int        ref_case,
                                 const FullMatrix<double> &inverse_mass_matrix,
                                 std::vector<FullMatrix<double>> &matrices) {
@@ -2235,42 +2229,17 @@ namespace FETools
 
         for (unsigned int i = 0; i < nc; ++i)
           {
-            Assert(matrices[i].
-
-                     n()
-
-                     == n,
-                   ExcDimensionMismatch(matrices[i].
-
-                                        n(),
-                                        n
-
-                                        ));
-            Assert(matrices[i].
-
-                     m()
-
-                     == n,
-                   ExcDimensionMismatch(matrices[i].
-
-                                        m(),
-                                        n
-
-                                        ));
+            Assert(matrices[i].n() == n,
+                   ExcDimensionMismatch(matrices[i].n(), n));
+            Assert(matrices[i].m() == n,
+                   ExcDimensionMismatch(matrices[i].m(), n));
           }
 
         // create a respective refinement on the triangulation
         Triangulation<dim, spacedim> tr;
         GridGenerator::hyper_cube(tr, 0, 1);
-        tr.
-
-          begin_active()
-            ->
-
-          set_refine_flag(RefinementCase<dim>(ref_case));
-        tr.
-
-          execute_coarsening_and_refinement();
+        tr.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
+        tr.execute_coarsening_and_refinement();
 
         FEValues<dim, spacedim> fine(StaticMappingQ1<dim, spacedim>::mapping,
                                      fe,
@@ -2293,16 +2262,8 @@ namespace FETools
             fine.reinit(coarse_cell->child(cell_number));
             const std::vector<Point<spacedim>> &q_points_fine =
               fine.get_quadrature_points();
-            std::vector<Point<dim>> q_points_coarse(q_points_fine.
-
-                                                    size()
-
-            );
-            for (unsigned int q = 0; q < q_points_fine.
-
-                                         size();
-
-                 ++q)
+            std::vector<Point<dim>> q_points_coarse(q_points_fine.size());
+            for (unsigned int q = 0; q < q_points_fine.size(); ++q)
               for (unsigned int j = 0; j < dim; ++j)
                 q_points_coarse[q](j) = q_points_fine[q](j);
             Quadrature<dim> q_coarse(q_points_coarse, fine.get_JxW_values());
@@ -2322,11 +2283,7 @@ namespace FETools
               {
                 for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i)
                   {
-                    if (fe.
-
-                        is_primitive()
-
-                    )
+                    if (fe.is_primitive())
                       {
                         const double *coarse_i = &coarse.shape_value(i, 0);
                         const double *fine_j   = &fine.shape_value(j, 0);
@@ -2355,16 +2312,8 @@ namespace FETools
               }
 
             // Remove small entries from the matrix
-            for (unsigned int i = 0; i < this_matrix.
-
-                                         m();
-
-                 ++i)
-              for (unsigned int j = 0; j < this_matrix.
-
-                                           n();
-
-                   ++j)
+            for (unsigned int i = 0; i < this_matrix.m(); ++i)
+              for (unsigned int j = 0; j < this_matrix.n(); ++j)
                 if (std::fabs(this_matrix(i, j)) < 1e-12)
                   this_matrix(i, j) = 0.;
           }
@@ -2381,9 +2330,7 @@ namespace FETools
         compute_one_case(ref_case, mass, matrices[ref_case - 1]);
       });
 
-    tasks.
-
-      join_all();
+    tasks.join_all();
   }
 
 

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.