]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
make indent
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 3 Dec 2012 19:44:54 +0000 (19:44 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 3 Dec 2012 19:44:54 +0000 (19:44 +0000)
git-svn-id: https://svn.dealii.org/trunk@27737 0785d39b-7218-0410-832d-ea1e28bc413d

12 files changed:
deal.II/examples/step-46/step-46.cc
deal.II/examples/step-6/step-6.cc
deal.II/include/deal.II/grid/tria_objects.h
deal.II/include/deal.II/lac/relaxation_block.h
deal.II/include/deal.II/lac/relaxation_block.templates.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/dofs/dof_handler_policy.cc
deal.II/source/dofs/dof_tools.cc
deal.II/source/fe/fe_face.cc
deal.II/source/grid/grid_tools.cc
deal.II/source/lac/trilinos_sparse_matrix.cc

index 1c27847ed9e65b5a9275a339040ccceb9909bf38..a3bd49cc215a1e520bf1737e8c416ab9f00f4ce4 100644 (file)
@@ -684,8 +684,8 @@ namespace Step46
                 //
                 // - The neighbor is at the same refinement level and has no
                 //   children.
-               // - The neighbor has children.
-               // - The neighbor is coarser.
+                // - The neighbor has children.
+                // - The neighbor is coarser.
                 //
                 // In all three cases, we are only interested in it if it is
                 // part of the fluid subdomain. So let us start with the first
index b62734b2123562e50f8085507466a1ee37c3b755..068fe9a410effadb4a509dfca3e4b7b34b6ba630 100644 (file)
@@ -430,9 +430,9 @@ void Step6<dim>::assemble_system ()
       // @p cell_rhs into the global objects.
       cell->get_dof_indices (local_dof_indices);
       constraints.distribute_local_to_global(cell_matrix,
-                                            cell_rhs,
-                                            local_dof_indices,
-                                            system_matrix, system_rhs);
+                                             cell_rhs,
+                                             local_dof_indices,
+                                             system_matrix, system_rhs);
     }
   // Now we are done assembling the linear system.  The constrained nodes are
   // still in the linear system (there is a one on the diagonal of the matrix
index d4f57aad4b1d36df6c1cb4527bc3aa4fa35f662a..a0cf6f1a855b432ad1d3869e03206312549574f7 100644 (file)
@@ -319,7 +319,7 @@ namespace internal
       /**
        * Access to user pointers.
        */
-      void  * &user_pointer(const unsigned int i);
+      void  *&user_pointer(const unsigned int i);
 
       /**
        * Read-only access to user pointers.
@@ -763,7 +763,7 @@ namespace internal
 
     template<typename G>
     inline
-    void * &
+    void*&
     TriaObjects<G>::user_pointer (const unsigned int i)
     {
 #ifdef DEBUG
index 54e57fe500e752b67a9abfb9191c0da5faea7cac..6a2d94fc250d04100c426cbf05c64429d3252e8e 100644 (file)
@@ -310,7 +310,7 @@ public:
   /**
    * Return the memory allocated in this object.
    */
-    std::size_t memory_consumption() const;
+  std::size_t memory_consumption() const;
 };
 
 
index d4ae73c14d8fa9e36c657c38b5da64ce8921e8a7..f0fa8b5e90ceff6ca725d5ed3dea14c6f9342df2 100644 (file)
@@ -39,8 +39,8 @@ std::size_t
 RelaxationBlock<MATRIX,inverse_type>::AdditionalData::memory_consumption() const
 {
   std::size_t result = sizeof(*this)
-                      + - sizeof(block_list) + block_list.memory_consumption();
-  for (unsigned int i=0;i<order.size();++i)
+                       + - sizeof(block_list) + block_list.memory_consumption();
+  for (unsigned int i=0; i<order.size(); ++i)
     result += MemoryConsumption::memory_consumption(order[i]);
   return result;
 }
index ff0a55ba90b1a95bb05d70d293fa3f5fa898e2b5..60fb6cac1020183cf8cd04e61dab964d57c8ebf9 100644 (file)
@@ -508,7 +508,7 @@ namespace internal
     struct Norm2
     {
       RealType
-      operator() (const Number  *&X, const Number  * &, const RealType &) const
+      operator() (const Number  *&X, const Number  *&, const RealType &) const
       {
         return numbers::NumberTraits<Number>::abs_square(*X++);
       }
@@ -518,7 +518,7 @@ namespace internal
     struct Norm1
     {
       RealType
-      operator() (const Number  *&X, const Number  * &, const RealType &) const
+      operator() (const Number  *&X, const Number  *&, const RealType &) const
       {
         return numbers::NumberTraits<Number>::abs(*X++);
       }
@@ -528,7 +528,7 @@ namespace internal
     struct NormP
     {
       RealType
-      operator() (const Number  *&X, const Number  * &, const RealType &p) const
+      operator() (const Number  *&X, const Number  *&, const RealType &p) const
       {
         return std::pow(numbers::NumberTraits<Number>::abs(*X++), p);
       }
@@ -538,7 +538,7 @@ namespace internal
     struct MeanValue
     {
       Number
-      operator() (const Number  *&X, const Number  * &, const Number &) const
+      operator() (const Number  *&X, const Number  *&, const Number &) const
       {
         return *X++;
       }
index 6936970500cfaea745d1c26a8ebb1a41c674742c..a96dfb3a24072e4ad9a769b6ff2ad5ac77d29d20 100644 (file)
@@ -77,14 +77,14 @@ namespace VectorTools
     template <typename Number>
     void perform_compress_insert (::dealii::parallel::distributed::Vector<Number> &vec)
     {
-                                // should not do compress when inserting
-                                // elements as the ghosts are fixed and some
-                                // will not be set at all. Instead, zero the
-                                // ghost data afterwards to get consistent
-                                // data. Otherwise, at least with the layout
-                                // in r27671 the tests/mpi/step-48/ncpu_10
-                                // will signal incorrect results because of
-                                // incorrect interpolation.
+      // should not do compress when inserting
+      // elements as the ghosts are fixed and some
+      // will not be set at all. Instead, zero the
+      // ghost data afterwards to get consistent
+      // data. Otherwise, at least with the layout
+      // in r27671 the tests/mpi/step-48/ncpu_10
+      // will signal incorrect results because of
+      // incorrect interpolation.
       vec.zero_out_ghosts();
     }
 
index 8d6aa68f8ff12011d9716eb60426ceb0798d74ae..16593216c2241ad1eae888c15735574f78861267 100644 (file)
@@ -247,8 +247,8 @@ namespace internal
                 (cell->subdomain_id() == subdomain_id))
               next_free_dof
                 = Implementation::distribute_dofs_on_cell (dof_handler,
-                                                          cell,
-                                                          next_free_dof);
+                                                           cell,
+                                                           next_free_dof);
 
           // update the cache used for cell dof indices
           for (typename DoFHandler<dim,spacedim>::cell_iterator
index 874a78c99d7f704f2fe15617e213dc17e0ccb432..aecaa3dd4838d2d5b42d689201448b7bfa0d06e8 100644 (file)
@@ -3304,16 +3304,16 @@ namespace DoFTools
     static const int dim = FaceIterator::AccessorType::dimension;
 
     Assert( (dim != 1) ||
-                (face_orientation == true &&
-                 face_flip == false &&
-                 face_rotation == false),
+            (face_orientation == true &&
+             face_flip == false &&
+             face_rotation == false),
             ExcMessage ("The supplied orientation "
                         "(face_orientation, face_flip, face_rotation) "
                         "is invalid for 1D"));
 
     Assert( (dim != 2) ||
-                (face_orientation == true &&
-                 face_rotation == false),
+            (face_orientation == true &&
+             face_rotation == false),
             ExcMessage ("The supplied orientation "
                         "(face_orientation, face_flip, face_rotation) "
                         "is invalid for 2D"));
@@ -3332,20 +3332,26 @@ namespace DoFTools
     static const int lookup_table_2d[2][2]
     //             flip
     = { {0, 1}, // false
-        {1, 0}, // true
-      };
+      {1, 0}, // true
+    };
 
     static const int lookup_table_3d[2][2][2][4]
     //                             orientation flip  rotation
     = { { { {0, 2, 1, 3},       // false       false false
-            {2, 3, 0, 1}, },    // false       false true
-          { {3, 1, 2, 0},       // false       true  false
-            {1, 0, 3, 2}, }, }, // false       true  true
-        { { {0, 1, 2, 3},       // true        false false
-            {1, 3, 0, 2}, },    // true        false true
-          { {3, 2, 1, 0},       // true        true  false
-            {2, 0, 3, 1}, }, }, // true        true  true
-      };
+          {2, 3, 0, 1},
+        },    // false       false true
+        { {3, 1, 2, 0},       // false       true  false
+          {1, 0, 3, 2},
+        },
+      }, // false       true  true
+      { { {0, 1, 2, 3},       // true        false false
+          {1, 3, 0, 2},
+        },    // true        false true
+        { {3, 2, 1, 0},       // true        true  false
+          {2, 0, 3, 1},
+        },
+      }, // true        true  true
+    };
 
     // In the case that both faces have children, we loop over all
     // children and apply make_periodicty_constrains recursively:
@@ -3359,16 +3365,16 @@ namespace DoFTools
           {
             // Lookup the index for the second face
             unsigned int j;
-            switch(dim)
+            switch (dim)
               {
-                case 2:
-                  j = lookup_table_2d[face_flip][i];
-                  break;
-                case 3:
-                  j = lookup_table_3d[face_orientation][face_flip][face_rotation][i];
-                  break;
-                default:
-                  AssertThrow(false, ExcNotImplemented());
+              case 2:
+                j = lookup_table_2d[face_flip][i];
+                break;
+              case 3:
+                j = lookup_table_3d[face_orientation][face_flip][face_rotation][i];
+                break;
+              default:
+                AssertThrow(false, ExcNotImplemented());
               }
 
             make_periodicity_constraints (face_1->child(i),
@@ -3433,11 +3439,11 @@ namespace DoFTools
     for (unsigned int i = 0; i < dofs_per_face; ++i)
       {
         const unsigned int cell_index = fe.
-          face_to_cell_index(i,
-                             0, // It doesn't really matter, just assume
-                                // we're on the first face...
-                             true, false, false // default orientation
-                             );
+                                        face_to_cell_index(i,
+                                                           0, // It doesn't really matter, just assume
+                                                           // we're on the first face...
+                                                           true, false, false // default orientation
+                                                          );
         cell_to_rotated_face_index[cell_index] = i;
       }
 
@@ -3447,12 +3453,12 @@ namespace DoFTools
         // orientation:
         const unsigned int j =
           cell_to_rotated_face_index[fe.
-                face_to_cell_index(i,
-                                   0, // It doesn't really matter, just assume
-                                      // we're on the first face...
-                                   face_orientation,
-                                   face_flip,
-                                   face_rotation)];
+                                     face_to_cell_index(i,
+                                                        0, // It doesn't really matter, just assume
+                                                        // we're on the first face...
+                                                        face_orientation,
+                                                        face_flip,
+                                                        face_rotation)];
 
         // And finally constrain the two DoFs respecting component_mask:
         if ((component_mask.n_selected_components(fe.n_components()) == fe.n_components())
index be980ad419c67f03cc23fb8bcb54a4d4664f248b..85812d966c09ae12a753e66afe8b68124bfb35b6 100644 (file)
@@ -36,7 +36,7 @@ FE_FaceQ<dim,spacedim>::FE_FaceQ (const unsigned int degree)
     {
       const double step = 1./this->degree;
       Point<codim> p;
-  
+
       unsigned int k=0;
       for (unsigned int iz=0; iz <= ((codim>2) ? this->degree : 0) ; ++iz)
         for (unsigned int iy=0; iy <= ((codim>1) ? this->degree : 0) ; ++iy)
@@ -47,7 +47,7 @@ FE_FaceQ<dim,spacedim>::FE_FaceQ (const unsigned int degree)
                 p(1) = iy * step;
               if (codim>2)
                 p(2) = iz * step;
-              
+
               this->unit_face_support_points[k++] = p;
             }
       AssertDimension (k, this->unit_face_support_points.size());
index 1e4516091ba33bfd0a395a813b36cc65d8f07596..0933ec500f8929bedb150607b823a11023e56df4 100644 (file)
@@ -2499,10 +2499,10 @@ next_cell:
     FaceMap matching = match_periodic_face_pairs(faces1, faces2, direction, offset);
 
     std::map<typename DH::face_iterator, typename DH::face_iterator>
-      return_value;
+    return_value;
 
-    for(typename FaceMap::iterator pairing = matching.begin();
-        pairing != matching.end(); ++pairing)
+    for (typename FaceMap::iterator pairing = matching.begin();
+         pairing != matching.end(); ++pairing)
       {
         Assert(pairing->second.second == 1,
                ExcMessage("Found a face match with non standard orientation. "
index d475a648eb5c35240b6c149457147aa9c0d62123..a3d05064c9538e5eb2ad241978f925a77e77eca7 100644 (file)
@@ -771,7 +771,7 @@ set_matrix_values:
     // Extract local indices in
     // the matrix.
     int trilinos_i = matrix->LRID(static_cast<int>(i)),
-       trilinos_j = matrix->LCID(static_cast<int>(j));
+        trilinos_j = matrix->LCID(static_cast<int>(j));
     TrilinosScalar value = 0.;
 
     // If the data is not on the

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.