From: Wolfgang Bangerth Date: Sun, 2 Jul 2023 02:34:04 +0000 (-0600) Subject: Standardize on 'typename MatrixType'. X-Git-Tag: relicensing~799^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e5e01eed1d647d6f4a58af00e1c7a92b4f4c59d9;p=dealii.git Standardize on 'typename MatrixType'. --- diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 01c4f6b890..06db33dc96 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -59,7 +59,7 @@ namespace BlockMatrixIterators * Base class for block matrix accessors, implementing the stepping through * a matrix. */ - template + template class AccessorBase { public: @@ -111,14 +111,14 @@ namespace BlockMatrixIterators /** * Accessor classes in block matrices. */ - template + template class Accessor; /** * Block matrix accessor for non const matrices. */ - template + template class Accessor : public AccessorBase { public: @@ -203,7 +203,7 @@ namespace BlockMatrixIterators * Block matrix accessor for constant matrices, implementing the stepping * through a matrix. */ - template + template class Accessor : public AccessorBase { public: @@ -401,7 +401,7 @@ public: * * The function returns a reference to this. */ - template + template BlockMatrixBase & copy_from(const BlockMatrixType &source); @@ -1083,14 +1083,14 @@ private: namespace BlockMatrixIterators { - template + template inline AccessorBase::AccessorBase() : row_block(0) , col_block(0) {} - template + template inline unsigned int AccessorBase::block_row() const { @@ -1100,7 +1100,7 @@ namespace BlockMatrixIterators } - template + template inline unsigned int AccessorBase::block_column() const { @@ -1110,7 +1110,7 @@ namespace BlockMatrixIterators } - template + template inline Accessor::Accessor( const BlockMatrixType *matrix, const size_type row, @@ -1161,7 +1161,7 @@ namespace BlockMatrixIterators } - // template + // template // inline // Accessor::Accessor (const // Accessor& other) @@ -1174,7 +1174,7 @@ namespace BlockMatrixIterators // } - template + template inline Accessor::Accessor( const Accessor &other) : matrix(other.matrix) @@ -1185,7 +1185,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::size_type Accessor::row() const { @@ -1197,7 +1197,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::size_type Accessor::column() const { @@ -1209,7 +1209,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::value_type Accessor::value() const { @@ -1223,7 +1223,7 @@ namespace BlockMatrixIterators - template + template inline void Accessor::advance() { @@ -1289,7 +1289,7 @@ namespace BlockMatrixIterators } - template + template inline bool Accessor::operator==(const Accessor &a) const { @@ -1311,7 +1311,7 @@ namespace BlockMatrixIterators //----------------------------------------------------------------------// - template + template inline Accessor::Accessor(BlockMatrixType *matrix, const size_type row, const size_type col) @@ -1360,7 +1360,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::size_type Accessor::row() const { @@ -1371,7 +1371,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::size_type Accessor::column() const { @@ -1382,7 +1382,7 @@ namespace BlockMatrixIterators } - template + template inline typename Accessor::value_type Accessor::value() const { @@ -1394,7 +1394,7 @@ namespace BlockMatrixIterators - template + template inline void Accessor::set_value( typename Accessor::value_type newval) const @@ -1407,7 +1407,7 @@ namespace BlockMatrixIterators - template + template inline void Accessor::advance() { @@ -1472,7 +1472,7 @@ namespace BlockMatrixIterators - template + template inline bool Accessor::operator==(const Accessor &a) const { @@ -1507,8 +1507,8 @@ inline BlockMatrixBase::~BlockMatrixBase() } -template -template +template +template inline BlockMatrixBase & BlockMatrixBase::copy_from(const BlockMatrixType &source) { @@ -1520,7 +1520,7 @@ BlockMatrixBase::copy_from(const BlockMatrixType &source) } -template +template std::size_t BlockMatrixBase::memory_consumption() const { @@ -1545,7 +1545,7 @@ BlockMatrixBase::memory_consumption() const -template +template inline void BlockMatrixBase::clear() { @@ -1564,7 +1564,7 @@ BlockMatrixBase::clear() -template +template inline typename BlockMatrixBase::BlockType & BlockMatrixBase::block(const unsigned int row, const unsigned int column) @@ -1577,7 +1577,7 @@ BlockMatrixBase::block(const unsigned int row, -template +template inline const typename BlockMatrixBase::BlockType & BlockMatrixBase::block(const unsigned int row, const unsigned int column) const @@ -1589,7 +1589,7 @@ BlockMatrixBase::block(const unsigned int row, } -template +template inline typename BlockMatrixBase::size_type BlockMatrixBase::m() const { @@ -1598,7 +1598,7 @@ BlockMatrixBase::m() const -template +template inline typename BlockMatrixBase::size_type BlockMatrixBase::n() const { @@ -1607,7 +1607,7 @@ BlockMatrixBase::n() const -template +template inline unsigned int BlockMatrixBase::n_block_cols() const { @@ -1616,7 +1616,7 @@ BlockMatrixBase::n_block_cols() const -template +template inline unsigned int BlockMatrixBase::n_block_rows() const { @@ -1628,7 +1628,7 @@ BlockMatrixBase::n_block_rows() const // Write the single set manually, // since the other function has a lot // of overhead in that case. -template +template inline void BlockMatrixBase::set(const size_type i, const size_type j, @@ -1647,7 +1647,7 @@ BlockMatrixBase::set(const size_type i, -template +template template inline void BlockMatrixBase::set(const std::vector &row_indices, @@ -1670,7 +1670,7 @@ BlockMatrixBase::set(const std::vector &row_indices, -template +template template inline void BlockMatrixBase::set(const std::vector &indices, @@ -1691,7 +1691,7 @@ BlockMatrixBase::set(const std::vector &indices, -template +template template inline void BlockMatrixBase::set(const size_type row, @@ -1714,7 +1714,7 @@ BlockMatrixBase::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 +template template inline void BlockMatrixBase::set(const size_type row, @@ -1820,7 +1820,7 @@ BlockMatrixBase::set(const size_type row, -template +template inline void BlockMatrixBase::add(const size_type i, const size_type j, @@ -1847,7 +1847,7 @@ BlockMatrixBase::add(const size_type i, -template +template template inline void BlockMatrixBase::add(const std::vector &row_indices, @@ -1870,7 +1870,7 @@ BlockMatrixBase::add(const std::vector &row_indices, -template +template template inline void BlockMatrixBase::add(const std::vector &indices, @@ -1891,7 +1891,7 @@ BlockMatrixBase::add(const std::vector &indices, -template +template template inline void BlockMatrixBase::add(const size_type row, @@ -1914,7 +1914,7 @@ BlockMatrixBase::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 +template template inline void BlockMatrixBase::add(const size_type row, @@ -2077,7 +2077,7 @@ BlockMatrixBase::add(const size_type row, -template +template inline void BlockMatrixBase::add(const value_type factor, const BlockMatrixBase &matrix) @@ -2102,7 +2102,7 @@ BlockMatrixBase::add(const value_type factor, -template +template inline typename BlockMatrixBase::value_type BlockMatrixBase::operator()(const size_type i, const size_type j) const @@ -2116,7 +2116,7 @@ BlockMatrixBase::operator()(const size_type i, -template +template inline typename BlockMatrixBase::value_type BlockMatrixBase::el(const size_type i, const size_type j) const { @@ -2129,7 +2129,7 @@ BlockMatrixBase::el(const size_type i, const size_type j) const -template +template inline typename BlockMatrixBase::value_type BlockMatrixBase::diag_element(const size_type i) const { @@ -2142,7 +2142,7 @@ BlockMatrixBase::diag_element(const size_type i) const -template +template inline void BlockMatrixBase::compress(VectorOperation::values operation) { @@ -2153,7 +2153,7 @@ BlockMatrixBase::compress(VectorOperation::values operation) -template +template inline BlockMatrixBase & BlockMatrixBase::operator*=(const value_type factor) { @@ -2169,7 +2169,7 @@ BlockMatrixBase::operator*=(const value_type factor) -template +template inline BlockMatrixBase & BlockMatrixBase::operator/=(const value_type factor) { @@ -2188,7 +2188,7 @@ BlockMatrixBase::operator/=(const value_type factor) -template +template const BlockIndices & BlockMatrixBase::get_row_indices() const { @@ -2197,7 +2197,7 @@ BlockMatrixBase::get_row_indices() const -template +template const BlockIndices & BlockMatrixBase::get_column_indices() const { @@ -2206,7 +2206,7 @@ BlockMatrixBase::get_column_indices() const -template +template template void BlockMatrixBase::vmult_block_block(BlockVectorType & dst, @@ -2227,7 +2227,7 @@ BlockMatrixBase::vmult_block_block(BlockVectorType & dst, -template +template template void BlockMatrixBase::vmult_nonblock_block( @@ -2245,7 +2245,7 @@ BlockMatrixBase::vmult_nonblock_block( -template +template template void BlockMatrixBase::vmult_block_nonblock(BlockVectorType & dst, @@ -2261,7 +2261,7 @@ BlockMatrixBase::vmult_block_nonblock(BlockVectorType & dst, -template +template template void BlockMatrixBase::vmult_nonblock_nonblock( @@ -2276,7 +2276,7 @@ BlockMatrixBase::vmult_nonblock_nonblock( -template +template template void BlockMatrixBase::vmult_add(BlockVectorType & dst, @@ -2294,7 +2294,7 @@ BlockMatrixBase::vmult_add(BlockVectorType & dst, -template +template template void BlockMatrixBase::Tvmult_block_block( @@ -2317,7 +2317,7 @@ BlockMatrixBase::Tvmult_block_block( -template +template template void BlockMatrixBase::Tvmult_block_nonblock(BlockVectorType & dst, @@ -2335,7 +2335,7 @@ BlockMatrixBase::Tvmult_block_nonblock(BlockVectorType & dst, -template +template template void BlockMatrixBase::Tvmult_nonblock_block( @@ -2354,7 +2354,7 @@ BlockMatrixBase::Tvmult_nonblock_block( -template +template template void BlockMatrixBase::Tvmult_nonblock_nonblock( @@ -2369,7 +2369,7 @@ BlockMatrixBase::Tvmult_nonblock_nonblock( -template +template template void BlockMatrixBase::Tvmult_add(BlockVectorType & dst, @@ -2387,7 +2387,7 @@ BlockMatrixBase::Tvmult_add(BlockVectorType & dst, -template +template template typename BlockMatrixBase::value_type BlockMatrixBase::matrix_norm_square(const BlockVectorType &v) const @@ -2409,7 +2409,7 @@ BlockMatrixBase::matrix_norm_square(const BlockVectorType &v) const -template +template typename BlockMatrixBase::real_type BlockMatrixBase::frobenius_norm() const { @@ -2431,7 +2431,7 @@ BlockMatrixBase::frobenius_norm() const -template +template template typename BlockMatrixBase::value_type BlockMatrixBase::matrix_scalar_product( @@ -2453,7 +2453,7 @@ BlockMatrixBase::matrix_scalar_product( -template +template template typename BlockMatrixBase::value_type BlockMatrixBase::residual(BlockVectorType & dst, @@ -2502,7 +2502,7 @@ BlockMatrixBase::residual(BlockVectorType & dst, -template +template inline void BlockMatrixBase::print(std::ostream &out, const bool alternative_output) const @@ -2519,7 +2519,7 @@ BlockMatrixBase::print(std::ostream &out, -template +template inline typename BlockMatrixBase::const_iterator BlockMatrixBase::begin() const { @@ -2528,7 +2528,7 @@ BlockMatrixBase::begin() const -template +template inline typename BlockMatrixBase::const_iterator BlockMatrixBase::end() const { @@ -2537,7 +2537,7 @@ BlockMatrixBase::end() const -template +template inline typename BlockMatrixBase::const_iterator BlockMatrixBase::begin(const size_type r) const { @@ -2547,7 +2547,7 @@ BlockMatrixBase::begin(const size_type r) const -template +template inline typename BlockMatrixBase::const_iterator BlockMatrixBase::end(const size_type r) const { @@ -2557,7 +2557,7 @@ BlockMatrixBase::end(const size_type r) const -template +template inline typename BlockMatrixBase::iterator BlockMatrixBase::begin() { @@ -2566,7 +2566,7 @@ BlockMatrixBase::begin() -template +template inline typename BlockMatrixBase::iterator BlockMatrixBase::end() { @@ -2575,7 +2575,7 @@ BlockMatrixBase::end() -template +template inline typename BlockMatrixBase::iterator BlockMatrixBase::begin(const size_type r) { @@ -2585,7 +2585,7 @@ BlockMatrixBase::begin(const size_type r) -template +template inline typename BlockMatrixBase::iterator BlockMatrixBase::end(const size_type r) { @@ -2595,7 +2595,7 @@ BlockMatrixBase::end(const size_type r) -template +template void BlockMatrixBase::collect_sizes() { @@ -2634,7 +2634,7 @@ BlockMatrixBase::collect_sizes() -template +template void BlockMatrixBase::prepare_add_operation() { @@ -2645,7 +2645,7 @@ BlockMatrixBase::prepare_add_operation() -template +template void BlockMatrixBase::prepare_set_operation() { diff --git a/include/deal.II/lac/petsc_snes.h b/include/deal.II/lac/petsc_snes.h index 168f35a9b9..82513b2691 100644 --- a/include/deal.II/lac/petsc_snes.h +++ b/include/deal.II/lac/petsc_snes.h @@ -170,7 +170,7 @@ namespace PETScWrappers * methods: * * @code - * typename VectorType : public Subscriptor + * class VectorType : public Subscriptor * ... * explicit VectorType(Vec); * ... diff --git a/include/deal.II/lac/petsc_ts.h b/include/deal.II/lac/petsc_ts.h index 915f6e5f93..92a088b309 100644 --- a/include/deal.II/lac/petsc_ts.h +++ b/include/deal.II/lac/petsc_ts.h @@ -228,7 +228,7 @@ namespace PETScWrappers * methods: * * @code - * typename VectorType : public Subscriptor + * class VectorType : public Subscriptor * ... * explicit VectorType(Vec); * ... diff --git a/include/deal.II/multigrid/mg_coarse.h b/include/deal.II/multigrid/mg_coarse.h index 553ad3bb24..514d1c0f6f 100644 --- a/include/deal.II/multigrid/mg_coarse.h +++ b/include/deal.II/multigrid/mg_coarse.h @@ -89,7 +89,7 @@ private: */ template class MGCoarseGridIterativeSolver : public MGCoarseGridBase { @@ -290,7 +290,7 @@ MGCoarseGridApplySmoother::operator()(const unsigned int level, template MGCoarseGridIterativeSolver MGCoarseGridIterativeSolver void MGCoarseGridIterativeSolver< @@ -343,7 +343,7 @@ MGCoarseGridIterativeSolver< template void MGCoarseGridIterativeSolver::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::value, @@ -412,7 +412,7 @@ namespace internal template void MGCoarseGridIterativeSolver<