]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Consistently use 'template <...' with a space. 4936/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 23 Aug 2017 02:15:10 +0000 (20:15 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 23 Aug 2017 02:16:29 +0000 (20:16 -0600)
29 files changed:
include/deal.II/base/function.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/template_constraints.h
include/deal.II/hp/fe_collection.h
include/deal.II/lac/full_matrix.templates.h
include/deal.II/lac/solver_fire.h
include/deal.II/non_matching/immersed_surface_quadrature.h
include/deal.II/numerics/kdtree.h
source/non_matching/immersed_surface_quadrature.cc
source/numerics/kdtree.cc
tests/base/pattern_tools_01.cc
tests/base/pattern_tools_02.cc
tests/base/pattern_tools_03.cc
tests/base/pattern_tools_04.cc
tests/base/pattern_tools_05.cc
tests/base/pattern_tools_06.cc
tests/base/pattern_tools_07.cc
tests/base/patterns_05.cc
tests/base/symmetric_tensor_40.cc
tests/base/symmetric_tensor_41.cc
tests/base/symmetric_tensor_44.cc
tests/fe/fe_values_view_get_function_from_local_dof_values_01.cc
tests/fe/fe_values_view_get_function_from_local_dof_values_02.cc
tests/meshworker/mesh_loop_02.cc
tests/meshworker/mesh_loop_03.cc
tests/meshworker/mesh_loop_gmg_01.cc
tests/meshworker/mesh_loop_mpi_01.cc
tests/non_matching/immersed_surface_quadrature.cc

index b0b82a199229fc8ac526ce13b7eb9aeb2d6115ad..0d4db6aaecac1505064c620702224d30f799d5e1 100644 (file)
@@ -454,7 +454,7 @@ namespace Functions
  *
  * @deprecated use Functions::ConstantFunction instead.
  */
-template<int dim, typename Number=double>
+template <int dim, typename Number=double>
 using ConstantFunction DEAL_II_DEPRECATED = Functions::ConstantFunction<dim,Number>;
 
 /**
@@ -462,7 +462,7 @@ using ConstantFunction DEAL_II_DEPRECATED = Functions::ConstantFunction<dim,Numb
  *
  * @deprecated use Functions::ZeroFunction instead.
  */
-template<int dim, typename Number=double>
+template <int dim, typename Number=double>
 using ZeroFunction DEAL_II_DEPRECATED = Functions::ZeroFunction<dim,Number>;
 
 
index b0ec4232f529dc277450bb8498130223906a8303..f92c39ea562788c08ec34790fbd52de6fa425b92 100644 (file)
@@ -263,7 +263,7 @@ MGLevelObject<Object>::max_level () const
   return minlevel + objects.size() - 1;
 }
 
-template<class Object>
+template <class Object>
 template <typename ActionFunctionObjectType>
 void
 MGLevelObject<Object>::apply (ActionFunctionObjectType action)
index a0e5a6eb9586dc56ddb149c855ddea9eb1f7ad10..18f17d185518bb8077dcd7fb30cd0fa1e2775e30 100644 (file)
@@ -62,7 +62,7 @@ namespace internal
      * Compute the inverse of a symmetric tensor of a
      * generic @p rank, @p dim and @p Number type.
      */
-    template<int rank, int dim, typename Number>
+    template <int rank, int dim, typename Number>
     struct Inverse;
   }
 
@@ -568,7 +568,7 @@ public:
    * <tt>symmetrize</tt> function first. If you aren't sure, it is good
    * practice to check before calling <tt>symmetrize</tt>.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   explicit
   SymmetricTensor (const Tensor<2,dim,OtherNumber> &t);
 
@@ -684,7 +684,7 @@ public:
    * as this operator, but rather than returning the result as a return value,
    * they write it into the first argument to the function.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   typename internal::SymmetricTensorAccessors::double_contraction_result<rank,2,dim,Number,OtherNumber>::type
   operator * (const SymmetricTensor<2,dim,OtherNumber> &s) const;
 
@@ -692,7 +692,7 @@ public:
    * Contraction over two indices of the present object with the rank-4
    * symmetric tensor given as argument.
    */
-  template<typename OtherNumber>
+  template <typename OtherNumber>
   typename internal::SymmetricTensorAccessors::double_contraction_result<rank,4,dim,Number,OtherNumber>::type
   operator * (const SymmetricTensor<4,dim,OtherNumber> &s) const;
 
@@ -948,7 +948,7 @@ SymmetricTensor<rank,dim,Number>::SymmetricTensor ()
 
 
 template <int rank, int dim, typename Number>
-template<typename OtherNumber>
+template <typename OtherNumber>
 inline
 SymmetricTensor<rank,dim,Number>::SymmetricTensor (const Tensor<2,dim,OtherNumber> &t)
 {
@@ -1094,7 +1094,7 @@ namespace internal
     }
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<2,1,Number>
     {
       static inline dealii::SymmetricTensor<2,1,Number>
@@ -1109,7 +1109,7 @@ namespace internal
     };
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<2,2,Number>
     {
       static inline dealii::SymmetricTensor<2,2,Number>
@@ -1136,7 +1136,7 @@ namespace internal
     };
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<2,3,Number>
     {
       static dealii::SymmetricTensor<2,3,Number>
@@ -1179,7 +1179,7 @@ namespace internal
     };
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<4,1,Number>
     {
       static inline dealii::SymmetricTensor<4,1,Number>
@@ -1192,7 +1192,7 @@ namespace internal
     };
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<4,2,Number>
     {
       static inline dealii::SymmetricTensor<4,2,Number>
@@ -1254,7 +1254,7 @@ namespace internal
     };
 
 
-    template<typename Number>
+    template <typename Number>
     struct Inverse<4,3,Number>
     {
       static dealii::SymmetricTensor<4,3,Number>
@@ -1596,7 +1596,7 @@ namespace internal
 
 
 template <int rank, int dim, typename Number>
-template<typename OtherNumber>
+template <typename OtherNumber>
 inline
 typename internal::SymmetricTensorAccessors::double_contraction_result<rank,2,dim,Number,OtherNumber>::type
 SymmetricTensor<rank,dim,Number>::operator * (const SymmetricTensor<2,dim,OtherNumber> &s) const
@@ -1611,7 +1611,7 @@ SymmetricTensor<rank,dim,Number>::operator * (const SymmetricTensor<2,dim,OtherN
 
 
 template <int rank, int dim, typename Number>
-template<typename OtherNumber>
+template <typename OtherNumber>
 inline
 typename internal::SymmetricTensorAccessors::double_contraction_result<rank,4,dim,Number,OtherNumber>::type
 SymmetricTensor<rank,dim,Number>::operator * (const SymmetricTensor<4,dim,OtherNumber> &s) const
@@ -2956,7 +2956,7 @@ namespace internal
        * A struct that is used to sort arrays of pairs of eign=envalues and
        * eigenvectors. Sorting is performed in in descending order of eigenvalue.
        */
-      template<int dim, typename Number>
+      template <int dim, typename Number>
       struct SortEigenValuesVectors
       {
         typedef std::pair<Number, Tensor<1,dim,Number> > EigValsVecs;
index 908d85e12df35208567e2728b823e993e0fefcb8..6171fd5ab3a9025feabaf8574e7d321a02c39422 100644 (file)
@@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace
 {
   // helper struct for is_base_of_all
-  template<bool... Types> struct BoolStorage;
+  template <bool... Types> struct BoolStorage;
 }
 
 /**
@@ -37,7 +37,7 @@ namespace
  * classes have Base as base class or are Base itself. The result
  * is stored in the member variable value.
  */
-template<class Base, class... Derived>
+template <class Base, class... Derived>
 struct is_base_of_all
 {
   static constexpr bool value =
index abde512ee27d8ee92f4b8cddd2b3b92f2d1d0e88..d913b137fc78a2db7c344ffb42a8e1073cbdf8b8 100644 (file)
@@ -72,7 +72,7 @@ namespace hp
      * Constructor. This constructor creates a FECollection from more than
      * one finite element.
      */
-    template<class... FETypes>
+    template <class... FETypes>
     explicit FECollection (const FETypes &... fes);
 
     /**
index 9b205ff226c7eacf0282c3b86403874a66e5987e..a12020cf4b7e83ddbe2616365f6ad3d438ca45e4 100644 (file)
@@ -1171,7 +1171,7 @@ namespace internal
   {
     // LAPACKFullMatrix is not implemented for
     // complex numbers or long doubles
-    template<typename number, typename = void>
+    template <typename number, typename = void>
     struct Determinant
     {
       static number value (const FullMatrix<number> &)
@@ -1184,7 +1184,7 @@ namespace internal
 
     // LAPACKFullMatrix is only implemented for
     // floats and doubles
-    template<typename number>
+    template <typename number>
     struct Determinant<number, typename std::enable_if<
       std::is_same<number,float>::value ||
       std::is_same<number,double>::value
index 99873e4c2168e41689c7124daafbf4a61a3d362c..6a822847e1d34cff8e6c8e33abffbaeed8bf23bb 100644 (file)
@@ -85,7 +85,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Vishal Boddu, Denis Davydov, 2017
  */
-template<typename VectorType = Vector<double> >
+template <typename VectorType = Vector<double> >
 class SolverFIRE : public Solver<VectorType>
 {
 
@@ -151,7 +151,7 @@ public:
    * passed in as first argument based on the second argument-- the state of
    * variables.
    */
-  template<typename PreconditionerType = DiagonalMatrix<VectorType>>
+  template <typename PreconditionerType = DiagonalMatrix<VectorType>>
   void solve
   (const std::function<double(VectorType &, const VectorType &)> &compute,
    VectorType                                                    &x,
@@ -162,7 +162,7 @@ public:
    * when $E(\mathbf x)
    * = \frac{1}{2} \mathbf x^{T} \mathbf A \mathbf x - \mathbf x^{T} \mathbf b$.
    */
-  template<typename MatrixType, typename PreconditionerType>
+  template <typename MatrixType, typename PreconditionerType>
   void solve (const MatrixType         &A,
               VectorType               &x,
               const VectorType         &b,
@@ -194,7 +194,7 @@ protected:
 
 #ifndef DOXYGEN
 
-template<typename VectorType>
+template <typename VectorType>
 SolverFIRE<VectorType>::AdditionalData::
 AdditionalData (const double  initial_timestep,
                 const double  maximum_timestep,
@@ -214,7 +214,7 @@ AdditionalData (const double  initial_timestep,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverFIRE<VectorType>::
 SolverFIRE (SolverControl            &solver_control,
             VectorMemory<VectorType> &vector_memory,
@@ -226,7 +226,7 @@ SolverFIRE (SolverControl            &solver_control,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverFIRE<VectorType>::
 SolverFIRE (SolverControl         &solver_control,
             const AdditionalData  &data          )
@@ -237,14 +237,14 @@ SolverFIRE (SolverControl         &solver_control,
 
 
 
-template<typename VectorType>
+template <typename VectorType>
 SolverFIRE<VectorType>::~SolverFIRE()
 {}
 
 
 
-template<typename VectorType>
-template<typename PreconditionerType>
+template <typename VectorType>
+template <typename PreconditionerType>
 void
 SolverFIRE<VectorType>::solve
 (const std::function<double(VectorType &, const VectorType &)> &compute,
@@ -373,7 +373,7 @@ SolverFIRE<VectorType>::solve
 
 
 template <typename VectorType>
-template<typename MatrixType, typename PreconditionerType>
+template <typename MatrixType, typename PreconditionerType>
 void SolverFIRE<VectorType>::solve (const MatrixType         &A,
                                     VectorType               &x,
                                     const VectorType         &b,
index ffa4f3a172338e22d2b1ff450933f2559bef7a9e..f14084b80989e5ca1d2a7f97326cc6faeeda1e30 100644 (file)
@@ -70,7 +70,7 @@ namespace NonMatching
    *
    * @author Simon Sticko, 2017
    */
-  template<int dim>
+  template <int dim>
   class ImmersedSurfaceQuadrature : public Quadrature<dim>
   {
   public:
index 87365664711c3bb79856cf1b6d4882fcde708e24..d87cde2156ca1daf11d432a04eb1e6486c55a82a 100644 (file)
@@ -62,7 +62,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @author Luca Heltai, 2017.
  */
-template<int dim>
+template <int dim>
 class KDTree
 {
 public:
@@ -239,7 +239,7 @@ private:
 //------------ inline functions -------------
 #ifndef DOXYGEN
 
-template<int dim>
+template <int dim>
 inline
 unsigned int KDTree<dim>::size() const
 {
@@ -251,7 +251,7 @@ unsigned int KDTree<dim>::size() const
 
 
 
-template<int dim>
+template <int dim>
 inline const Point<dim> &
 KDTree<dim>::operator[](unsigned int i) const
 {
@@ -261,14 +261,14 @@ KDTree<dim>::operator[](unsigned int i) const
 
 
 
-template<int dim>
+template <int dim>
 KDTree<dim>::PointCloudAdaptor::PointCloudAdaptor(const std::vector<Point<dim> > &_points)
   : points(_points)
 {}
 
 
 
-template<int dim>
+template <int dim>
 inline size_t
 KDTree<dim>::PointCloudAdaptor::kdtree_get_point_count() const
 {
@@ -277,7 +277,7 @@ KDTree<dim>::PointCloudAdaptor::kdtree_get_point_count() const
 
 
 
-template<int dim>
+template <int dim>
 inline double
 KDTree<dim>::PointCloudAdaptor::kdtree_get_pt(const size_t idx, int d) const
 {
@@ -287,7 +287,7 @@ KDTree<dim>::PointCloudAdaptor::kdtree_get_pt(const size_t idx, int d) const
 
 
 
-template<int dim>
+template <int dim>
 template <class BBOX>
 inline bool
 KDTree<dim>::PointCloudAdaptor::kdtree_get_bbox(BBOX &) const
@@ -297,7 +297,7 @@ KDTree<dim>::PointCloudAdaptor::kdtree_get_bbox(BBOX &) const
 
 
 
-template<int dim>
+template <int dim>
 inline double
 KDTree<dim>::PointCloudAdaptor::kdtree_distance(const double *p1, const size_t idx_p2,size_t size) const
 {
index f130b016e8b4d032e71ef569fb402689e88d231c..23fd0df780364ee95a8cd70b8aca5e1fe1cbf9aa 100644 (file)
@@ -19,7 +19,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace NonMatching
 {
 
-  template<int dim>
+  template <int dim>
   ImmersedSurfaceQuadrature<dim>::ImmersedSurfaceQuadrature(
     const std::vector<Point<dim> > &points,
     const std::vector<double> &weights,
@@ -39,7 +39,7 @@ namespace NonMatching
 
 
 
-  template<int dim>
+  template <int dim>
   void ImmersedSurfaceQuadrature<dim>::push_back(
     const Point<dim> &point,
     const double weight,
@@ -54,7 +54,7 @@ namespace NonMatching
 
 
 
-  template<int dim>
+  template <int dim>
   const Tensor<1,dim> &
   ImmersedSurfaceQuadrature<dim>::normal_vector(
     const unsigned int i) const
@@ -65,7 +65,7 @@ namespace NonMatching
 
 
 
-  template<int dim>
+  template <int dim>
   const std::vector<Tensor<1,dim> > &
   ImmersedSurfaceQuadrature<dim>::get_normal_vectors() const
   {
index 39676cd65433043838d8d17b82b340db0fcca1d8..ee6228bc720c61d881e6ca5b9741564cb965d776 100644 (file)
@@ -7,7 +7,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template<int dim>
+template <int dim>
 KDTree<dim>::KDTree(const unsigned int &max_leaf_size,
                     const std::vector<Point<dim> > &pts)
   : max_leaf_size(max_leaf_size)
@@ -17,7 +17,7 @@ KDTree<dim>::KDTree(const unsigned int &max_leaf_size,
 }
 
 
-template<int dim>
+template <int dim>
 std::vector<std::pair<unsigned int, double> > KDTree<dim>::get_points_within_ball(const Point<dim> &center,
     const double &radius,
     bool sorted) const
@@ -35,7 +35,7 @@ std::vector<std::pair<unsigned int, double> > KDTree<dim>::get_points_within_bal
   return matches;
 }
 
-template<int dim>
+template <int dim>
 std::vector<std::pair<unsigned int, double> > KDTree<dim>::get_closest_points(const Point<dim> &target,
     const unsigned int n_points) const
 {
@@ -51,7 +51,7 @@ std::vector<std::pair<unsigned int, double> > KDTree<dim>::get_closest_points(co
   return matches;
 }
 
-template<int dim>
+template <int dim>
 void KDTree<dim>::set_points(const std::vector<Point<dim> > &pts)
 {
   Assert(pts.size() > 0, ExcMessage("Expecting a non zero set of points."));
index ca71c1e83fde85cebd18315d91cb567a5b22b201..a4d290028c5e3208038dbd7293bbe966042f9616 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on elementary types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index df9b19ad514be25ad947f44d43e6634527b83160..7398aff8a3e5d55305a868f95e1cc629f6e7014f 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on non elementary types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index 311edf0eb30362c8d7d15429ae3a78efb9508807..4a6996c990680e1a8039a6c8e804bab9da5527fd 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on container types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index e46f6acc6d3f13c8739e2d0d53e409f0ce691b4d..86a0b92cebed2ddde87f23e5603f30f7be3da5cd 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on map types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index 4a78f744f72267eb4e9dbca18d6d0ba07f0c6817..7cb1ae161b2188fcf02be48b22ed65dca17eced4 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on complex map types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index 42d0914c0715380192bcc4b538998c1f7e696a8d..50e99401270edee154fe9c38414d90f0f00d33b9 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on complex map types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index d50d17b8b65b47040bd86b9324abc6f0036d54a4..c7237b8940b2d731da1b155c99305565f7ed118c 100644 (file)
@@ -27,7 +27,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on arbitrary container types
 
-template<class T>
+template <class T>
 void test(T t)
 {
   auto p = Convert<T>::to_pattern();
index fb0afff76aa3123b63b3fb9a221f18d875d3120d..538a8cfe082622e6411ef662d08d188f759b3223 100644 (file)
@@ -25,7 +25,7 @@ using namespace Patterns::Tools;
 
 // Try conversion on elementary types
 
-template<class T>
+template <class T>
 void test(T t, std::string s)
 {
   auto p = Convert<T>::to_pattern();
index f000fcc42af7a23ab371028c75e10290b7271f55..4a58f7f2da3aff37afb40d4efc0a5f8ec01915f5 100644 (file)
@@ -39,14 +39,14 @@ check_value (const int dim, const int index,
     }
 };
 
-template<int dim>
+template <int dim>
 bool
 is_unit_vector(const Tensor<1,dim> &v)
 {
   return std::abs(v.norm() - 1.0) < 1e-9;
 }
 
-template<int dim>
+template <int dim>
 bool
 check_orientation(Tensor<1,dim> v1,
                   Tensor<1,dim> v2)
index 67d4aaae5c36c0ff4c84e8677b0e8de365aac4a0..f21864a1c0eede29959913c2c23fba343ba93dfb 100644 (file)
@@ -39,14 +39,14 @@ check_value (const int dim, const int index,
     }
 };
 
-template<int dim>
+template <int dim>
 bool
 is_unit_vector(const Tensor<1,dim> &v)
 {
   return std::abs(v.norm() - 1.0) < 1e-9;
 }
 
-template<int dim>
+template <int dim>
 bool
 check_orientation(Tensor<1,dim> v1,
                   Tensor<1,dim> v2,
@@ -57,7 +57,7 @@ check_orientation(Tensor<1,dim> v1,
   return std::abs(std::abs(v1*v2) - 1.0) < tol;
 }
 
-template<int dim>
+template <int dim>
 void
 check_vector (const int index,
               const Tensor<1,dim> expected, const Tensor<1,dim> actual,
index ce61dcd9a22bc9bc47cb099d6246cccfc5572067..968d4a72305f62950ba6f6adf23ad36643ca8c70 100644 (file)
@@ -42,8 +42,8 @@ void fill_tensor  (Tensor<rank,dim,NumberType> &t)
 }
 
 template <int dim,
-          template<int,int,typename> class TensorType1, typename NumberType1,
-          template<int,int,typename> class TensorType2, typename NumberType2>
+          template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 void print (const TensorType1<2,dim,NumberType1> &t2,
             const TensorType2<4,dim,NumberType2> &t4)
 {
@@ -52,8 +52,8 @@ void print (const TensorType1<2,dim,NumberType1> &t2,
 }
 
 template <int dim,
-          template<int,int,typename> class TensorType1, typename NumberType1,
-          template<int,int,typename> class TensorType2, typename NumberType2>
+          template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 void print (const TensorType1<2,dim,NumberType1> &t2_1,
             const TensorType2<2,dim,NumberType2> &t2_2,
             const TensorType1<4,dim,NumberType1> &t4_1,
@@ -66,18 +66,18 @@ void print (const TensorType1<2,dim,NumberType1> &t2_1,
 }
 
 
-template<template<int,int,typename> class TensorType1,
-         template<int,int,typename> class TensorType2>
+template <template <int,int,typename> class TensorType1,
+          template <int,int,typename> class TensorType2>
 struct AreSame : std::false_type
 {};
 
-template<template<int,int,typename> class TensorType1>
+template <template <int,int,typename> class TensorType1>
 struct AreSame<TensorType1,TensorType1> : std::true_type
 {};
 
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 void test_one ()
 {
   const unsigned int dim = 2;
@@ -108,8 +108,8 @@ void test_one ()
   deallog << scalar_product(t2_1,t2_2) << std::endl;
 }
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 typename std::enable_if<AreSame<TensorType1,TensorType2>::value>::type
 test_two ()
 {
@@ -159,14 +159,14 @@ test_two ()
   deallog << (t4_1*t4_2) << std::endl;
 }
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 typename std::enable_if<!AreSame<TensorType1,TensorType2>::value>::type
 test_two ()
 {}
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 typename std::enable_if<(
   AreSame<TensorType1,SymmetricTensor>::value &&
   AreSame<TensorType2,SymmetricTensor>::value)>::type
@@ -187,8 +187,8 @@ test_three ()
   deallog << res_dc << std::endl;
 }
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 typename std::enable_if<!(
   AreSame<TensorType1,SymmetricTensor>::value &&
   AreSame<TensorType2,SymmetricTensor>::value)>::type
@@ -196,8 +196,8 @@ test_three ()
 {}
 
 
-template<template<int,int,typename> class TensorType1, typename NumberType1,
-         template<int,int,typename> class TensorType2, typename NumberType2>
+template <template <int,int,typename> class TensorType1, typename NumberType1,
+          template <int,int,typename> class TensorType2, typename NumberType2>
 void test_all ()
 {
   test_one<TensorType1,NumberType1,TensorType2,NumberType2>();
@@ -205,7 +205,7 @@ void test_all ()
   test_three<TensorType1,NumberType1,TensorType2,NumberType2>();
 }
 
-template<typename Number1, typename Number2>
+template <typename Number1, typename Number2>
 void test_T ()
 {
   deallog.push("ST,ST");
index f19c2723cfa7debbb3b593719419751ab2cf7c91..cbde3601019699888c16208faedbee7f9d76cadf 100644 (file)
@@ -33,7 +33,7 @@
 #include <fstream>
 #include <type_traits>
 
-template<typename NumberType, int dim, typename ExtractorType>
+template <typename NumberType, int dim, typename ExtractorType>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -41,7 +41,7 @@ void test_view (const Vector<double> &solution,
                 const std::vector<NumberType> &local_dof_values);
 
 // Scalar view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim> &fe_values,
                 const unsigned int  &n_q_points,
@@ -110,7 +110,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // Vector view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim> &fe_values,
                 const unsigned int  &n_q_points,
@@ -212,7 +212,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // SymmetricTensor view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -251,7 +251,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // Tensor view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -289,7 +289,7 @@ void test_view (const Vector<double> &solution,
     }
 }
 
-template<typename NumberType, int dim, typename FEType, typename ExtractorType>
+template <typename NumberType, int dim, typename FEType, typename ExtractorType>
 void test_extractor (const FEType        &fe,
                      const ExtractorType &extractor)
 {
@@ -337,7 +337,7 @@ void test_extractor (const FEType        &fe,
   deallog << "OK" << std::endl;
 }
 
-template<typename NumberType, int dim = 2>
+template <typename NumberType, int dim = 2>
 void test()
 {
   const unsigned int degree = 3; // Need third derivatives
index c9ff474b76076f70361233f2eac31b2fc21374cf..d80a0719ddaf91458adda0cb60bc1a225c871d73 100644 (file)
@@ -38,7 +38,7 @@
 #include <fstream>
 #include <type_traits>
 
-template<typename NumberType, int dim, typename ExtractorType>
+template <typename NumberType, int dim, typename ExtractorType>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -46,7 +46,7 @@ void test_view (const Vector<double> &solution,
                 const std::vector<NumberType> &local_dof_values);
 
 // Scalar view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim> &fe_values,
                 const unsigned int  &n_q_points,
@@ -81,7 +81,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // Vector view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim> &fe_values,
                 const unsigned int  &n_q_points,
@@ -128,7 +128,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // SymmetricTensor view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -153,7 +153,7 @@ void test_view (const Vector<double> &solution,
 }
 
 // Tensor view
-template<typename NumberType, int dim>
+template <typename NumberType, int dim>
 void test_view (const Vector<double> &solution,
                 const FEValues<dim>  &fe_values,
                 const unsigned int   &n_q_points,
@@ -177,7 +177,7 @@ void test_view (const Vector<double> &solution,
   fe_values_view.get_function_divergences_from_local_dof_values(local_dof_values, qp_divs_local);
 }
 
-template<typename NumberType, int dim, typename FEType, typename ExtractorType>
+template <typename NumberType, int dim, typename FEType, typename ExtractorType>
 void test_extractor (const FEType        &fe,
                      const ExtractorType &extractor)
 {
@@ -225,7 +225,7 @@ void test_extractor (const FEType        &fe,
   deallog << "OK" << std::endl;
 }
 
-template<typename NumberType, int dim = 2>
+template <typename NumberType, int dim = 2>
 void test()
 {
   const unsigned int degree = 3; // Need third derivatives
index ee37afd9a1ac0e44adc41732535799cc6cd81bd6..c4ba93c3b84da34a3bcd70e61d86e9e297f92156 100644 (file)
@@ -31,7 +31,7 @@ struct CopyData {};
 
 using namespace MeshWorker;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   Triangulation<dim,spacedim> tria;
index f4d91d8874bfcfdb5215bd259869b48188715da6..8f60365c81a23f514b04424c041709c37b5d9b1b 100644 (file)
@@ -32,7 +32,7 @@ struct CopyData {};
 
 using namespace MeshWorker;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   Triangulation<dim,spacedim> tria;
index 9199ad354df7e5a7ead8ba6ac6196a0d361e8567..4cc768fd20b844630dd1b6a8db4eb6d930b97c46 100644 (file)
@@ -44,7 +44,7 @@ struct CopyData
 
 using namespace MeshWorker;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
index 1bae3090fbdfe6f864cb1dece25f9baf35e3274b..afec2b8250d555537ee00ba38b40fe6d8cbb99fa 100644 (file)
@@ -43,7 +43,7 @@ struct CopyData
 
 using namespace MeshWorker;
 
-template<int dim, int spacedim>
+template <int dim, int spacedim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD);
index 51307b88110b52fefc82753cac9def2e1c2c9b3d..22fd7f7ca09344956ada68bf2786d8a55a71d9d3 100644 (file)
@@ -25,7 +25,7 @@ using namespace dealii;
 
 
 
-template<int dim>
+template <int dim>
 void print_quadrature(const NonMatching::ImmersedSurfaceQuadrature<dim> &quadrature)
 {
   for (unsigned int i = 0; i < quadrature.size(); ++i)
@@ -39,7 +39,7 @@ void print_quadrature(const NonMatching::ImmersedSurfaceQuadrature<dim> &quadrat
 
 //Check that get_normals() are callable and are of the same size as
 //points and weights.
-template<int dim>
+template <int dim>
 void check_get_normals(
   const NonMatching::ImmersedSurfaceQuadrature<dim> &quadrature)
 {
@@ -52,7 +52,7 @@ void check_get_normals(
 
 
 
-template<int dim>
+template <int dim>
 void test_non_default_constructor()
 {
   deallog<<"Using constructor"<<std::endl;
@@ -67,7 +67,7 @@ void test_non_default_constructor()
 
 
 
-template<int dim>
+template <int dim>
 void test_push_back()
 {
   deallog<<"Using push_back"<<std::endl;
@@ -83,7 +83,7 @@ void test_push_back()
 
 
 
-template<int dim>
+template <int dim>
 void construct_quadrature_and_print_points()
 {
   test_push_back<dim>();

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.