]> https://gitweb.dealii.org/ - dealii.git/commitdiff
make astyle happy
authorMatthias Maier <tamiko@kyomu.43-1.org>
Wed, 26 Nov 2014 22:34:04 +0000 (23:34 +0100)
committerMatthias Maier <tamiko@kyomu.43-1.org>
Sun, 30 Nov 2014 14:42:53 +0000 (15:42 +0100)
include/deal.II/grid/grid_tools.h
source/dofs/dof_tools_constraints.cc
source/grid/grid_tools.cc

index d304ffbbc316d01ff0d4b5f8e37d54de4cb7f4a2..b13760d5bedacf50809b26dcf440b0c80ea7f92a 100644 (file)
@@ -1171,7 +1171,7 @@ namespace GridTools
                        const FaceIterator &face2,
                        const int          direction,
                        const Tensor<1,FaceIterator::AccessorType::space_dimension> &offset
-                         = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
+                       = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
                        const FullMatrix<double> &matrix = FullMatrix<double>());
 
 
@@ -1184,7 +1184,7 @@ namespace GridTools
                        const FaceIterator &face2,
                        const int          direction,
                        const Tensor<2,FaceIterator::AccessorType::space_dimension> &offset
-                         = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
+                       = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
                        const FullMatrix<double> &matrix = FullMatrix<double>());
 
 
index 3811a3433c44f46cd3ae3a058fcfc97194f79530..fdb01c9c73526da57080391f6367a11f8339ce43 100644 (file)
@@ -2020,7 +2020,7 @@ namespace DoFTools
       {
         Assert(face_1->n_active_fe_indices() == 1, ExcInternalError());
         const unsigned int n_dofs =
-            face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face;
+          face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face;
 
         Assert(matrix.m() == 0 || matrix.m() == n_dofs ||
                matrix.m() == (int)spacedim,
@@ -2032,7 +2032,7 @@ namespace DoFTools
       {
         Assert(face_2->n_active_fe_indices() == 1, ExcInternalError());
         const unsigned int n_dofs =
-            face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face;
+          face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face;
 
         Assert(matrix.m() == 0 || matrix.m() == n_dofs ||
                matrix.m() == (int)spacedim,
@@ -2072,16 +2072,17 @@ namespace DoFTools
 
     if (face_1->has_children() && face_2->has_children())
       {
-      // In the case that both faces have children, we loop over all
-      // children and apply make_periodicty_constrains recursively:
+        // In the case that both faces have children, we loop over all
+        // children and apply make_periodicty_constrains recursively:
 
-      Assert(face_1->n_children() == GeometryInfo<dim>::max_children_per_face &&
-                 face_2->n_children() ==
-                     GeometryInfo<dim>::max_children_per_face,
-             ExcNotImplemented());
+        Assert(face_1->n_children() == GeometryInfo<dim>::max_children_per_face &&
+               face_2->n_children() ==
+               GeometryInfo<dim>::max_children_per_face,
+               ExcNotImplemented());
 
-      for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face;
-           ++i) {
+        for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face;
+             ++i)
+          {
             // Lookup the index for the second face
             unsigned int j;
             switch (dim)
@@ -2114,9 +2115,9 @@ namespace DoFTools
 
         // The finite element that matters is the one on the active face:
         const FiniteElement<dim,spacedim> &fe =
-            face_1->has_children()
-                ? face_2->get_fe(face_2->nth_active_fe_index(0))
-                : face_1->get_fe(face_1->nth_active_fe_index(0));
+          face_1->has_children()
+          ? face_2->get_fe(face_2->nth_active_fe_index(0))
+          : face_1->get_fe(face_1->nth_active_fe_index(0));
 
         const unsigned int n_dofs = fe.dofs_per_face;
 
@@ -2127,7 +2128,7 @@ namespace DoFTools
           return;
 
         const FullMatrix<double> transformation =
-            compute_transformation(fe, matrix, first_vector_components);
+          compute_transformation(fe, matrix, first_vector_components);
 
         if (! face_2->has_children())
           {
@@ -2177,8 +2178,8 @@ namespace DoFTools
                                         component_mask,
                                         face_orientation,
                                         face_orientation
-                                          ? face_rotation ^ face_flip
-                                          : face_flip,
+                                        ? face_rotation ^ face_flip
+                                        : face_flip,
                                         face_rotation);
           }
       }
index 0a5a0c8322f86a2e7b4baffaa3dd47b9cc4f711e..72a11fedef54e79e857465b695bfccbbf909f7a2 100644 (file)
@@ -2593,12 +2593,14 @@ next_cell:
                 // We have a match, so insert the matching pairs and
                 // remove the matched cell in pairs2 to speed up the
                 // matching:
-              const PeriodicFacePair<CellIterator> matched_face = {
+                const PeriodicFacePair<CellIterator> matched_face =
+                {
                   {cell1, cell2},
                   {face_idx1, face_idx2},
                   orientation,
                   matrix,
-                  first_vector_components};
+                  first_vector_components
+                };
                 matched_pairs.push_back(matched_face);
                 pairs2.erase(it2);
                 ++n_matches;

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.