]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Standardize on 'typename MatrixType'.
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 2 Jul 2023 02:34:04 +0000 (20:34 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 2 Jul 2023 04:19:05 +0000 (22:19 -0600)
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/petsc_snes.h
include/deal.II/lac/petsc_ts.h
include/deal.II/multigrid/mg_coarse.h

index 01c4f6b890e477d741e864853083b3cdaae8f981..06db33dc9636a335cadf2fb71783c00d7e7b809d 100644 (file)
@@ -59,7 +59,7 @@ namespace BlockMatrixIterators
    * Base class for block matrix accessors, implementing the stepping through
    * a matrix.
    */
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   class AccessorBase
   {
   public:
@@ -111,14 +111,14 @@ namespace BlockMatrixIterators
   /**
    * Accessor classes in block matrices.
    */
-  template <class BlockMatrixType, bool Constness>
+  template <typename BlockMatrixType, bool Constness>
   class Accessor;
 
 
   /**
    * Block matrix accessor for non const matrices.
    */
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   class Accessor<BlockMatrixType, false> : public AccessorBase<BlockMatrixType>
   {
   public:
@@ -203,7 +203,7 @@ namespace BlockMatrixIterators
    * Block matrix accessor for constant matrices, implementing the stepping
    * through a matrix.
    */
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   class Accessor<BlockMatrixType, true> : public AccessorBase<BlockMatrixType>
   {
   public:
@@ -401,7 +401,7 @@ public:
    *
    * The function returns a reference to <tt>this</tt>.
    */
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   BlockMatrixBase &
   copy_from(const BlockMatrixType &source);
 
@@ -1083,14 +1083,14 @@ private:
 
 namespace BlockMatrixIterators
 {
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline AccessorBase<BlockMatrixType>::AccessorBase()
     : row_block(0)
     , col_block(0)
   {}
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline unsigned int
   AccessorBase<BlockMatrixType>::block_row() const
   {
@@ -1100,7 +1100,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline unsigned int
   AccessorBase<BlockMatrixType>::block_column() const
   {
@@ -1110,7 +1110,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline Accessor<BlockMatrixType, true>::Accessor(
     const BlockMatrixType *matrix,
     const size_type        row,
@@ -1161,7 +1161,7 @@ namespace BlockMatrixIterators
   }
 
 
-  //   template <class BlockMatrixType>
+  //   template <typename BlockMatrixType>
   //   inline
   //   Accessor<BlockMatrixType, true>::Accessor (const
   //   Accessor<BlockMatrixType, true>& other)
@@ -1174,7 +1174,7 @@ namespace BlockMatrixIterators
   //   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline Accessor<BlockMatrixType, true>::Accessor(
     const Accessor<BlockMatrixType, false> &other)
     : matrix(other.matrix)
@@ -1185,7 +1185,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, true>::size_type
   Accessor<BlockMatrixType, true>::row() const
   {
@@ -1197,7 +1197,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, true>::size_type
   Accessor<BlockMatrixType, true>::column() const
   {
@@ -1209,7 +1209,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, true>::value_type
   Accessor<BlockMatrixType, true>::value() const
   {
@@ -1223,7 +1223,7 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline void
   Accessor<BlockMatrixType, true>::advance()
   {
@@ -1289,7 +1289,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline bool
   Accessor<BlockMatrixType, true>::operator==(const Accessor &a) const
   {
@@ -1311,7 +1311,7 @@ namespace BlockMatrixIterators
   //----------------------------------------------------------------------//
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline Accessor<BlockMatrixType, false>::Accessor(BlockMatrixType *matrix,
                                                     const size_type  row,
                                                     const size_type  col)
@@ -1360,7 +1360,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, false>::size_type
   Accessor<BlockMatrixType, false>::row() const
   {
@@ -1371,7 +1371,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, false>::size_type
   Accessor<BlockMatrixType, false>::column() const
   {
@@ -1382,7 +1382,7 @@ namespace BlockMatrixIterators
   }
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline typename Accessor<BlockMatrixType, false>::value_type
   Accessor<BlockMatrixType, false>::value() const
   {
@@ -1394,7 +1394,7 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline void
   Accessor<BlockMatrixType, false>::set_value(
     typename Accessor<BlockMatrixType, false>::value_type newval) const
@@ -1407,7 +1407,7 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline void
   Accessor<BlockMatrixType, false>::advance()
   {
@@ -1472,7 +1472,7 @@ namespace BlockMatrixIterators
 
 
 
-  template <class BlockMatrixType>
+  template <typename BlockMatrixType>
   inline bool
   Accessor<BlockMatrixType, false>::operator==(const Accessor &a) const
   {
@@ -1507,8 +1507,8 @@ inline BlockMatrixBase<MatrixType>::~BlockMatrixBase()
 }
 
 
-template <class MatrixType>
-template <class BlockMatrixType>
+template <typename MatrixType>
+template <typename BlockMatrixType>
 inline BlockMatrixBase<MatrixType> &
 BlockMatrixBase<MatrixType>::copy_from(const BlockMatrixType &source)
 {
@@ -1520,7 +1520,7 @@ BlockMatrixBase<MatrixType>::copy_from(const BlockMatrixType &source)
 }
 
 
-template <class MatrixType>
+template <typename MatrixType>
 std::size_t
 BlockMatrixBase<MatrixType>::memory_consumption() const
 {
@@ -1545,7 +1545,7 @@ BlockMatrixBase<MatrixType>::memory_consumption() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::clear()
 {
@@ -1564,7 +1564,7 @@ BlockMatrixBase<MatrixType>::clear()
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::BlockType &
 BlockMatrixBase<MatrixType>::block(const unsigned int row,
                                    const unsigned int column)
@@ -1577,7 +1577,7 @@ BlockMatrixBase<MatrixType>::block(const unsigned int row,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline const typename BlockMatrixBase<MatrixType>::BlockType &
 BlockMatrixBase<MatrixType>::block(const unsigned int row,
                                    const unsigned int column) const
@@ -1589,7 +1589,7 @@ BlockMatrixBase<MatrixType>::block(const unsigned int row,
 }
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::m() const
 {
@@ -1598,7 +1598,7 @@ BlockMatrixBase<MatrixType>::m() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::size_type
 BlockMatrixBase<MatrixType>::n() const
 {
@@ -1607,7 +1607,7 @@ BlockMatrixBase<MatrixType>::n() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline unsigned int
 BlockMatrixBase<MatrixType>::n_block_cols() const
 {
@@ -1616,7 +1616,7 @@ BlockMatrixBase<MatrixType>::n_block_cols() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline unsigned int
 BlockMatrixBase<MatrixType>::n_block_rows() const
 {
@@ -1628,7 +1628,7 @@ BlockMatrixBase<MatrixType>::n_block_rows() const
 // Write the single set manually,
 // since the other function has a lot
 // of overhead in that case.
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::set(const size_type  i,
                                  const size_type  j,
@@ -1647,7 +1647,7 @@ BlockMatrixBase<MatrixType>::set(const size_type  i,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::set(const std::vector<size_type> &row_indices,
@@ -1670,7 +1670,7 @@ BlockMatrixBase<MatrixType>::set(const std::vector<size_type> &row_indices,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::set(const std::vector<size_type> &indices,
@@ -1691,7 +1691,7 @@ BlockMatrixBase<MatrixType>::set(const std::vector<size_type> &indices,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::set(const size_type               row,
@@ -1714,7 +1714,7 @@ BlockMatrixBase<MatrixType>::set(const size_type               row,
 // This is a very messy function, since
 // we need to calculate to each position
 // the location in the global array.
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::set(const size_type  row,
@@ -1820,7 +1820,7 @@ BlockMatrixBase<MatrixType>::set(const size_type  row,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::add(const size_type  i,
                                  const size_type  j,
@@ -1847,7 +1847,7 @@ BlockMatrixBase<MatrixType>::add(const size_type  i,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::add(const std::vector<size_type> &row_indices,
@@ -1870,7 +1870,7 @@ BlockMatrixBase<MatrixType>::add(const std::vector<size_type> &row_indices,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::add(const std::vector<size_type> &indices,
@@ -1891,7 +1891,7 @@ BlockMatrixBase<MatrixType>::add(const std::vector<size_type> &indices,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::add(const size_type               row,
@@ -1914,7 +1914,7 @@ BlockMatrixBase<MatrixType>::add(const size_type               row,
 // This is a very messy function, since
 // we need to calculate to each position
 // the location in the global array.
-template <class MatrixType>
+template <typename MatrixType>
 template <typename number>
 inline void
 BlockMatrixBase<MatrixType>::add(const size_type  row,
@@ -2077,7 +2077,7 @@ BlockMatrixBase<MatrixType>::add(const size_type  row,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::add(const value_type                   factor,
                                  const BlockMatrixBase<MatrixType> &matrix)
@@ -2102,7 +2102,7 @@ BlockMatrixBase<MatrixType>::add(const value_type                   factor,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::operator()(const size_type i,
                                         const size_type j) const
@@ -2116,7 +2116,7 @@ BlockMatrixBase<MatrixType>::operator()(const size_type i,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::el(const size_type i, const size_type j) const
 {
@@ -2129,7 +2129,7 @@ BlockMatrixBase<MatrixType>::el(const size_type i, const size_type j) const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::diag_element(const size_type i) const
 {
@@ -2142,7 +2142,7 @@ BlockMatrixBase<MatrixType>::diag_element(const size_type i) const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::compress(VectorOperation::values operation)
 {
@@ -2153,7 +2153,7 @@ BlockMatrixBase<MatrixType>::compress(VectorOperation::values operation)
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline BlockMatrixBase<MatrixType> &
 BlockMatrixBase<MatrixType>::operator*=(const value_type factor)
 {
@@ -2169,7 +2169,7 @@ BlockMatrixBase<MatrixType>::operator*=(const value_type factor)
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline BlockMatrixBase<MatrixType> &
 BlockMatrixBase<MatrixType>::operator/=(const value_type factor)
 {
@@ -2188,7 +2188,7 @@ BlockMatrixBase<MatrixType>::operator/=(const value_type factor)
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 const BlockIndices &
 BlockMatrixBase<MatrixType>::get_row_indices() const
 {
@@ -2197,7 +2197,7 @@ BlockMatrixBase<MatrixType>::get_row_indices() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 const BlockIndices &
 BlockMatrixBase<MatrixType>::get_column_indices() const
 {
@@ -2206,7 +2206,7 @@ BlockMatrixBase<MatrixType>::get_column_indices() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_block_block(BlockVectorType &      dst,
@@ -2227,7 +2227,7 @@ BlockMatrixBase<MatrixType>::vmult_block_block(BlockVectorType &      dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_nonblock_block(
@@ -2245,7 +2245,7 @@ BlockMatrixBase<MatrixType>::vmult_nonblock_block(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_block_nonblock(BlockVectorType & dst,
@@ -2261,7 +2261,7 @@ BlockMatrixBase<MatrixType>::vmult_block_nonblock(BlockVectorType & dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename VectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_nonblock_nonblock(
@@ -2276,7 +2276,7 @@ BlockMatrixBase<MatrixType>::vmult_nonblock_nonblock(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::vmult_add(BlockVectorType &      dst,
@@ -2294,7 +2294,7 @@ BlockMatrixBase<MatrixType>::vmult_add(BlockVectorType &      dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_block_block(
@@ -2317,7 +2317,7 @@ BlockMatrixBase<MatrixType>::Tvmult_block_block(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_block_nonblock(BlockVectorType & dst,
@@ -2335,7 +2335,7 @@ BlockMatrixBase<MatrixType>::Tvmult_block_nonblock(BlockVectorType & dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType, typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_nonblock_block(
@@ -2354,7 +2354,7 @@ BlockMatrixBase<MatrixType>::Tvmult_nonblock_block(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename VectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_nonblock_nonblock(
@@ -2369,7 +2369,7 @@ BlockMatrixBase<MatrixType>::Tvmult_nonblock_nonblock(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 void
 BlockMatrixBase<MatrixType>::Tvmult_add(BlockVectorType &      dst,
@@ -2387,7 +2387,7 @@ BlockMatrixBase<MatrixType>::Tvmult_add(BlockVectorType &      dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::matrix_norm_square(const BlockVectorType &v) const
@@ -2409,7 +2409,7 @@ BlockMatrixBase<MatrixType>::matrix_norm_square(const BlockVectorType &v) const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 typename BlockMatrixBase<MatrixType>::real_type
 BlockMatrixBase<MatrixType>::frobenius_norm() const
 {
@@ -2431,7 +2431,7 @@ BlockMatrixBase<MatrixType>::frobenius_norm() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::matrix_scalar_product(
@@ -2453,7 +2453,7 @@ BlockMatrixBase<MatrixType>::matrix_scalar_product(
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 template <typename BlockVectorType>
 typename BlockMatrixBase<MatrixType>::value_type
 BlockMatrixBase<MatrixType>::residual(BlockVectorType &      dst,
@@ -2502,7 +2502,7 @@ BlockMatrixBase<MatrixType>::residual(BlockVectorType &      dst,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline void
 BlockMatrixBase<MatrixType>::print(std::ostream &out,
                                    const bool    alternative_output) const
@@ -2519,7 +2519,7 @@ BlockMatrixBase<MatrixType>::print(std::ostream &out,
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::const_iterator
 BlockMatrixBase<MatrixType>::begin() const
 {
@@ -2528,7 +2528,7 @@ BlockMatrixBase<MatrixType>::begin() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::const_iterator
 BlockMatrixBase<MatrixType>::end() const
 {
@@ -2537,7 +2537,7 @@ BlockMatrixBase<MatrixType>::end() const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::const_iterator
 BlockMatrixBase<MatrixType>::begin(const size_type r) const
 {
@@ -2547,7 +2547,7 @@ BlockMatrixBase<MatrixType>::begin(const size_type r) const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::const_iterator
 BlockMatrixBase<MatrixType>::end(const size_type r) const
 {
@@ -2557,7 +2557,7 @@ BlockMatrixBase<MatrixType>::end(const size_type r) const
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::iterator
 BlockMatrixBase<MatrixType>::begin()
 {
@@ -2566,7 +2566,7 @@ BlockMatrixBase<MatrixType>::begin()
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::iterator
 BlockMatrixBase<MatrixType>::end()
 {
@@ -2575,7 +2575,7 @@ BlockMatrixBase<MatrixType>::end()
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::iterator
 BlockMatrixBase<MatrixType>::begin(const size_type r)
 {
@@ -2585,7 +2585,7 @@ BlockMatrixBase<MatrixType>::begin(const size_type r)
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 inline typename BlockMatrixBase<MatrixType>::iterator
 BlockMatrixBase<MatrixType>::end(const size_type r)
 {
@@ -2595,7 +2595,7 @@ BlockMatrixBase<MatrixType>::end(const size_type r)
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 void
 BlockMatrixBase<MatrixType>::collect_sizes()
 {
@@ -2634,7 +2634,7 @@ BlockMatrixBase<MatrixType>::collect_sizes()
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 void
 BlockMatrixBase<MatrixType>::prepare_add_operation()
 {
@@ -2645,7 +2645,7 @@ BlockMatrixBase<MatrixType>::prepare_add_operation()
 
 
 
-template <class MatrixType>
+template <typename MatrixType>
 void
 BlockMatrixBase<MatrixType>::prepare_set_operation()
 {
index 168f35a9b905452a47fec670aaff21590b67da3c..82513b26916e9e0995400d68ae1551d81357f5c1 100644 (file)
@@ -170,7 +170,7 @@ namespace PETScWrappers
    * methods:
    *
    * @code
-   * typename VectorType : public Subscriptor
+   * class VectorType : public Subscriptor
    *    ...
    *    explicit VectorType(Vec);
    *    ...
index 915f6e5f936a78dfe28cdaef65d9d855db42c10a..92a088b3094da86bb23e09d4dde3c7810174ae59 100644 (file)
@@ -228,7 +228,7 @@ namespace PETScWrappers
    * methods:
    *
    * @code
-   * typename VectorType : public Subscriptor
+   * class VectorType : public Subscriptor
    *    ...
    *    explicit VectorType(Vec);
    *    ...
index 553ad3bb249dbedc3b923111c20297d51902b9d9..514d1c0f6f28cac918e14ab1c425fbbe1416406f 100644 (file)
@@ -89,7 +89,7 @@ private:
  */
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 class MGCoarseGridIterativeSolver : public MGCoarseGridBase<VectorType>
 {
@@ -290,7 +290,7 @@ MGCoarseGridApplySmoother<VectorType>::operator()(const unsigned int level,
 
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 MGCoarseGridIterativeSolver<VectorType,
                             SolverType,
@@ -305,7 +305,7 @@ MGCoarseGridIterativeSolver<VectorType,
 
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 MGCoarseGridIterativeSolver<VectorType,
                             SolverType,
@@ -323,7 +323,7 @@ MGCoarseGridIterativeSolver<VectorType,
 
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 void
 MGCoarseGridIterativeSolver<
@@ -343,7 +343,7 @@ MGCoarseGridIterativeSolver<
 
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 void
 MGCoarseGridIterativeSolver<VectorType,
@@ -365,7 +365,7 @@ namespace internal
     template <
       typename VectorType,
       class SolverType,
-      class MatrixType,
+      typename MatrixType,
       class PreconditionerType,
       std::enable_if_t<
         std::is_same<VectorType, typename SolverType::vector_type>::value,
@@ -383,7 +383,7 @@ namespace internal
     template <
       typename VectorType,
       class SolverType,
-      class MatrixType,
+      typename MatrixType,
       class PreconditionerType,
       std::enable_if_t<
         !std::is_same<VectorType, typename SolverType::vector_type>::value,
@@ -412,7 +412,7 @@ namespace internal
 
 template <typename VectorType,
           class SolverType,
-          class MatrixType,
+          typename MatrixType,
           class PreconditionerType>
 void
                        MGCoarseGridIterativeSolver<

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.