]> https://gitweb.dealii.org/ - dealii.git/commitdiff
run astyle
authorMatthias Maier <tamiko@43-1.org>
Thu, 3 Sep 2015 00:07:08 +0000 (19:07 -0500)
committerMatthias Maier <tamiko@43-1.org>
Mon, 7 Sep 2015 18:36:22 +0000 (13:36 -0500)
include/deal.II/base/tensor.h
include/deal.II/base/tensor_base.h
tests/base/tensor_mixing_types_01.cc

index 738be73325e2e3c0b06a0c1c7c3f857b2648f2b2..adf1df91e73a348687a7d9eb172038a8b00df6ac 100644 (file)
@@ -128,9 +128,9 @@ std::ostream &operator << (std::ostream &out, const Tensor<1,1,double> &p)
  * @relates EnableIfScalar
  */
 template <int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<0,dim,typename ProductType<OtherNumber, Number>::type>
 operator * (const OtherNumber           factor,
@@ -147,9 +147,9 @@ operator * (const OtherNumber           factor,
  * @relates EnableIfScalar
  */
 template <int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<0,dim,typename ProductType<Number, OtherNumber>::type>
 operator * (const Tensor<0,dim,Number> &t,
@@ -166,9 +166,9 @@ operator * (const Tensor<0,dim,Number> &t,
  * @relates EnableIfScalar
  */
 template <int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<0,dim,typename ProductType<Number, OtherNumber>::type>
 operator / (const Tensor<0,dim,Number> &t,
index 08a1d022dd2bb764e99b611205cf02f9ddb63931..741b9600967be56dffdc784158e35d451e9d5ee5 100644 (file)
@@ -366,7 +366,7 @@ public:
    * times the number of independent components of each sub-tensor.
    */
   static const unsigned int
-  n_independent_components = Tensor<rank_-1,dim>::n_independent_components * dim;
+  n_independent_components = Tensor<rank_-1,dim>::n_independent_components *dim;
 
   /**
    * Declare a type that holds real-valued numbers with the same precision
@@ -394,7 +394,7 @@ public:
    * type statically.
    */
   typedef typename Tensor<rank_-1,dim,Number>::array_type
-    array_type[(dim != 0) ? dim : 1];
+  array_type[(dim != 0) ? dim : 1];
 
   /**
    * Constructor. Initialize all entries to zero if
@@ -436,12 +436,12 @@ public:
   /**
    * Read-Write access operator.
    */
-  value_type & operator [] (const unsigned int i);
+  value_type &operator [] (const unsigned int i);
 
   /**
    * Read-only access operator.
    */
-  const value_type & operator[](const unsigned int i) const;
+  const value_type &operator[](const unsigned int i) const;
 
   /**
    * Read access using TableIndices <tt>indices</tt>
@@ -852,11 +852,11 @@ namespace internal
     //   tensor[indices[0]][indices[1]]...[indices[rank_]]
     template<int rank, int dim, typename Number>
     static inline
-    Number & extract(Tensor<rank_,dim,Number> &t, const TableIndices<rank> &indices)
+    Number &extract(Tensor<rank_,dim,Number> &t, const TableIndices<rank> &indices)
     {
       Assert (indices[rank - rank_]<dim, ExcIndexRange (indices[rank - rank_], 0, dim));
       return TensorIndicesHelper<rank_ - 1>::template extract<rank, dim, Number>(
-          t[indices[rank - rank_]], indices);
+        t[indices[rank - rank_]], indices);
     }
   };
 
@@ -864,7 +864,7 @@ namespace internal
   {
     template<int rank, int dim, typename Number>
     static inline
-    Number & extract(Tensor<1,dim,Number> &t, const TableIndices<rank> &indices)
+    Number &extract(Tensor<1,dim,Number> &t, const TableIndices<rank> &indices)
     {
       Assert (indices[rank - 1]<dim, ExcIndexRange (indices[rank - 1], 0, dim));
       return t[indices[rank-1]];
@@ -1185,7 +1185,7 @@ Tensor<rank_, dim, Number>::unroll_recursion (Vector<OtherNumber> &result,
 {
   for (unsigned int i=0; i<dim; ++i)
     static_cast<Tensor<rank_ - 1, dim, Number> >(values[i]).
-      unroll_recursion(result, index);
+    unroll_recursion(result, index);
 }
 
 
@@ -1302,9 +1302,9 @@ struct ProductType<Tensor<rank,dim,T>,U>
  * @relates EnableIfScalar
  */
 template <int rank, int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<rank,dim,typename ProductType<Number, OtherNumber>::type>
 operator * (const Tensor<rank,dim,Number> &t,
@@ -1327,9 +1327,9 @@ operator * (const Tensor<rank,dim,Number> &t,
  * @relates EnableIfScalar
  */
 template <int rank, int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<rank,dim,typename ProductType<Number, OtherNumber>::type>
 operator * (const Number                        factor,
@@ -1349,9 +1349,9 @@ operator * (const Number                        factor,
  * @relates EnableIfScalar
  */
 template <int rank, int dim,
-         typename Number,
-         typename OtherNumber,
-         typename = typename EnableIfScalar<OtherNumber>::type>
+          typename Number,
+          typename OtherNumber,
+          typename = typename EnableIfScalar<OtherNumber>::type>
 inline
 Tensor<rank,dim,typename ProductType<Number, OtherNumber>::type>
 operator / (const Tensor<rank,dim,Number> &t,
index e82d6ffbaf6e151d003075d9be2e5d9bf957df97..ba51874a79cbd1201aa77d66fbafc636b632f028 100644 (file)
@@ -31,11 +31,11 @@ int main ()
 
     deallog << f + d << std::endl;
     deallog << f - d << std::endl;
-    deallog << f * d << std::endl;
+    deallog << f *d << std::endl;
 
     deallog << d + c << std::endl;
     deallog << d - c << std::endl;
-    deallog << d * c << std::endl;
+    deallog << d *c << std::endl;
 
     float f_scalar = 10.;
     deallog << (d * f_scalar) << std::endl;
@@ -59,11 +59,11 @@ int main ()
 
     deallog << f + d << std::endl;
     deallog << f - d << std::endl;
-    deallog << f * d << std::endl;
+    deallog << f *d << std::endl;
 
     deallog << d + c << std::endl;
     deallog << d - c << std::endl;
-    deallog << d * c << std::endl;
+    deallog << d *c << std::endl;
 
     float f_scalar = 10.;
     deallog << (d * f_scalar) << std::endl;
@@ -87,11 +87,11 @@ int main ()
 
     deallog << f + d << std::endl;
     deallog << f - d << std::endl;
-    deallog << f * d << std::endl;
+    deallog << f *d << std::endl;
 
     deallog << d + c << std::endl;
     deallog << d - c << std::endl;
-    deallog << d * c << std::endl;
+    deallog << d *c << std::endl;
 
     float f_scalar = 10.;
     deallog << (d * f_scalar) << std::endl;

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.