]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Some text cleanups. 4357/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Mon, 8 May 2017 14:50:17 +0000 (08:50 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 8 May 2017 14:57:43 +0000 (08:57 -0600)
No functionality changes.

include/deal.II/algorithms/operator.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/lac/vector_element_access.h

index 26d189363977183398668f449e71d3545a0a5457..ad9055531838d4504b027b59645fb029c9634bf2 100644 (file)
@@ -55,8 +55,8 @@ namespace Algorithms
             if (v == nullptr) continue;
             deallog << vectors.name(i);
             for (unsigned int j=0; j<v->size(); ++j)
-              deallog << ' ' << ::dealii::internal::ElementAccess<VectorType>::get(
-                        *v, j);
+              deallog << ' '
+                      << ::dealii::internal::ElementAccess<VectorType>::get(*v, j);
             deallog << std::endl;
           }
         deallog << std::endl;
@@ -69,8 +69,8 @@ namespace Algorithms
             const VectorType *v = vectors.try_read_ptr<VectorType>(i);
             if (v == nullptr) continue;
             for (unsigned int j=0; j<v->size(); ++j)
-              (*os) << ' ' << ::dealii::internal::ElementAccess<VectorType>::get(
-                      *v, j);
+              (*os) << ' '
+                    << ::dealii::internal::ElementAccess<VectorType>::get(*v, j);
           }
         (*os) << std::endl;
       }
index 2eddceae25eac144ecc2ba89df04128060aa1b7b..56d70f842d9f02507612b81faa314c02c43469fe 100644 (file)
@@ -238,7 +238,8 @@ namespace FETools
             = ::dealii::internal::ElementAccess<OutVector>::get(
                 u2, i);
           ::dealii::internal::ElementAccess<OutVector>::set(
-            val/::dealii::internal::ElementAccess<OutVector>::get(touch_count,i), i, u2);
+            val /
+            ::dealii::internal::ElementAccess<OutVector>::get(touch_count,i), i, u2);
         }
 
     // finish the work on parallel vectors
index 2d79a16a45db8bdf7983d0840c3d13528560adda..86aa4bbc3641d9e32db2cf3e892f60dfc4e5606f 100644 (file)
@@ -27,22 +27,25 @@ namespace internal
   struct ElementAccess
   {
   public:
-    static void add(typename VectorType::value_type value,
-                    types::global_dof_index i, VectorType &V);
+    static void add(const typename VectorType::value_type value,
+                    const types::global_dof_index         i,
+                    VectorType                           &V);
 
     static void set(typename VectorType::value_type value,
-                    types::global_dof_index i, VectorType &V);
+                    const types::global_dof_index   i,
+                    VectorType                     &V);
 
-    static typename VectorType::value_type get(const VectorType &V,
-                                               types::global_dof_index i);
+    static typename VectorType::value_type get(const VectorType             &V,
+                                               const types::global_dof_index i);
   };
 
 
 
   template <typename VectorType>
   inline
-  void ElementAccess<VectorType>::add(typename VectorType::value_type value,
-                                      types::global_dof_index i, VectorType &V)
+  void ElementAccess<VectorType>::add(const typename VectorType::value_type value,
+                                      const types::global_dof_index         i,
+                                      VectorType                           &V)
   {
     V(i) += value;
   }
@@ -51,8 +54,9 @@ namespace internal
 
   template <typename VectorType>
   inline
-  void ElementAccess<VectorType>::set(typename VectorType::value_type value,
-                                      types::global_dof_index i, VectorType &V)
+  void ElementAccess<VectorType>::set(const typename VectorType::value_type value,
+                                      const types::global_dof_index         i,
+                                      VectorType                           &V)
   {
     V(i) = value;
   }
@@ -62,7 +66,8 @@ namespace internal
   template <typename VectorType>
   inline
   typename VectorType::value_type
-  ElementAccess<VectorType>::get(const VectorType &V, types::global_dof_index i)
+  ElementAccess<VectorType>::get(const VectorType             &V,
+                                 const types::global_dof_index i)
   {
     return V(i);
   }
@@ -73,7 +78,9 @@ namespace internal
   template <>
   inline
   void ElementAccess<LinearAlgebra::EpetraWrappers::Vector>::
-  add(double value, types::global_dof_index i, LinearAlgebra::EpetraWrappers::Vector &V)
+  add(const double                           value,
+      const types::global_dof_index          i,
+      LinearAlgebra::EpetraWrappers::Vector &V)
   {
     // Extract local indices in the vector.
     Epetra_FEVector vector = V.trilinos_vector();
@@ -88,7 +95,9 @@ namespace internal
   template <>
   inline
   void ElementAccess<LinearAlgebra::EpetraWrappers::Vector>::
-  set(double value, types::global_dof_index i, LinearAlgebra::EpetraWrappers::Vector &V)
+  set(const double                           value,
+      const types::global_dof_index          i,
+      LinearAlgebra::EpetraWrappers::Vector &V)
   {
     // Extract local indices in the vector.
     Epetra_FEVector vector = V.trilinos_vector();
@@ -103,7 +112,8 @@ namespace internal
   inline
   double
   ElementAccess<LinearAlgebra::EpetraWrappers::Vector>::
-  get(const LinearAlgebra::EpetraWrappers::Vector &V, types::global_dof_index i)
+  get(const LinearAlgebra::EpetraWrappers::Vector &V,
+      const types::global_dof_index                i)
   {
     // Extract local indices in the vector.
     Epetra_FEVector vector = V.trilinos_vector();

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.