]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Standardize on 'template <typename X>.
authorWolfgang Bangerth <bangerth@colostate.edu>
Mon, 3 Jul 2023 03:52:43 +0000 (21:52 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 3 Jul 2023 03:56:00 +0000 (21:56 -0600)
51 files changed:
include/deal.II/algorithms/any_data.h
include/deal.II/base/exceptions.h
include/deal.II/base/index_set.h
include/deal.II/base/linear_index_iterator.h
include/deal.II/base/mutable_bind.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/path_search.h
include/deal.II/base/patterns.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/template_constraints.h
include/deal.II/base/timer.h
include/deal.II/differentiation/sd/symengine_optimizer.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_interface_values.h
include/deal.II/fe/fe_poly_face.h
include/deal.II/fe/fe_poly_face.templates.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/fe/fe_values.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/grid_tools_cache_update_flags.h
include/deal.II/grid/intergrid_map.h
include/deal.II/grid/tria_iterator.h
include/deal.II/hp/fe_values.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/cuda_sparse_matrix.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/solver_relaxation.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/meshworker/assemble_flags.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/mesh_loop.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/multigrid.h
include/deal.II/non_matching/fe_values.h
include/deal.II/numerics/vector_tools_interpolate.h
source/base/data_out_base.cc
source/dofs/dof_renumbering.cc
source/fe/mapping_cartesian.cc
source/grid/grid_tools.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/intergrid_map.cc
source/hp/fe_values.cc
source/lac/block_sparsity_pattern.cc

index d9c1ed57bbf2903909f862c88e69dc8d313db7f3..fafba5b08dab9d4233adfd7c563b9aa4aecc02c2 100644 (file)
@@ -186,7 +186,7 @@ public:
   is_type(const unsigned int i) const;
 
   /// List the contents to a stream
-  template <class StreamType>
+  template <typename StreamType>
   void
   list(StreamType &os) const;
 
@@ -448,7 +448,7 @@ AnyData::merge(const AnyData &other)
 }
 
 
-template <class StreamType>
+template <typename StreamType>
 inline void
 AnyData::list(StreamType &os) const
 {
index 1ed204414eb74f7da770852cbaf623467f6c8023..b165b755a056f69dc1c832f0e6c03e1546a65bee 100644 (file)
@@ -1421,7 +1421,7 @@ namespace deal_II_exceptions
      *
      * @ref ExceptionBase
      */
-    template <class ExceptionType>
+    template <typename ExceptionType>
     [[noreturn]] void
     issue_error_noreturn(ExceptionHandling handling,
                          const char *      file,
@@ -1471,7 +1471,7 @@ namespace deal_II_exceptions
      * @note This function is defined with a template for the same reasons as
      * issue_error_noreturn().
      */
-    template <class ExceptionType>
+    template <typename ExceptionType>
     void
     issue_error_nothrow(const char *  file,
                         int           line,
index c9abbddc7a6f489622596b988cf93c7ef1f21dd9..647ce8810cfa5bddcf65a850634ac15a056149d3 100644 (file)
@@ -448,7 +448,7 @@ public:
    * Output a text representation of this IndexSet to the given stream. Used
    * for testing.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print(StreamType &out) const;
 
@@ -1960,7 +1960,7 @@ IndexSet::fill_binary_vector(Vector &vector) const
 
 
 
-template <class StreamType>
+template <typename StreamType>
 inline void
 IndexSet::print(StreamType &out) const
 {
index ca71446db0b0ebf782c4dc183ee944985bab4b8f..b3c1b2dcc7ea342db23dada22012b37f7ca1070c 100644 (file)
@@ -135,7 +135,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @note TransposeTable uses this template to implement its iterators.
  */
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 class LinearIndexIterator
 {
 public:
@@ -332,7 +332,7 @@ protected:
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator &
 LinearIndexIterator<DerivedIterator, AccessorType>::operator=(
   const DerivedIterator &it)
@@ -344,7 +344,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator=(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator &
 LinearIndexIterator<DerivedIterator, AccessorType>::operator++()
 {
@@ -353,7 +353,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator++()
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator
 LinearIndexIterator<DerivedIterator, AccessorType>::operator++(int)
 {
@@ -364,7 +364,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator++(int)
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator &
 LinearIndexIterator<DerivedIterator, AccessorType>::operator--()
 {
@@ -373,7 +373,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator--()
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator
 LinearIndexIterator<DerivedIterator, AccessorType>::operator--(int)
 {
@@ -384,7 +384,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator--(int)
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator
 LinearIndexIterator<DerivedIterator, AccessorType>::operator+(
   const difference_type n) const
@@ -396,7 +396,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator+(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator
 LinearIndexIterator<DerivedIterator, AccessorType>::operator-(
   const difference_type n) const
@@ -408,7 +408,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator-(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator &
 LinearIndexIterator<DerivedIterator, AccessorType>::operator+=(
   const difference_type n)
@@ -419,7 +419,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator+=(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline DerivedIterator &
 LinearIndexIterator<DerivedIterator, AccessorType>::operator-=(
   const difference_type n)
@@ -429,7 +429,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator-=(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline
   typename LinearIndexIterator<DerivedIterator, AccessorType>::difference_type
   LinearIndexIterator<DerivedIterator, AccessorType>::operator-(
@@ -443,7 +443,7 @@ inline
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline typename LinearIndexIterator<DerivedIterator, AccessorType>::reference
 LinearIndexIterator<DerivedIterator, AccessorType>::operator*() const
 {
@@ -452,7 +452,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator*() const
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline typename LinearIndexIterator<DerivedIterator, AccessorType>::pointer
 LinearIndexIterator<DerivedIterator, AccessorType>::operator->() const
 {
@@ -461,7 +461,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator->() const
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline bool
 LinearIndexIterator<DerivedIterator, AccessorType>::operator<=(
   const DerivedIterator &other) const
@@ -471,7 +471,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator<=(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline bool
 LinearIndexIterator<DerivedIterator, AccessorType>::operator>=(
   const DerivedIterator &other) const
@@ -481,7 +481,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator>=(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline bool
 LinearIndexIterator<DerivedIterator, AccessorType>::operator<(
   const DerivedIterator &other) const
@@ -494,7 +494,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator<(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline bool
 LinearIndexIterator<DerivedIterator, AccessorType>::operator>(
   const DerivedIterator &other) const
@@ -504,7 +504,7 @@ LinearIndexIterator<DerivedIterator, AccessorType>::operator>(
 
 
 
-template <class DerivedIterator, class AccessorType>
+template <typename DerivedIterator, typename AccessorType>
 inline LinearIndexIterator<DerivedIterator, AccessorType>::LinearIndexIterator(
   const AccessorType accessor)
   : accessor(accessor)
index 7f153af4ca53a32ef5e6b97842514ea7fd3e49f9..1c73050dcb17ab3fedc91b44bb1ed21b0e83a4dc 100644 (file)
@@ -93,21 +93,21 @@ namespace Utilities
      * Construct a MutableBind object specifying the function, and
      * each arguments separately.
      */
-    template <class FunctionType>
+    template <typename FunctionType>
     MutableBind(FunctionType function, FunctionArgs &&...arguments);
 
     /**
      * Construct a MutableBind object specifying the function, and
      * the arguments as a tuple.
      */
-    template <class FunctionType>
+    template <typename FunctionType>
     MutableBind(FunctionType function, TupleType &&arguments);
 
     /**
      * Construct a MutableBind object specifying only the function. By default,
      * the arguments are left to their default constructor values.
      */
-    template <class FunctionType>
+    template <typename FunctionType>
     MutableBind(FunctionType function);
 
     /**
@@ -221,7 +221,7 @@ namespace Utilities
 
 #ifndef DOXYGEN
   template <typename ReturnType, class... FunctionArgs>
-  template <class FunctionType>
+  template <typename FunctionType>
   MutableBind<ReturnType, FunctionArgs...>::MutableBind(
     FunctionType function,
     FunctionArgs &&...arguments)
@@ -232,7 +232,7 @@ namespace Utilities
 
 
   template <typename ReturnType, class... FunctionArgs>
-  template <class FunctionType>
+  template <typename FunctionType>
   MutableBind<ReturnType, FunctionArgs...>::MutableBind(FunctionType function,
                                                         TupleType && arguments)
     : function(function)
@@ -242,7 +242,7 @@ namespace Utilities
 
 
   template <typename ReturnType, class... FunctionArgs>
-  template <class FunctionType>
+  template <typename FunctionType>
   MutableBind<ReturnType, FunctionArgs...>::MutableBind(FunctionType function)
     : function(function)
   {}
index 0c88ef62dbccbd1c61e7a4c83d4bef5c549bdbeb..2898f0ea05a873ecf67bfbdd50e1fbfa97ad68b7 100644 (file)
@@ -520,7 +520,7 @@ public:
    * See the documentation of ParameterHandler::add_parameter() for more
    * information.
    */
-  template <class ParameterType>
+  template <typename ParameterType>
   void
   add_parameter(const std::string &          entry,
                 ParameterType &              parameter,
@@ -724,7 +724,7 @@ public:
 
 
 // Inline and template functions
-template <class ParameterType>
+template <typename ParameterType>
 void
 ParameterAcceptor::add_parameter(const std::string &          entry,
                                  ParameterType &              parameter,
index 3fd37b9211309b6aa8f97a02b536726c30f04daa..fa4cf1c05b2ae47d19ed188a3ea3d732ea09d254 100644 (file)
@@ -1195,7 +1195,7 @@ public:
    * successfully can be queried by the functions get_entries_wrongly_not_set()
    * and assert_that_entries_have_been_set().
    */
-  template <class ParameterType>
+  template <typename ParameterType>
   void
   add_parameter(const std::string &          entry,
                 ParameterType &              parameter,
@@ -2331,7 +2331,7 @@ ParameterHandler::load(Archive &ar, const unsigned int)
 }
 
 
-template <class ParameterType>
+template <typename ParameterType>
 void
 ParameterHandler::add_parameter(const std::string &          entry,
                                 ParameterType &              parameter,
index cfd25c713798b56d913460061e01b7d36da2e415..82fae2c0516ec1ab219a8acd6fbe15c74e28e65f 100644 (file)
@@ -149,7 +149,7 @@ public:
   /**
    * Show the paths and suffixes used for this object.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   show(StreamType &stream) const;
 
@@ -258,7 +258,7 @@ private:
 /* ----------------------------- inline functions ------------------------- */
 
 
-template <class StreamType>
+template <typename StreamType>
 inline void
 PathSearch::show(StreamType &out) const
 {
index 779a4aa5517b9e26dd4f02af0ecb5017053fbe8d..01a762a2e59c8d96bfd77186601fd7c414afe259 100644 (file)
@@ -1904,7 +1904,7 @@ namespace Patterns
     };
 
     // std::array
-    template <class ValueType, std::size_t N>
+    template <typename ValueType, std::size_t N>
     struct Convert<std::array<ValueType, N>>
     {
       using T = std::array<ValueType, N>;
index 9cc21c8d842092549c085c7416b7bd8617ba79cd..279626fc3fd95ce716596896f3b8a2825babf78a 100644 (file)
@@ -117,7 +117,7 @@ public:
   /**
    * Prints the list of the indices to <tt>out</tt>.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   output_indices(StreamType &out) const;
 
@@ -313,7 +313,7 @@ PolynomialSpace<dim>::name() const
 
 
 template <int dim>
-template <class StreamType>
+template <typename StreamType>
 void
 PolynomialSpace<dim>::output_indices(StreamType &out) const
 {
index d298064240ae73f6563457d8b55e1fb04f0f0672..3e4f5025022c309e2e0d514e296dc97d75b20013 100644 (file)
@@ -235,7 +235,7 @@ struct is_base_of_all
  * parameter pack are equal to the `Type` given as first template
  * argument. The result is stored in the member variable `value`.
  */
-template <class Type, class... Types>
+template <typename Type, class... Types>
 struct all_same_as
 {
   static constexpr bool value = internal::TemplateConstraints::all_true<
@@ -250,7 +250,7 @@ struct all_same_as
  * parameter pack are equal to the `Type` given as first template
  * argument. The result is stored in the member variable `value`.
  */
-template <class Type, class... Types>
+template <typename Type, class... Types>
 struct is_same_as_any_of
 {
   static constexpr bool value = internal::TemplateConstraints::any_true<
index d99e825cada72baed7161ae3c1ad67f3875483d6..9d0966323acdc14dec05a4300f7a0515adbdc304 100644 (file)
@@ -160,7 +160,7 @@ public:
    * Print the data returned by Timer::get_last_lap_wall_time_data() to the
    * given stream.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print_last_lap_wall_time_data(StreamType &stream) const;
 
@@ -168,7 +168,7 @@ public:
    * Print the data returned by Timer::get_accumulated_wall_time_data() to the
    * given stream.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print_accumulated_wall_time_data(StreamType &stream) const;
 
@@ -918,7 +918,7 @@ Timer::get_accumulated_wall_time_data() const
 
 
 
-template <class StreamType>
+template <typename StreamType>
 inline void
 Timer::print_last_lap_wall_time_data(StreamType &stream) const
 {
@@ -930,7 +930,7 @@ Timer::print_last_lap_wall_time_data(StreamType &stream) const
 
 
 
-template <class StreamType>
+template <typename StreamType>
 inline void
 Timer::print_accumulated_wall_time_data(StreamType &stream) const
 {
index 8bd56698d9c3d4d4541834ba866644e12074c20d..e9caa8b832d2f09ef7e9a975190533de8d410c9c 100644 (file)
@@ -116,7 +116,7 @@ namespace Differentiation
     /**
      * Output operator that outputs the selected optimizer type.
      */
-    template <class StreamType>
+    template <typename StreamType>
     inline StreamType &
     operator<<(StreamType &s, OptimizerType o)
     {
@@ -268,7 +268,7 @@ namespace Differentiation
      * Output operator that outputs optimization flags as a set of or'd
      * text values.
      */
-    template <class StreamType>
+    template <typename StreamType>
     inline StreamType &
     operator<<(StreamType &s, OptimizationFlags o)
     {
index e36b7043a786bf772ddc74dd0c6b7c75e56dd992..fb0397d8db9a80272fcd5f36e261c7c3b343f298 100644 (file)
@@ -52,7 +52,7 @@ namespace hp
   template <int dim, int spacedim>
   class FECollection;
 } // namespace hp
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 class InterGridMap;
 template <int dim, int spacedim>
index 9ba197011c1526322af384fb0072addbbd66d969..d10d5774f2a9c1fa2583486556cb0621b3d925c1 100644 (file)
@@ -49,7 +49,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @ingroup febase
  */
-template <class PolynomialType, int dim, int spacedim = dim>
+template <typename PolynomialType, int dim, int spacedim = dim>
 class FE_DGVector : public FE_PolyTensor<dim, spacedim>
 {
 public:
index 36d7a5c4cc713365830ea470c6ec16d98bc3a272..ac179c29659195eed701ea3511b9f471e5d274b5 100644 (file)
@@ -32,7 +32,7 @@ DEAL_II_NAMESPACE_OPEN
 // TODO:[GK] deg+1 is wrong here and should be fixed after FiniteElementData was
 // cleaned up
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 FE_DGVector<PolynomialType, dim, spacedim>::FE_DGVector(const unsigned int deg,
                                                         MappingKind        map)
   : FE_PolyTensor<dim, spacedim>(
@@ -57,7 +57,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::FE_DGVector(const unsigned int deg,
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 std::unique_ptr<FiniteElement<dim, spacedim>>
 FE_DGVector<PolynomialType, dim, spacedim>::clone() const
 {
@@ -65,7 +65,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::clone() const
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 std::string
 FE_DGVector<PolynomialType, dim, spacedim>::get_name() const
 {
@@ -76,7 +76,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::get_name() const
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 std::vector<unsigned int>
 FE_DGVector<PolynomialType, dim, spacedim>::get_dpo_vector(
   const unsigned int deg)
@@ -88,7 +88,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::get_dpo_vector(
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 bool
 FE_DGVector<PolynomialType, dim, spacedim>::has_support_on_face(
   const unsigned int,
@@ -98,7 +98,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::has_support_on_face(
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 std::size_t
 FE_DGVector<PolynomialType, dim, spacedim>::memory_consumption() const
 {
index dc6684e2298b91f9143cb69b918591d595b079c3..7a46e44f13a9da5ecc84faab68b6be295091ba2d 100644 (file)
@@ -1443,7 +1443,7 @@ public:
    *   is initialized with an hp::FECollection, an hp::QCollection, and possibly
    *   an hp::MappingCollection).
    */
-  template <class CellIteratorType, class CellNeighborIteratorType>
+  template <typename CellIteratorType, typename CellNeighborIteratorType>
   void
   reinit(const CellIteratorType &        cell,
          const unsigned int              face_no,
@@ -1481,7 +1481,7 @@ public:
    * is initialized with an hp::FECollection, an hp::QCollection, and possibly
    * an hp::MappingCollection).
    */
-  template <class CellIteratorType>
+  template <typename CellIteratorType>
   void
   reinit(const CellIteratorType &cell,
          const unsigned int      face_no,
@@ -2308,7 +2308,7 @@ FEInterfaceValues<dim, spacedim>::FEInterfaceValues(
 
 
 template <int dim, int spacedim>
-template <class CellIteratorType, class CellNeighborIteratorType>
+template <typename CellIteratorType, typename CellNeighborIteratorType>
 void
 FEInterfaceValues<dim, spacedim>::reinit(
   const CellIteratorType &        cell,
@@ -2510,7 +2510,7 @@ FEInterfaceValues<dim, spacedim>::reinit(
 
 
 template <int dim, int spacedim>
-template <class CellIteratorType>
+template <typename CellIteratorType>
 void
 FEInterfaceValues<dim, spacedim>::reinit(const CellIteratorType &cell,
                                          const unsigned int      face_no,
index ac4d04ff1f16e9d5747e8120b7a0733ea3aa3eba..a74603ba3590d76e5ae127682a643a5a690ea3b4 100644 (file)
@@ -55,7 +55,7 @@ DEAL_II_NAMESPACE_OPEN
  * which cannot be implemented by this class but are left for implementation
  * in derived classes.
  */
-template <class PolynomialType,
+template <typename PolynomialType,
           int dim      = PolynomialType::dimension + 1,
           int spacedim = dim>
 class FE_PolyFace : public FiniteElement<dim, spacedim>
index a6cd58f38701440b6649f810d8f57c3cf1ab0061..7f3aba00ba6980a932cb3365c3eb3180ad08daf4 100644 (file)
@@ -28,7 +28,7 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 FE_PolyFace<PolynomialType, dim, spacedim>::FE_PolyFace(
   const PolynomialType &        poly_space,
   const FiniteElementData<dim> &fe_data,
@@ -43,7 +43,7 @@ FE_PolyFace<PolynomialType, dim, spacedim>::FE_PolyFace(
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 unsigned int
 FE_PolyFace<PolynomialType, dim, spacedim>::get_degree() const
 {
@@ -56,7 +56,7 @@ FE_PolyFace<PolynomialType, dim, spacedim>::get_degree() const
 //---------------------------------------------------------------------------
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 UpdateFlags
 FE_PolyFace<PolynomialType, dim, spacedim>::requires_update_flags(
   const UpdateFlags flags) const
@@ -76,7 +76,7 @@ FE_PolyFace<PolynomialType, dim, spacedim>::requires_update_flags(
 //---------------------------------------------------------------------------
 // Fill data of FEValues
 //---------------------------------------------------------------------------
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 void
 FE_PolyFace<PolynomialType, dim, spacedim>::fill_fe_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &,
@@ -105,7 +105,7 @@ FE_PolyFace<PolynomialType, dim, spacedim>::fill_fe_values(
 
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 void
 FE_PolyFace<PolynomialType, dim, spacedim>::fill_fe_face_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &,
@@ -198,7 +198,7 @@ FE_PolyFace<PolynomialType, dim, spacedim>::fill_fe_face_values(
 }
 
 
-template <class PolynomialType, int dim, int spacedim>
+template <typename PolynomialType, int dim, int spacedim>
 void
 FE_PolyFace<PolynomialType, dim, spacedim>::fill_fe_subface_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &,
index 6e2a7d42ae0b1c99bfd4ef1655d59b2e626ad41d..f8e1028884c6913e0fb07be20682dcc03ffcc02d 100644 (file)
@@ -241,7 +241,7 @@ enum UpdateFlags
  *
  * @ref UpdateFlags
  */
-template <class StreamType>
+template <typename StreamType>
 inline StreamType &
 operator<<(StreamType &s, const UpdateFlags u)
 {
index 6c179a2188bce99b8be4f64693bf11c92b7e7d40..369b235ca30977b26ac6fd7118eecc882877615c 100644 (file)
@@ -69,7 +69,7 @@ namespace internal
    * A class whose specialization is used to define what type the curl of a
    * vector valued function corresponds to.
    */
-  template <int dim, class NumberType = double>
+  template <int dim, typename NumberType = double>
   struct CurlType;
 
   /**
@@ -78,7 +78,7 @@ namespace internal
    *
    * In 1d, the curl is a scalar.
    */
-  template <class NumberType>
+  template <typename NumberType>
   struct CurlType<1, NumberType>
   {
     using type = Tensor<1, 1, NumberType>;
@@ -90,7 +90,7 @@ namespace internal
    *
    * In 2d, the curl is a scalar.
    */
-  template <class NumberType>
+  template <typename NumberType>
   struct CurlType<2, NumberType>
   {
     using type = Tensor<1, 1, NumberType>;
@@ -102,7 +102,7 @@ namespace internal
    *
    * In 3d, the curl is a vector.
    */
-  template <class NumberType>
+  template <typename NumberType>
   struct CurlType<3, NumberType>
   {
     using type = Tensor<1, 3, NumberType>;
index cbfa05a523d85091f442358439d554ee9d76f4b3..7dc37934ba21f4db6e9e02ab7182bd1a28b4596d 100644 (file)
@@ -99,7 +99,7 @@ namespace GridTools
 
 namespace internal
 {
-  template <int dim, int spacedim, class MeshType>
+  template <int dim, int spacedim, typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   class ActiveCellIterator
   {
@@ -1572,7 +1572,7 @@ namespace GridTools
    * @dealiiConceptRequires{
    *   concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler<MeshType>))
 #ifndef _MSC_VER
   std::vector<typename MeshType::active_cell_iterator>
@@ -1908,7 +1908,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<typename MeshType::active_cell_iterator> get_active_child_cells(
     const typename MeshType::cell_iterator &cell);
@@ -1939,7 +1939,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   void get_active_neighbors(
     const typename MeshType::active_cell_iterator &       cell,
@@ -1996,7 +1996,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::active_cell_iterator> compute_active_cell_halo_layer(
@@ -2014,7 +2014,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::cell_iterator> compute_cell_halo_layer_on_level(
@@ -2038,7 +2038,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<
     typename MeshType::
@@ -2094,7 +2094,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::active_cell_iterator> compute_active_cell_layer_within_distance(
@@ -2127,7 +2127,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::active_cell_iterator> compute_ghost_cell_layer_within_distance(
@@ -2151,7 +2151,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::pair<
     Point<MeshType::space_dimension>,
@@ -2234,7 +2234,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<BoundingBox<MeshType::space_dimension>> compute_mesh_predicate_bounding_box(
@@ -2858,7 +2858,7 @@ namespace GridTools
    *
    * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
    */
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<typename MeshType::active_cell_iterator> get_patch_around_cell(
     const typename MeshType::active_cell_iterator &cell);
@@ -3973,7 +3973,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<typename MeshType::active_cell_iterator> get_active_child_cells(
     const typename MeshType::cell_iterator &cell)
@@ -4000,7 +4000,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   void get_active_neighbors(
     const typename MeshType::active_cell_iterator &       cell,
index c2f4a5f867c8d287f738aecd21b8099f58b6b39e..55f85fd71176eb049a6966ef130f6dc2e187ef92 100644 (file)
@@ -102,7 +102,7 @@ namespace GridTools
    *
    * @ref CacheUpdateFlags
    */
-  template <class StreamType>
+  template <typename StreamType>
   inline StreamType &
   operator<<(StreamType &s, const CacheUpdateFlags u)
   {
index 0b9b0e1421e3fdb3b25131e988f55094a646e015..4dd0d3e215f3523635c11d22d27620b442e34233 100644 (file)
@@ -112,7 +112,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler<MeshType>}
  */
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 class InterGridMap : public Subscriptor
 {
index 97d7ef1bbbd6d1ac295b6ae9daea1499f656fd9e..b63b36857706d96cba5616826efd311bbeedb4ac 100644 (file)
@@ -478,7 +478,7 @@ public:
    * Print the iterator to a stream <code>out</code>. The format is
    * <tt>level.index</tt>.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print(StreamType &out) const;
 
@@ -1118,7 +1118,7 @@ TriaRawIterator<Accessor>::operator--()
 
 
 template <typename Accessor>
-template <class StreamType>
+template <typename StreamType>
 inline void
 TriaRawIterator<Accessor>::print(StreamType &out) const
 {
index cfc41b4ee1c123e30daffbe3a7188e26d1b27c72..5f520d008ad701d164b562ae6a3946f83b63f358 100644 (file)
@@ -64,7 +64,7 @@ namespace hp
    *
    * @ingroup hp
    */
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   class FEValuesBase : public Subscriptor
   {
   public:
@@ -690,7 +690,7 @@ namespace hp
 
 namespace hp
 {
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   inline const FEValuesType &
   FEValuesBase<dim, q_dim, FEValuesType>::get_present_fe_values() const
   {
@@ -699,7 +699,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   inline const FECollection<dim, FEValuesType::space_dimension> &
   FEValuesBase<dim, q_dim, FEValuesType>::get_fe_collection() const
   {
@@ -708,7 +708,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   inline const MappingCollection<dim, FEValuesType::space_dimension> &
   FEValuesBase<dim, q_dim, FEValuesType>::get_mapping_collection() const
   {
@@ -717,7 +717,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   inline const QCollection<q_dim> &
   FEValuesBase<dim, q_dim, FEValuesType>::get_quadrature_collection() const
   {
@@ -726,7 +726,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   inline UpdateFlags
   FEValuesBase<dim, q_dim, FEValuesType>::get_update_flags() const
   {
index d951ddb6f42d7b95cd773881448fc3868c163b0a..759ecbd0887914d1305f7187c93cab2063c28735 100644 (file)
@@ -3149,7 +3149,7 @@ namespace internal
     // able to use functions like vector.block(1)(block_local_id), instead of
     // vector(global_id). This avoids transforming indices one-by-one later
     // on.
-    template <typename number, class BlockType>
+    template <typename number, typename BlockType>
     inline void
     make_block_starts(const BlockType &            block_object,
                       GlobalRowsFromLocal<number> &global_rows,
@@ -3186,7 +3186,7 @@ namespace internal
 
     // same as before, but for std::vector<uint> instead of
     // GlobalRowsFromLocal. Used in functions for sparsity patterns.
-    template <class BlockType>
+    template <typename BlockType>
     inline void
     make_block_starts(const BlockType &       block_object,
                       std::vector<size_type> &row_indices,
index 7dcacc7ce37f23827fdf5afad07e2c375459cc94..5c3d3ea0a98e6638fad207d5cc950f2d4e1d9825 100644 (file)
@@ -241,7 +241,7 @@ public:
    * existing row lengths and allocated row lengths. Otherwise, just the
    * relation of allocated and used entries is shown.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print_statistics(StreamType &s, bool full = false);
 
@@ -442,7 +442,7 @@ BlockSparseMatrixEZ<Number>::Tvmult_add(
 
 
 template <typename number>
-template <class StreamType>
+template <typename StreamType>
 inline void
 BlockSparseMatrixEZ<number>::print_statistics(StreamType &out, bool full)
 {
index 6ad97a8d857b4ded20f4bb7ba96816a38358737e..4b60f951207321f7b612c1cf1c5efa994e83c368 100644 (file)
@@ -159,7 +159,7 @@ namespace CUDAWrappers
      * quadratic matrices are printed first in their row. If it is false,
      * the elements in a row are written in ascending column order.
      */
-    template <class StreamType>
+    template <typename StreamType>
     void
     print(StreamType &out,
           const bool  across         = false,
@@ -404,7 +404,7 @@ namespace CUDAWrappers
 
 
   template <typename Number>
-  template <class StreamType>
+  template <typename StreamType>
   inline void
   SparseMatrix<Number>::print(StreamType &out,
                               const bool  across,
index 0ab26570d5bfecb7362eb1d49b33af6c1bd38ef7..8e54a51c63a28ebe3445be5ddc90383f0a3b0b40 100644 (file)
@@ -487,7 +487,7 @@ public:
    * stream before setting these given values for output, and restores the
    * previous values after output.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print(StreamType &       s,
         const unsigned int width     = 5,
@@ -1421,7 +1421,7 @@ FullMatrix<number>::add(const size_type   row,
 
 
 template <typename number>
-template <class StreamType>
+template <typename StreamType>
 inline void
 FullMatrix<number>::print(StreamType &       s,
                           const unsigned int w,
index ace14db6bc50a4ad6d4e133d6f76ca54be94abe1..585b11baa303527d5514846aa881ac10d2be21d8 100644 (file)
@@ -75,7 +75,7 @@ public:
    * R(x_k,b)$. The matrix <i>A</i> itself is only used to compute the
    * residual.
    */
-  template <typename MatrixType, class RelaxationType>
+  template <typename MatrixType, typename RelaxationType>
   void
   solve(const MatrixType &    A,
         VectorType &          x,
@@ -94,7 +94,7 @@ SolverRelaxation<VectorType>::SolverRelaxation(SolverControl &cn,
 
 
 template <typename VectorType>
-template <typename MatrixType, class RelaxationType>
+template <typename MatrixType, typename RelaxationType>
 void
 SolverRelaxation<VectorType>::solve(const MatrixType &    A,
                                     VectorType &          x,
index 7b7a53eb15aa15756e9deb5a9037dae55878e607..135cf96f4ae5ce8f8d24a218465145c2e149d54c 100644 (file)
@@ -1577,7 +1577,7 @@ public:
    * internal storage scheme. If it is false, the elements in a row are
    * written in ascending column order.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print(StreamType &out,
         const bool  across         = false,
@@ -2506,7 +2506,7 @@ SparseMatrix<number>::end(const size_type r)
 
 
 template <typename number>
-template <class StreamType>
+template <typename StreamType>
 inline void
 SparseMatrix<number>::print(StreamType &out,
                             const bool  across,
index a78480b07f6a1a27b17b2800c2a5b8a3c256ef9d..63b40104809f1dc2b64961fc550afb9e118d32fe 100644 (file)
@@ -414,7 +414,7 @@ public:
    * existing row lengths and allocated row lengths. Otherwise, just the
    * relation of allocated and used entries is shown.
    */
-  template <class StreamType>
+  template <typename StreamType>
   void
   print_statistics(StreamType &s, bool full = false);
 
@@ -1570,7 +1570,7 @@ SparseMatrixEZ<number>::conjugate_add(const MatrixTypeA &A,
 
 
 template <typename number>
-template <class StreamType>
+template <typename StreamType>
 inline void
 SparseMatrixEZ<number>::print_statistics(StreamType &out, bool full)
 {
index 48f8b7979ab222ab25c112ccd0e35009eb3e9dbd..3172ad300355c74528baac5b360487543f9f2417 100644 (file)
@@ -1177,7 +1177,7 @@ namespace TrilinosWrappers
      * operators/preconditioners. For details, see
      * https://docs.trilinos.org/latest-release/packages/belos/doc/html/classBelos_1_1Operator.html.
      */
-    template <class OperatorType, typename VectorType>
+    template <typename OperatorType, typename VectorType>
     class OperatorWrapper
       : public Belos::Operator<typename VectorType::value_type>
     {
index 8c28b086012cb6b4d1073a5053e4f9394137e28f..e9c772c2c2c9a63c8164ee0d3672ebea76c013db 100644 (file)
@@ -111,7 +111,7 @@ namespace MeshWorker
    *
    * @ref AssembleFlags
    */
-  template <class StreamType>
+  template <typename StreamType>
   inline StreamType &
   operator<<(StreamType &s, AssembleFlags u)
   {
index 6ddca48766adc9b33908f1fbc7928016c827de29..fa15acbe1ffe63ff6b94dd5b3976407188afe926 100644 (file)
@@ -385,7 +385,7 @@ namespace MeshWorker
     void
     reinit(const BlockIndices &local_sizes);
 
-    template <class StreamType>
+    template <typename StreamType>
     void
     print_debug(StreamType &os) const;
 
@@ -659,7 +659,7 @@ namespace MeshWorker
 
 
   template <typename number>
-  template <class StreamType>
+  template <typename StreamType>
   void
   LocalResults<number>::print_debug(StreamType &os) const
   {
index eb212da85d4961e224ec603fa6d494fc7ad4b781..8af89aa03cc9cc6a5c8709679447f39718a5f5eb 100644 (file)
@@ -51,7 +51,7 @@ namespace MeshWorker
      * A helper class to provide a type definition for the underlying cell
      * iterator type.
      */
-    template <class CellIteratorType>
+    template <typename CellIteratorType>
     struct CellIteratorBaseType
     {
       /**
@@ -67,7 +67,7 @@ namespace MeshWorker
      * This specialization is for IteratorRange, which may have either a
      * TriaActiveIterator or a FilteredIterator as its base type.
      */
-    template <class CellIteratorType>
+    template <typename CellIteratorType>
     struct CellIteratorBaseType<IteratorOverIterators<CellIteratorType>>
     {
       /**
@@ -87,7 +87,7 @@ namespace MeshWorker
      * TriaActiveIterator as its base type, or may be nested with another
      * FilteredIterator as the type to iterate over.
      */
-    template <class CellIteratorType>
+    template <typename CellIteratorType>
     struct CellIteratorBaseType<FilteredIterator<CellIteratorType>>
     {
       /**
@@ -273,10 +273,10 @@ namespace MeshWorker
    *
    * @ingroup MeshWorker
    */
-  template <class CellIteratorType,
+  template <typename CellIteratorType,
             class ScratchData,
             class CopyData,
-            class CellIteratorBaseType =
+            typename CellIteratorBaseType =
               typename internal::CellIteratorBaseType<CellIteratorType>::type>
   void
   mesh_loop(
@@ -707,10 +707,10 @@ namespace MeshWorker
    *
    * @ingroup MeshWorker
    */
-  template <class CellIteratorType,
+  template <typename CellIteratorType,
             class ScratchData,
             class CopyData,
-            class CellIteratorBaseType =
+            typename CellIteratorBaseType =
               typename internal::CellIteratorBaseType<CellIteratorType>::type>
   void
   mesh_loop(
@@ -833,7 +833,7 @@ namespace MeshWorker
    *
    * @ingroup MeshWorker
    */
-  template <class CellIteratorType,
+  template <typename CellIteratorType,
             class ScratchData,
             class CopyData,
             class MainClass>
@@ -1013,11 +1013,11 @@ namespace MeshWorker
    *
    * @ingroup MeshWorker
    */
-  template <class CellIteratorType,
+  template <typename CellIteratorType,
             class ScratchData,
             class CopyData,
             class MainClass,
-            class CellIteratorBaseType =
+            typename CellIteratorBaseType =
               typename internal::CellIteratorBaseType<CellIteratorType>::type>
   void
   mesh_loop(IteratorRange<CellIteratorType> iterator_range,
index 6224e6dc97dbd8f761e30cb510c85a67ca125353..4eb2a48a49389730998d09b078a6baade4e73a81 100644 (file)
@@ -150,14 +150,14 @@ namespace MeshWorker
     /**
      * Print the contents of the selection to the stream.
      */
-    template <class StreamType, typename DATA>
+    template <typename StreamType, typename DATA>
     void
     print(StreamType &s, const AnyData &v) const;
 
     /**
      * Print the number of selections to the stream.
      */
-    template <class StreamType>
+    template <typename StreamType>
     void
     print(StreamType &s) const;
 
@@ -521,7 +521,7 @@ namespace MeshWorker
   }
 
 
-  template <class StreamType>
+  template <typename StreamType>
   inline void
   VectorSelector::print(StreamType &s) const
   {
@@ -530,7 +530,7 @@ namespace MeshWorker
   }
 
 
-  template <class StreamType, typename DATA>
+  template <typename StreamType, typename DATA>
   inline void
   VectorSelector::print(StreamType &s, const AnyData &v) const
   {
index ac321dfc82ddb1b0f1083b18f1c16224021e92db..45c03990414058fd4b3ebb38eae4f25a25f22a4c 100644 (file)
@@ -47,7 +47,7 @@ DEAL_II_NAMESPACE_OPEN
  * smoother object. Therefore, the smoother object for each level must be
  * constructed by hand.
  */
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 class MGSmootherBlock : public MGSmoother<BlockVector<number>>
 {
 public:
@@ -73,7 +73,7 @@ public:
    * This function stores pointers to the level matrices and smoothing
    * operator for each level.
    */
-  template <class MGMatrixType, class MGRelaxationType>
+  template <typename MGMatrixType, typename MGRelaxationType>
   void
   initialize(const MGMatrixType &matrices, const MGRelaxationType &smoothers);
 
@@ -135,7 +135,7 @@ private:
 
 #ifndef DOXYGEN
 
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 inline MGSmootherBlock<MatrixType, RelaxationType, number>::MGSmootherBlock(
   const unsigned int steps,
   const bool         variable,
@@ -148,7 +148,7 @@ inline MGSmootherBlock<MatrixType, RelaxationType, number>::MGSmootherBlock(
 {}
 
 
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 inline void
 MGSmootherBlock<MatrixType, RelaxationType, number>::clear()
 {
@@ -161,8 +161,8 @@ MGSmootherBlock<MatrixType, RelaxationType, number>::clear()
 }
 
 
-template <typename MatrixType, class RelaxationType, typename number>
-template <class MGMatrixType, class MGRelaxationType>
+template <typename MatrixType, typename RelaxationType, typename number>
+template <typename MGMatrixType, typename MGRelaxationType>
 inline void
 MGSmootherBlock<MatrixType, RelaxationType, number>::initialize(
   const MGMatrixType &    m,
@@ -186,7 +186,7 @@ MGSmootherBlock<MatrixType, RelaxationType, number>::initialize(
 }
 
 
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 inline void
 MGSmootherBlock<MatrixType, RelaxationType, number>::set_reverse(
   const bool flag)
@@ -195,7 +195,7 @@ MGSmootherBlock<MatrixType, RelaxationType, number>::set_reverse(
 }
 
 
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 inline std::size_t
 MGSmootherBlock<MatrixType, RelaxationType, number>::memory_consumption() const
 {
@@ -205,7 +205,7 @@ MGSmootherBlock<MatrixType, RelaxationType, number>::memory_consumption() const
 }
 
 
-template <typename MatrixType, class RelaxationType, typename number>
+template <typename MatrixType, typename RelaxationType, typename number>
 inline void
 MGSmootherBlock<MatrixType, RelaxationType, number>::smooth(
   const unsigned int         level,
index b805774a02b383c4db6e1aa4a28898add8ac38cf..3fc5a9e332f2a3bcd448ed6a907badd9644391dc 100644 (file)
@@ -181,7 +181,7 @@ namespace mg
    * the multigrid method must be used only with the vector associated to that
    * single block.
    */
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   class SmootherRelaxation : public MGLevelObject<RelaxationType>,
                              public MGSmoother<VectorType>
   {
@@ -292,7 +292,7 @@ namespace mg
  * float and @p double. Additional instantiations may be created by including
  * the file mg_smoother.templates.h.
  */
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 class MGSmootherRelaxation : public MGSmoother<VectorType>
 {
 public:
@@ -658,7 +658,7 @@ MGSmoother<VectorType>::set_transpose(const bool flag)
 
 namespace mg
 {
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   inline SmootherRelaxation<RelaxationType, VectorType>::SmootherRelaxation(
     const unsigned int steps,
     const bool         variable,
@@ -668,7 +668,7 @@ namespace mg
   {}
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   inline void
   SmootherRelaxation<RelaxationType, VectorType>::clear()
   {
@@ -676,7 +676,7 @@ namespace mg
   }
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   template <typename MatrixType2>
   inline void
   SmootherRelaxation<RelaxationType, VectorType>::initialize(
@@ -693,7 +693,7 @@ namespace mg
   }
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   template <typename MatrixType2, class DATA>
   inline void
   SmootherRelaxation<RelaxationType, VectorType>::initialize(
@@ -710,7 +710,7 @@ namespace mg
   }
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   inline void
   SmootherRelaxation<RelaxationType, VectorType>::smooth(
     const unsigned int level,
@@ -741,7 +741,7 @@ namespace mg
   }
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   inline void
   SmootherRelaxation<RelaxationType, VectorType>::apply(
     const unsigned int level,
@@ -778,7 +778,7 @@ namespace mg
   }
 
 
-  template <class RelaxationType, typename VectorType>
+  template <typename RelaxationType, typename VectorType>
   inline std::size_t
   SmootherRelaxation<RelaxationType, VectorType>::memory_consumption() const
   {
@@ -791,7 +791,7 @@ namespace mg
 
 //----------------------------------------------------------------------//
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 inline MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::
   MGSmootherRelaxation(const unsigned int steps,
                        const bool         variable,
@@ -802,7 +802,7 @@ inline MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::
 
 
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::clear()
 {
@@ -814,7 +814,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::clear()
 }
 
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 template <typename MatrixType2>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
@@ -838,7 +838,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
     }
 }
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 template <typename MatrixType2, class DATA>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
@@ -865,7 +865,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
     }
 }
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 template <typename MatrixType2, class DATA>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
@@ -891,7 +891,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
     }
 }
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 template <typename MatrixType2, class DATA>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
@@ -921,7 +921,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::initialize(
 }
 
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::smooth(
   const unsigned int level,
@@ -952,7 +952,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::smooth(
 }
 
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 inline void
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::apply(
   const unsigned int level,
@@ -990,7 +990,7 @@ MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::apply(
 
 
 
-template <typename MatrixType, class RelaxationType, typename VectorType>
+template <typename MatrixType, typename RelaxationType, typename VectorType>
 inline std::size_t
 MGSmootherRelaxation<MatrixType, RelaxationType, VectorType>::
   memory_consumption() const
index 27ef91def70ff6775a0c87e0c7962f0c6f7f485b..3ef46d160e2e45e0d0482999349404cffb96cd3a 100644 (file)
@@ -478,7 +478,7 @@ private:
    */
   SmartPointer<const MGMatrixBase<VectorType>, Multigrid<VectorType>> edge_up;
 
-  template <int dim, class OtherVectorType, class TRANSFER>
+  template <int dim, typename OtherVectorType, class TRANSFER>
   friend class PreconditionMG;
 };
 
@@ -529,7 +529,7 @@ public:
    *
    * This is the operator used by LAC iterative solvers.
    */
-  template <class OtherVectorType>
+  template <typename OtherVectorType>
   void
   vmult(OtherVectorType &dst, const OtherVectorType &src) const;
 
@@ -537,7 +537,7 @@ public:
    * Preconditioning operator. Calls the @p vcycle function of the @p MG
    * object passed to the constructor.
    */
-  template <class OtherVectorType>
+  template <typename OtherVectorType>
   void
   vmult_add(OtherVectorType &dst, const OtherVectorType &src) const;
 
@@ -546,7 +546,7 @@ public:
    *
    * Not implemented, but the definition may be needed.
    */
-  template <class OtherVectorType>
+  template <typename OtherVectorType>
   void
   Tvmult(OtherVectorType &dst, const OtherVectorType &src) const;
 
@@ -555,7 +555,7 @@ public:
    *
    * Not implemented, but the definition may be needed.
    */
-  template <class OtherVectorType>
+  template <typename OtherVectorType>
   void
   Tvmult_add(OtherVectorType &dst, const OtherVectorType &src) const;
 
@@ -866,7 +866,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::empty() const
 }
 
 template <int dim, typename VectorType, class TRANSFER>
-template <class OtherVectorType>
+template <typename OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::vmult(
   OtherVectorType &      dst,
@@ -940,7 +940,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::connect_transfer_to_global(
 
 
 template <int dim, typename VectorType, class TRANSFER>
-template <class OtherVectorType>
+template <typename OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::vmult_add(
   OtherVectorType &      dst,
@@ -958,7 +958,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::vmult_add(
 
 
 template <int dim, typename VectorType, class TRANSFER>
-template <class OtherVectorType>
+template <typename OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::Tvmult(OtherVectorType &,
                                                   const OtherVectorType &) const
@@ -968,7 +968,7 @@ PreconditionMG<dim, VectorType, TRANSFER>::Tvmult(OtherVectorType &,
 
 
 template <int dim, typename VectorType, class TRANSFER>
-template <class OtherVectorType>
+template <typename OtherVectorType>
 void
 PreconditionMG<dim, VectorType, TRANSFER>::Tvmult_add(
   OtherVectorType &,
index 1231d1f4e54084ed0dec07b10f35875d045b362f..0f612e2550a4d20dccb7c390ca2af4d57cf05682 100644 (file)
@@ -520,7 +520,7 @@ namespace NonMatching
      * implemented, the passed values of these must equal
      * numbers::invalid_unsigned_int.
      */
-    template <class CellIteratorType, class CellNeighborIteratorType>
+    template <typename CellIteratorType, typename CellNeighborIteratorType>
     void
     reinit(const CellIteratorType &        cell,
            const unsigned int              face_no,
@@ -537,7 +537,7 @@ namespace NonMatching
      * FEInterfaceValues object can be retrieved for each region using the
      * functions get_inside_fe_values() or get_outside_fe_values().
      */
-    template <class CellIteratorType>
+    template <typename CellIteratorType>
     void
     reinit(const CellIteratorType &cell, const unsigned int face_no);
 
@@ -688,7 +688,7 @@ namespace NonMatching
   /*---------------------- Inline functions ---------------------*/
 
   template <int dim>
-  template <class CellIteratorType>
+  template <typename CellIteratorType>
   inline void
   FEInterfaceValues<dim>::reinit(const CellIteratorType &cell,
                                  const unsigned int      face_no)
@@ -706,7 +706,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class CellIteratorType, class CellNeighborIteratorType>
+  template <typename CellIteratorType, typename CellNeighborIteratorType>
   inline void
   FEInterfaceValues<dim>::reinit(const CellIteratorType &        cell,
                                  const unsigned int              face_no,
index 2f6e1d26ed509801ff591de52bfeecedcb060ecf..ba32e7aa48717505336d2b5589b08007138ed00f 100644 (file)
@@ -35,7 +35,7 @@ template <typename number>
 class FullMatrix;
 template <int dim, typename Number>
 class Function;
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 class InterGridMap;
 template <int dim, int spacedim>
index dc1ba232a7e930a69b2d72a4d12c162f1d3728f8..c38690b64bb92bed5be20f57b95cd6cc5525fae9 100644 (file)
@@ -2826,7 +2826,7 @@ namespace DataOutBase
   }
 
 
-  template <int dim, int spacedim, class StreamType>
+  template <int dim, int spacedim, typename StreamType>
   void
   write_data(const std::vector<Patch<dim, spacedim>> &patches,
              unsigned int                             n_data_sets,
index e2f35e7d7f04f20b4903e44851f3736d361956fc..5374a2437fda3a8ac8d43afa8db5fefed93cbe4a 100644 (file)
@@ -1265,7 +1265,7 @@ namespace DoFRenumbering
     // cell, renumbers DoF indices on it. The function starts renumbering with
     // 'next_free_dof_index' and returns the first still unused DoF index at the
     // end of its operation.
-    template <int dim, class CellIteratorType>
+    template <int dim, typename CellIteratorType>
     types::global_dof_index
     compute_hierarchical_recursive(
       const types::global_dof_index         next_free_dof_offset,
index 9437ab53044995a668a10645f98086d251bc9f88..182a71a9f74aa6e10a8f9237240ff66decd95acc 100644 (file)
@@ -48,7 +48,7 @@ DeclExceptionMsg(
  * checking if the smallest BoundingBox that encloses the cell has the same
  * vertices as the cell itself.
  */
-template <class CellType>
+template <typename CellType>
 bool
 is_cartesian(const CellType &cell)
 {
index b8680497eae8a5f012fb4facae15c48fe6b30611..51ef15235d622224942725bb18a3f4089b68577e 100644 (file)
@@ -495,7 +495,7 @@ namespace GridTools
       /**
        * Store the data about the given face @p face.
        */
-      template <class FaceIteratorType>
+      template <typename FaceIteratorType>
       void
       insert_face_data(const FaceIteratorType &face)
       {
@@ -534,7 +534,7 @@ namespace GridTools
     class FaceDataHelper<1>
     {
     public:
-      template <class FaceIteratorType>
+      template <typename FaceIteratorType>
       void
       insert_face_data(const FaceIteratorType &)
       {}
@@ -3083,7 +3083,7 @@ namespace GridTools
   {
     namespace BoundingBoxPredicate
     {
-      template <class MeshType>
+      template <typename MeshType>
       DEAL_II_CXX20_REQUIRES(
         concepts::is_triangulation_or_dof_handler<MeshType>)
       std::tuple<
@@ -3141,7 +3141,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<BoundingBox<MeshType::space_dimension>> compute_mesh_predicate_bounding_box(
index fc5bfee757abde7af6a6ca3c9d6ac8ae08684e63..56c197e6552c5bd623b3663cb92d5add898fd345 100644 (file)
@@ -189,7 +189,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler<MeshType>))
 #ifndef _MSC_VER
   std::vector<typename MeshType::active_cell_iterator>
@@ -761,7 +761,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::active_cell_iterator> compute_active_cell_halo_layer(
@@ -799,7 +799,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::cell_iterator> compute_cell_halo_layer_on_level(
@@ -844,7 +844,7 @@ namespace GridTools
 
   namespace
   {
-    template <class MeshType>
+    template <typename MeshType>
     DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
     bool contains_locally_owned_cells(
       const std::vector<typename MeshType::active_cell_iterator> &cells)
@@ -861,7 +861,7 @@ namespace GridTools
       return false;
     }
 
-    template <class MeshType>
+    template <typename MeshType>
     DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
     bool contains_artificial_cells(
       const std::vector<typename MeshType::active_cell_iterator> &cells)
@@ -881,7 +881,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<
     typename MeshType::
@@ -905,7 +905,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::
     vector<typename MeshType::active_cell_iterator> compute_active_cell_layer_within_distance(
@@ -1050,7 +1050,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<
     typename MeshType::
@@ -1090,7 +1090,7 @@ namespace GridTools
 
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::pair<
     Point<MeshType::space_dimension>,
@@ -1426,7 +1426,7 @@ namespace GridTools
   }
 
 
-  template <class MeshType>
+  template <typename MeshType>
   DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
   std::vector<typename MeshType::active_cell_iterator> get_patch_around_cell(
     const typename MeshType::active_cell_iterator &cell)
index 9d0b27f0c4977c745b66e13fcf6b886c60f03aef..031abfffc46f8f320f7f1fffe8dd5a12de05733f 100644 (file)
@@ -33,7 +33,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 InterGridMap<MeshType>::InterGridMap()
   : source_grid(nullptr, typeid(*this).name())
@@ -42,7 +42,7 @@ InterGridMap<MeshType>::InterGridMap()
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 void InterGridMap<MeshType>::make_mapping(const MeshType &source_grid,
                                           const MeshType &destination_grid)
@@ -98,7 +98,7 @@ void InterGridMap<MeshType>::make_mapping(const MeshType &source_grid,
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 void InterGridMap<MeshType>::set_mapping(const cell_iterator &src_cell,
                                          const cell_iterator &dst_cell)
@@ -137,7 +137,7 @@ void InterGridMap<MeshType>::set_mapping(const cell_iterator &src_cell,
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 void InterGridMap<MeshType>::set_entries_to_cell(const cell_iterator &src_cell,
                                                  const cell_iterator &dst_cell)
@@ -153,7 +153,7 @@ void InterGridMap<MeshType>::set_entries_to_cell(const cell_iterator &src_cell,
 }
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 typename InterGridMap<MeshType>::cell_iterator
   InterGridMap<MeshType>::operator[](const cell_iterator &source_cell) const
@@ -171,7 +171,7 @@ typename InterGridMap<MeshType>::cell_iterator
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 void InterGridMap<MeshType>::clear()
 {
@@ -182,7 +182,7 @@ void InterGridMap<MeshType>::clear()
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 const MeshType &InterGridMap<MeshType>::get_source_grid() const
 {
@@ -191,7 +191,7 @@ const MeshType &InterGridMap<MeshType>::get_source_grid() const
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 const MeshType &InterGridMap<MeshType>::get_destination_grid() const
 {
@@ -200,7 +200,7 @@ const MeshType &InterGridMap<MeshType>::get_destination_grid() const
 
 
 
-template <class MeshType>
+template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
 std::size_t InterGridMap<MeshType>::memory_consumption() const
 {
index 51e40fe29bea5582bf37687bb4f69523f55808f8..77e3da57cbf79ecfa0ff3b445f35cdb1c4e44288 100644 (file)
@@ -62,7 +62,7 @@ namespace hp
 
   // -------------------------- FEValuesBase -------------------------
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const MappingCollection<dim, FEValuesType::space_dimension>
       &                                                     mapping_collection,
@@ -82,7 +82,7 @@ namespace hp
     , update_flags(update_flags)
   {}
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const MappingCollection<dim, FEValuesType::space_dimension>
       &                                                     mapping_collection,
@@ -103,7 +103,7 @@ namespace hp
   {}
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const FECollection<dim, FEValuesType::space_dimension> &fe_collection,
     const QCollection<q_dim> &                              q_collection,
@@ -117,7 +117,7 @@ namespace hp
   {}
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const FECollection<dim, FEValuesType::space_dimension> &fe_collection,
     const std::vector<QCollection<q_dim>> &                 q_collection,
@@ -132,7 +132,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const FEValuesBase<dim, q_dim, FEValuesType> &other)
     : Subscriptor(other)
@@ -171,7 +171,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   FEValuesType &
   FEValuesBase<dim, q_dim, FEValuesType>::select_fe_values(
     const unsigned int fe_index,
@@ -201,7 +201,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   void
   FEValuesBase<dim, q_dim, FEValuesType>::precalculate_fe_values(
     const std::vector<unsigned int> &fe_indices,
@@ -238,7 +238,7 @@ namespace hp
 
 
 
-  template <int dim, int q_dim, class FEValuesType>
+  template <int dim, int q_dim, typename FEValuesType>
   void
   FEValuesBase<dim, q_dim, FEValuesType>::precalculate_fe_values()
   {
index c2de6c6d6ace13037d2c73610788570bf149324b..2c71280fb3d5ebf56d3bd0633311c40edb2c7575 100644 (file)
@@ -21,7 +21,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase()
   : block_rows(0)
   , block_columns(0)
@@ -29,7 +29,7 @@ BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase()
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase(
   const size_type block_rows,
   const size_type block_columns)
@@ -40,7 +40,7 @@ BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase(
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase(
   const BlockSparsityPatternBase &s)
   : BlockSparsityPatternBase()
@@ -55,7 +55,7 @@ BlockSparsityPatternBase<SparsityPatternType>::BlockSparsityPatternBase(
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::reinit(
   const size_type new_block_rows,
@@ -73,7 +73,7 @@ BlockSparsityPatternBase<SparsityPatternType>::reinit(
 }
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 BlockSparsityPatternBase<SparsityPatternType> &
 BlockSparsityPatternBase<SparsityPatternType>::operator=(
   const BlockSparsityPatternBase<SparsityPatternType> &bsp)
@@ -92,7 +92,7 @@ BlockSparsityPatternBase<SparsityPatternType>::operator=(
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 typename BlockSparsityPatternBase<SparsityPatternType>::size_type
 BlockSparsityPatternBase<SparsityPatternType>::compute_n_rows() const
 {
@@ -106,7 +106,7 @@ BlockSparsityPatternBase<SparsityPatternType>::compute_n_rows() const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 typename BlockSparsityPatternBase<SparsityPatternType>::size_type
 BlockSparsityPatternBase<SparsityPatternType>::compute_n_cols() const
 {
@@ -120,7 +120,7 @@ BlockSparsityPatternBase<SparsityPatternType>::compute_n_cols() const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::collect_sizes()
 {
@@ -165,7 +165,7 @@ BlockSparsityPatternBase<SparsityPatternType>::collect_sizes()
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::compress()
 {
@@ -176,7 +176,7 @@ BlockSparsityPatternBase<SparsityPatternType>::compress()
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 bool
 BlockSparsityPatternBase<SparsityPatternType>::empty() const
 {
@@ -189,7 +189,7 @@ BlockSparsityPatternBase<SparsityPatternType>::empty() const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 typename BlockSparsityPatternBase<SparsityPatternType>::size_type
 BlockSparsityPatternBase<SparsityPatternType>::max_entries_per_row() const
 {
@@ -208,7 +208,7 @@ BlockSparsityPatternBase<SparsityPatternType>::max_entries_per_row() const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 typename BlockSparsityPatternBase<SparsityPatternType>::size_type
 BlockSparsityPatternBase<SparsityPatternType>::n_nonzero_elements() const
 {
@@ -221,7 +221,7 @@ BlockSparsityPatternBase<SparsityPatternType>::n_nonzero_elements() const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::print(std::ostream &out) const
 {
@@ -278,7 +278,7 @@ BlockSparsityPatternBase<DynamicSparsityPattern>::print(std::ostream &out) const
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::print_gnuplot(
   std::ostream &out) const
@@ -305,7 +305,7 @@ BlockSparsityPatternBase<SparsityPatternType>::print_gnuplot(
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 void
 BlockSparsityPatternBase<SparsityPatternType>::print_svg(
   std::ostream &out) const
@@ -346,7 +346,7 @@ BlockSparsityPatternBase<SparsityPatternType>::print_svg(
 
 
 
-template <class SparsityPatternType>
+template <typename SparsityPatternType>
 std::size_t
 BlockSparsityPatternBase<SparsityPatternType>::memory_consumption() const
 {

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.