From e3ce2648dc2e5eb1702822b09e83aa144535c907 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sat, 1 Jul 2023 20:32:49 -0600 Subject: [PATCH] Standardize on 'typename VectorType'. --- .../fe/fe_tools_extrapolate.templates.h | 10 +- include/deal.II/lac/affine_constraints.h | 28 +-- .../lac/affine_constraints.templates.h | 22 +-- include/deal.II/lac/block_matrix_base.h | 52 +++--- include/deal.II/lac/block_sparse_matrix.h | 4 +- include/deal.II/lac/block_vector_base.h | 160 +++++++++--------- include/deal.II/lac/eigen.h | 8 +- include/deal.II/lac/householder.h | 8 +- include/deal.II/lac/matrix_block.h | 16 +- include/deal.II/lac/petsc_snes.h | 2 +- include/deal.II/lac/petsc_ts.h | 2 +- include/deal.II/lac/precondition.h | 58 +++---- include/deal.II/lac/qr.h | 4 +- .../deal.II/lac/relaxation_block.templates.h | 2 +- include/deal.II/lac/solver.h | 12 +- include/deal.II/lac/solver_gmres.h | 60 +++---- include/deal.II/lac/solver_idr.h | 16 +- include/deal.II/lac/solver_minres.h | 12 +- include/deal.II/lac/solver_qmrs.h | 12 +- include/deal.II/lac/solver_relaxation.h | 4 +- include/deal.II/lac/solver_richardson.h | 18 +- include/deal.II/lac/trilinos_solver.h | 4 +- include/deal.II/matrix_free/type_traits.h | 6 +- include/deal.II/multigrid/mg_coarse.h | 44 ++--- include/deal.II/non_matching/fe_values.h | 8 +- .../deal.II/non_matching/mesh_classifier.h | 2 +- .../non_matching/quadrature_generator.h | 4 +- include/deal.II/numerics/data_out_dof_data.h | 18 +- .../numerics/data_out_dof_data.templates.h | 4 +- .../deal.II/numerics/dof_print_solver_step.h | 6 +- .../deal.II/numerics/point_value_history.h | 8 +- .../numerics/vector_tools_mean_value.h | 2 +- .../vector_tools_mean_value.templates.h | 2 +- include/deal.II/optimization/solver_bfgs.h | 4 +- include/deal.II/particles/particle_handler.h | 8 +- source/fe/mapping_q1_eulerian.cc | 10 +- source/fe/mapping_q_eulerian.cc | 12 +- source/non_matching/fe_values.cc | 8 +- source/non_matching/mesh_classifier.cc | 14 +- source/non_matching/quadrature_generator.cc | 18 +- 40 files changed, 346 insertions(+), 346 deletions(-) diff --git a/include/deal.II/fe/fe_tools_extrapolate.templates.h b/include/deal.II/fe/fe_tools_extrapolate.templates.h index 5b3ff3b54a..02a4a3131a 100644 --- a/include/deal.II/fe/fe_tools_extrapolate.templates.h +++ b/include/deal.II/fe/fe_tools_extrapolate.templates.h @@ -1458,23 +1458,23 @@ namespace FETools } #endif // DEAL_II_WITH_P4EST - template + template struct BlockTypeHelper { using type = VectorType; }; - template + template struct BlockTypeHelper::value>> { using type = typename VectorType::BlockType; }; - template + template using BlockType = typename BlockTypeHelper::type; - template + template void reinit_distributed(const DH &dh, VectorType &vector) { @@ -1568,7 +1568,7 @@ namespace FETools - template + template void reinit_ghosted(const DH & /*dh*/, VectorType & /*vector*/) { diff --git a/include/deal.II/lac/affine_constraints.h b/include/deal.II/lac/affine_constraints.h index 2eed5643f0..874e29d9c7 100644 --- a/include/deal.II/lac/affine_constraints.h +++ b/include/deal.II/lac/affine_constraints.h @@ -410,7 +410,7 @@ namespace internal { namespace AffineConstraintsImplementation { - template + template void set_zero_all(const std::vector &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 + template 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 + template 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 + template void condense(SparseMatrix &matrix, VectorType &vector) const; @@ -1123,7 +1123,7 @@ public: * Same function as above, but condenses square block sparse matrices and * vectors. */ - template + template void condense(BlockSparseMatrix &matrix, BlockVectorType &vector) const; @@ -1133,7 +1133,7 @@ public: * BlockVector<...>, a PETSc or Trilinos vector wrapper class, or * any other type having the same interface. */ - template + template void set_zero(VectorType &vec) const; @@ -1284,7 +1284,7 @@ public: /** * Enter a single value into a result vector, obeying constraints. */ - template + template void distribute_local_to_global(const size_type index, const number value, @@ -1324,7 +1324,7 @@ public: */ template + typename VectorType> void distribute_local_to_global(ForwardIteratorVec local_vector_begin, ForwardIteratorVec local_vector_end, @@ -1580,7 +1580,7 @@ public: */ template + 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 + template void distribute(VectorType &vec) const; @@ -2136,7 +2136,7 @@ AffineConstraints::set_inhomogeneity( template -template +template inline void AffineConstraints::set_zero(VectorType &vec) const { @@ -2268,7 +2268,7 @@ AffineConstraints::get_local_lines() const } template -template +template inline void AffineConstraints::distribute_local_to_global( const size_type index, @@ -2292,7 +2292,7 @@ AffineConstraints::distribute_local_to_global( template template + typename VectorType> inline void AffineConstraints::distribute_local_to_global( ForwardIteratorVec local_vector_begin, @@ -2340,7 +2340,7 @@ AffineConstraints::distribute_local_to_global( template template + typename VectorType> inline void AffineConstraints::get_dof_values( const VectorType & global_vector, diff --git a/include/deal.II/lac/affine_constraints.templates.h b/include/deal.II/lac/affine_constraints.templates.h index da30239ef1..523dd85f52 100644 --- a/include/deal.II/lac/affine_constraints.templates.h +++ b/include/deal.II/lac/affine_constraints.templates.h @@ -1761,7 +1761,7 @@ AffineConstraints::condense( template -template +template void AffineConstraints::condense(const VectorType &vec_ghosted, VectorType & vec) const @@ -1806,7 +1806,7 @@ AffineConstraints::condense(const VectorType &vec_ghosted, template -template +template void AffineConstraints::condense(VectorType &vec) const { @@ -1816,7 +1816,7 @@ AffineConstraints::condense(VectorType &vec) const template -template +template void AffineConstraints::condense(SparseMatrix &uncondensed, VectorType & vec) const @@ -1989,7 +1989,7 @@ AffineConstraints::condense(SparseMatrix &uncondensed, template -template +template void AffineConstraints::condense(BlockSparseMatrix &uncondensed, BlockVectorType & vec) const @@ -2185,7 +2185,7 @@ namespace internal { using size_type = types::global_dof_index; - template + template void set_zero_parallel(const std::vector &cm, VectorType & vec, @@ -2272,7 +2272,7 @@ namespace internal vec.zero_out_ghost_values(); } - template + template void set_zero_in_parallel(const std::vector &cm, VectorType & vec, @@ -2282,7 +2282,7 @@ namespace internal } // in parallel for BlockVectors - template + template void set_zero_in_parallel(const std::vector &cm, VectorType & vec, @@ -2296,7 +2296,7 @@ namespace internal } } - template + template void set_zero_serial(const std::vector &cm, VectorType &vec) { @@ -2304,7 +2304,7 @@ namespace internal vec(index) = 0.; } - template + template void set_zero_all(const std::vector &cm, VectorType &vec) { @@ -2535,7 +2535,7 @@ namespace internal } // for block vectors, simply dispatch to the individual blocks - template + template void import_vector_with_ghost_elements( const VectorType &vec, @@ -2565,7 +2565,7 @@ namespace internal } // namespace internal template -template +template void AffineConstraints::distribute(VectorType &vec) const { diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index cd3abd476a..01c4f6b890 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -671,7 +671,7 @@ public: * Adding Matrix-vector multiplication. Add $M*src$ on $dst$ with $M$ being * this matrix. */ - template + template void vmult_add(BlockVectorType &dst, const BlockVectorType &src) const; @@ -680,7 +680,7 @@ public: * dst with M being this matrix. This function does the same * as vmult_add() but takes the transposed matrix. */ - template + template 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 + template value_type matrix_norm_square(const BlockVectorType &v) const; @@ -710,7 +710,7 @@ public: /** * Compute the matrix scalar product $\left(u,Mv\right)$. */ - template + template value_type matrix_scalar_product(const BlockVectorType &u, const BlockVectorType &v) const; @@ -718,7 +718,7 @@ public: /** * Compute the residual r=b-Ax. Write the residual into dst. */ - template + template 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 + template 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 + template 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 + template 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 + template 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 + template 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 + template 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 + template 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 + template void Tvmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const; @@ -2207,7 +2207,7 @@ BlockMatrixBase::get_column_indices() const template -template +template void BlockMatrixBase::vmult_block_block(BlockVectorType & dst, const BlockVectorType &src) const @@ -2228,7 +2228,7 @@ BlockMatrixBase::vmult_block_block(BlockVectorType & dst, template -template +template void BlockMatrixBase::vmult_nonblock_block( VectorType & dst, @@ -2246,7 +2246,7 @@ BlockMatrixBase::vmult_nonblock_block( template -template +template void BlockMatrixBase::vmult_block_nonblock(BlockVectorType & dst, const VectorType &src) const @@ -2262,7 +2262,7 @@ BlockMatrixBase::vmult_block_nonblock(BlockVectorType & dst, template -template +template void BlockMatrixBase::vmult_nonblock_nonblock( VectorType & dst, @@ -2277,7 +2277,7 @@ BlockMatrixBase::vmult_nonblock_nonblock( template -template +template void BlockMatrixBase::vmult_add(BlockVectorType & dst, const BlockVectorType &src) const @@ -2295,7 +2295,7 @@ BlockMatrixBase::vmult_add(BlockVectorType & dst, template -template +template void BlockMatrixBase::Tvmult_block_block( BlockVectorType & dst, @@ -2318,7 +2318,7 @@ BlockMatrixBase::Tvmult_block_block( template -template +template void BlockMatrixBase::Tvmult_block_nonblock(BlockVectorType & dst, const VectorType &src) const @@ -2336,7 +2336,7 @@ BlockMatrixBase::Tvmult_block_nonblock(BlockVectorType & dst, template -template +template void BlockMatrixBase::Tvmult_nonblock_block( VectorType & dst, @@ -2355,7 +2355,7 @@ BlockMatrixBase::Tvmult_nonblock_block( template -template +template void BlockMatrixBase::Tvmult_nonblock_nonblock( VectorType & dst, @@ -2370,7 +2370,7 @@ BlockMatrixBase::Tvmult_nonblock_nonblock( template -template +template void BlockMatrixBase::Tvmult_add(BlockVectorType & dst, const BlockVectorType &src) const @@ -2388,7 +2388,7 @@ BlockMatrixBase::Tvmult_add(BlockVectorType & dst, template -template +template typename BlockMatrixBase::value_type BlockMatrixBase::matrix_norm_square(const BlockVectorType &v) const { @@ -2432,7 +2432,7 @@ BlockMatrixBase::frobenius_norm() const template -template +template typename BlockMatrixBase::value_type BlockMatrixBase::matrix_scalar_product( const BlockVectorType &u, @@ -2454,7 +2454,7 @@ BlockMatrixBase::matrix_scalar_product( template -template +template typename BlockMatrixBase::value_type BlockMatrixBase::residual(BlockVectorType & dst, const BlockVectorType &x, diff --git a/include/deal.II/lac/block_sparse_matrix.h b/include/deal.II/lac/block_sparse_matrix.h index 78bbe647e0..2e97f1fffc 100644 --- a/include/deal.II/lac/block_sparse_matrix.h +++ b/include/deal.II/lac/block_sparse_matrix.h @@ -297,7 +297,7 @@ public: * * All diagonal blocks must be square matrices for this operation. */ - template + template void precondition_Jacobi(BlockVectorType & dst, const BlockVectorType &src, @@ -479,7 +479,7 @@ BlockSparseMatrix::Tvmult(Vector & dst, template -template +template inline void BlockSparseMatrix::precondition_Jacobi(BlockVectorType & dst, const BlockVectorType &src, diff --git a/include/deal.II/lac/block_vector_base.h b/include/deal.II/lac/block_vector_base.h index 33a9c266c1..ef0b8aa64c 100644 --- a/include/deal.II/lac/block_vector_base.h +++ b/include/deal.II/lac/block_vector_base.h @@ -118,7 +118,7 @@ namespace internal * constant and we again have that the iterator satisfies the requirements * of a random access iterator. */ - template + template class Iterator { public: @@ -438,7 +438,7 @@ namespace internal * @see * @ref GlossBlockLA "Block (linear algebra)" */ -template +template class BlockVectorBase : public Subscriptor, public ReadVector { @@ -714,7 +714,7 @@ public: /** * Copy operator for template arguments of different types. */ - template + template BlockVectorBase & operator=(const BlockVectorBase &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 + template bool operator==(const BlockVectorBase &v) const; @@ -988,7 +988,7 @@ namespace internal { namespace BlockVectorIterators { - template + template inline Iterator::Iterator( const Iterator &c) : parent(c.parent) @@ -1001,7 +1001,7 @@ namespace internal - template + template inline Iterator::Iterator( const Iterator &c) : parent(c.parent) @@ -1021,7 +1021,7 @@ namespace internal - template + template inline Iterator::Iterator( BlockVector & parent, const size_type global_index, @@ -1039,7 +1039,7 @@ namespace internal - template + template inline Iterator & Iterator::operator=(const Iterator &c) { @@ -1055,7 +1055,7 @@ namespace internal - template + template inline typename Iterator::dereference_type Iterator::operator*() const { @@ -1064,7 +1064,7 @@ namespace internal - template + template inline typename Iterator::dereference_type Iterator::operator[]( const difference_type d) const @@ -1090,7 +1090,7 @@ namespace internal - template + template inline Iterator & Iterator::operator++() { @@ -1100,7 +1100,7 @@ namespace internal - template + template inline Iterator Iterator::operator++(int) { @@ -1111,7 +1111,7 @@ namespace internal - template + template inline Iterator & Iterator::operator--() { @@ -1121,7 +1121,7 @@ namespace internal - template + template inline Iterator Iterator::operator--(int) { @@ -1132,7 +1132,7 @@ namespace internal - template + template template inline bool Iterator::operator==( @@ -1145,7 +1145,7 @@ namespace internal - template + template template inline bool Iterator::operator!=( @@ -1158,7 +1158,7 @@ namespace internal - template + template template inline bool Iterator::operator<( @@ -1171,7 +1171,7 @@ namespace internal - template + template template inline bool Iterator::operator<=( @@ -1184,7 +1184,7 @@ namespace internal - template + template template inline bool Iterator::operator>( @@ -1197,7 +1197,7 @@ namespace internal - template + template template inline bool Iterator::operator>=( @@ -1210,7 +1210,7 @@ namespace internal - template + template template inline typename Iterator::difference_type Iterator::operator-( @@ -1224,7 +1224,7 @@ namespace internal - template + template inline Iterator Iterator::operator+( const difference_type &d) const @@ -1251,7 +1251,7 @@ namespace internal - template + template inline Iterator Iterator::operator-( const difference_type &d) const @@ -1278,7 +1278,7 @@ namespace internal - template + template inline Iterator & Iterator::operator+=(const difference_type &d) { @@ -1304,7 +1304,7 @@ namespace internal - template + template inline Iterator & Iterator::operator-=(const difference_type &d) { @@ -1329,7 +1329,7 @@ namespace internal } - template + template Iterator::Iterator(BlockVector & parent, const size_type global_index) : parent(&parent) @@ -1368,7 +1368,7 @@ namespace internal - template + template void Iterator::move_forward() { @@ -1402,7 +1402,7 @@ namespace internal - template + template void Iterator::move_backward() { @@ -1444,7 +1444,7 @@ namespace internal -template +template inline typename BlockVectorBase::size_type BlockVectorBase::size() const { @@ -1453,7 +1453,7 @@ BlockVectorBase::size() const -template +template inline std::size_t BlockVectorBase::locally_owned_size() const { @@ -1465,7 +1465,7 @@ BlockVectorBase::locally_owned_size() const -template +template inline IndexSet BlockVectorBase::locally_owned_elements() const { @@ -1486,7 +1486,7 @@ BlockVectorBase::locally_owned_elements() const -template +template inline unsigned int BlockVectorBase::n_blocks() const { @@ -1494,7 +1494,7 @@ BlockVectorBase::n_blocks() const } -template +template inline typename BlockVectorBase::BlockType & BlockVectorBase::block(const unsigned int i) { @@ -1505,7 +1505,7 @@ BlockVectorBase::block(const unsigned int i) -template +template inline const typename BlockVectorBase::BlockType & BlockVectorBase::block(const unsigned int i) const { @@ -1516,7 +1516,7 @@ BlockVectorBase::block(const unsigned int i) const -template +template inline const BlockIndices & BlockVectorBase::get_block_indices() const { @@ -1524,7 +1524,7 @@ BlockVectorBase::get_block_indices() const } -template +template inline void BlockVectorBase::collect_sizes() { @@ -1538,7 +1538,7 @@ BlockVectorBase::collect_sizes() -template +template inline void BlockVectorBase::compress(VectorOperation::values operation) { @@ -1548,7 +1548,7 @@ BlockVectorBase::compress(VectorOperation::values operation) -template +template inline typename BlockVectorBase::iterator BlockVectorBase::begin() { @@ -1557,7 +1557,7 @@ BlockVectorBase::begin() -template +template inline typename BlockVectorBase::const_iterator BlockVectorBase::begin() const { @@ -1565,7 +1565,7 @@ BlockVectorBase::begin() const } -template +template inline typename BlockVectorBase::iterator BlockVectorBase::end() { @@ -1574,7 +1574,7 @@ BlockVectorBase::end() -template +template inline typename BlockVectorBase::const_iterator BlockVectorBase::end() const { @@ -1582,7 +1582,7 @@ BlockVectorBase::end() const } -template +template inline bool BlockVectorBase::in_local_range(const size_type global_index) const { @@ -1593,7 +1593,7 @@ BlockVectorBase::in_local_range(const size_type global_index) const } -template +template bool BlockVectorBase::all_zero() const { @@ -1606,7 +1606,7 @@ BlockVectorBase::all_zero() const -template +template bool BlockVectorBase::is_non_negative() const { @@ -1619,7 +1619,7 @@ BlockVectorBase::is_non_negative() const -template +template typename BlockVectorBase::value_type BlockVectorBase::operator*( const BlockVectorBase &v) const @@ -1635,7 +1635,7 @@ BlockVectorBase::operator*( } -template +template typename BlockVectorBase::real_type BlockVectorBase::norm_sqr() const { @@ -1648,7 +1648,7 @@ BlockVectorBase::norm_sqr() const -template +template typename BlockVectorBase::value_type BlockVectorBase::mean_value() const { @@ -1665,7 +1665,7 @@ BlockVectorBase::mean_value() const -template +template typename BlockVectorBase::real_type BlockVectorBase::l1_norm() const { @@ -1678,7 +1678,7 @@ BlockVectorBase::l1_norm() const -template +template typename BlockVectorBase::real_type BlockVectorBase::l2_norm() const { @@ -1687,7 +1687,7 @@ BlockVectorBase::l2_norm() const -template +template typename BlockVectorBase::real_type BlockVectorBase::linfty_norm() const { @@ -1703,7 +1703,7 @@ BlockVectorBase::linfty_norm() const -template +template typename BlockVectorBase::value_type BlockVectorBase::add_and_dot( const typename BlockVectorBase::value_type a, @@ -1722,7 +1722,7 @@ BlockVectorBase::add_and_dot( -template +template BlockVectorBase & BlockVectorBase::operator+=(const BlockVectorBase &v) { @@ -1739,7 +1739,7 @@ BlockVectorBase::operator+=(const BlockVectorBase &v) -template +template BlockVectorBase & BlockVectorBase::operator-=(const BlockVectorBase &v) { @@ -1755,7 +1755,7 @@ BlockVectorBase::operator-=(const BlockVectorBase &v) -template +template template inline void BlockVectorBase::add(const std::vector &indices, @@ -1768,7 +1768,7 @@ BlockVectorBase::add(const std::vector &indices, -template +template template inline void BlockVectorBase::add(const std::vector &indices, @@ -1783,7 +1783,7 @@ BlockVectorBase::add(const std::vector &indices, -template +template template inline void BlockVectorBase::add(const size_type n_indices, @@ -1796,7 +1796,7 @@ BlockVectorBase::add(const size_type n_indices, -template +template void BlockVectorBase::add(const value_type a) { @@ -1810,7 +1810,7 @@ BlockVectorBase::add(const value_type a) -template +template void BlockVectorBase::add(const value_type a, const BlockVectorBase &v) @@ -1828,7 +1828,7 @@ BlockVectorBase::add(const value_type a, -template +template void BlockVectorBase::add(const value_type a, const BlockVectorBase &v, @@ -1852,7 +1852,7 @@ BlockVectorBase::add(const value_type a, -template +template void BlockVectorBase::sadd(const value_type x, const BlockVectorBase &v) @@ -1870,7 +1870,7 @@ BlockVectorBase::sadd(const value_type x, -template +template void BlockVectorBase::sadd(const value_type x, const value_type a, @@ -1890,7 +1890,7 @@ BlockVectorBase::sadd(const value_type x, -template +template void BlockVectorBase::sadd(const value_type x, const value_type a, @@ -1915,7 +1915,7 @@ BlockVectorBase::sadd(const value_type x, -template +template void BlockVectorBase::sadd(const value_type x, const value_type a, @@ -1946,7 +1946,7 @@ BlockVectorBase::sadd(const value_type x, -template +template template void BlockVectorBase::scale(const BlockVector2 &v) @@ -1959,7 +1959,7 @@ BlockVectorBase::scale(const BlockVector2 &v) -template +template std::size_t BlockVectorBase::memory_consumption() const { @@ -1969,7 +1969,7 @@ BlockVectorBase::memory_consumption() const -template +template template void BlockVectorBase::equ(const value_type a, const BlockVector2 &v) @@ -1985,7 +1985,7 @@ BlockVectorBase::equ(const value_type a, const BlockVector2 &v) -template +template void BlockVectorBase::update_ghost_values() const { @@ -1995,7 +1995,7 @@ BlockVectorBase::update_ghost_values() const -template +template BlockVectorBase & BlockVectorBase::operator=(const value_type s) { @@ -2008,7 +2008,7 @@ BlockVectorBase::operator=(const value_type s) } -template +template BlockVectorBase & BlockVectorBase::operator=(const BlockVectorBase &v) { @@ -2021,8 +2021,8 @@ BlockVectorBase::operator=(const BlockVectorBase &v) } -template -template +template +template BlockVectorBase & BlockVectorBase::operator=(const BlockVectorBase &v) { @@ -2036,7 +2036,7 @@ BlockVectorBase::operator=(const BlockVectorBase &v) -template +template BlockVectorBase & BlockVectorBase::operator=(const VectorType &v) { @@ -2052,8 +2052,8 @@ BlockVectorBase::operator=(const VectorType &v) -template -template +template +template inline bool BlockVectorBase::operator==( const BlockVectorBase &v) const @@ -2069,7 +2069,7 @@ BlockVectorBase::operator==( -template +template inline BlockVectorBase & BlockVectorBase::operator*=(const value_type factor) { @@ -2083,7 +2083,7 @@ BlockVectorBase::operator*=(const value_type factor) -template +template inline BlockVectorBase & BlockVectorBase::operator/=(const value_type factor) { @@ -2099,7 +2099,7 @@ BlockVectorBase::operator/=(const value_type factor) } -template +template inline typename BlockVectorBase::value_type BlockVectorBase::operator()(const size_type i) const { @@ -2110,7 +2110,7 @@ BlockVectorBase::operator()(const size_type i) const -template +template inline typename BlockVectorBase::reference BlockVectorBase::operator()(const size_type i) { @@ -2121,7 +2121,7 @@ BlockVectorBase::operator()(const size_type i) -template +template inline typename BlockVectorBase::value_type BlockVectorBase::operator[](const size_type i) const { @@ -2130,7 +2130,7 @@ BlockVectorBase::operator[](const size_type i) const -template +template inline typename BlockVectorBase::reference BlockVectorBase::operator[](const size_type i) { diff --git a/include/deal.II/lac/eigen.h b/include/deal.II/lac/eigen.h index 2cf0b2d429..998bc74d89 100644 --- a/include/deal.II/lac/eigen.h +++ b/include/deal.II/lac/eigen.h @@ -193,7 +193,7 @@ protected: //--------------------------------------------------------------------------- -template +template EigenPower::EigenPower(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -203,7 +203,7 @@ EigenPower::EigenPower(SolverControl & cn, -template +template template void EigenPower::solve(double &value, const MatrixType &A, VectorType &x) @@ -276,7 +276,7 @@ EigenPower::solve(double &value, const MatrixType &A, VectorType &x) //--------------------------------------------------------------------------- -template +template EigenInverse::EigenInverse(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -286,7 +286,7 @@ EigenInverse::EigenInverse(SolverControl & cn, -template +template template void EigenInverse::solve(double & value, diff --git a/include/deal.II/lac/householder.h b/include/deal.II/lac/householder.h index 66fce2bd1e..6aca34f3d7 100644 --- a/include/deal.II/lac/householder.h +++ b/include/deal.II/lac/householder.h @@ -131,7 +131,7 @@ public: * A wrapper to least_squares(), implementing the standard MatrixType * interface. */ - template + template 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 + template void Tvmult(VectorType &dst, const VectorType &src) const; @@ -330,7 +330,7 @@ Householder::least_squares(BlockVector & dst, template -template +template void Householder::vmult(VectorType &dst, const VectorType &src) const { @@ -339,7 +339,7 @@ Householder::vmult(VectorType &dst, const VectorType &src) const template -template +template void Householder::Tvmult(VectorType &, const VectorType &) const { diff --git a/include/deal.II/lac/matrix_block.h b/include/deal.II/lac/matrix_block.h index 6b124e636e..84a2dc113a 100644 --- a/include/deal.II/lac/matrix_block.h +++ b/include/deal.II/lac/matrix_block.h @@ -253,7 +253,7 @@ public: * MatrixType. No index computations are done, thus, the vectors need to * have sizes matching #matrix. */ - template + template 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 + template 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 + template 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 + template void Tvmult_add(VectorType &w, const VectorType &v) const; @@ -796,7 +796,7 @@ MatrixBlock::add(const size_type row, template -template +template inline void MatrixBlock::vmult(VectorType &w, const VectorType &v) const { @@ -805,7 +805,7 @@ MatrixBlock::vmult(VectorType &w, const VectorType &v) const template -template +template inline void MatrixBlock::vmult_add(VectorType &w, const VectorType &v) const { @@ -814,7 +814,7 @@ MatrixBlock::vmult_add(VectorType &w, const VectorType &v) const template -template +template inline void MatrixBlock::Tvmult(VectorType &w, const VectorType &v) const { @@ -823,7 +823,7 @@ MatrixBlock::Tvmult(VectorType &w, const VectorType &v) const template -template +template inline void MatrixBlock::Tvmult_add(VectorType &w, const VectorType &v) const { diff --git a/include/deal.II/lac/petsc_snes.h b/include/deal.II/lac/petsc_snes.h index 82513b2691..168f35a9b9 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 - * class VectorType : public Subscriptor + * typename 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 92a088b309..915f6e5f93 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 - * class VectorType : public Subscriptor + * typename VectorType : public Subscriptor * ... * explicit VectorType(Vec); * ... diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index d2868bccfa..264fc8d717 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -117,7 +117,7 @@ public: /** * Apply preconditioner. */ - template + template 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 + template void Tvmult(VectorType &, const VectorType &) const; /** * Apply preconditioner, adding to the previous value. */ - template + template 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 + template void Tvmult_add(VectorType &, const VectorType &) const; @@ -245,7 +245,7 @@ public: /** * Apply preconditioner. */ - template + template 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 + template void Tvmult(VectorType &, const VectorType &) const; /** * Apply preconditioner, adding to the previous value. */ - template + template 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 + template void Tvmult_add(VectorType &, const VectorType &) const; @@ -358,7 +358,7 @@ private: * @endcode */ template , - class VectorType = Vector> + typename VectorType = Vector> class PreconditionUseMatrix : public Subscriptor { public: @@ -472,7 +472,7 @@ public: /** * Apply preconditioner. */ - template + template 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 + template void Tvmult(VectorType &, const VectorType &) const; /** * Perform one step of the preconditioned Richardson iteration */ - template + template void step(VectorType &x, const VectorType &rhs) const; /** * Perform one transposed step of the preconditioned Richardson iteration. */ - template + template void Tstep(VectorType &x, const VectorType &rhs) const; @@ -2263,7 +2263,7 @@ PreconditionIdentity::initialize(const MatrixType &matrix, } -template +template inline void PreconditionIdentity::vmult(VectorType &dst, const VectorType &src) const { @@ -2272,14 +2272,14 @@ PreconditionIdentity::vmult(VectorType &dst, const VectorType &src) const -template +template inline void PreconditionIdentity::Tvmult(VectorType &dst, const VectorType &src) const { dst = src; } -template +template 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 +template inline void PreconditionIdentity::Tvmult_add(VectorType &dst, const VectorType &src) const { @@ -2358,7 +2358,7 @@ PreconditionRichardson::initialize( -template +template inline void PreconditionRichardson::vmult(VectorType &dst, const VectorType &src) const { @@ -2371,7 +2371,7 @@ PreconditionRichardson::vmult(VectorType &dst, const VectorType &src) const -template +template 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 +template 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 +template inline void PreconditionRichardson::Tvmult_add(VectorType &dst, const VectorType &src) const { @@ -2465,7 +2465,7 @@ inline } template -template +template inline void PreconditionRelaxation::vmult( VectorType & dst, @@ -2482,7 +2482,7 @@ PreconditionRelaxation::vmult( } template -template +template inline void PreconditionRelaxation::Tvmult( VectorType & dst, @@ -2499,7 +2499,7 @@ PreconditionRelaxation::Tvmult( } template -template +template inline void PreconditionRelaxation::step( VectorType & dst, @@ -2516,7 +2516,7 @@ PreconditionRelaxation::step( } template -template +template inline void PreconditionRelaxation::Tstep( VectorType & dst, @@ -2636,7 +2636,7 @@ PreconditionPSOR::AdditionalData::AdditionalData( //--------------------------------------------------------------------------- -template +template PreconditionUseMatrix::PreconditionUseMatrix( const MatrixType & M, const function_ptr method) @@ -2646,7 +2646,7 @@ PreconditionUseMatrix::PreconditionUseMatrix( -template +template void PreconditionUseMatrix::vmult( VectorType & dst, @@ -3444,7 +3444,7 @@ namespace internal -template +template inline PreconditionChebyshev:: AdditionalData::AdditionalData(const unsigned int degree, const double smoothing_range, @@ -3464,7 +3464,7 @@ inline PreconditionChebyshev:: -template +template inline typename PreconditionChebyshev::AdditionalData & diff --git a/include/deal.II/lac/qr.h b/include/deal.II/lac/qr.h index 141c342b17..fac1bb39d1 100644 --- a/include/deal.II/lac/qr.h +++ b/include/deal.II/lac/qr.h @@ -560,7 +560,7 @@ BaseQR::multiply_with_colsT(Vector & y, -template +template boost::signals2::connection BaseQR::connect_givens_slot( const std::function::connect_givens_slot( -template +template boost::signals2::connection ImplicitQR::connect_append_column_slot( const std::function &u, diff --git a/include/deal.II/lac/relaxation_block.templates.h b/include/deal.II/lac/relaxation_block.templates.h index e41b8156f8..c4a513c140 100644 --- a/include/deal.II/lac/relaxation_block.templates.h +++ b/include/deal.II/lac/relaxation_block.templates.h @@ -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 + template const VectorType & prepare_ghost_vector(const VectorType &prev, VectorType *other) { diff --git a/include/deal.II/lac/solver.h b/include/deal.II/lac/solver.h index 2f5b0b5373..6491d61498 100644 --- a/include/deal.II/lac/solver.h +++ b/include/deal.II/lac/solver.h @@ -336,7 +336,7 @@ class Vector; * * @ingroup Solvers */ -template > +template > class SolverBase : public Subscriptor { public: @@ -475,7 +475,7 @@ protected: /*-------------------------------- Inline functions ------------------------*/ -template +template inline SolverControl::State SolverBase::StateCombiner::operator()( const SolverControl::State state1, @@ -491,7 +491,7 @@ SolverBase::StateCombiner::operator()( } -template +template template inline SolverControl::State SolverBase::StateCombiner::operator()(const Iterator begin, @@ -511,7 +511,7 @@ SolverBase::StateCombiner::operator()(const Iterator begin, } -template +template inline SolverBase::SolverBase( SolverControl & solver_control, VectorMemory &vector_memory) @@ -530,7 +530,7 @@ inline SolverBase::SolverBase( -template +template inline SolverBase::SolverBase(SolverControl &solver_control) : // use the static memory object this class owns memory(static_vector_memory) @@ -548,7 +548,7 @@ inline SolverBase::SolverBase(SolverControl &solver_control) -template +template inline boost::signals2::connection SolverBase::connect( const std::function> +template > class SolverGMRES : public SolverBase { public: @@ -495,7 +495,7 @@ protected: * * For more details see @cite Saad1991. */ -template > +template > class SolverFGMRES : public SolverBase { public: @@ -577,7 +577,7 @@ namespace internal { namespace SolverGMRESImplementation { - template + template inline TmpVectors::TmpVectors(const unsigned int max_size, VectorMemory &vmem) : mem(vmem) @@ -586,7 +586,7 @@ namespace internal - template + template inline VectorType & TmpVectors::operator[](const unsigned int i) const { @@ -598,7 +598,7 @@ namespace internal - template + template inline VectorType & TmpVectors::operator()(const unsigned int i, const VectorType & temp) @@ -614,7 +614,7 @@ namespace internal - template + template unsigned int TmpVectors::size() const { @@ -654,7 +654,7 @@ namespace internal -template +template inline SolverGMRES::AdditionalData::AdditionalData( const unsigned int max_n_tmp_vectors, const bool right_preconditioning, @@ -676,7 +676,7 @@ inline SolverGMRES::AdditionalData::AdditionalData( -template +template SolverGMRES::SolverGMRES(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -687,7 +687,7 @@ SolverGMRES::SolverGMRES(SolverControl & cn, -template +template SolverGMRES::SolverGMRES(SolverControl & cn, const AdditionalData &data) : SolverBase(cn) @@ -697,7 +697,7 @@ SolverGMRES::SolverGMRES(SolverControl & cn, -template +template inline void SolverGMRES::givens_rotation(Vector &h, Vector &b, @@ -827,7 +827,7 @@ namespace internal - template ::value, VectorType> * = nullptr> @@ -844,7 +844,7 @@ namespace internal - template ::value, VectorType> * = nullptr> @@ -917,7 +917,7 @@ namespace internal - template ::value, VectorType> * = nullptr> @@ -939,7 +939,7 @@ namespace internal - template ::value, VectorType> * = nullptr> @@ -1027,7 +1027,7 @@ namespace internal } - template ::value, VectorType> * = nullptr> @@ -1042,7 +1042,7 @@ namespace internal } - template ::value, VectorType> * = nullptr> @@ -1071,7 +1071,7 @@ namespace internal - template ::value, VectorType> * = nullptr> @@ -1094,7 +1094,7 @@ namespace internal - template ::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 + template inline double iterated_gram_schmidt( const LinearAlgebra::OrthogonalizationStrategy orthogonalization_strategy, @@ -1230,7 +1230,7 @@ namespace internal -template +template inline void SolverGMRES::compute_eigs_and_cond( const FullMatrix &H_orig, @@ -1282,7 +1282,7 @@ SolverGMRES::compute_eigs_and_cond( -template +template template void SolverGMRES::solve(const MatrixType & A, @@ -1601,7 +1601,7 @@ SolverGMRES::solve(const MatrixType & A, -template +template boost::signals2::connection SolverGMRES::connect_condition_number_slot( const std::function &slot, @@ -1619,7 +1619,7 @@ SolverGMRES::connect_condition_number_slot( -template +template boost::signals2::connection SolverGMRES::connect_eigenvalues_slot( const std::function> &)> &slot, @@ -1637,7 +1637,7 @@ SolverGMRES::connect_eigenvalues_slot( -template +template boost::signals2::connection SolverGMRES::connect_hessenberg_slot( const std::function &)> &slot, @@ -1655,7 +1655,7 @@ SolverGMRES::connect_hessenberg_slot( -template +template boost::signals2::connection SolverGMRES::connect_krylov_space_slot( const std::function::connect_krylov_space_slot( -template +template boost::signals2::connection SolverGMRES::connect_re_orthogonalization_slot( const std::function &slot) @@ -1676,7 +1676,7 @@ SolverGMRES::connect_re_orthogonalization_slot( -template +template double SolverGMRES::criterion() { @@ -1689,7 +1689,7 @@ SolverGMRES::criterion() //----------------------------------------------------------------------// -template +template SolverFGMRES::SolverFGMRES(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -1699,7 +1699,7 @@ SolverFGMRES::SolverFGMRES(SolverControl & cn, -template +template SolverFGMRES::SolverFGMRES(SolverControl & cn, const AdditionalData &data) : SolverBase(cn) @@ -1708,7 +1708,7 @@ SolverFGMRES::SolverFGMRES(SolverControl & cn, -template +template template void SolverFGMRES::solve(const MatrixType & A, diff --git a/include/deal.II/lac/solver_idr.h b/include/deal.II/lac/solver_idr.h index bef8748216..f9e4b3cf3d 100644 --- a/include/deal.II/lac/solver_idr.h +++ b/include/deal.II/lac/solver_idr.h @@ -115,7 +115,7 @@ namespace internal * these steps is stored and therefore there will be multiple values per * iteration. */ -template > +template > class SolverIDR : public SolverBase { public: @@ -192,7 +192,7 @@ namespace internal { namespace SolverIDRImplementation { - template + template inline TmpVectors::TmpVectors(const unsigned int s_param, VectorMemory &vmem) : mem(vmem) @@ -201,7 +201,7 @@ namespace internal - template + template inline VectorType & TmpVectors::operator[](const unsigned int i) const { @@ -213,7 +213,7 @@ namespace internal - template + template inline VectorType & TmpVectors::operator()(const unsigned int i, const VectorType & temp) @@ -278,7 +278,7 @@ namespace internal -template +template SolverIDR::SolverIDR(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -288,7 +288,7 @@ SolverIDR::SolverIDR(SolverControl & cn, -template +template SolverIDR::SolverIDR(SolverControl &cn, const AdditionalData &data) : SolverBase(cn) , additional_data(data) @@ -296,7 +296,7 @@ SolverIDR::SolverIDR(SolverControl &cn, const AdditionalData &data) -template +template void SolverIDR::print_vectors(const unsigned int, const VectorType &, @@ -306,7 +306,7 @@ SolverIDR::print_vectors(const unsigned int, -template +template template void SolverIDR::solve(const MatrixType & A, diff --git a/include/deal.II/lac/solver_minres.h b/include/deal.II/lac/solver_minres.h index a78bfa29c9..7a995aaca5 100644 --- a/include/deal.II/lac/solver_minres.h +++ b/include/deal.II/lac/solver_minres.h @@ -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 > +template > class SolverMinRes : public SolverBase { public: @@ -149,7 +149,7 @@ protected: #ifndef DOXYGEN -template +template SolverMinRes::SolverMinRes(SolverControl & cn, VectorMemory &mem, const AdditionalData &) @@ -159,7 +159,7 @@ SolverMinRes::SolverMinRes(SolverControl & cn, -template +template SolverMinRes::SolverMinRes(SolverControl &cn, const AdditionalData &) : SolverBase(cn) @@ -168,7 +168,7 @@ SolverMinRes::SolverMinRes(SolverControl &cn, -template +template double SolverMinRes::criterion() { @@ -176,7 +176,7 @@ SolverMinRes::criterion() } -template +template void SolverMinRes::print_vectors(const unsigned int, const VectorType &, @@ -186,7 +186,7 @@ SolverMinRes::print_vectors(const unsigned int, -template +template template void SolverMinRes::solve(const MatrixType & A, diff --git a/include/deal.II/lac/solver_qmrs.h b/include/deal.II/lac/solver_qmrs.h index 7280104710..54a34f479f 100644 --- a/include/deal.II/lac/solver_qmrs.h +++ b/include/deal.II/lac/solver_qmrs.h @@ -240,7 +240,7 @@ private: #ifndef DOXYGEN -template +template SolverQMRS::IterationResult::IterationResult( const SolverControl::State state, const double last_residual) @@ -250,7 +250,7 @@ SolverQMRS::IterationResult::IterationResult( -template +template SolverQMRS::SolverQMRS(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -259,7 +259,7 @@ SolverQMRS::SolverQMRS(SolverControl & cn, , step(0) {} -template +template SolverQMRS::SolverQMRS(SolverControl & cn, const AdditionalData &data) : SolverBase(cn) @@ -267,7 +267,7 @@ SolverQMRS::SolverQMRS(SolverControl & cn, , step(0) {} -template +template void SolverQMRS::print_vectors(const unsigned int, const VectorType &, @@ -275,7 +275,7 @@ SolverQMRS::print_vectors(const unsigned int, const VectorType &) const {} -template +template template void SolverQMRS::solve(const MatrixType & A, @@ -323,7 +323,7 @@ SolverQMRS::solve(const MatrixType & A, // otherwise exit as normal } -template +template template typename SolverQMRS::IterationResult SolverQMRS::iterate(const MatrixType & A, diff --git a/include/deal.II/lac/solver_relaxation.h b/include/deal.II/lac/solver_relaxation.h index e3e058b315..ace14db6bc 100644 --- a/include/deal.II/lac/solver_relaxation.h +++ b/include/deal.II/lac/solver_relaxation.h @@ -85,7 +85,7 @@ public: //----------------------------------------------------------------------// -template +template SolverRelaxation::SolverRelaxation(SolverControl &cn, const AdditionalData &) : SolverBase(cn) @@ -93,7 +93,7 @@ SolverRelaxation::SolverRelaxation(SolverControl &cn, -template +template template void SolverRelaxation::solve(const MatrixType & A, diff --git a/include/deal.II/lac/solver_richardson.h b/include/deal.II/lac/solver_richardson.h index dce9c236d0..68850ae3e8 100644 --- a/include/deal.II/lac/solver_richardson.h +++ b/include/deal.II/lac/solver_richardson.h @@ -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 > +template > class SolverRichardson : public SolverBase { public: @@ -163,7 +163,7 @@ protected: #ifndef DOXYGEN -template +template inline SolverRichardson::AdditionalData::AdditionalData( const double omega, const bool use_preconditioned_residual) @@ -172,7 +172,7 @@ inline SolverRichardson::AdditionalData::AdditionalData( {} -template +template SolverRichardson::SolverRichardson(SolverControl & cn, VectorMemory &mem, const AdditionalData & data) @@ -182,7 +182,7 @@ SolverRichardson::SolverRichardson(SolverControl & cn, -template +template SolverRichardson::SolverRichardson(SolverControl & cn, const AdditionalData &data) : SolverBase(cn) @@ -191,7 +191,7 @@ SolverRichardson::SolverRichardson(SolverControl & cn, -template +template template void SolverRichardson::solve(const MatrixType & A, @@ -248,7 +248,7 @@ SolverRichardson::solve(const MatrixType & A, -template +template template void SolverRichardson::Tsolve(const MatrixType & A, @@ -302,7 +302,7 @@ SolverRichardson::Tsolve(const MatrixType & A, } -template +template void SolverRichardson::print_vectors(const unsigned int, const VectorType &, @@ -312,7 +312,7 @@ SolverRichardson::print_vectors(const unsigned int, -template +template inline typename VectorType::value_type SolverRichardson::criterion(const VectorType &r, const VectorType &d) const @@ -324,7 +324,7 @@ SolverRichardson::criterion(const VectorType &r, } -template +template inline void SolverRichardson::set_omega(const double om) { diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index 7fe3f76ee5..48f8b7979a 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -738,7 +738,7 @@ namespace TrilinosWrappers * see * https://docs.trilinos.org/latest-release/packages/belos/doc/html/classBelos_1_1MultiVec.html. */ - template + template class MultiVecWrapper : public Belos::MultiVec { @@ -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 + template class OperatorWrapper : public Belos::Operator { diff --git a/include/deal.II/matrix_free/type_traits.h b/include/deal.II/matrix_free/type_traits.h index 6a3c37a37a..7b29f84478 100644 --- a/include/deal.II/matrix_free/type_traits.h +++ b/include/deal.II/matrix_free/type_traits.h @@ -194,14 +194,14 @@ namespace internal * by seeing whether the `is_serial_vector` type is declared for the * given vector type. */ - template + template using is_vector_type = decltype(is_serial_vector::value); /** * A predicate stating whether something is a vector type and is * indeed a serial vector. */ - template + template using is_serial_vector_type = decltype(std::enable_if_t::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 + template constexpr bool is_not_parallel_vector = (is_supported_operation == false) || (is_supported_operation == true); diff --git a/include/deal.II/multigrid/mg_coarse.h b/include/deal.II/multigrid/mg_coarse.h index 56223ef01b..553ad3bb24 100644 --- a/include/deal.II/multigrid/mg_coarse.h +++ b/include/deal.II/multigrid/mg_coarse.h @@ -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 > +template > class MGCoarseGridApplySmoother : public MGCoarseGridBase { 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 @@ -173,7 +173,7 @@ private: * the operator() uses Householder::least_squares() to compute the action of * the inverse. */ -template > +template > class MGCoarseGridHouseholder : public MGCoarseGridBase { public: @@ -206,7 +206,7 @@ private: * Upon initialization, the singular value decomposition of the matrix is * computed. then, the operator() uses */ -template > +template > class MGCoarseGridSVD : public MGCoarseGridBase { public: @@ -243,12 +243,12 @@ private: #ifndef DOXYGEN /* ------------------ Functions for MGCoarseGridApplySmoother -----------*/ -template +template MGCoarseGridApplySmoother::MGCoarseGridApplySmoother() : coarse_smooth(nullptr) {} -template +template MGCoarseGridApplySmoother::MGCoarseGridApplySmoother( const MGSmootherBase &coarse_smooth) : coarse_smooth(nullptr) @@ -257,7 +257,7 @@ MGCoarseGridApplySmoother::MGCoarseGridApplySmoother( } -template +template void MGCoarseGridApplySmoother::initialize( const MGSmootherBase &coarse_smooth_) @@ -269,7 +269,7 @@ MGCoarseGridApplySmoother::initialize( } -template +template void MGCoarseGridApplySmoother::clear() { @@ -277,7 +277,7 @@ MGCoarseGridApplySmoother::clear() } -template +template void MGCoarseGridApplySmoother::operator()(const unsigned int level, VectorType & dst, @@ -288,7 +288,7 @@ MGCoarseGridApplySmoother::operator()(const unsigned int level, /* ------------------ Functions for MGCoarseGridIterativeSolver ------------ */ -template @@ -303,7 +303,7 @@ MGCoarseGridIterativeSolver @@ -321,7 +321,7 @@ MGCoarseGridIterativeSolver @@ -341,7 +341,7 @@ MGCoarseGridIterativeSolver< -template @@ -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 @@ -436,7 +436,7 @@ void /* ------------------ Functions for MGCoarseGridHouseholder ------------ */ -template +template MGCoarseGridHouseholder::MGCoarseGridHouseholder( const FullMatrix *A) { @@ -446,7 +446,7 @@ MGCoarseGridHouseholder::MGCoarseGridHouseholder( -template +template void MGCoarseGridHouseholder::initialize( const FullMatrix &A) @@ -456,7 +456,7 @@ MGCoarseGridHouseholder::initialize( -template +template void MGCoarseGridHouseholder::operator()( const unsigned int /*level*/, @@ -470,7 +470,7 @@ MGCoarseGridHouseholder::operator()( -template +template void MGCoarseGridSVD::initialize(const FullMatrix &A, double threshold) @@ -481,7 +481,7 @@ MGCoarseGridSVD::initialize(const FullMatrix &A, } -template +template void MGCoarseGridSVD::operator()(const unsigned int /*level*/, VectorType & dst, @@ -491,7 +491,7 @@ MGCoarseGridSVD::operator()(const unsigned int /*level*/, } -template +template void MGCoarseGridSVD::log() const { diff --git a/include/deal.II/non_matching/fe_values.h b/include/deal.II/non_matching/fe_values.h index 6d42e31ade..1231d1f4e5 100644 --- a/include/deal.II/non_matching/fe_values.h +++ b/include/deal.II/non_matching/fe_values.h @@ -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 + template FEValues(const hp::FECollection &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 + template FEValues(const hp::MappingCollection &mapping_collection, const hp::FECollection & fe_collection, const hp::QCollection & 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 + template FEInterfaceValues(const hp::FECollection &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 + template FEInterfaceValues(const hp::MappingCollection &mapping_collection, const hp::FECollection & fe_collection, const hp::QCollection & q_collection, diff --git a/include/deal.II/non_matching/mesh_classifier.h b/include/deal.II/non_matching/mesh_classifier.h index 1a019dffb0..91d94f3515 100644 --- a/include/deal.II/non_matching/mesh_classifier.h +++ b/include/deal.II/non_matching/mesh_classifier.h @@ -114,7 +114,7 @@ namespace NonMatching * Vector. The triangulation attached to DoFHandler is the one that will be * classified. */ - template + template MeshClassifier(const DoFHandler &level_set_dof_handler, const VectorType & level_set); diff --git a/include/deal.II/non_matching/quadrature_generator.h b/include/deal.II/non_matching/quadrature_generator.h index 7b7b7947cf..8ee5ad25eb 100644 --- a/include/deal.II/non_matching/quadrature_generator.h +++ b/include/deal.II/non_matching/quadrature_generator.h @@ -500,7 +500,7 @@ namespace NonMatching * class. The hp::QCollection<1> and AdditionalData is passed to the * QuadratureGenerator class. */ - template + template DiscreteQuadratureGenerator( const hp::QCollection<1> &quadratures1D, const DoFHandler & dof_handler, @@ -556,7 +556,7 @@ namespace NonMatching * class. The hp::QCollection<1> and AdditionalData is passed to the * QuadratureGenerator class. */ - template + template DiscreteFaceQuadratureGenerator( const hp::QCollection<1> &quadratures1D, const DoFHandler & dof_handler, diff --git a/include/deal.II/numerics/data_out_dof_data.h b/include/deal.II/numerics/data_out_dof_data.h index 1ef22eca8d..59da95c608 100644 --- a/include/deal.II/numerics/data_out_dof_data.h +++ b/include/deal.II/numerics/data_out_dof_data.h @@ -726,7 +726,7 @@ public: * which FEValues can extract values on a cell using the * FEValuesBase::get_function_values() function. */ - template + template 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 + template 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 + template void add_data_vector( const DoFHandler &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 + template void add_data_vector( const DoFHandler &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 + template void add_data_vector(const VectorType & data, const DataPostprocessor &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 + template void add_data_vector(const DoFHandler & 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 + template void add_mg_data_vector( const DoFHandler &dof_handler, @@ -871,7 +871,7 @@ public: /** * Scalar version of the function above. */ - template + template void add_mg_data_vector(const DoFHandler &dof_handler, const MGLevelObject &data, @@ -1030,7 +1030,7 @@ private: /** * Common function called by the four public add_data_vector methods. */ - template + template void add_data_vector_internal( const DoFHandler *dof_handler, diff --git a/include/deal.II/numerics/data_out_dof_data.templates.h b/include/deal.II/numerics/data_out_dof_data.templates.h index eb7f003a60..0b01dc0c89 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -2009,7 +2009,7 @@ DataOut_DoFData:: template -template +template void DataOut_DoFData::add_mg_data_vector( const DoFHandler &dof_handler, @@ -2024,7 +2024,7 @@ DataOut_DoFData::add_mg_data_vector( template -template +template void DataOut_DoFData::add_mg_data_vector( const DoFHandler &dof_handler, diff --git a/include/deal.II/numerics/dof_print_solver_step.h b/include/deal.II/numerics/dof_print_solver_step.h index e11f0cb34d..2e47c7d841 100644 --- a/include/deal.II/numerics/dof_print_solver_step.h +++ b/include/deal.II/numerics/dof_print_solver_step.h @@ -51,7 +51,7 @@ DEAL_II_NAMESPACE_OPEN * * @ingroup output */ -template > +template > class DoFPrintSolverStep : public SolverType { public: @@ -91,7 +91,7 @@ private: /* ----------------------- template functions --------------- */ -template +template DoFPrintSolverStep::DoFPrintSolverStep( SolverControl & control, VectorMemory &mem, @@ -103,7 +103,7 @@ DoFPrintSolverStep::DoFPrintSolverStep( {} -template +template void DoFPrintSolverStep::print_vectors( const unsigned int step, diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index b1a3401f59..827e5d902f 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -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 + template 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 + template void evaluate_field(const std::vector &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 + template 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 + template void evaluate_field_at_requested_location(const std::string &name, const VectorType & solution); diff --git a/include/deal.II/numerics/vector_tools_mean_value.h b/include/deal.II/numerics/vector_tools_mean_value.h index 4282935aaa..3f4ecdda9a 100644 --- a/include/deal.II/numerics/vector_tools_mean_value.h +++ b/include/deal.II/numerics/vector_tools_mean_value.h @@ -134,7 +134,7 @@ namespace VectorTools * * @dealiiConceptRequires{concepts::is_writable_dealii_vector_type} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_writable_dealii_vector_type) void add_constant(VectorType & solution, const DoFHandler & dof_handler, diff --git a/include/deal.II/numerics/vector_tools_mean_value.templates.h b/include/deal.II/numerics/vector_tools_mean_value.templates.h index 654b3727d1..04c94d3b33 100644 --- a/include/deal.II/numerics/vector_tools_mean_value.templates.h +++ b/include/deal.II/numerics/vector_tools_mean_value.templates.h @@ -130,7 +130,7 @@ namespace VectorTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_writable_dealii_vector_type) void add_constant(VectorType & solution, const DoFHandler & dof_handler, diff --git a/include/deal.II/optimization/solver_bfgs.h b/include/deal.II/optimization/solver_bfgs.h index a938b7c588..7a291ab67e 100644 --- a/include/deal.II/optimization/solver_bfgs.h +++ b/include/deal.II/optimization/solver_bfgs.h @@ -203,7 +203,7 @@ SolverBFGS::SolverBFGS(SolverControl & solver_control, -template +template boost::signals2::connection SolverBFGS::connect_line_search_slot( const std::function< @@ -216,7 +216,7 @@ SolverBFGS::connect_line_search_slot( -template +template boost::signals2::connection SolverBFGS::connect_preconditioner_slot( const std::function + template std::enable_if_t< std::is_convertible *>::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 + template void get_particle_positions(VectorType &output_vector, const bool add_to_output_vector = false); @@ -1330,7 +1330,7 @@ namespace Particles template - template + template inline std::enable_if_t< std::is_convertible *>::value == false> ParticleHandler::set_particle_positions( @@ -1354,7 +1354,7 @@ namespace Particles template - template + template inline void ParticleHandler::get_particle_positions( VectorType &output_vector, diff --git a/source/fe/mapping_q1_eulerian.cc b/source/fe/mapping_q1_eulerian.cc index 0e379d8c45..4f24bec6bb 100644 --- a/source/fe/mapping_q1_eulerian.cc +++ b/source/fe/mapping_q1_eulerian.cc @@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN -template +template MappingQ1Eulerian::MappingQ1Eulerian( const DoFHandler &shiftmap_dof_handler, const VectorType & euler_transform_vectors) @@ -49,7 +49,7 @@ MappingQ1Eulerian::MappingQ1Eulerian( -template +template boost::container::small_vector, GeometryInfo::vertices_per_cell> MappingQ1Eulerian::get_vertices( @@ -103,7 +103,7 @@ MappingQ1Eulerian::get_vertices( -template +template std::vector> MappingQ1Eulerian::compute_mapping_support_points( const typename Triangulation::cell_iterator &cell) const @@ -119,7 +119,7 @@ MappingQ1Eulerian::compute_mapping_support_points( -template +template std::unique_ptr> MappingQ1Eulerian::clone() const { @@ -128,7 +128,7 @@ MappingQ1Eulerian::clone() const -template +template CellSimilarity::Similarity MappingQ1Eulerian::fill_fe_values( const typename Triangulation::cell_iterator &cell, diff --git a/source/fe/mapping_q_eulerian.cc b/source/fe/mapping_q_eulerian.cc index 44429d1d75..b28588e378 100644 --- a/source/fe/mapping_q_eulerian.cc +++ b/source/fe/mapping_q_eulerian.cc @@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN // .... MAPPING Q EULERIAN CONSTRUCTOR -template +template MappingQEulerian::MappingQEulerian( const unsigned int degree, const DoFHandler &euler_dof_handler, @@ -62,7 +62,7 @@ MappingQEulerian::MappingQEulerian( -template +template std::unique_ptr> MappingQEulerian::clone() const { @@ -74,7 +74,7 @@ MappingQEulerian::clone() const // .... SUPPORT QUADRATURE CONSTRUCTOR -template +template MappingQEulerian::SupportQuadrature:: SupportQuadrature(const unsigned int map_degree) : Quadrature(Utilities::fixed_power(map_degree + 1)) @@ -99,7 +99,7 @@ MappingQEulerian::SupportQuadrature:: // .... COMPUTE MAPPING SUPPORT POINTS -template +template boost::container::small_vector, GeometryInfo::vertices_per_cell> MappingQEulerian::get_vertices( @@ -118,7 +118,7 @@ MappingQEulerian::get_vertices( -template +template std::vector> MappingQEulerian::compute_mapping_support_points( const typename Triangulation::cell_iterator &cell) const @@ -191,7 +191,7 @@ MappingQEulerian::compute_mapping_support_points( -template +template CellSimilarity::Similarity MappingQEulerian::fill_fe_values( const typename Triangulation::cell_iterator &cell, diff --git a/source/non_matching/fe_values.cc b/source/non_matching/fe_values.cc index 4c17985207..cfced4aa53 100644 --- a/source/non_matching/fe_values.cc +++ b/source/non_matching/fe_values.cc @@ -45,7 +45,7 @@ namespace NonMatching template - template + template FEValues::FEValues(const hp::FECollection &fe_collection, const Quadrature<1> & quadrature, const RegionUpdateFlags region_update_flags, @@ -75,7 +75,7 @@ namespace NonMatching template - template + template FEValues::FEValues(const hp::MappingCollection &mapping_collection, const hp::FECollection & fe_collection, const hp::QCollection & q_collection, @@ -270,7 +270,7 @@ namespace NonMatching template - template + template FEInterfaceValues::FEInterfaceValues( const hp::FECollection &fe_collection, const Quadrature<1> & quadrature, @@ -301,7 +301,7 @@ namespace NonMatching template - template + template FEInterfaceValues::FEInterfaceValues( const hp::MappingCollection &mapping_collection, const hp::FECollection & fe_collection, diff --git a/source/non_matching/mesh_classifier.cc b/source/non_matching/mesh_classifier.cc index d88a69e35a..b1b0edabb3 100644 --- a/source/non_matching/mesh_classifier.cc +++ b/source/non_matching/mesh_classifier.cc @@ -61,7 +61,7 @@ namespace NonMatching * vector are negative/positive, otherwise return * LocationToLevelSet::intersected. */ - template + template 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 + template class DiscreteLevelSetDescription : public LevelSetDescription { public: @@ -132,7 +132,7 @@ namespace NonMatching - template + template DiscreteLevelSetDescription::DiscreteLevelSetDescription( const DoFHandler &dof_handler, const VectorType & level_set) @@ -142,7 +142,7 @@ namespace NonMatching - template + template const hp::FECollection & DiscreteLevelSetDescription::get_fe_collection() const { @@ -151,7 +151,7 @@ namespace NonMatching - template + template void DiscreteLevelSetDescription::get_local_level_set_values( const typename Triangulation::active_cell_iterator &cell, @@ -179,7 +179,7 @@ namespace NonMatching - template + template unsigned int DiscreteLevelSetDescription::active_fe_index( const typename Triangulation::active_cell_iterator &cell) const @@ -311,7 +311,7 @@ namespace NonMatching template - template + template MeshClassifier::MeshClassifier(const DoFHandler &dof_handler, const VectorType & level_set) : triangulation(&dof_handler.get_triangulation()) diff --git a/source/non_matching/quadrature_generator.cc b/source/non_matching/quadrature_generator.cc index 18ed8736a5..f0863b0189 100644 --- a/source/non_matching/quadrature_generator.cc +++ b/source/non_matching/quadrature_generator.cc @@ -1308,7 +1308,7 @@ namespace NonMatching * function must be called to specify which cell the function should be * evaluated on. */ - template > + template > class RefSpaceFEFieldFunction : public CellWiseFunction { public: @@ -1417,7 +1417,7 @@ namespace NonMatching - template + template RefSpaceFEFieldFunction::RefSpaceFEFieldFunction( const DoFHandler &dof_handler, const VectorType & dof_values) @@ -1430,7 +1430,7 @@ namespace NonMatching - template + template void RefSpaceFEFieldFunction::set_active_cell( const typename Triangulation::active_cell_iterator &cell) @@ -1493,7 +1493,7 @@ namespace NonMatching - template + template bool RefSpaceFEFieldFunction::cell_is_set() const { @@ -1504,7 +1504,7 @@ namespace NonMatching - template + template double RefSpaceFEFieldFunction::value( const Point & point, @@ -1536,7 +1536,7 @@ namespace NonMatching - template + template Tensor<1, dim> RefSpaceFEFieldFunction::gradient( const Point & point, @@ -1569,7 +1569,7 @@ namespace NonMatching - template + template SymmetricTensor<2, dim> RefSpaceFEFieldFunction::hessian( const Point & point, @@ -1873,7 +1873,7 @@ namespace NonMatching template - template + template DiscreteQuadratureGenerator::DiscreteQuadratureGenerator( const hp::QCollection<1> &quadratures1D, const DoFHandler & dof_handler, @@ -1906,7 +1906,7 @@ namespace NonMatching template - template + template DiscreteFaceQuadratureGenerator::DiscreteFaceQuadratureGenerator( const hp::QCollection<1> &quadratures1D, const DoFHandler & dof_handler, -- 2.39.5