]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Standardize on 'typename VectorType'.
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 2 Jul 2023 02:32:49 +0000 (20:32 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 2 Jul 2023 02:32:49 +0000 (20:32 -0600)
40 files changed:
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/eigen.h
include/deal.II/lac/householder.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/petsc_snes.h
include/deal.II/lac/petsc_ts.h
include/deal.II/lac/precondition.h
include/deal.II/lac/qr.h
include/deal.II/lac/relaxation_block.templates.h
include/deal.II/lac/solver.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_idr.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_qmrs.h
include/deal.II/lac/solver_relaxation.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/matrix_free/type_traits.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/non_matching/fe_values.h
include/deal.II/non_matching/mesh_classifier.h
include/deal.II/non_matching/quadrature_generator.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/dof_print_solver_step.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/vector_tools_mean_value.h
include/deal.II/numerics/vector_tools_mean_value.templates.h
include/deal.II/optimization/solver_bfgs.h
include/deal.II/particles/particle_handler.h
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/non_matching/fe_values.cc
source/non_matching/mesh_classifier.cc
source/non_matching/quadrature_generator.cc

index 5b3ff3b54ae272538d48470b306c3d60ccf43dff..02a4a3131a9524454fd24f1e33a994a63127260b 100644 (file)
@@ -1458,23 +1458,23 @@ namespace FETools
     }
 #endif // DEAL_II_WITH_P4EST
 
-    template <class VectorType, typename dummy = void>
+    template <typename VectorType, typename dummy = void>
     struct BlockTypeHelper
     {
       using type = VectorType;
     };
 
-    template <class VectorType>
+    template <typename VectorType>
     struct BlockTypeHelper<VectorType,
                            std::enable_if_t<IsBlockVector<VectorType>::value>>
     {
       using type = typename VectorType::BlockType;
     };
 
-    template <class VectorType>
+    template <typename VectorType>
     using BlockType = typename BlockTypeHelper<VectorType>::type;
 
-    template <class VectorType, class DH>
+    template <typename VectorType, class DH>
     void
     reinit_distributed(const DH &dh, VectorType &vector)
     {
@@ -1568,7 +1568,7 @@ namespace FETools
 
 
 
-    template <class VectorType, class DH>
+    template <typename VectorType, class DH>
     void
     reinit_ghosted(const DH & /*dh*/, VectorType & /*vector*/)
     {
index 2eed5643f0ed3bde21d9ef3b10575e240f1d9e26..874e29d9c71dc36456bbaea4902eb82f4afe6811 100644 (file)
@@ -410,7 +410,7 @@ namespace internal
 {
   namespace AffineConstraintsImplementation
   {
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_all(const std::vector<types::global_dof_index> &cm,
                  VectorType &                                vec);
@@ -1089,7 +1089,7 @@ public:
    * @note This function does not work for MPI vectors. Use condense() with
    * two vector arguments instead.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   condense(VectorType &vec) const;
 
@@ -1099,7 +1099,7 @@ public:
    * called in parallel, @p vec_ghosted is supposed to contain ghost elements
    * while @p output should not.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   condense(const VectorType &vec_ghosted, VectorType &output) const;
 
@@ -1115,7 +1115,7 @@ public:
    * See the general documentation of this class for more detailed
    * information.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   condense(SparseMatrix<number> &matrix, VectorType &vector) const;
 
@@ -1123,7 +1123,7 @@ public:
    * Same function as above, but condenses square block sparse matrices and
    * vectors.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   condense(BlockSparseMatrix<number> &matrix, BlockVectorType &vector) const;
 
@@ -1133,7 +1133,7 @@ public:
    * BlockVector<tt><...></tt>, a PETSc or Trilinos vector wrapper class, or
    * any other type having the same interface.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   set_zero(VectorType &vec) const;
 
@@ -1284,7 +1284,7 @@ public:
   /**
    * Enter a single value into a result vector, obeying constraints.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   distribute_local_to_global(const size_type index,
                              const number    value,
@@ -1324,7 +1324,7 @@ public:
    */
   template <typename ForwardIteratorVec,
             typename ForwardIteratorInd,
-            class VectorType>
+            typename VectorType>
   void
   distribute_local_to_global(ForwardIteratorVec local_vector_begin,
                              ForwardIteratorVec local_vector_end,
@@ -1580,7 +1580,7 @@ public:
    */
   template <typename ForwardIteratorVec,
             typename ForwardIteratorInd,
-            class VectorType>
+            typename VectorType>
   void
   get_dof_values(const VectorType & global_vector,
                  ForwardIteratorInd local_indices_begin,
@@ -1608,7 +1608,7 @@ public:
    * @note If this function is called with a parallel vector @p vec, then the
    * vector must not contain ghost elements.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   distribute(VectorType &vec) const;
 
@@ -2136,7 +2136,7 @@ AffineConstraints<number>::set_inhomogeneity(
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 inline void
 AffineConstraints<number>::set_zero(VectorType &vec) const
 {
@@ -2268,7 +2268,7 @@ AffineConstraints<number>::get_local_lines() const
 }
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 inline void
 AffineConstraints<number>::distribute_local_to_global(
   const size_type index,
@@ -2292,7 +2292,7 @@ AffineConstraints<number>::distribute_local_to_global(
 template <typename number>
 template <typename ForwardIteratorVec,
           typename ForwardIteratorInd,
-          class VectorType>
+          typename VectorType>
 inline void
 AffineConstraints<number>::distribute_local_to_global(
   ForwardIteratorVec local_vector_begin,
@@ -2340,7 +2340,7 @@ AffineConstraints<number>::distribute_local_to_global(
 template <typename number>
 template <typename ForwardIteratorVec,
           typename ForwardIteratorInd,
-          class VectorType>
+          typename VectorType>
 inline void
 AffineConstraints<number>::get_dof_values(
   const VectorType & global_vector,
index da30239ef1c9ec9498d760597e4f6c3609fb755f..523dd85f52765e5ea6b07c294ef9d5f65026ccf8 100644 (file)
@@ -1761,7 +1761,7 @@ AffineConstraints<number>::condense(
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 AffineConstraints<number>::condense(const VectorType &vec_ghosted,
                                     VectorType &      vec) const
@@ -1806,7 +1806,7 @@ AffineConstraints<number>::condense(const VectorType &vec_ghosted,
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 AffineConstraints<number>::condense(VectorType &vec) const
 {
@@ -1816,7 +1816,7 @@ AffineConstraints<number>::condense(VectorType &vec) const
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 AffineConstraints<number>::condense(SparseMatrix<number> &uncondensed,
                                     VectorType &          vec) const
@@ -1989,7 +1989,7 @@ AffineConstraints<number>::condense(SparseMatrix<number> &uncondensed,
 
 
 template <typename number>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 void
 AffineConstraints<number>::condense(BlockSparseMatrix<number> &uncondensed,
                                     BlockVectorType &          vec) const
@@ -2185,7 +2185,7 @@ namespace internal
   {
     using size_type = types::global_dof_index;
 
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_parallel(const std::vector<size_type> &cm,
                       VectorType &                  vec,
@@ -2272,7 +2272,7 @@ namespace internal
       vec.zero_out_ghost_values();
     }
 
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_in_parallel(const std::vector<size_type> &cm,
                          VectorType &                  vec,
@@ -2282,7 +2282,7 @@ namespace internal
     }
 
     // in parallel for BlockVectors
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_in_parallel(const std::vector<size_type> &cm,
                          VectorType &                  vec,
@@ -2296,7 +2296,7 @@ namespace internal
         }
     }
 
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_serial(const std::vector<size_type> &cm, VectorType &vec)
     {
@@ -2304,7 +2304,7 @@ namespace internal
         vec(index) = 0.;
     }
 
-    template <class VectorType>
+    template <typename VectorType>
     void
     set_zero_all(const std::vector<size_type> &cm, VectorType &vec)
     {
@@ -2535,7 +2535,7 @@ namespace internal
   }
 
   // for block vectors, simply dispatch to the individual blocks
-  template <class VectorType>
+  template <typename VectorType>
   void
   import_vector_with_ghost_elements(
     const VectorType &vec,
@@ -2565,7 +2565,7 @@ namespace internal
 } // namespace internal
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 AffineConstraints<number>::distribute(VectorType &vec) const
 {
index cd3abd476af223626cce93d95cf3c67a7d95b79a..01c4f6b890e477d741e864853083b3cdaae8f981 100644 (file)
@@ -671,7 +671,7 @@ public:
    * Adding Matrix-vector multiplication. Add $M*src$ on $dst$ with $M$ being
    * this matrix.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   vmult_add(BlockVectorType &dst, const BlockVectorType &src) const;
 
@@ -680,7 +680,7 @@ public:
    * <i>dst</i> with <i>M</i> being this matrix. This function does the same
    * as vmult_add() but takes the transposed matrix.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   Tvmult_add(BlockVectorType &dst, const BlockVectorType &src) const;
 
@@ -696,7 +696,7 @@ public:
    *
    * Obviously, the matrix needs to be square for this operation.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   value_type
   matrix_norm_square(const BlockVectorType &v) const;
 
@@ -710,7 +710,7 @@ public:
   /**
    * Compute the matrix scalar product $\left(u,Mv\right)$.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   value_type
   matrix_scalar_product(const BlockVectorType &u,
                         const BlockVectorType &v) const;
@@ -718,7 +718,7 @@ public:
   /**
    * Compute the residual <i>r=b-Ax</i>. Write the residual into <tt>dst</tt>.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   value_type
   residual(BlockVectorType &      dst,
            const BlockVectorType &x,
@@ -884,7 +884,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   vmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const;
 
@@ -898,7 +898,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType, class VectorType>
+  template <typename BlockVectorType, typename VectorType>
   void
   vmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const;
 
@@ -912,7 +912,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType, class VectorType>
+  template <typename BlockVectorType, typename VectorType>
   void
   vmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const;
 
@@ -926,7 +926,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const;
 
@@ -941,7 +941,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   Tvmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const;
 
@@ -955,7 +955,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType, class VectorType>
+  template <typename BlockVectorType, typename VectorType>
   void
   Tvmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const;
 
@@ -969,7 +969,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class BlockVectorType, class VectorType>
+  template <typename BlockVectorType, typename VectorType>
   void
   Tvmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const;
 
@@ -983,7 +983,7 @@ protected:
    * calls to the implementations provided here under a unique name for which
    * template arguments can be derived by the compiler.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const;
 
@@ -2207,7 +2207,7 @@ BlockMatrixBase<MatrixType>::get_column_indices() const
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_block_block(BlockVectorType &      dst,
                                                const BlockVectorType &src) const
@@ -2228,7 +2228,7 @@ BlockMatrixBase<MatrixType>::vmult_block_block(BlockVectorType &      dst,
 
 
 template <class MatrixType>
-template <class BlockVectorType, class VectorType>
+template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_nonblock_block(
   VectorType &           dst,
@@ -2246,7 +2246,7 @@ BlockMatrixBase<MatrixType>::vmult_nonblock_block(
 
 
 template <class MatrixType>
-template <class BlockVectorType, class VectorType>
+template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_block_nonblock(BlockVectorType & dst,
                                                   const VectorType &src) const
@@ -2262,7 +2262,7 @@ BlockMatrixBase<MatrixType>::vmult_block_nonblock(BlockVectorType & dst,
 
 
 template <class MatrixType>
-template <class VectorType>
+template <typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_nonblock_nonblock(
   VectorType &      dst,
@@ -2277,7 +2277,7 @@ BlockMatrixBase<MatrixType>::vmult_nonblock_nonblock(
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_add(BlockVectorType &      dst,
                                        const BlockVectorType &src) const
@@ -2295,7 +2295,7 @@ BlockMatrixBase<MatrixType>::vmult_add(BlockVectorType &      dst,
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_block_block(
   BlockVectorType &      dst,
@@ -2318,7 +2318,7 @@ BlockMatrixBase<MatrixType>::Tvmult_block_block(
 
 
 template <class MatrixType>
-template <class BlockVectorType, class VectorType>
+template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_block_nonblock(BlockVectorType & dst,
                                                    const VectorType &src) const
@@ -2336,7 +2336,7 @@ BlockMatrixBase<MatrixType>::Tvmult_block_nonblock(BlockVectorType & dst,
 
 
 template <class MatrixType>
-template <class BlockVectorType, class VectorType>
+template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_nonblock_block(
   VectorType &           dst,
@@ -2355,7 +2355,7 @@ BlockMatrixBase<MatrixType>::Tvmult_nonblock_block(
 
 
 template <class MatrixType>
-template <class VectorType>
+template <typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_nonblock_nonblock(
   VectorType &      dst,
@@ -2370,7 +2370,7 @@ BlockMatrixBase<MatrixType>::Tvmult_nonblock_nonblock(
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_add(BlockVectorType &      dst,
                                         const BlockVectorType &src) const
@@ -2388,7 +2388,7 @@ BlockMatrixBase<MatrixType>::Tvmult_add(BlockVectorType &      dst,
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::matrix_norm_square(const BlockVectorType &v) const
 {
@@ -2432,7 +2432,7 @@ BlockMatrixBase<MatrixType>::frobenius_norm() const
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::matrix_scalar_product(
   const BlockVectorType &u,
@@ -2454,7 +2454,7 @@ BlockMatrixBase<MatrixType>::matrix_scalar_product(
 
 
 template <class MatrixType>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::residual(BlockVectorType &      dst,
                                       const BlockVectorType &x,
index 78bbe647e07e70dcf541ca58151a095fc16906ab..2e97f1fffc6c846fbb847e62f6b30358a298fe28 100644 (file)
@@ -297,7 +297,7 @@ public:
    *
    * All diagonal blocks must be square matrices for this operation.
    */
-  template <class BlockVectorType>
+  template <typename BlockVectorType>
   void
   precondition_Jacobi(BlockVectorType &      dst,
                       const BlockVectorType &src,
@@ -479,7 +479,7 @@ BlockSparseMatrix<number>::Tvmult(Vector<nonblock_number> &      dst,
 
 
 template <typename number>
-template <class BlockVectorType>
+template <typename BlockVectorType>
 inline void
 BlockSparseMatrix<number>::precondition_Jacobi(BlockVectorType &      dst,
                                                const BlockVectorType &src,
index 33a9c266c13f190552380e967301459df3920b61..ef0b8aa64ccc6c76c712aeff0213739dc9a1f202 100644 (file)
@@ -118,7 +118,7 @@ namespace internal
      * constant and we again have that the iterator satisfies the requirements
      * of a random access iterator.
      */
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     class Iterator
     {
     public:
@@ -438,7 +438,7 @@ namespace internal
  * @see
  * @ref GlossBlockLA "Block (linear algebra)"
  */
-template <class VectorType>
+template <typename VectorType>
 class BlockVectorBase : public Subscriptor,
                         public ReadVector<typename VectorType::value_type>
 {
@@ -714,7 +714,7 @@ public:
   /**
    * Copy operator for template arguments of different types.
    */
-  template <class VectorType2>
+  template <typename VectorType2>
   BlockVectorBase &
   operator=(const BlockVectorBase<VectorType2> &V);
 
@@ -728,7 +728,7 @@ public:
    * Check for equality of two block vector types. This operation is only
    * allowed if the two vectors already have the same block structure.
    */
-  template <class VectorType2>
+  template <typename VectorType2>
   bool
   operator==(const BlockVectorBase<VectorType2> &v) const;
 
@@ -988,7 +988,7 @@ namespace internal
 {
   namespace BlockVectorIterators
   {
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>::Iterator(
       const Iterator<BlockVectorType, Constness> &c)
       : parent(c.parent)
@@ -1001,7 +1001,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>::Iterator(
       const Iterator<BlockVectorType, !Constness> &c)
       : parent(c.parent)
@@ -1021,7 +1021,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>::Iterator(
       BlockVector &   parent,
       const size_type global_index,
@@ -1039,7 +1039,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness> &
     Iterator<BlockVectorType, Constness>::operator=(const Iterator &c)
     {
@@ -1055,7 +1055,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline typename Iterator<BlockVectorType, Constness>::dereference_type
     Iterator<BlockVectorType, Constness>::operator*() const
     {
@@ -1064,7 +1064,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline typename Iterator<BlockVectorType, Constness>::dereference_type
     Iterator<BlockVectorType, Constness>::operator[](
       const difference_type d) const
@@ -1090,7 +1090,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness> &
     Iterator<BlockVectorType, Constness>::operator++()
     {
@@ -1100,7 +1100,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>
     Iterator<BlockVectorType, Constness>::operator++(int)
     {
@@ -1111,7 +1111,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness> &
     Iterator<BlockVectorType, Constness>::operator--()
     {
@@ -1121,7 +1121,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>
     Iterator<BlockVectorType, Constness>::operator--(int)
     {
@@ -1132,7 +1132,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator==(
@@ -1145,7 +1145,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator!=(
@@ -1158,7 +1158,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator<(
@@ -1171,7 +1171,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator<=(
@@ -1184,7 +1184,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator>(
@@ -1197,7 +1197,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline bool
     Iterator<BlockVectorType, Constness>::operator>=(
@@ -1210,7 +1210,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     template <bool OtherConstness>
     inline typename Iterator<BlockVectorType, Constness>::difference_type
     Iterator<BlockVectorType, Constness>::operator-(
@@ -1224,7 +1224,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>
     Iterator<BlockVectorType, Constness>::operator+(
       const difference_type &d) const
@@ -1251,7 +1251,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness>
     Iterator<BlockVectorType, Constness>::operator-(
       const difference_type &d) const
@@ -1278,7 +1278,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness> &
     Iterator<BlockVectorType, Constness>::operator+=(const difference_type &d)
     {
@@ -1304,7 +1304,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     inline Iterator<BlockVectorType, Constness> &
     Iterator<BlockVectorType, Constness>::operator-=(const difference_type &d)
     {
@@ -1329,7 +1329,7 @@ namespace internal
     }
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     Iterator<BlockVectorType, Constness>::Iterator(BlockVector &   parent,
                                                    const size_type global_index)
       : parent(&parent)
@@ -1368,7 +1368,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     void
     Iterator<BlockVectorType, Constness>::move_forward()
     {
@@ -1402,7 +1402,7 @@ namespace internal
 
 
 
-    template <class BlockVectorType, bool Constness>
+    template <typename BlockVectorType, bool Constness>
     void
     Iterator<BlockVectorType, Constness>::move_backward()
     {
@@ -1444,7 +1444,7 @@ namespace internal
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::size_type
 BlockVectorBase<VectorType>::size() const
 {
@@ -1453,7 +1453,7 @@ BlockVectorBase<VectorType>::size() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline std::size_t
 BlockVectorBase<VectorType>::locally_owned_size() const
 {
@@ -1465,7 +1465,7 @@ BlockVectorBase<VectorType>::locally_owned_size() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline IndexSet
 BlockVectorBase<VectorType>::locally_owned_elements() const
 {
@@ -1486,7 +1486,7 @@ BlockVectorBase<VectorType>::locally_owned_elements() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline unsigned int
 BlockVectorBase<VectorType>::n_blocks() const
 {
@@ -1494,7 +1494,7 @@ BlockVectorBase<VectorType>::n_blocks() const
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::BlockType &
 BlockVectorBase<VectorType>::block(const unsigned int i)
 {
@@ -1505,7 +1505,7 @@ BlockVectorBase<VectorType>::block(const unsigned int i)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline const typename BlockVectorBase<VectorType>::BlockType &
 BlockVectorBase<VectorType>::block(const unsigned int i) const
 {
@@ -1516,7 +1516,7 @@ BlockVectorBase<VectorType>::block(const unsigned int i) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline const BlockIndices &
 BlockVectorBase<VectorType>::get_block_indices() const
 {
@@ -1524,7 +1524,7 @@ BlockVectorBase<VectorType>::get_block_indices() const
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 BlockVectorBase<VectorType>::collect_sizes()
 {
@@ -1538,7 +1538,7 @@ BlockVectorBase<VectorType>::collect_sizes()
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 BlockVectorBase<VectorType>::compress(VectorOperation::values operation)
 {
@@ -1548,7 +1548,7 @@ BlockVectorBase<VectorType>::compress(VectorOperation::values operation)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::iterator
 BlockVectorBase<VectorType>::begin()
 {
@@ -1557,7 +1557,7 @@ BlockVectorBase<VectorType>::begin()
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::const_iterator
 BlockVectorBase<VectorType>::begin() const
 {
@@ -1565,7 +1565,7 @@ BlockVectorBase<VectorType>::begin() const
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::iterator
 BlockVectorBase<VectorType>::end()
 {
@@ -1574,7 +1574,7 @@ BlockVectorBase<VectorType>::end()
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::const_iterator
 BlockVectorBase<VectorType>::end() const
 {
@@ -1582,7 +1582,7 @@ BlockVectorBase<VectorType>::end() const
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline bool
 BlockVectorBase<VectorType>::in_local_range(const size_type global_index) const
 {
@@ -1593,7 +1593,7 @@ BlockVectorBase<VectorType>::in_local_range(const size_type global_index) const
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 bool
 BlockVectorBase<VectorType>::all_zero() const
 {
@@ -1606,7 +1606,7 @@ BlockVectorBase<VectorType>::all_zero() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 bool
 BlockVectorBase<VectorType>::is_non_negative() const
 {
@@ -1619,7 +1619,7 @@ BlockVectorBase<VectorType>::is_non_negative() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::operator*(
   const BlockVectorBase<VectorType> &v) const
@@ -1635,7 +1635,7 @@ BlockVectorBase<VectorType>::operator*(
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::real_type
 BlockVectorBase<VectorType>::norm_sqr() const
 {
@@ -1648,7 +1648,7 @@ BlockVectorBase<VectorType>::norm_sqr() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::mean_value() const
 {
@@ -1665,7 +1665,7 @@ BlockVectorBase<VectorType>::mean_value() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::real_type
 BlockVectorBase<VectorType>::l1_norm() const
 {
@@ -1678,7 +1678,7 @@ BlockVectorBase<VectorType>::l1_norm() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::real_type
 BlockVectorBase<VectorType>::l2_norm() const
 {
@@ -1687,7 +1687,7 @@ BlockVectorBase<VectorType>::l2_norm() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::real_type
 BlockVectorBase<VectorType>::linfty_norm() const
 {
@@ -1703,7 +1703,7 @@ BlockVectorBase<VectorType>::linfty_norm() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::add_and_dot(
   const typename BlockVectorBase<VectorType>::value_type a,
@@ -1722,7 +1722,7 @@ BlockVectorBase<VectorType>::add_and_dot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator+=(const BlockVectorBase<VectorType> &v)
 {
@@ -1739,7 +1739,7 @@ BlockVectorBase<VectorType>::operator+=(const BlockVectorBase<VectorType> &v)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator-=(const BlockVectorBase<VectorType> &v)
 {
@@ -1755,7 +1755,7 @@ BlockVectorBase<VectorType>::operator-=(const BlockVectorBase<VectorType> &v)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename Number>
 inline void
 BlockVectorBase<VectorType>::add(const std::vector<size_type> &indices,
@@ -1768,7 +1768,7 @@ BlockVectorBase<VectorType>::add(const std::vector<size_type> &indices,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename Number>
 inline void
 BlockVectorBase<VectorType>::add(const std::vector<size_type> &indices,
@@ -1783,7 +1783,7 @@ BlockVectorBase<VectorType>::add(const std::vector<size_type> &indices,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename Number>
 inline void
 BlockVectorBase<VectorType>::add(const size_type  n_indices,
@@ -1796,7 +1796,7 @@ BlockVectorBase<VectorType>::add(const size_type  n_indices,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::add(const value_type a)
 {
@@ -1810,7 +1810,7 @@ BlockVectorBase<VectorType>::add(const value_type a)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::add(const value_type                   a,
                                  const BlockVectorBase<VectorType> &v)
@@ -1828,7 +1828,7 @@ BlockVectorBase<VectorType>::add(const value_type                   a,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::add(const value_type                   a,
                                  const BlockVectorBase<VectorType> &v,
@@ -1852,7 +1852,7 @@ BlockVectorBase<VectorType>::add(const value_type                   a,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::sadd(const value_type                   x,
                                   const BlockVectorBase<VectorType> &v)
@@ -1870,7 +1870,7 @@ BlockVectorBase<VectorType>::sadd(const value_type                   x,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::sadd(const value_type                   x,
                                   const value_type                   a,
@@ -1890,7 +1890,7 @@ BlockVectorBase<VectorType>::sadd(const value_type                   x,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::sadd(const value_type                   x,
                                   const value_type                   a,
@@ -1915,7 +1915,7 @@ BlockVectorBase<VectorType>::sadd(const value_type                   x,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::sadd(const value_type                   x,
                                   const value_type                   a,
@@ -1946,7 +1946,7 @@ BlockVectorBase<VectorType>::sadd(const value_type                   x,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <class BlockVector2>
 void
 BlockVectorBase<VectorType>::scale(const BlockVector2 &v)
@@ -1959,7 +1959,7 @@ BlockVectorBase<VectorType>::scale(const BlockVector2 &v)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 std::size_t
 BlockVectorBase<VectorType>::memory_consumption() const
 {
@@ -1969,7 +1969,7 @@ BlockVectorBase<VectorType>::memory_consumption() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <class BlockVector2>
 void
 BlockVectorBase<VectorType>::equ(const value_type a, const BlockVector2 &v)
@@ -1985,7 +1985,7 @@ BlockVectorBase<VectorType>::equ(const value_type a, const BlockVector2 &v)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 BlockVectorBase<VectorType>::update_ghost_values() const
 {
@@ -1995,7 +1995,7 @@ BlockVectorBase<VectorType>::update_ghost_values() const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator=(const value_type s)
 {
@@ -2008,7 +2008,7 @@ BlockVectorBase<VectorType>::operator=(const value_type s)
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator=(const BlockVectorBase<VectorType> &v)
 {
@@ -2021,8 +2021,8 @@ BlockVectorBase<VectorType>::operator=(const BlockVectorBase<VectorType> &v)
 }
 
 
-template <class VectorType>
-template <class VectorType2>
+template <typename VectorType>
+template <typename VectorType2>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator=(const BlockVectorBase<VectorType2> &v)
 {
@@ -2036,7 +2036,7 @@ BlockVectorBase<VectorType>::operator=(const BlockVectorBase<VectorType2> &v)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator=(const VectorType &v)
 {
@@ -2052,8 +2052,8 @@ BlockVectorBase<VectorType>::operator=(const VectorType &v)
 
 
 
-template <class VectorType>
-template <class VectorType2>
+template <typename VectorType>
+template <typename VectorType2>
 inline bool
 BlockVectorBase<VectorType>::operator==(
   const BlockVectorBase<VectorType2> &v) const
@@ -2069,7 +2069,7 @@ BlockVectorBase<VectorType>::operator==(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator*=(const value_type factor)
 {
@@ -2083,7 +2083,7 @@ BlockVectorBase<VectorType>::operator*=(const value_type factor)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline BlockVectorBase<VectorType> &
 BlockVectorBase<VectorType>::operator/=(const value_type factor)
 {
@@ -2099,7 +2099,7 @@ BlockVectorBase<VectorType>::operator/=(const value_type factor)
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::operator()(const size_type i) const
 {
@@ -2110,7 +2110,7 @@ BlockVectorBase<VectorType>::operator()(const size_type i) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::reference
 BlockVectorBase<VectorType>::operator()(const size_type i)
 {
@@ -2121,7 +2121,7 @@ BlockVectorBase<VectorType>::operator()(const size_type i)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::operator[](const size_type i) const
 {
@@ -2130,7 +2130,7 @@ BlockVectorBase<VectorType>::operator[](const size_type i) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename BlockVectorBase<VectorType>::reference
 BlockVectorBase<VectorType>::operator[](const size_type i)
 {
index 2cf0b2d429972f2e60b34d2df8cf95dbfc7c385b..998bc74d89334edfbd9016b398728e690676b534 100644 (file)
@@ -193,7 +193,7 @@ protected:
 //---------------------------------------------------------------------------
 
 
-template <class VectorType>
+template <typename VectorType>
 EigenPower<VectorType>::EigenPower(SolverControl &           cn,
                                    VectorMemory<VectorType> &mem,
                                    const AdditionalData &    data)
@@ -203,7 +203,7 @@ EigenPower<VectorType>::EigenPower(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType>
 void
 EigenPower<VectorType>::solve(double &value, const MatrixType &A, VectorType &x)
@@ -276,7 +276,7 @@ EigenPower<VectorType>::solve(double &value, const MatrixType &A, VectorType &x)
 
 //---------------------------------------------------------------------------
 
-template <class VectorType>
+template <typename VectorType>
 EigenInverse<VectorType>::EigenInverse(SolverControl &           cn,
                                        VectorMemory<VectorType> &mem,
                                        const AdditionalData &    data)
@@ -286,7 +286,7 @@ EigenInverse<VectorType>::EigenInverse(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType>
 void
 EigenInverse<VectorType>::solve(double &          value,
index 66fce2bd1e625d3ff143d77c38dafdec0ce1b258..6aca34f3d735e53a926f58ab60ca185cb0fb23ec 100644 (file)
@@ -131,7 +131,7 @@ public:
    * A wrapper to least_squares(), implementing the standard MatrixType
    * interface.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &dst, const VectorType &src) const;
 
@@ -139,7 +139,7 @@ public:
    * A wrapper to least_squares() that implements multiplication with
    * the transpose matrix.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &dst, const VectorType &src) const;
 
@@ -330,7 +330,7 @@ Householder<number>::least_squares(BlockVector<number2> &      dst,
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 Householder<number>::vmult(VectorType &dst, const VectorType &src) const
 {
@@ -339,7 +339,7 @@ Householder<number>::vmult(VectorType &dst, const VectorType &src) const
 
 
 template <typename number>
-template <class VectorType>
+template <typename VectorType>
 void
 Householder<number>::Tvmult(VectorType &, const VectorType &) const
 {
index 6b124e636eb83bdb33e6b12dec05287ad0861452..84a2dc113aa14854d95f1416eb9f9ed38a938603 100644 (file)
@@ -253,7 +253,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &w, const VectorType &v) const;
 
@@ -262,7 +262,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult_add(VectorType &w, const VectorType &v) const;
 
@@ -271,7 +271,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &w, const VectorType &v) const;
 
@@ -280,7 +280,7 @@ public:
    * MatrixType. No index computations are done, thus, the vectors need to
    * have sizes matching #matrix.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult_add(VectorType &w, const VectorType &v) const;
 
@@ -796,7 +796,7 @@ MatrixBlock<MatrixType>::add(const size_type               row,
 
 
 template <typename MatrixType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 MatrixBlock<MatrixType>::vmult(VectorType &w, const VectorType &v) const
 {
@@ -805,7 +805,7 @@ MatrixBlock<MatrixType>::vmult(VectorType &w, const VectorType &v) const
 
 
 template <typename MatrixType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 MatrixBlock<MatrixType>::vmult_add(VectorType &w, const VectorType &v) const
 {
@@ -814,7 +814,7 @@ MatrixBlock<MatrixType>::vmult_add(VectorType &w, const VectorType &v) const
 
 
 template <typename MatrixType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 MatrixBlock<MatrixType>::Tvmult(VectorType &w, const VectorType &v) const
 {
@@ -823,7 +823,7 @@ MatrixBlock<MatrixType>::Tvmult(VectorType &w, const VectorType &v) const
 
 
 template <typename MatrixType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 MatrixBlock<MatrixType>::Tvmult_add(VectorType &w, const VectorType &v) const
 {
index 82513b26916e9e0995400d68ae1551d81357f5c1..168f35a9b905452a47fec670aaff21590b67da3c 100644 (file)
@@ -170,7 +170,7 @@ namespace PETScWrappers
    * methods:
    *
    * @code
-   * class VectorType : public Subscriptor
+   * typename VectorType : public Subscriptor
    *    ...
    *    explicit VectorType(Vec);
    *    ...
index 92a088b3094da86bb23e09d4dde3c7810174ae59..915f6e5f936a78dfe28cdaef65d9d855db42c10a 100644 (file)
@@ -228,7 +228,7 @@ namespace PETScWrappers
    * methods:
    *
    * @code
-   * class VectorType : public Subscriptor
+   * typename VectorType : public Subscriptor
    *    ...
    *    explicit VectorType(Vec);
    *    ...
index d2868bccfad632346b50891f7c152fe2a389ffb1..264fc8d7174cc8580263f7b3232dec0817fbad7f 100644 (file)
@@ -117,7 +117,7 @@ public:
   /**
    * Apply preconditioner.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &, const VectorType &) const;
 
@@ -125,14 +125,14 @@ public:
    * Apply transpose preconditioner. Since this is the identity, this function
    * is the same as vmult().
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &, const VectorType &) const;
 
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult_add(VectorType &, const VectorType &) const;
 
@@ -140,7 +140,7 @@ public:
    * Apply transpose preconditioner, adding. Since this is the identity, this
    * function is the same as vmult_add().
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult_add(VectorType &, const VectorType &) const;
 
@@ -245,7 +245,7 @@ public:
   /**
    * Apply preconditioner.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &, const VectorType &) const;
 
@@ -253,13 +253,13 @@ public:
    * Apply transpose preconditioner. Since this is the identity, this function
    * is the same as vmult().
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &, const VectorType &) const;
   /**
    * Apply preconditioner, adding to the previous value.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult_add(VectorType &, const VectorType &) const;
 
@@ -267,7 +267,7 @@ public:
    * Apply transpose preconditioner, adding. Since this is the identity, this
    * function is the same as vmult_add().
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult_add(VectorType &, const VectorType &) const;
 
@@ -358,7 +358,7 @@ private:
  * @endcode
  */
 template <typename MatrixType = SparseMatrix<double>,
-          class VectorType    = Vector<double>>
+          typename VectorType = Vector<double>>
 class PreconditionUseMatrix : public Subscriptor
 {
 public:
@@ -472,7 +472,7 @@ public:
   /**
    * Apply preconditioner.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   vmult(VectorType &, const VectorType &) const;
 
@@ -480,21 +480,21 @@ public:
    * Apply transpose preconditioner. Since this is a symmetric preconditioner,
    * this function is the same as vmult().
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tvmult(VectorType &, const VectorType &) const;
 
   /**
    * Perform one step of the preconditioned Richardson iteration
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   step(VectorType &x, const VectorType &rhs) const;
 
   /**
    * Perform one transposed step of the preconditioned Richardson iteration.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   Tstep(VectorType &x, const VectorType &rhs) const;
 
@@ -2263,7 +2263,7 @@ PreconditionIdentity::initialize(const MatrixType &matrix,
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionIdentity::vmult(VectorType &dst, const VectorType &src) const
 {
@@ -2272,14 +2272,14 @@ PreconditionIdentity::vmult(VectorType &dst, const VectorType &src) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionIdentity::Tvmult(VectorType &dst, const VectorType &src) const
 {
   dst = src;
 }
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionIdentity::vmult_add(VectorType &dst, const VectorType &src) const
 {
@@ -2288,7 +2288,7 @@ PreconditionIdentity::vmult_add(VectorType &dst, const VectorType &src) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionIdentity::Tvmult_add(VectorType &dst, const VectorType &src) const
 {
@@ -2358,7 +2358,7 @@ PreconditionRichardson::initialize(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRichardson::vmult(VectorType &dst, const VectorType &src) const
 {
@@ -2371,7 +2371,7 @@ PreconditionRichardson::vmult(VectorType &dst, const VectorType &src) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRichardson::Tvmult(VectorType &dst, const VectorType &src) const
 {
@@ -2382,7 +2382,7 @@ PreconditionRichardson::Tvmult(VectorType &dst, const VectorType &src) const
   dst.equ(relaxation, src);
 }
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRichardson::vmult_add(VectorType &dst, const VectorType &src) const
 {
@@ -2395,7 +2395,7 @@ PreconditionRichardson::vmult_add(VectorType &dst, const VectorType &src) const
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRichardson::Tvmult_add(VectorType &dst, const VectorType &src) const
 {
@@ -2465,7 +2465,7 @@ inline
 }
 
 template <typename MatrixType, typename PreconditionerType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRelaxation<MatrixType, PreconditionerType>::vmult(
   VectorType &      dst,
@@ -2482,7 +2482,7 @@ PreconditionRelaxation<MatrixType, PreconditionerType>::vmult(
 }
 
 template <typename MatrixType, typename PreconditionerType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRelaxation<MatrixType, PreconditionerType>::Tvmult(
   VectorType &      dst,
@@ -2499,7 +2499,7 @@ PreconditionRelaxation<MatrixType, PreconditionerType>::Tvmult(
 }
 
 template <typename MatrixType, typename PreconditionerType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRelaxation<MatrixType, PreconditionerType>::step(
   VectorType &      dst,
@@ -2516,7 +2516,7 @@ PreconditionRelaxation<MatrixType, PreconditionerType>::step(
 }
 
 template <typename MatrixType, typename PreconditionerType>
-template <class VectorType>
+template <typename VectorType>
 inline void
 PreconditionRelaxation<MatrixType, PreconditionerType>::Tstep(
   VectorType &      dst,
@@ -2636,7 +2636,7 @@ PreconditionPSOR<MatrixType>::AdditionalData::AdditionalData(
 //---------------------------------------------------------------------------
 
 
-template <typename MatrixType, class VectorType>
+template <typename MatrixType, typename VectorType>
 PreconditionUseMatrix<MatrixType, VectorType>::PreconditionUseMatrix(
   const MatrixType & M,
   const function_ptr method)
@@ -2646,7 +2646,7 @@ PreconditionUseMatrix<MatrixType, VectorType>::PreconditionUseMatrix(
 
 
 
-template <typename MatrixType, class VectorType>
+template <typename MatrixType, typename VectorType>
 void
 PreconditionUseMatrix<MatrixType, VectorType>::vmult(
   VectorType &      dst,
@@ -3444,7 +3444,7 @@ namespace internal
 
 
 
-template <typename MatrixType, class VectorType, typename PreconditionerType>
+template <typename MatrixType, typename VectorType, typename PreconditionerType>
 inline PreconditionChebyshev<MatrixType, VectorType, PreconditionerType>::
   AdditionalData::AdditionalData(const unsigned int        degree,
                                  const double              smoothing_range,
@@ -3464,7 +3464,7 @@ inline PreconditionChebyshev<MatrixType, VectorType, PreconditionerType>::
 
 
 
-template <typename MatrixType, class VectorType, typename PreconditionerType>
+template <typename MatrixType, typename VectorType, typename PreconditionerType>
 inline typename PreconditionChebyshev<MatrixType,
                                       VectorType,
                                       PreconditionerType>::AdditionalData &
index 141c342b174026e28be3e72d5ce38eb983decbd4..fac1bb39d1ab66d27e1e233d9ddc327b5addaebc 100644 (file)
@@ -560,7 +560,7 @@ BaseQR<VectorType>::multiply_with_colsT(Vector<Number> &  y,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 BaseQR<VectorType>::connect_givens_slot(
   const std::function<void(const unsigned int i,
@@ -572,7 +572,7 @@ BaseQR<VectorType>::connect_givens_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 ImplicitQR<VectorType>::connect_append_column_slot(
   const std::function<bool(const Vector<Number> &u,
index e41b8156f8c250cfb185224ba19bf111d20a84c4..c4a513c1404c85dfdc12b2f1e12fb250e4caa08d 100644 (file)
@@ -180,7 +180,7 @@ namespace internal
    * Default implementation for serial vectors. Here we don't need to make a
    * copy into a ghosted vector, so just return a reference to @p prev.
    */
-  template <class VectorType>
+  template <typename VectorType>
   const VectorType &
   prepare_ghost_vector(const VectorType &prev, VectorType *other)
   {
index 2f5b0b53734b6c27cdc070d9fea8b62fa60f6f89..6491d614985ea0120660ac00b3e1e5c880dbda1f 100644 (file)
@@ -336,7 +336,7 @@ class Vector;
  *
  * @ingroup Solvers
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverBase : public Subscriptor
 {
 public:
@@ -475,7 +475,7 @@ protected:
 /*-------------------------------- Inline functions ------------------------*/
 
 
-template <class VectorType>
+template <typename VectorType>
 inline SolverControl::State
 SolverBase<VectorType>::StateCombiner::operator()(
   const SolverControl::State state1,
@@ -491,7 +491,7 @@ SolverBase<VectorType>::StateCombiner::operator()(
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename Iterator>
 inline SolverControl::State
 SolverBase<VectorType>::StateCombiner::operator()(const Iterator begin,
@@ -511,7 +511,7 @@ SolverBase<VectorType>::StateCombiner::operator()(const Iterator begin,
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline SolverBase<VectorType>::SolverBase(
   SolverControl &           solver_control,
   VectorMemory<VectorType> &vector_memory)
@@ -530,7 +530,7 @@ inline SolverBase<VectorType>::SolverBase(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline SolverBase<VectorType>::SolverBase(SolverControl &solver_control)
   : // use the static memory object this class owns
   memory(static_vector_memory)
@@ -548,7 +548,7 @@ inline SolverBase<VectorType>::SolverBase(SolverControl &solver_control)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline boost::signals2::connection
 SolverBase<VectorType>::connect(
   const std::function<SolverControl::State(const unsigned int iteration,
index fa2ad318ec3aa967e34ee14e7a93b3931e238fac..9c86964b5d66f7e92d20fec62c7c0a3651539fd3 100644 (file)
@@ -190,7 +190,7 @@ namespace internal
  * connect_condition_number_slot and @p connect_eigenvalues_slot. These slots
  * will then be called from the solver with the estimates as argument.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverGMRES : public SolverBase<VectorType>
 {
 public:
@@ -495,7 +495,7 @@ protected:
  *
  * For more details see @cite Saad1991.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverFGMRES : public SolverBase<VectorType>
 {
 public:
@@ -577,7 +577,7 @@ namespace internal
 {
   namespace SolverGMRESImplementation
   {
-    template <class VectorType>
+    template <typename VectorType>
     inline TmpVectors<VectorType>::TmpVectors(const unsigned int max_size,
                                               VectorMemory<VectorType> &vmem)
       : mem(vmem)
@@ -586,7 +586,7 @@ namespace internal
 
 
 
-    template <class VectorType>
+    template <typename VectorType>
     inline VectorType &
     TmpVectors<VectorType>::operator[](const unsigned int i) const
     {
@@ -598,7 +598,7 @@ namespace internal
 
 
 
-    template <class VectorType>
+    template <typename VectorType>
     inline VectorType &
     TmpVectors<VectorType>::operator()(const unsigned int i,
                                        const VectorType & temp)
@@ -614,7 +614,7 @@ namespace internal
 
 
 
-    template <class VectorType>
+    template <typename VectorType>
     unsigned int
     TmpVectors<VectorType>::size() const
     {
@@ -654,7 +654,7 @@ namespace internal
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline SolverGMRES<VectorType>::AdditionalData::AdditionalData(
   const unsigned int                             max_n_tmp_vectors,
   const bool                                     right_preconditioning,
@@ -676,7 +676,7 @@ inline SolverGMRES<VectorType>::AdditionalData::AdditionalData(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverGMRES<VectorType>::SolverGMRES(SolverControl &           cn,
                                      VectorMemory<VectorType> &mem,
                                      const AdditionalData &    data)
@@ -687,7 +687,7 @@ SolverGMRES<VectorType>::SolverGMRES(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverGMRES<VectorType>::SolverGMRES(SolverControl &       cn,
                                      const AdditionalData &data)
   : SolverBase<VectorType>(cn)
@@ -697,7 +697,7 @@ SolverGMRES<VectorType>::SolverGMRES(SolverControl &       cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 SolverGMRES<VectorType>::givens_rotation(Vector<double> &h,
                                          Vector<double> &b,
@@ -827,7 +827,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 !is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -844,7 +844,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -917,7 +917,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 !is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -939,7 +939,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -1027,7 +1027,7 @@ namespace internal
     }
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 !is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -1042,7 +1042,7 @@ namespace internal
     }
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -1071,7 +1071,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 !is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -1094,7 +1094,7 @@ namespace internal
 
 
 
-    template <class VectorType,
+    template <typename VectorType,
               std::enable_if_t<
                 is_dealii_compatible_distributed_vector<VectorType>::value,
                 VectorType> * = nullptr>
@@ -1129,7 +1129,7 @@ namespace internal
      * All subsequent iterations use re-orthogonalization.
      * Calls the signal re_orthogonalize_signal if it is connected.
      */
-    template <class VectorType>
+    template <typename VectorType>
     inline double
     iterated_gram_schmidt(
       const LinearAlgebra::OrthogonalizationStrategy orthogonalization_strategy,
@@ -1230,7 +1230,7 @@ namespace internal
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 SolverGMRES<VectorType>::compute_eigs_and_cond(
   const FullMatrix<double> &H_orig,
@@ -1282,7 +1282,7 @@ SolverGMRES<VectorType>::compute_eigs_and_cond(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverGMRES<VectorType>::solve(const MatrixType &        A,
@@ -1601,7 +1601,7 @@ SolverGMRES<VectorType>::solve(const MatrixType &        A,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_condition_number_slot(
   const std::function<void(double)> &slot,
@@ -1619,7 +1619,7 @@ SolverGMRES<VectorType>::connect_condition_number_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_eigenvalues_slot(
   const std::function<void(const std::vector<std::complex<double>> &)> &slot,
@@ -1637,7 +1637,7 @@ SolverGMRES<VectorType>::connect_eigenvalues_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_hessenberg_slot(
   const std::function<void(const FullMatrix<double> &)> &slot,
@@ -1655,7 +1655,7 @@ SolverGMRES<VectorType>::connect_hessenberg_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_krylov_space_slot(
   const std::function<void(
@@ -1666,7 +1666,7 @@ SolverGMRES<VectorType>::connect_krylov_space_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverGMRES<VectorType>::connect_re_orthogonalization_slot(
   const std::function<void(int)> &slot)
@@ -1676,7 +1676,7 @@ SolverGMRES<VectorType>::connect_re_orthogonalization_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 double
 SolverGMRES<VectorType>::criterion()
 {
@@ -1689,7 +1689,7 @@ SolverGMRES<VectorType>::criterion()
 
 //----------------------------------------------------------------------//
 
-template <class VectorType>
+template <typename VectorType>
 SolverFGMRES<VectorType>::SolverFGMRES(SolverControl &           cn,
                                        VectorMemory<VectorType> &mem,
                                        const AdditionalData &    data)
@@ -1699,7 +1699,7 @@ SolverFGMRES<VectorType>::SolverFGMRES(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverFGMRES<VectorType>::SolverFGMRES(SolverControl &       cn,
                                        const AdditionalData &data)
   : SolverBase<VectorType>(cn)
@@ -1708,7 +1708,7 @@ SolverFGMRES<VectorType>::SolverFGMRES(SolverControl &       cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverFGMRES<VectorType>::solve(const MatrixType &        A,
index bef87482164e40a0185b14ca9957f7fcc5f74d79..f9e4b3cf3dca921502f8f4e65cc549ca5f111b94 100644 (file)
@@ -115,7 +115,7 @@ namespace internal
  * these steps is stored and therefore there will be multiple values per
  * iteration.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverIDR : public SolverBase<VectorType>
 {
 public:
@@ -192,7 +192,7 @@ namespace internal
 {
   namespace SolverIDRImplementation
   {
-    template <class VectorType>
+    template <typename VectorType>
     inline TmpVectors<VectorType>::TmpVectors(const unsigned int        s_param,
                                               VectorMemory<VectorType> &vmem)
       : mem(vmem)
@@ -201,7 +201,7 @@ namespace internal
 
 
 
-    template <class VectorType>
+    template <typename VectorType>
     inline VectorType &
     TmpVectors<VectorType>::operator[](const unsigned int i) const
     {
@@ -213,7 +213,7 @@ namespace internal
 
 
 
-    template <class VectorType>
+    template <typename VectorType>
     inline VectorType &
     TmpVectors<VectorType>::operator()(const unsigned int i,
                                        const VectorType & temp)
@@ -278,7 +278,7 @@ namespace internal
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverIDR<VectorType>::SolverIDR(SolverControl &           cn,
                                  VectorMemory<VectorType> &mem,
                                  const AdditionalData &    data)
@@ -288,7 +288,7 @@ SolverIDR<VectorType>::SolverIDR(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverIDR<VectorType>::SolverIDR(SolverControl &cn, const AdditionalData &data)
   : SolverBase<VectorType>(cn)
   , additional_data(data)
@@ -296,7 +296,7 @@ SolverIDR<VectorType>::SolverIDR(SolverControl &cn, const AdditionalData &data)
 
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 SolverIDR<VectorType>::print_vectors(const unsigned int,
                                      const VectorType &,
@@ -306,7 +306,7 @@ SolverIDR<VectorType>::print_vectors(const unsigned int,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverIDR<VectorType>::solve(const MatrixType &        A,
index a78bfa29c93ade9a9241fd0a150c04714270192c..7a995aaca59b75ec9a9c2f2d05fd8d85a655bc77 100644 (file)
@@ -66,7 +66,7 @@ DEAL_II_NAMESPACE_OPEN
  * Solver base class to determine convergence. This mechanism can also be used
  * to observe the progress of the iteration.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverMinRes : public SolverBase<VectorType>
 {
 public:
@@ -149,7 +149,7 @@ protected:
 
 #ifndef DOXYGEN
 
-template <class VectorType>
+template <typename VectorType>
 SolverMinRes<VectorType>::SolverMinRes(SolverControl &           cn,
                                        VectorMemory<VectorType> &mem,
                                        const AdditionalData &)
@@ -159,7 +159,7 @@ SolverMinRes<VectorType>::SolverMinRes(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverMinRes<VectorType>::SolverMinRes(SolverControl &cn,
                                        const AdditionalData &)
   : SolverBase<VectorType>(cn)
@@ -168,7 +168,7 @@ SolverMinRes<VectorType>::SolverMinRes(SolverControl &cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 double
 SolverMinRes<VectorType>::criterion()
 {
@@ -176,7 +176,7 @@ SolverMinRes<VectorType>::criterion()
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 SolverMinRes<VectorType>::print_vectors(const unsigned int,
                                         const VectorType &,
@@ -186,7 +186,7 @@ SolverMinRes<VectorType>::print_vectors(const unsigned int,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverMinRes<VectorType>::solve(const MatrixType &        A,
index 72801047102c64871df10a638b39752082ac5e96..54a34f479fa494baf861d24aaf7812d36bebe4d9 100644 (file)
@@ -240,7 +240,7 @@ private:
 #ifndef DOXYGEN
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverQMRS<VectorType>::IterationResult::IterationResult(
   const SolverControl::State state,
   const double               last_residual)
@@ -250,7 +250,7 @@ SolverQMRS<VectorType>::IterationResult::IterationResult(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverQMRS<VectorType>::SolverQMRS(SolverControl &           cn,
                                    VectorMemory<VectorType> &mem,
                                    const AdditionalData &    data)
@@ -259,7 +259,7 @@ SolverQMRS<VectorType>::SolverQMRS(SolverControl &           cn,
   , step(0)
 {}
 
-template <class VectorType>
+template <typename VectorType>
 SolverQMRS<VectorType>::SolverQMRS(SolverControl &       cn,
                                    const AdditionalData &data)
   : SolverBase<VectorType>(cn)
@@ -267,7 +267,7 @@ SolverQMRS<VectorType>::SolverQMRS(SolverControl &       cn,
   , step(0)
 {}
 
-template <class VectorType>
+template <typename VectorType>
 void
 SolverQMRS<VectorType>::print_vectors(const unsigned int,
                                       const VectorType &,
@@ -275,7 +275,7 @@ SolverQMRS<VectorType>::print_vectors(const unsigned int,
                                       const VectorType &) const
 {}
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverQMRS<VectorType>::solve(const MatrixType &        A,
@@ -323,7 +323,7 @@ SolverQMRS<VectorType>::solve(const MatrixType &        A,
   // otherwise exit as normal
 }
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 typename SolverQMRS<VectorType>::IterationResult
 SolverQMRS<VectorType>::iterate(const MatrixType &        A,
index e3e058b315e1b8185b54200bafa1a9b5adac5f3e..ace14db6bc50a4ad6d4e133d6f76ca54be94abe1 100644 (file)
@@ -85,7 +85,7 @@ public:
 
 //----------------------------------------------------------------------//
 
-template <class VectorType>
+template <typename VectorType>
 SolverRelaxation<VectorType>::SolverRelaxation(SolverControl &cn,
                                                const AdditionalData &)
   : SolverBase<VectorType>(cn)
@@ -93,7 +93,7 @@ SolverRelaxation<VectorType>::SolverRelaxation(SolverControl &cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, class RelaxationType>
 void
 SolverRelaxation<VectorType>::solve(const MatrixType &    A,
index dce9c236d06bf1afe3841e54f858b483bf2488dd..68850ae3e8b90879eb975d805f9098557ee1cb7d 100644 (file)
@@ -60,7 +60,7 @@ DEAL_II_NAMESPACE_OPEN
  * Solver base class to determine convergence. This mechanism can also be used
  * to observe the progress of the iteration.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class SolverRichardson : public SolverBase<VectorType>
 {
 public:
@@ -163,7 +163,7 @@ protected:
 
 #ifndef DOXYGEN
 
-template <class VectorType>
+template <typename VectorType>
 inline SolverRichardson<VectorType>::AdditionalData::AdditionalData(
   const double omega,
   const bool   use_preconditioned_residual)
@@ -172,7 +172,7 @@ inline SolverRichardson<VectorType>::AdditionalData::AdditionalData(
 {}
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverRichardson<VectorType>::SolverRichardson(SolverControl &           cn,
                                                VectorMemory<VectorType> &mem,
                                                const AdditionalData &    data)
@@ -182,7 +182,7 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl &           cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 SolverRichardson<VectorType>::SolverRichardson(SolverControl &       cn,
                                                const AdditionalData &data)
   : SolverBase<VectorType>(cn)
@@ -191,7 +191,7 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl &       cn,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverRichardson<VectorType>::solve(const MatrixType &        A,
@@ -248,7 +248,7 @@ SolverRichardson<VectorType>::solve(const MatrixType &        A,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
 SolverRichardson<VectorType>::Tsolve(const MatrixType &        A,
@@ -302,7 +302,7 @@ SolverRichardson<VectorType>::Tsolve(const MatrixType &        A,
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 SolverRichardson<VectorType>::print_vectors(const unsigned int,
                                             const VectorType &,
@@ -312,7 +312,7 @@ SolverRichardson<VectorType>::print_vectors(const unsigned int,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 inline typename VectorType::value_type
 SolverRichardson<VectorType>::criterion(const VectorType &r,
                                         const VectorType &d) const
@@ -324,7 +324,7 @@ SolverRichardson<VectorType>::criterion(const VectorType &r,
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 inline void
 SolverRichardson<VectorType>::set_omega(const double om)
 {
index 7fe3f76ee5397802bb230563db91c9fdb58992a8..48f8b7979ab222ab25c112ccd0e35009eb3e9dbd 100644 (file)
@@ -738,7 +738,7 @@ namespace TrilinosWrappers
      * see
      * https://docs.trilinos.org/latest-release/packages/belos/doc/html/classBelos_1_1MultiVec.html.
      */
-    template <class VectorType>
+    template <typename VectorType>
     class MultiVecWrapper
       : public Belos::MultiVec<typename VectorType::value_type>
     {
@@ -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, class VectorType>
+    template <class OperatorType, typename VectorType>
     class OperatorWrapper
       : public Belos::Operator<typename VectorType::value_type>
     {
index 6a3c37a37a300fd6520d39eb5a1a8001ac523094..7b29f84478a3b6d766e56bf90b1a7f4a85cb9f98 100644 (file)
@@ -194,14 +194,14 @@ namespace internal
    * by seeing whether the `is_serial_vector` type is declared for the
    * given vector type.
    */
-  template <class VectorType>
+  template <typename VectorType>
   using is_vector_type = decltype(is_serial_vector<VectorType>::value);
 
   /**
    * A predicate stating whether something is a vector type and is
    * indeed a serial vector.
    */
-  template <class VectorType>
+  template <typename VectorType>
   using is_serial_vector_type =
     decltype(std::enable_if_t<is_serial_vector<VectorType>::value, int>());
 
@@ -210,7 +210,7 @@ namespace internal
    * a vector type at all, or (ii) if it is a vector type,
    * that it is not a parallel vector type.
    */
-  template <class VectorType>
+  template <typename VectorType>
   constexpr bool is_not_parallel_vector =
     (is_supported_operation<is_vector_type, VectorType> == false) ||
     (is_supported_operation<is_serial_vector_type, VectorType> == true);
index 56223ef01bdba6a71ca77e3221c287ddf45f78ab..553ad3bb249dbedc3b923111c20297d51902b9d9 100644 (file)
@@ -36,7 +36,7 @@ DEAL_II_NAMESPACE_OPEN
  * Coarse grid solver using smoother only. This is a little wrapper,
  * transforming a smoother into a coarse grid solver.
  */
-template <class VectorType = Vector<double>>
+template <typename VectorType = Vector<double>>
 class MGCoarseGridApplySmoother : public MGCoarseGridBase<VectorType>
 {
 public:
@@ -87,7 +87,7 @@ private:
  * This class provides a wrapper for a deal.II iterative solver with a given
  * matrix and preconditioner as a coarse grid operator.
  */
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -173,7 +173,7 @@ private:
  * the operator() uses Householder::least_squares() to compute the action of
  * the inverse.
  */
-template <typename number = double, class VectorType = Vector<number>>
+template <typename number = double, typename VectorType = Vector<number>>
 class MGCoarseGridHouseholder : public MGCoarseGridBase<VectorType>
 {
 public:
@@ -206,7 +206,7 @@ private:
  * Upon initialization, the singular value decomposition of the matrix is
  * computed. then, the operator() uses
  */
-template <typename number = double, class VectorType = Vector<number>>
+template <typename number = double, typename VectorType = Vector<number>>
 class MGCoarseGridSVD : public MGCoarseGridBase<VectorType>
 {
 public:
@@ -243,12 +243,12 @@ private:
 
 #ifndef DOXYGEN
 /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/
-template <class VectorType>
+template <typename VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother()
   : coarse_smooth(nullptr)
 {}
 
-template <class VectorType>
+template <typename VectorType>
 MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother(
   const MGSmootherBase<VectorType> &coarse_smooth)
   : coarse_smooth(nullptr)
@@ -257,7 +257,7 @@ MGCoarseGridApplySmoother<VectorType>::MGCoarseGridApplySmoother(
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::initialize(
   const MGSmootherBase<VectorType> &coarse_smooth_)
@@ -269,7 +269,7 @@ MGCoarseGridApplySmoother<VectorType>::initialize(
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::clear()
 {
@@ -277,7 +277,7 @@ MGCoarseGridApplySmoother<VectorType>::clear()
 }
 
 
-template <class VectorType>
+template <typename VectorType>
 void
 MGCoarseGridApplySmoother<VectorType>::operator()(const unsigned int level,
                                                   VectorType &       dst,
@@ -288,7 +288,7 @@ MGCoarseGridApplySmoother<VectorType>::operator()(const unsigned int level,
 
 /* ------------------ Functions for MGCoarseGridIterativeSolver ------------ */
 
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -303,7 +303,7 @@ MGCoarseGridIterativeSolver<VectorType,
 
 
 
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -321,7 +321,7 @@ MGCoarseGridIterativeSolver<VectorType,
 
 
 
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -341,7 +341,7 @@ MGCoarseGridIterativeSolver<
 
 
 
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -363,7 +363,7 @@ namespace internal
   namespace MGCoarseGridIterativeSolver
   {
     template <
-      class VectorType,
+      typename VectorType,
       class SolverType,
       class MatrixType,
       class PreconditionerType,
@@ -381,7 +381,7 @@ namespace internal
     }
 
     template <
-      class VectorType,
+      typename VectorType,
       class SolverType,
       class MatrixType,
       class PreconditionerType,
@@ -410,7 +410,7 @@ namespace internal
 
 
 
-template <class VectorType,
+template <typename VectorType,
           class SolverType,
           class MatrixType,
           class PreconditionerType>
@@ -436,7 +436,7 @@ void
 
 /* ------------------ Functions for MGCoarseGridHouseholder ------------ */
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 MGCoarseGridHouseholder<number, VectorType>::MGCoarseGridHouseholder(
   const FullMatrix<number> *A)
 {
@@ -446,7 +446,7 @@ MGCoarseGridHouseholder<number, VectorType>::MGCoarseGridHouseholder(
 
 
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 void
 MGCoarseGridHouseholder<number, VectorType>::initialize(
   const FullMatrix<number> &A)
@@ -456,7 +456,7 @@ MGCoarseGridHouseholder<number, VectorType>::initialize(
 
 
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 void
 MGCoarseGridHouseholder<number, VectorType>::operator()(
   const unsigned int /*level*/,
@@ -470,7 +470,7 @@ MGCoarseGridHouseholder<number, VectorType>::operator()(
 
 
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::initialize(const FullMatrix<number> &A,
                                                 double threshold)
@@ -481,7 +481,7 @@ MGCoarseGridSVD<number, VectorType>::initialize(const FullMatrix<number> &A,
 }
 
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::operator()(const unsigned int /*level*/,
                                                 VectorType &      dst,
@@ -491,7 +491,7 @@ MGCoarseGridSVD<number, VectorType>::operator()(const unsigned int /*level*/,
 }
 
 
-template <typename number, class VectorType>
+template <typename number, typename VectorType>
 void
 MGCoarseGridSVD<number, VectorType>::log() const
 {
index 6d42e31ade20804db6fc099db473e200451c15e3..1231d1f4e54084ed0dec07b10f35875d045b362f 100644 (file)
@@ -167,7 +167,7 @@ namespace NonMatching
      * and @p level_set are stored internally, so these need to have a longer life
      * span than the instance of this class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     FEValues(const hp::FECollection<dim> &fe_collection,
              const Quadrature<1> &        quadrature,
              const RegionUpdateFlags      region_update_flags,
@@ -202,7 +202,7 @@ namespace NonMatching
      * internally, so these need to have a longer life span than the instance of
      * this class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     FEValues(const hp::MappingCollection<dim> &mapping_collection,
              const hp::FECollection<dim> &     fe_collection,
              const hp::QCollection<dim> &      q_collection,
@@ -461,7 +461,7 @@ namespace NonMatching
      * and @p level_set are stored internally, so these need to have a longer life
      * span than the instance of this class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     FEInterfaceValues(const hp::FECollection<dim> &fe_collection,
                       const Quadrature<1> &        quadrature,
                       const RegionUpdateFlags      region_update_flags,
@@ -496,7 +496,7 @@ namespace NonMatching
      * internally, so these need to have a longer life span than the instance of
      * this class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     FEInterfaceValues(const hp::MappingCollection<dim> &mapping_collection,
                       const hp::FECollection<dim> &     fe_collection,
                       const hp::QCollection<dim - 1> &  q_collection,
index 1a019dffb0f188aa9d63e9e3706d2b44d508880f..91d94f351518275b7b3bc61d08bbbc8bb11b4c4c 100644 (file)
@@ -114,7 +114,7 @@ namespace NonMatching
      * Vector. The triangulation attached to DoFHandler is the one that will be
      * classified.
      */
-    template <class VectorType>
+    template <typename VectorType>
     MeshClassifier(const DoFHandler<dim> &level_set_dof_handler,
                    const VectorType &     level_set);
 
index 7b7b7947cf64124d3c8935e8f6b23527d98f4439..8ee5ad25eb3b9818d7662cb7c4f9d89dad58f35d 100644 (file)
@@ -500,7 +500,7 @@ namespace NonMatching
      * class. The hp::QCollection<1> and AdditionalData is passed to the
      * QuadratureGenerator class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     DiscreteQuadratureGenerator(
       const hp::QCollection<1> &quadratures1D,
       const DoFHandler<dim> &   dof_handler,
@@ -556,7 +556,7 @@ namespace NonMatching
      * class. The hp::QCollection<1> and AdditionalData is passed to the
      * QuadratureGenerator class.
      */
-    template <class VectorType>
+    template <typename VectorType>
     DiscreteFaceQuadratureGenerator(
       const hp::QCollection<1> &quadratures1D,
       const DoFHandler<dim> &   dof_handler,
index 1ef22eca8deb9307863dfb1c7418c5c8ebb04689..59da95c6083aacbee0309f759fc1db0580da85fd 100644 (file)
@@ -726,7 +726,7 @@ public:
    * which FEValues can extract values on a cell using the
    * FEValuesBase::get_function_values() function.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(
     const VectorType &              data,
@@ -751,7 +751,7 @@ public:
    * which FEValues can extract values on a cell using the
    * FEValuesBase::get_function_values() function.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(
     const VectorType &   data,
@@ -775,7 +775,7 @@ public:
    * represents dof data, the data vector type argument present in the other
    * methods above is not necessary.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(
     const DoFHandler<dim, spacedim> &dof_handler,
@@ -789,7 +789,7 @@ public:
    * This function is an abbreviation of the function above with only a scalar
    * @p dof_handler given and a single data name.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(
     const DoFHandler<dim, spacedim> &dof_handler,
@@ -824,7 +824,7 @@ public:
    * error by declaring the data postprocessor variable before the DataOut
    * variable as objects are destroyed in reverse order of declaration.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(const VectorType &                 data,
                   const DataPostprocessor<spacedim> &data_postprocessor);
@@ -835,7 +835,7 @@ public:
    * postprocessor can only read data from the given DoFHandler and solution
    * vector, not other solution vectors or DoFHandlers.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector(const DoFHandler<dim, spacedim> &  dof_handler,
                   const VectorType &                 data,
@@ -858,7 +858,7 @@ public:
    * The handling of @p names and @p data_component_interpretation is identical
    * to the add_data_vector() function.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_mg_data_vector(
     const DoFHandler<dim, spacedim> &dof_handler,
@@ -871,7 +871,7 @@ public:
   /**
    * Scalar version of the function above.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_mg_data_vector(const DoFHandler<dim, spacedim> &dof_handler,
                      const MGLevelObject<VectorType> &data,
@@ -1030,7 +1030,7 @@ private:
   /**
    * Common function called by the four public add_data_vector methods.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   add_data_vector_internal(
     const DoFHandler<dim, spacedim> *dof_handler,
index eb7f003a60715e5ecb3a5e3049a8330bf0d49d26..0b01dc0c89d61ea6d56affabc45bb7dc36f7f6ca 100644 (file)
@@ -2009,7 +2009,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::
 
 
 template <int dim, int patch_dim, int spacedim, int patch_spacedim>
-template <class VectorType>
+template <typename VectorType>
 void
 DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::add_mg_data_vector(
   const DoFHandler<dim, spacedim> &dof_handler,
@@ -2024,7 +2024,7 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::add_mg_data_vector(
 
 
 template <int dim, int patch_dim, int spacedim, int patch_spacedim>
-template <class VectorType>
+template <typename VectorType>
 void
 DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::add_mg_data_vector(
   const DoFHandler<dim, spacedim> &dof_handler,
index e11f0cb34d55ea3d0e25d2bda8e9bdc8d6d0ab33..2e47c7d841f4baf4ad9854aa098ec0792fce0a29 100644 (file)
@@ -51,7 +51,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @ingroup output
  */
-template <int dim, typename SolverType, class VectorType = Vector<double>>
+template <int dim, typename SolverType, typename VectorType = Vector<double>>
 class DoFPrintSolverStep : public SolverType
 {
 public:
@@ -91,7 +91,7 @@ private:
 
 /* ----------------------- template functions --------------- */
 
-template <int dim, typename SolverType, class VectorType>
+template <int dim, typename SolverType, typename VectorType>
 DoFPrintSolverStep<dim, SolverType, VectorType>::DoFPrintSolverStep(
   SolverControl &           control,
   VectorMemory<VectorType> &mem,
@@ -103,7 +103,7 @@ DoFPrintSolverStep<dim, SolverType, VectorType>::DoFPrintSolverStep(
 {}
 
 
-template <int dim, typename SolverType, class VectorType>
+template <int dim, typename SolverType, typename VectorType>
 void
 DoFPrintSolverStep<dim, SolverType, VectorType>::print_vectors(
   const unsigned int step,
index b1a3401f5949b4ee52af557dc9ab2835ece7bc9a..827e5d902f50c8351c4ce08adb86879b7f28c750 100644 (file)
@@ -332,7 +332,7 @@ public:
    * called for each dataset (time step, iteration, etc) for each vector_name,
    * otherwise a @p ExcDataLostSync error can occur.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   evaluate_field(const std::string &name, const VectorType &solution);
 
@@ -354,7 +354,7 @@ public:
    * method must be called for each dataset (time step, iteration, etc) for
    * each vector_name, otherwise a @p ExcDataLostSync error can occur.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   evaluate_field(const std::vector<std::string> &names,
                  const VectorType &              solution,
@@ -366,7 +366,7 @@ public:
    * call the above function. The above function is more efficient if multiple
    * fields use the same @p DataPostprocessor object.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   evaluate_field(const std::string &           name,
                  const VectorType &            solution,
@@ -386,7 +386,7 @@ public:
    * called for each dataset (time step, iteration, etc) for each vector_name,
    * otherwise a @p ExcDataLostSync error can occur.
    */
-  template <class VectorType>
+  template <typename VectorType>
   void
   evaluate_field_at_requested_location(const std::string &name,
                                        const VectorType & solution);
index 4282935aaa8ecae9031eaf74d1b4b5f379d36190..3f4ecdda9a423125cb7fd6fca59a25e09f89deab 100644 (file)
@@ -134,7 +134,7 @@ namespace VectorTools
    *
    * @dealiiConceptRequires{concepts::is_writable_dealii_vector_type<VectorType>}
    */
-  template <class VectorType, int dim, int spacedim = dim>
+  template <typename VectorType, int dim, int spacedim = dim>
   DEAL_II_CXX20_REQUIRES(concepts::is_writable_dealii_vector_type<VectorType>)
   void add_constant(VectorType &                          solution,
                     const DoFHandler<dim, spacedim> &     dof_handler,
index 654b3727d10a27d4cdc31bfe5f91bbd8320eb145..04c94d3b330025b2e8b5afe11e9ee859efae7879 100644 (file)
@@ -130,7 +130,7 @@ namespace VectorTools
 
 
 
-  template <class VectorType, int dim, int spacedim>
+  template <typename VectorType, int dim, int spacedim>
   DEAL_II_CXX20_REQUIRES(concepts::is_writable_dealii_vector_type<VectorType>)
   void add_constant(VectorType &                          solution,
                     const DoFHandler<dim, spacedim> &     dof_handler,
index a938b7c58853e35a73234054a6f79a8a76f83b23..7a291ab67e6371b370b68612c5099d5ae672bec4 100644 (file)
@@ -203,7 +203,7 @@ SolverBFGS<VectorType>::SolverBFGS(SolverControl &       solver_control,
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverBFGS<VectorType>::connect_line_search_slot(
   const std::function<
@@ -216,7 +216,7 @@ SolverBFGS<VectorType>::connect_line_search_slot(
 
 
 
-template <class VectorType>
+template <typename VectorType>
 boost::signals2::connection
 SolverBFGS<VectorType>::connect_preconditioner_slot(
   const std::function<void(VectorType &                         g,
index b9270eafd8137f837b42e21298840a3d2a651028..49a0def316aa6b2b964233945430cd2f8a96cb81 100644 (file)
@@ -480,7 +480,7 @@ namespace Particles
      * be interpreted as a displacement vector, or a vector of absolute
      * positions.
      */
-    template <class VectorType>
+    template <typename VectorType>
     std::enable_if_t<
       std::is_convertible<VectorType *, Function<spacedim> *>::value == false>
     set_particle_positions(const VectorType &input_vector,
@@ -560,7 +560,7 @@ namespace Particles
      * @param[in] add_to_output_vector Control if the function should set the
      * entries of the @p output_vector or if should add to them.
      */
-    template <class VectorType>
+    template <typename VectorType>
     void
     get_particle_positions(VectorType &output_vector,
                            const bool  add_to_output_vector = false);
@@ -1330,7 +1330,7 @@ namespace Particles
 
 
   template <int dim, int spacedim>
-  template <class VectorType>
+  template <typename VectorType>
   inline std::enable_if_t<
     std::is_convertible<VectorType *, Function<spacedim> *>::value == false>
   ParticleHandler<dim, spacedim>::set_particle_positions(
@@ -1354,7 +1354,7 @@ namespace Particles
 
 
   template <int dim, int spacedim>
-  template <class VectorType>
+  template <typename VectorType>
   inline void
   ParticleHandler<dim, spacedim>::get_particle_positions(
     VectorType &output_vector,
index 0e379d8c4598a18ed2e23c1fa0d00295a5a0ef1a..4f24bec6bb91dafe134d781975d83832ab3e0895 100644 (file)
@@ -38,7 +38,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 MappingQ1Eulerian<dim, VectorType, spacedim>::MappingQ1Eulerian(
   const DoFHandler<dim, spacedim> &shiftmap_dof_handler,
   const VectorType &               euler_transform_vectors)
@@ -49,7 +49,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::MappingQ1Eulerian(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 boost::container::small_vector<Point<spacedim>,
                                GeometryInfo<dim>::vertices_per_cell>
 MappingQ1Eulerian<dim, VectorType, spacedim>::get_vertices(
@@ -103,7 +103,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::get_vertices(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 std::vector<Point<spacedim>>
 MappingQ1Eulerian<dim, VectorType, spacedim>::compute_mapping_support_points(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
@@ -119,7 +119,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::compute_mapping_support_points(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 std::unique_ptr<Mapping<dim, spacedim>>
 MappingQ1Eulerian<dim, VectorType, spacedim>::clone() const
 {
@@ -128,7 +128,7 @@ MappingQ1Eulerian<dim, VectorType, spacedim>::clone() const
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 CellSimilarity::Similarity
 MappingQ1Eulerian<dim, VectorType, spacedim>::fill_fe_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
index 44429d1d751cbaf76296a354f89838129b6a1f31..b28588e378b29dcb06c0ae19543dd73155750d15 100644 (file)
@@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN
 // .... MAPPING Q EULERIAN CONSTRUCTOR
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 MappingQEulerian<dim, VectorType, spacedim>::MappingQEulerian(
   const unsigned int               degree,
   const DoFHandler<dim, spacedim> &euler_dof_handler,
@@ -62,7 +62,7 @@ MappingQEulerian<dim, VectorType, spacedim>::MappingQEulerian(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 std::unique_ptr<Mapping<dim, spacedim>>
 MappingQEulerian<dim, VectorType, spacedim>::clone() const
 {
@@ -74,7 +74,7 @@ MappingQEulerian<dim, VectorType, spacedim>::clone() const
 
 // .... SUPPORT QUADRATURE CONSTRUCTOR
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 MappingQEulerian<dim, VectorType, spacedim>::SupportQuadrature::
   SupportQuadrature(const unsigned int map_degree)
   : Quadrature<dim>(Utilities::fixed_power<dim>(map_degree + 1))
@@ -99,7 +99,7 @@ MappingQEulerian<dim, VectorType, spacedim>::SupportQuadrature::
 
 // .... COMPUTE MAPPING SUPPORT POINTS
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 boost::container::small_vector<Point<spacedim>,
                                GeometryInfo<dim>::vertices_per_cell>
 MappingQEulerian<dim, VectorType, spacedim>::get_vertices(
@@ -118,7 +118,7 @@ MappingQEulerian<dim, VectorType, spacedim>::get_vertices(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 std::vector<Point<spacedim>>
 MappingQEulerian<dim, VectorType, spacedim>::compute_mapping_support_points(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
@@ -191,7 +191,7 @@ MappingQEulerian<dim, VectorType, spacedim>::compute_mapping_support_points(
 
 
 
-template <int dim, class VectorType, int spacedim>
+template <int dim, typename VectorType, int spacedim>
 CellSimilarity::Similarity
 MappingQEulerian<dim, VectorType, spacedim>::fill_fe_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
index 4c1798520787eb6ae995dab3c60f7f95cbb86587..cfced4aa53d99c68058ab5a60afa1975cf261c8b 100644 (file)
@@ -45,7 +45,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   FEValues<dim>::FEValues(const hp::FECollection<dim> &fe_collection,
                           const Quadrature<1> &        quadrature,
                           const RegionUpdateFlags      region_update_flags,
@@ -75,7 +75,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   FEValues<dim>::FEValues(const hp::MappingCollection<dim> &mapping_collection,
                           const hp::FECollection<dim> &     fe_collection,
                           const hp::QCollection<dim> &      q_collection,
@@ -270,7 +270,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   FEInterfaceValues<dim>::FEInterfaceValues(
     const hp::FECollection<dim> &fe_collection,
     const Quadrature<1> &        quadrature,
@@ -301,7 +301,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   FEInterfaceValues<dim>::FEInterfaceValues(
     const hp::MappingCollection<dim> &mapping_collection,
     const hp::FECollection<dim> &     fe_collection,
index d88a69e35a114760f0975456a059b61acd05ad64..b1b0edabb33fea845329f17325b2f39b76d9b6d8 100644 (file)
@@ -61,7 +61,7 @@ namespace NonMatching
        * vector are negative/positive, otherwise return
        * LocationToLevelSet::intersected.
        */
-      template <class VectorType>
+      template <typename VectorType>
       LocationToLevelSet
       location_from_dof_signs(const VectorType &local_levelset_values)
       {
@@ -83,7 +83,7 @@ namespace NonMatching
        * The concrete LevelSetDescription used when the level set function is
        * described as a (DoFHandler, Vector)-pair.
        */
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       class DiscreteLevelSetDescription : public LevelSetDescription<dim>
       {
       public:
@@ -132,7 +132,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       DiscreteLevelSetDescription<dim, VectorType>::DiscreteLevelSetDescription(
         const DoFHandler<dim> &dof_handler,
         const VectorType &     level_set)
@@ -142,7 +142,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       const hp::FECollection<dim> &
       DiscreteLevelSetDescription<dim, VectorType>::get_fe_collection() const
       {
@@ -151,7 +151,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       void
       DiscreteLevelSetDescription<dim, VectorType>::get_local_level_set_values(
         const typename Triangulation<dim>::active_cell_iterator &cell,
@@ -179,7 +179,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       unsigned int
       DiscreteLevelSetDescription<dim, VectorType>::active_fe_index(
         const typename Triangulation<dim>::active_cell_iterator &cell) const
@@ -311,7 +311,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   MeshClassifier<dim>::MeshClassifier(const DoFHandler<dim> &dof_handler,
                                       const VectorType &     level_set)
     : triangulation(&dof_handler.get_triangulation())
index 18ed8736a58944c4b63342b27af43e8c3987b747..f0863b01891eb7405be3d1797512e646c1880ba8 100644 (file)
@@ -1308,7 +1308,7 @@ namespace NonMatching
        * function must be called to specify which cell the function should be
        * evaluated on.
        */
-      template <int dim, class VectorType = Vector<double>>
+      template <int dim, typename VectorType = Vector<double>>
       class RefSpaceFEFieldFunction : public CellWiseFunction<dim>
       {
       public:
@@ -1417,7 +1417,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       RefSpaceFEFieldFunction<dim, VectorType>::RefSpaceFEFieldFunction(
         const DoFHandler<dim> &dof_handler,
         const VectorType &     dof_values)
@@ -1430,7 +1430,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       void
       RefSpaceFEFieldFunction<dim, VectorType>::set_active_cell(
         const typename Triangulation<dim>::active_cell_iterator &cell)
@@ -1493,7 +1493,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       bool
       RefSpaceFEFieldFunction<dim, VectorType>::cell_is_set() const
       {
@@ -1504,7 +1504,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       double
       RefSpaceFEFieldFunction<dim, VectorType>::value(
         const Point<dim> & point,
@@ -1536,7 +1536,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       Tensor<1, dim>
       RefSpaceFEFieldFunction<dim, VectorType>::gradient(
         const Point<dim> & point,
@@ -1569,7 +1569,7 @@ namespace NonMatching
 
 
 
-      template <int dim, class VectorType>
+      template <int dim, typename VectorType>
       SymmetricTensor<2, dim>
       RefSpaceFEFieldFunction<dim, VectorType>::hessian(
         const Point<dim> & point,
@@ -1873,7 +1873,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   DiscreteQuadratureGenerator<dim>::DiscreteQuadratureGenerator(
     const hp::QCollection<1> &quadratures1D,
     const DoFHandler<dim> &   dof_handler,
@@ -1906,7 +1906,7 @@ namespace NonMatching
 
 
   template <int dim>
-  template <class VectorType>
+  template <typename VectorType>
   DiscreteFaceQuadratureGenerator<dim>::DiscreteFaceQuadratureGenerator(
     const hp::QCollection<1> &quadratures1D,
     const DoFHandler<dim> &   dof_handler,

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.