From 5d1757a271c2cea9a9bc3b23ece376272fcb168f Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 2 Jul 2023 21:52:43 -0600 Subject: [PATCH] Standardize on 'template . --- include/deal.II/algorithms/any_data.h | 4 +-- include/deal.II/base/exceptions.h | 4 +-- include/deal.II/base/index_set.h | 4 +-- include/deal.II/base/linear_index_iterator.h | 36 +++++++++---------- include/deal.II/base/mutable_bind.h | 12 +++---- include/deal.II/base/parameter_acceptor.h | 4 +-- include/deal.II/base/parameter_handler.h | 4 +-- include/deal.II/base/path_search.h | 4 +-- include/deal.II/base/patterns.h | 2 +- include/deal.II/base/polynomial_space.h | 4 +-- include/deal.II/base/template_constraints.h | 4 +-- include/deal.II/base/timer.h | 8 ++--- .../differentiation/sd/symengine_optimizer.h | 4 +-- include/deal.II/dofs/dof_tools.h | 2 +- include/deal.II/fe/fe_dg_vector.h | 2 +- include/deal.II/fe/fe_dg_vector.templates.h | 12 +++---- include/deal.II/fe/fe_interface_values.h | 8 ++--- include/deal.II/fe/fe_poly_face.h | 2 +- include/deal.II/fe/fe_poly_face.templates.h | 12 +++---- include/deal.II/fe/fe_update_flags.h | 2 +- include/deal.II/fe/fe_values.h | 8 ++--- include/deal.II/grid/grid_tools.h | 28 +++++++-------- .../grid/grid_tools_cache_update_flags.h | 2 +- include/deal.II/grid/intergrid_map.h | 2 +- include/deal.II/grid/tria_iterator.h | 4 +-- include/deal.II/hp/fe_values.h | 12 +++---- .../lac/affine_constraints.templates.h | 4 +-- include/deal.II/lac/block_sparse_matrix_ez.h | 4 +-- include/deal.II/lac/cuda_sparse_matrix.h | 4 +-- include/deal.II/lac/full_matrix.h | 4 +-- include/deal.II/lac/solver_relaxation.h | 4 +-- include/deal.II/lac/sparse_matrix.h | 4 +-- include/deal.II/lac/sparse_matrix_ez.h | 4 +-- include/deal.II/lac/trilinos_solver.h | 2 +- include/deal.II/meshworker/assemble_flags.h | 2 +- include/deal.II/meshworker/local_results.h | 4 +-- include/deal.II/meshworker/mesh_loop.h | 20 +++++------ include/deal.II/meshworker/vector_selector.h | 8 ++--- include/deal.II/multigrid/mg_block_smoother.h | 18 +++++----- include/deal.II/multigrid/mg_smoother.h | 36 +++++++++---------- include/deal.II/multigrid/multigrid.h | 18 +++++----- include/deal.II/non_matching/fe_values.h | 8 ++--- .../numerics/vector_tools_interpolate.h | 2 +- source/base/data_out_base.cc | 2 +- source/dofs/dof_renumbering.cc | 2 +- source/fe/mapping_cartesian.cc | 2 +- source/grid/grid_tools.cc | 8 ++--- source/grid/grid_tools_dof_handlers.cc | 20 +++++------ source/grid/intergrid_map.cc | 18 +++++----- source/hp/fe_values.cc | 16 ++++----- source/lac/block_sparsity_pattern.cc | 32 ++++++++--------- 51 files changed, 218 insertions(+), 218 deletions(-) diff --git a/include/deal.II/algorithms/any_data.h b/include/deal.II/algorithms/any_data.h index d9c1ed57bb..fafba5b08d 100644 --- a/include/deal.II/algorithms/any_data.h +++ b/include/deal.II/algorithms/any_data.h @@ -186,7 +186,7 @@ public: is_type(const unsigned int i) const; /// List the contents to a stream - template + template void list(StreamType &os) const; @@ -448,7 +448,7 @@ AnyData::merge(const AnyData &other) } -template +template inline void AnyData::list(StreamType &os) const { diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index 1ed204414e..b165b755a0 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -1421,7 +1421,7 @@ namespace deal_II_exceptions * * @ref ExceptionBase */ - template + template [[noreturn]] void issue_error_noreturn(ExceptionHandling handling, const char * file, @@ -1471,7 +1471,7 @@ namespace deal_II_exceptions * @note This function is defined with a template for the same reasons as * issue_error_noreturn(). */ - template + template void issue_error_nothrow(const char * file, int line, diff --git a/include/deal.II/base/index_set.h b/include/deal.II/base/index_set.h index c9abbddc7a..647ce8810c 100644 --- a/include/deal.II/base/index_set.h +++ b/include/deal.II/base/index_set.h @@ -448,7 +448,7 @@ public: * Output a text representation of this IndexSet to the given stream. Used * for testing. */ - template + template void print(StreamType &out) const; @@ -1960,7 +1960,7 @@ IndexSet::fill_binary_vector(Vector &vector) const -template +template inline void IndexSet::print(StreamType &out) const { diff --git a/include/deal.II/base/linear_index_iterator.h b/include/deal.II/base/linear_index_iterator.h index ca71446db0..b3c1b2dcc7 100644 --- a/include/deal.II/base/linear_index_iterator.h +++ b/include/deal.II/base/linear_index_iterator.h @@ -135,7 +135,7 @@ DEAL_II_NAMESPACE_OPEN * * @note TransposeTable uses this template to implement its iterators. */ -template +template class LinearIndexIterator { public: @@ -332,7 +332,7 @@ protected: -template +template inline DerivedIterator & LinearIndexIterator::operator=( const DerivedIterator &it) @@ -344,7 +344,7 @@ LinearIndexIterator::operator=( -template +template inline DerivedIterator & LinearIndexIterator::operator++() { @@ -353,7 +353,7 @@ LinearIndexIterator::operator++() -template +template inline DerivedIterator LinearIndexIterator::operator++(int) { @@ -364,7 +364,7 @@ LinearIndexIterator::operator++(int) -template +template inline DerivedIterator & LinearIndexIterator::operator--() { @@ -373,7 +373,7 @@ LinearIndexIterator::operator--() -template +template inline DerivedIterator LinearIndexIterator::operator--(int) { @@ -384,7 +384,7 @@ LinearIndexIterator::operator--(int) -template +template inline DerivedIterator LinearIndexIterator::operator+( const difference_type n) const @@ -396,7 +396,7 @@ LinearIndexIterator::operator+( -template +template inline DerivedIterator LinearIndexIterator::operator-( const difference_type n) const @@ -408,7 +408,7 @@ LinearIndexIterator::operator-( -template +template inline DerivedIterator & LinearIndexIterator::operator+=( const difference_type n) @@ -419,7 +419,7 @@ LinearIndexIterator::operator+=( -template +template inline DerivedIterator & LinearIndexIterator::operator-=( const difference_type n) @@ -429,7 +429,7 @@ LinearIndexIterator::operator-=( -template +template inline typename LinearIndexIterator::difference_type LinearIndexIterator::operator-( @@ -443,7 +443,7 @@ inline -template +template inline typename LinearIndexIterator::reference LinearIndexIterator::operator*() const { @@ -452,7 +452,7 @@ LinearIndexIterator::operator*() const -template +template inline typename LinearIndexIterator::pointer LinearIndexIterator::operator->() const { @@ -461,7 +461,7 @@ LinearIndexIterator::operator->() const -template +template inline bool LinearIndexIterator::operator<=( const DerivedIterator &other) const @@ -471,7 +471,7 @@ LinearIndexIterator::operator<=( -template +template inline bool LinearIndexIterator::operator>=( const DerivedIterator &other) const @@ -481,7 +481,7 @@ LinearIndexIterator::operator>=( -template +template inline bool LinearIndexIterator::operator<( const DerivedIterator &other) const @@ -494,7 +494,7 @@ LinearIndexIterator::operator<( -template +template inline bool LinearIndexIterator::operator>( const DerivedIterator &other) const @@ -504,7 +504,7 @@ LinearIndexIterator::operator>( -template +template inline LinearIndexIterator::LinearIndexIterator( const AccessorType accessor) : accessor(accessor) diff --git a/include/deal.II/base/mutable_bind.h b/include/deal.II/base/mutable_bind.h index 7f153af4ca..1c73050dcb 100644 --- a/include/deal.II/base/mutable_bind.h +++ b/include/deal.II/base/mutable_bind.h @@ -93,21 +93,21 @@ namespace Utilities * Construct a MutableBind object specifying the function, and * each arguments separately. */ - template + template MutableBind(FunctionType function, FunctionArgs &&...arguments); /** * Construct a MutableBind object specifying the function, and * the arguments as a tuple. */ - template + template MutableBind(FunctionType function, TupleType &&arguments); /** * Construct a MutableBind object specifying only the function. By default, * the arguments are left to their default constructor values. */ - template + template MutableBind(FunctionType function); /** @@ -221,7 +221,7 @@ namespace Utilities #ifndef DOXYGEN template - template + template MutableBind::MutableBind( FunctionType function, FunctionArgs &&...arguments) @@ -232,7 +232,7 @@ namespace Utilities template - template + template MutableBind::MutableBind(FunctionType function, TupleType && arguments) : function(function) @@ -242,7 +242,7 @@ namespace Utilities template - template + template MutableBind::MutableBind(FunctionType function) : function(function) {} diff --git a/include/deal.II/base/parameter_acceptor.h b/include/deal.II/base/parameter_acceptor.h index 0c88ef62db..2898f0ea05 100644 --- a/include/deal.II/base/parameter_acceptor.h +++ b/include/deal.II/base/parameter_acceptor.h @@ -520,7 +520,7 @@ public: * See the documentation of ParameterHandler::add_parameter() for more * information. */ - template + template void add_parameter(const std::string & entry, ParameterType & parameter, @@ -724,7 +724,7 @@ public: // Inline and template functions -template +template void ParameterAcceptor::add_parameter(const std::string & entry, ParameterType & parameter, diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 3fd37b9211..fa4cf1c05b 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -1195,7 +1195,7 @@ public: * successfully can be queried by the functions get_entries_wrongly_not_set() * and assert_that_entries_have_been_set(). */ - template + template void add_parameter(const std::string & entry, ParameterType & parameter, @@ -2331,7 +2331,7 @@ ParameterHandler::load(Archive &ar, const unsigned int) } -template +template void ParameterHandler::add_parameter(const std::string & entry, ParameterType & parameter, diff --git a/include/deal.II/base/path_search.h b/include/deal.II/base/path_search.h index cfd25c7137..82fae2c051 100644 --- a/include/deal.II/base/path_search.h +++ b/include/deal.II/base/path_search.h @@ -149,7 +149,7 @@ public: /** * Show the paths and suffixes used for this object. */ - template + template void show(StreamType &stream) const; @@ -258,7 +258,7 @@ private: /* ----------------------------- inline functions ------------------------- */ -template +template inline void PathSearch::show(StreamType &out) const { diff --git a/include/deal.II/base/patterns.h b/include/deal.II/base/patterns.h index 779a4aa551..01a762a2e5 100644 --- a/include/deal.II/base/patterns.h +++ b/include/deal.II/base/patterns.h @@ -1904,7 +1904,7 @@ namespace Patterns }; // std::array - template + template struct Convert> { using T = std::array; diff --git a/include/deal.II/base/polynomial_space.h b/include/deal.II/base/polynomial_space.h index 9cc21c8d84..279626fc3f 100644 --- a/include/deal.II/base/polynomial_space.h +++ b/include/deal.II/base/polynomial_space.h @@ -117,7 +117,7 @@ public: /** * Prints the list of the indices to out. */ - template + template void output_indices(StreamType &out) const; @@ -313,7 +313,7 @@ PolynomialSpace::name() const template -template +template void PolynomialSpace::output_indices(StreamType &out) const { diff --git a/include/deal.II/base/template_constraints.h b/include/deal.II/base/template_constraints.h index d298064240..3e4f502502 100644 --- a/include/deal.II/base/template_constraints.h +++ b/include/deal.II/base/template_constraints.h @@ -235,7 +235,7 @@ struct is_base_of_all * parameter pack are equal to the `Type` given as first template * argument. The result is stored in the member variable `value`. */ -template +template struct all_same_as { static constexpr bool value = internal::TemplateConstraints::all_true< @@ -250,7 +250,7 @@ struct all_same_as * parameter pack are equal to the `Type` given as first template * argument. The result is stored in the member variable `value`. */ -template +template struct is_same_as_any_of { static constexpr bool value = internal::TemplateConstraints::any_true< diff --git a/include/deal.II/base/timer.h b/include/deal.II/base/timer.h index d99e825cad..9d0966323a 100644 --- a/include/deal.II/base/timer.h +++ b/include/deal.II/base/timer.h @@ -160,7 +160,7 @@ public: * Print the data returned by Timer::get_last_lap_wall_time_data() to the * given stream. */ - template + template void print_last_lap_wall_time_data(StreamType &stream) const; @@ -168,7 +168,7 @@ public: * Print the data returned by Timer::get_accumulated_wall_time_data() to the * given stream. */ - template + template void print_accumulated_wall_time_data(StreamType &stream) const; @@ -918,7 +918,7 @@ Timer::get_accumulated_wall_time_data() const -template +template inline void Timer::print_last_lap_wall_time_data(StreamType &stream) const { @@ -930,7 +930,7 @@ Timer::print_last_lap_wall_time_data(StreamType &stream) const -template +template inline void Timer::print_accumulated_wall_time_data(StreamType &stream) const { diff --git a/include/deal.II/differentiation/sd/symengine_optimizer.h b/include/deal.II/differentiation/sd/symengine_optimizer.h index 8bd56698d9..e9caa8b832 100644 --- a/include/deal.II/differentiation/sd/symengine_optimizer.h +++ b/include/deal.II/differentiation/sd/symengine_optimizer.h @@ -116,7 +116,7 @@ namespace Differentiation /** * Output operator that outputs the selected optimizer type. */ - template + template inline StreamType & operator<<(StreamType &s, OptimizerType o) { @@ -268,7 +268,7 @@ namespace Differentiation * Output operator that outputs optimization flags as a set of or'd * text values. */ - template + template inline StreamType & operator<<(StreamType &s, OptimizationFlags o) { diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index e36b7043a7..fb0397d8db 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -52,7 +52,7 @@ namespace hp template class FECollection; } // namespace hp -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) class InterGridMap; template diff --git a/include/deal.II/fe/fe_dg_vector.h b/include/deal.II/fe/fe_dg_vector.h index 9ba197011c..d10d5774f2 100644 --- a/include/deal.II/fe/fe_dg_vector.h +++ b/include/deal.II/fe/fe_dg_vector.h @@ -49,7 +49,7 @@ DEAL_II_NAMESPACE_OPEN * * @ingroup febase */ -template +template class FE_DGVector : public FE_PolyTensor { public: diff --git a/include/deal.II/fe/fe_dg_vector.templates.h b/include/deal.II/fe/fe_dg_vector.templates.h index 36d7a5c4cc..ac179c2965 100644 --- a/include/deal.II/fe/fe_dg_vector.templates.h +++ b/include/deal.II/fe/fe_dg_vector.templates.h @@ -32,7 +32,7 @@ DEAL_II_NAMESPACE_OPEN // TODO:[GK] deg+1 is wrong here and should be fixed after FiniteElementData was // cleaned up -template +template FE_DGVector::FE_DGVector(const unsigned int deg, MappingKind map) : FE_PolyTensor( @@ -57,7 +57,7 @@ FE_DGVector::FE_DGVector(const unsigned int deg, } -template +template std::unique_ptr> FE_DGVector::clone() const { @@ -65,7 +65,7 @@ FE_DGVector::clone() const } -template +template std::string FE_DGVector::get_name() const { @@ -76,7 +76,7 @@ FE_DGVector::get_name() const } -template +template std::vector FE_DGVector::get_dpo_vector( const unsigned int deg) @@ -88,7 +88,7 @@ FE_DGVector::get_dpo_vector( } -template +template bool FE_DGVector::has_support_on_face( const unsigned int, @@ -98,7 +98,7 @@ FE_DGVector::has_support_on_face( } -template +template std::size_t FE_DGVector::memory_consumption() const { diff --git a/include/deal.II/fe/fe_interface_values.h b/include/deal.II/fe/fe_interface_values.h index dc6684e229..7a46e44f13 100644 --- a/include/deal.II/fe/fe_interface_values.h +++ b/include/deal.II/fe/fe_interface_values.h @@ -1443,7 +1443,7 @@ public: * is initialized with an hp::FECollection, an hp::QCollection, and possibly * an hp::MappingCollection). */ - template + template void reinit(const CellIteratorType & cell, const unsigned int face_no, @@ -1481,7 +1481,7 @@ public: * is initialized with an hp::FECollection, an hp::QCollection, and possibly * an hp::MappingCollection). */ - template + template void reinit(const CellIteratorType &cell, const unsigned int face_no, @@ -2308,7 +2308,7 @@ FEInterfaceValues::FEInterfaceValues( template -template +template void FEInterfaceValues::reinit( const CellIteratorType & cell, @@ -2510,7 +2510,7 @@ FEInterfaceValues::reinit( template -template +template void FEInterfaceValues::reinit(const CellIteratorType &cell, const unsigned int face_no, diff --git a/include/deal.II/fe/fe_poly_face.h b/include/deal.II/fe/fe_poly_face.h index ac4d04ff1f..a74603ba35 100644 --- a/include/deal.II/fe/fe_poly_face.h +++ b/include/deal.II/fe/fe_poly_face.h @@ -55,7 +55,7 @@ DEAL_II_NAMESPACE_OPEN * which cannot be implemented by this class but are left for implementation * in derived classes. */ -template class FE_PolyFace : public FiniteElement diff --git a/include/deal.II/fe/fe_poly_face.templates.h b/include/deal.II/fe/fe_poly_face.templates.h index a6cd58f387..7f3aba00ba 100644 --- a/include/deal.II/fe/fe_poly_face.templates.h +++ b/include/deal.II/fe/fe_poly_face.templates.h @@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN -template +template FE_PolyFace::FE_PolyFace( const PolynomialType & poly_space, const FiniteElementData &fe_data, @@ -43,7 +43,7 @@ FE_PolyFace::FE_PolyFace( } -template +template unsigned int FE_PolyFace::get_degree() const { @@ -56,7 +56,7 @@ FE_PolyFace::get_degree() const //--------------------------------------------------------------------------- -template +template UpdateFlags FE_PolyFace::requires_update_flags( const UpdateFlags flags) const @@ -76,7 +76,7 @@ FE_PolyFace::requires_update_flags( //--------------------------------------------------------------------------- // Fill data of FEValues //--------------------------------------------------------------------------- -template +template void FE_PolyFace::fill_fe_values( const typename Triangulation::cell_iterator &, @@ -105,7 +105,7 @@ FE_PolyFace::fill_fe_values( -template +template void FE_PolyFace::fill_fe_face_values( const typename Triangulation::cell_iterator &, @@ -198,7 +198,7 @@ FE_PolyFace::fill_fe_face_values( } -template +template void FE_PolyFace::fill_fe_subface_values( const typename Triangulation::cell_iterator &, diff --git a/include/deal.II/fe/fe_update_flags.h b/include/deal.II/fe/fe_update_flags.h index 6e2a7d42ae..f8e1028884 100644 --- a/include/deal.II/fe/fe_update_flags.h +++ b/include/deal.II/fe/fe_update_flags.h @@ -241,7 +241,7 @@ enum UpdateFlags * * @ref UpdateFlags */ -template +template inline StreamType & operator<<(StreamType &s, const UpdateFlags u) { diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 6c179a2188..369b235ca3 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -69,7 +69,7 @@ namespace internal * A class whose specialization is used to define what type the curl of a * vector valued function corresponds to. */ - template + template struct CurlType; /** @@ -78,7 +78,7 @@ namespace internal * * In 1d, the curl is a scalar. */ - template + template struct CurlType<1, NumberType> { using type = Tensor<1, 1, NumberType>; @@ -90,7 +90,7 @@ namespace internal * * In 2d, the curl is a scalar. */ - template + template struct CurlType<2, NumberType> { using type = Tensor<1, 1, NumberType>; @@ -102,7 +102,7 @@ namespace internal * * In 3d, the curl is a vector. */ - template + template struct CurlType<3, NumberType> { using type = Tensor<1, 3, NumberType>; diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index cbfa05a523..7dc37934ba 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -99,7 +99,7 @@ namespace GridTools namespace internal { - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) class ActiveCellIterator { @@ -1572,7 +1572,7 @@ namespace GridTools * @dealiiConceptRequires{ * concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler)) #ifndef _MSC_VER std::vector @@ -1908,7 +1908,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector get_active_child_cells( const typename MeshType::cell_iterator &cell); @@ -1939,7 +1939,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void get_active_neighbors( const typename MeshType::active_cell_iterator & cell, @@ -1996,7 +1996,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_active_cell_halo_layer( @@ -2014,7 +2014,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_cell_halo_layer_on_level( @@ -2038,7 +2038,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector< typename MeshType:: @@ -2094,7 +2094,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_active_cell_layer_within_distance( @@ -2127,7 +2127,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_ghost_cell_layer_within_distance( @@ -2151,7 +2151,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::pair< Point, @@ -2234,7 +2234,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector> compute_mesh_predicate_bounding_box( @@ -2858,7 +2858,7 @@ namespace GridTools * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector get_patch_around_cell( const typename MeshType::active_cell_iterator &cell); @@ -3973,7 +3973,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector get_active_child_cells( const typename MeshType::cell_iterator &cell) @@ -4000,7 +4000,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void get_active_neighbors( const typename MeshType::active_cell_iterator & cell, diff --git a/include/deal.II/grid/grid_tools_cache_update_flags.h b/include/deal.II/grid/grid_tools_cache_update_flags.h index c2f4a5f867..55f85fd711 100644 --- a/include/deal.II/grid/grid_tools_cache_update_flags.h +++ b/include/deal.II/grid/grid_tools_cache_update_flags.h @@ -102,7 +102,7 @@ namespace GridTools * * @ref CacheUpdateFlags */ - template + template inline StreamType & operator<<(StreamType &s, const CacheUpdateFlags u) { diff --git a/include/deal.II/grid/intergrid_map.h b/include/deal.II/grid/intergrid_map.h index 0b9b0e1421..4dd0d3e215 100644 --- a/include/deal.II/grid/intergrid_map.h +++ b/include/deal.II/grid/intergrid_map.h @@ -112,7 +112,7 @@ DEAL_II_NAMESPACE_OPEN * * @dealiiConceptRequires{concepts::is_triangulation_or_dof_handler} */ -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) class InterGridMap : public Subscriptor { diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index 97d7ef1bbb..b63b368577 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -478,7 +478,7 @@ public: * Print the iterator to a stream out. The format is * level.index. */ - template + template void print(StreamType &out) const; @@ -1118,7 +1118,7 @@ TriaRawIterator::operator--() template -template +template inline void TriaRawIterator::print(StreamType &out) const { diff --git a/include/deal.II/hp/fe_values.h b/include/deal.II/hp/fe_values.h index cfc41b4ee1..5f520d008a 100644 --- a/include/deal.II/hp/fe_values.h +++ b/include/deal.II/hp/fe_values.h @@ -64,7 +64,7 @@ namespace hp * * @ingroup hp */ - template + template class FEValuesBase : public Subscriptor { public: @@ -690,7 +690,7 @@ namespace hp namespace hp { - template + template inline const FEValuesType & FEValuesBase::get_present_fe_values() const { @@ -699,7 +699,7 @@ namespace hp - template + template inline const FECollection & FEValuesBase::get_fe_collection() const { @@ -708,7 +708,7 @@ namespace hp - template + template inline const MappingCollection & FEValuesBase::get_mapping_collection() const { @@ -717,7 +717,7 @@ namespace hp - template + template inline const QCollection & FEValuesBase::get_quadrature_collection() const { @@ -726,7 +726,7 @@ namespace hp - template + template inline UpdateFlags FEValuesBase::get_update_flags() const { diff --git a/include/deal.II/lac/affine_constraints.templates.h b/include/deal.II/lac/affine_constraints.templates.h index d951ddb6f4..759ecbd088 100644 --- a/include/deal.II/lac/affine_constraints.templates.h +++ b/include/deal.II/lac/affine_constraints.templates.h @@ -3149,7 +3149,7 @@ namespace internal // able to use functions like vector.block(1)(block_local_id), instead of // vector(global_id). This avoids transforming indices one-by-one later // on. - template + template inline void make_block_starts(const BlockType & block_object, GlobalRowsFromLocal &global_rows, @@ -3186,7 +3186,7 @@ namespace internal // same as before, but for std::vector instead of // GlobalRowsFromLocal. Used in functions for sparsity patterns. - template + template inline void make_block_starts(const BlockType & block_object, std::vector &row_indices, diff --git a/include/deal.II/lac/block_sparse_matrix_ez.h b/include/deal.II/lac/block_sparse_matrix_ez.h index 7dcacc7ce3..5c3d3ea0a9 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.h @@ -241,7 +241,7 @@ public: * existing row lengths and allocated row lengths. Otherwise, just the * relation of allocated and used entries is shown. */ - template + template void print_statistics(StreamType &s, bool full = false); @@ -442,7 +442,7 @@ BlockSparseMatrixEZ::Tvmult_add( template -template +template inline void BlockSparseMatrixEZ::print_statistics(StreamType &out, bool full) { diff --git a/include/deal.II/lac/cuda_sparse_matrix.h b/include/deal.II/lac/cuda_sparse_matrix.h index 6ad97a8d85..4b60f95120 100644 --- a/include/deal.II/lac/cuda_sparse_matrix.h +++ b/include/deal.II/lac/cuda_sparse_matrix.h @@ -159,7 +159,7 @@ namespace CUDAWrappers * quadratic matrices are printed first in their row. If it is false, * the elements in a row are written in ascending column order. */ - template + template void print(StreamType &out, const bool across = false, @@ -404,7 +404,7 @@ namespace CUDAWrappers template - template + template inline void SparseMatrix::print(StreamType &out, const bool across, diff --git a/include/deal.II/lac/full_matrix.h b/include/deal.II/lac/full_matrix.h index 0ab26570d5..8e54a51c63 100644 --- a/include/deal.II/lac/full_matrix.h +++ b/include/deal.II/lac/full_matrix.h @@ -487,7 +487,7 @@ public: * stream before setting these given values for output, and restores the * previous values after output. */ - template + template void print(StreamType & s, const unsigned int width = 5, @@ -1421,7 +1421,7 @@ FullMatrix::add(const size_type row, template -template +template inline void FullMatrix::print(StreamType & s, const unsigned int w, diff --git a/include/deal.II/lac/solver_relaxation.h b/include/deal.II/lac/solver_relaxation.h index ace14db6bc..585b11baa3 100644 --- a/include/deal.II/lac/solver_relaxation.h +++ b/include/deal.II/lac/solver_relaxation.h @@ -75,7 +75,7 @@ public: * R(x_k,b)$. The matrix A itself is only used to compute the * residual. */ - template + template void solve(const MatrixType & A, VectorType & x, @@ -94,7 +94,7 @@ SolverRelaxation::SolverRelaxation(SolverControl &cn, template -template +template void SolverRelaxation::solve(const MatrixType & A, VectorType & x, diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index 7b7a53eb15..135cf96f4a 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -1577,7 +1577,7 @@ public: * internal storage scheme. If it is false, the elements in a row are * written in ascending column order. */ - template + template void print(StreamType &out, const bool across = false, @@ -2506,7 +2506,7 @@ SparseMatrix::end(const size_type r) template -template +template inline void SparseMatrix::print(StreamType &out, const bool across, diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index a78480b07f..63b4010480 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -414,7 +414,7 @@ public: * existing row lengths and allocated row lengths. Otherwise, just the * relation of allocated and used entries is shown. */ - template + template void print_statistics(StreamType &s, bool full = false); @@ -1570,7 +1570,7 @@ SparseMatrixEZ::conjugate_add(const MatrixTypeA &A, template -template +template inline void SparseMatrixEZ::print_statistics(StreamType &out, bool full) { diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index 48f8b7979a..3172ad3003 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -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/meshworker/assemble_flags.h b/include/deal.II/meshworker/assemble_flags.h index 8c28b08601..e9c772c2c2 100644 --- a/include/deal.II/meshworker/assemble_flags.h +++ b/include/deal.II/meshworker/assemble_flags.h @@ -111,7 +111,7 @@ namespace MeshWorker * * @ref AssembleFlags */ - template + template inline StreamType & operator<<(StreamType &s, AssembleFlags u) { diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index 6ddca48766..fa15acbe1f 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -385,7 +385,7 @@ namespace MeshWorker void reinit(const BlockIndices &local_sizes); - template + template void print_debug(StreamType &os) const; @@ -659,7 +659,7 @@ namespace MeshWorker template - template + template void LocalResults::print_debug(StreamType &os) const { diff --git a/include/deal.II/meshworker/mesh_loop.h b/include/deal.II/meshworker/mesh_loop.h index eb212da85d..8af89aa03c 100644 --- a/include/deal.II/meshworker/mesh_loop.h +++ b/include/deal.II/meshworker/mesh_loop.h @@ -51,7 +51,7 @@ namespace MeshWorker * A helper class to provide a type definition for the underlying cell * iterator type. */ - template + template struct CellIteratorBaseType { /** @@ -67,7 +67,7 @@ namespace MeshWorker * This specialization is for IteratorRange, which may have either a * TriaActiveIterator or a FilteredIterator as its base type. */ - template + template struct CellIteratorBaseType> { /** @@ -87,7 +87,7 @@ namespace MeshWorker * TriaActiveIterator as its base type, or may be nested with another * FilteredIterator as the type to iterate over. */ - template + template struct CellIteratorBaseType> { /** @@ -273,10 +273,10 @@ namespace MeshWorker * * @ingroup MeshWorker */ - template ::type> void mesh_loop( @@ -707,10 +707,10 @@ namespace MeshWorker * * @ingroup MeshWorker */ - template ::type> void mesh_loop( @@ -833,7 +833,7 @@ namespace MeshWorker * * @ingroup MeshWorker */ - template @@ -1013,11 +1013,11 @@ namespace MeshWorker * * @ingroup MeshWorker */ - template ::type> void mesh_loop(IteratorRange iterator_range, diff --git a/include/deal.II/meshworker/vector_selector.h b/include/deal.II/meshworker/vector_selector.h index 6224e6dc97..4eb2a48a49 100644 --- a/include/deal.II/meshworker/vector_selector.h +++ b/include/deal.II/meshworker/vector_selector.h @@ -150,14 +150,14 @@ namespace MeshWorker /** * Print the contents of the selection to the stream. */ - template + template void print(StreamType &s, const AnyData &v) const; /** * Print the number of selections to the stream. */ - template + template void print(StreamType &s) const; @@ -521,7 +521,7 @@ namespace MeshWorker } - template + template inline void VectorSelector::print(StreamType &s) const { @@ -530,7 +530,7 @@ namespace MeshWorker } - template + template inline void VectorSelector::print(StreamType &s, const AnyData &v) const { diff --git a/include/deal.II/multigrid/mg_block_smoother.h b/include/deal.II/multigrid/mg_block_smoother.h index ac321dfc82..45c0399041 100644 --- a/include/deal.II/multigrid/mg_block_smoother.h +++ b/include/deal.II/multigrid/mg_block_smoother.h @@ -47,7 +47,7 @@ DEAL_II_NAMESPACE_OPEN * smoother object. Therefore, the smoother object for each level must be * constructed by hand. */ -template +template class MGSmootherBlock : public MGSmoother> { public: @@ -73,7 +73,7 @@ public: * This function stores pointers to the level matrices and smoothing * operator for each level. */ - template + template void initialize(const MGMatrixType &matrices, const MGRelaxationType &smoothers); @@ -135,7 +135,7 @@ private: #ifndef DOXYGEN -template +template inline MGSmootherBlock::MGSmootherBlock( const unsigned int steps, const bool variable, @@ -148,7 +148,7 @@ inline MGSmootherBlock::MGSmootherBlock( {} -template +template inline void MGSmootherBlock::clear() { @@ -161,8 +161,8 @@ MGSmootherBlock::clear() } -template -template +template +template inline void MGSmootherBlock::initialize( const MGMatrixType & m, @@ -186,7 +186,7 @@ MGSmootherBlock::initialize( } -template +template inline void MGSmootherBlock::set_reverse( const bool flag) @@ -195,7 +195,7 @@ MGSmootherBlock::set_reverse( } -template +template inline std::size_t MGSmootherBlock::memory_consumption() const { @@ -205,7 +205,7 @@ MGSmootherBlock::memory_consumption() const } -template +template inline void MGSmootherBlock::smooth( const unsigned int level, diff --git a/include/deal.II/multigrid/mg_smoother.h b/include/deal.II/multigrid/mg_smoother.h index b805774a02..3fc5a9e332 100644 --- a/include/deal.II/multigrid/mg_smoother.h +++ b/include/deal.II/multigrid/mg_smoother.h @@ -181,7 +181,7 @@ namespace mg * the multigrid method must be used only with the vector associated to that * single block. */ - template + template class SmootherRelaxation : public MGLevelObject, public MGSmoother { @@ -292,7 +292,7 @@ namespace mg * float and @p double. Additional instantiations may be created by including * the file mg_smoother.templates.h. */ -template +template class MGSmootherRelaxation : public MGSmoother { public: @@ -658,7 +658,7 @@ MGSmoother::set_transpose(const bool flag) namespace mg { - template + template inline SmootherRelaxation::SmootherRelaxation( const unsigned int steps, const bool variable, @@ -668,7 +668,7 @@ namespace mg {} - template + template inline void SmootherRelaxation::clear() { @@ -676,7 +676,7 @@ namespace mg } - template + template template inline void SmootherRelaxation::initialize( @@ -693,7 +693,7 @@ namespace mg } - template + template template inline void SmootherRelaxation::initialize( @@ -710,7 +710,7 @@ namespace mg } - template + template inline void SmootherRelaxation::smooth( const unsigned int level, @@ -741,7 +741,7 @@ namespace mg } - template + template inline void SmootherRelaxation::apply( const unsigned int level, @@ -778,7 +778,7 @@ namespace mg } - template + template inline std::size_t SmootherRelaxation::memory_consumption() const { @@ -791,7 +791,7 @@ namespace mg //----------------------------------------------------------------------// -template +template inline MGSmootherRelaxation:: MGSmootherRelaxation(const unsigned int steps, const bool variable, @@ -802,7 +802,7 @@ inline MGSmootherRelaxation:: -template +template inline void MGSmootherRelaxation::clear() { @@ -814,7 +814,7 @@ MGSmootherRelaxation::clear() } -template +template template inline void MGSmootherRelaxation::initialize( @@ -838,7 +838,7 @@ MGSmootherRelaxation::initialize( } } -template +template template inline void MGSmootherRelaxation::initialize( @@ -865,7 +865,7 @@ MGSmootherRelaxation::initialize( } } -template +template template inline void MGSmootherRelaxation::initialize( @@ -891,7 +891,7 @@ MGSmootherRelaxation::initialize( } } -template +template template inline void MGSmootherRelaxation::initialize( @@ -921,7 +921,7 @@ MGSmootherRelaxation::initialize( } -template +template inline void MGSmootherRelaxation::smooth( const unsigned int level, @@ -952,7 +952,7 @@ MGSmootherRelaxation::smooth( } -template +template inline void MGSmootherRelaxation::apply( const unsigned int level, @@ -990,7 +990,7 @@ MGSmootherRelaxation::apply( -template +template inline std::size_t MGSmootherRelaxation:: memory_consumption() const diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 27ef91def7..3ef46d160e 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -478,7 +478,7 @@ private: */ SmartPointer, Multigrid> edge_up; - template + template friend class PreconditionMG; }; @@ -529,7 +529,7 @@ public: * * This is the operator used by LAC iterative solvers. */ - template + template void vmult(OtherVectorType &dst, const OtherVectorType &src) const; @@ -537,7 +537,7 @@ public: * Preconditioning operator. Calls the @p vcycle function of the @p MG * object passed to the constructor. */ - template + template void vmult_add(OtherVectorType &dst, const OtherVectorType &src) const; @@ -546,7 +546,7 @@ public: * * Not implemented, but the definition may be needed. */ - template + template void Tvmult(OtherVectorType &dst, const OtherVectorType &src) const; @@ -555,7 +555,7 @@ public: * * Not implemented, but the definition may be needed. */ - template + template void Tvmult_add(OtherVectorType &dst, const OtherVectorType &src) const; @@ -866,7 +866,7 @@ PreconditionMG::empty() const } template -template +template void PreconditionMG::vmult( OtherVectorType & dst, @@ -940,7 +940,7 @@ PreconditionMG::connect_transfer_to_global( template -template +template void PreconditionMG::vmult_add( OtherVectorType & dst, @@ -958,7 +958,7 @@ PreconditionMG::vmult_add( template -template +template void PreconditionMG::Tvmult(OtherVectorType &, const OtherVectorType &) const @@ -968,7 +968,7 @@ PreconditionMG::Tvmult(OtherVectorType &, template -template +template void PreconditionMG::Tvmult_add( OtherVectorType &, diff --git a/include/deal.II/non_matching/fe_values.h b/include/deal.II/non_matching/fe_values.h index 1231d1f4e5..0f612e2550 100644 --- a/include/deal.II/non_matching/fe_values.h +++ b/include/deal.II/non_matching/fe_values.h @@ -520,7 +520,7 @@ namespace NonMatching * implemented, the passed values of these must equal * numbers::invalid_unsigned_int. */ - template + template void reinit(const CellIteratorType & cell, const unsigned int face_no, @@ -537,7 +537,7 @@ namespace NonMatching * FEInterfaceValues object can be retrieved for each region using the * functions get_inside_fe_values() or get_outside_fe_values(). */ - template + template void reinit(const CellIteratorType &cell, const unsigned int face_no); @@ -688,7 +688,7 @@ namespace NonMatching /*---------------------- Inline functions ---------------------*/ template - template + template inline void FEInterfaceValues::reinit(const CellIteratorType &cell, const unsigned int face_no) @@ -706,7 +706,7 @@ namespace NonMatching template - template + template inline void FEInterfaceValues::reinit(const CellIteratorType & cell, const unsigned int face_no, diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h index 2f6e1d26ed..ba32e7aa48 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.h +++ b/include/deal.II/numerics/vector_tools_interpolate.h @@ -35,7 +35,7 @@ template class FullMatrix; template class Function; -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) class InterGridMap; template diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index dc1ba232a7..c38690b64b 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -2826,7 +2826,7 @@ namespace DataOutBase } - template + template void write_data(const std::vector> &patches, unsigned int n_data_sets, diff --git a/source/dofs/dof_renumbering.cc b/source/dofs/dof_renumbering.cc index e2f35e7d7f..5374a2437f 100644 --- a/source/dofs/dof_renumbering.cc +++ b/source/dofs/dof_renumbering.cc @@ -1265,7 +1265,7 @@ namespace DoFRenumbering // cell, renumbers DoF indices on it. The function starts renumbering with // 'next_free_dof_index' and returns the first still unused DoF index at the // end of its operation. - template + template types::global_dof_index compute_hierarchical_recursive( const types::global_dof_index next_free_dof_offset, diff --git a/source/fe/mapping_cartesian.cc b/source/fe/mapping_cartesian.cc index 9437ab5304..182a71a9f7 100644 --- a/source/fe/mapping_cartesian.cc +++ b/source/fe/mapping_cartesian.cc @@ -48,7 +48,7 @@ DeclExceptionMsg( * checking if the smallest BoundingBox that encloses the cell has the same * vertices as the cell itself. */ -template +template bool is_cartesian(const CellType &cell) { diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index b8680497ea..51ef15235d 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -495,7 +495,7 @@ namespace GridTools /** * Store the data about the given face @p face. */ - template + template void insert_face_data(const FaceIteratorType &face) { @@ -534,7 +534,7 @@ namespace GridTools class FaceDataHelper<1> { public: - template + template void insert_face_data(const FaceIteratorType &) {} @@ -3083,7 +3083,7 @@ namespace GridTools { namespace BoundingBoxPredicate { - template + template DEAL_II_CXX20_REQUIRES( concepts::is_triangulation_or_dof_handler) std::tuple< @@ -3141,7 +3141,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector> compute_mesh_predicate_bounding_box( diff --git a/source/grid/grid_tools_dof_handlers.cc b/source/grid/grid_tools_dof_handlers.cc index fc5bfee757..56c197e655 100644 --- a/source/grid/grid_tools_dof_handlers.cc +++ b/source/grid/grid_tools_dof_handlers.cc @@ -189,7 +189,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES((concepts::is_triangulation_or_dof_handler)) #ifndef _MSC_VER std::vector @@ -761,7 +761,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_active_cell_halo_layer( @@ -799,7 +799,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_cell_halo_layer_on_level( @@ -844,7 +844,7 @@ namespace GridTools namespace { - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) bool contains_locally_owned_cells( const std::vector &cells) @@ -861,7 +861,7 @@ namespace GridTools return false; } - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) bool contains_artificial_cells( const std::vector &cells) @@ -881,7 +881,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector< typename MeshType:: @@ -905,7 +905,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std:: vector compute_active_cell_layer_within_distance( @@ -1050,7 +1050,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector< typename MeshType:: @@ -1090,7 +1090,7 @@ namespace GridTools - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::pair< Point, @@ -1426,7 +1426,7 @@ namespace GridTools } - template + template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::vector get_patch_around_cell( const typename MeshType::active_cell_iterator &cell) diff --git a/source/grid/intergrid_map.cc b/source/grid/intergrid_map.cc index 9d0b27f0c4..031abfffc4 100644 --- a/source/grid/intergrid_map.cc +++ b/source/grid/intergrid_map.cc @@ -33,7 +33,7 @@ DEAL_II_NAMESPACE_OPEN -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) InterGridMap::InterGridMap() : source_grid(nullptr, typeid(*this).name()) @@ -42,7 +42,7 @@ InterGridMap::InterGridMap() -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void InterGridMap::make_mapping(const MeshType &source_grid, const MeshType &destination_grid) @@ -98,7 +98,7 @@ void InterGridMap::make_mapping(const MeshType &source_grid, -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void InterGridMap::set_mapping(const cell_iterator &src_cell, const cell_iterator &dst_cell) @@ -137,7 +137,7 @@ void InterGridMap::set_mapping(const cell_iterator &src_cell, -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void InterGridMap::set_entries_to_cell(const cell_iterator &src_cell, const cell_iterator &dst_cell) @@ -153,7 +153,7 @@ void InterGridMap::set_entries_to_cell(const cell_iterator &src_cell, } -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) typename InterGridMap::cell_iterator InterGridMap::operator[](const cell_iterator &source_cell) const @@ -171,7 +171,7 @@ typename InterGridMap::cell_iterator -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) void InterGridMap::clear() { @@ -182,7 +182,7 @@ void InterGridMap::clear() -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) const MeshType &InterGridMap::get_source_grid() const { @@ -191,7 +191,7 @@ const MeshType &InterGridMap::get_source_grid() const -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) const MeshType &InterGridMap::get_destination_grid() const { @@ -200,7 +200,7 @@ const MeshType &InterGridMap::get_destination_grid() const -template +template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) std::size_t InterGridMap::memory_consumption() const { diff --git a/source/hp/fe_values.cc b/source/hp/fe_values.cc index 51e40fe29b..77e3da57cb 100644 --- a/source/hp/fe_values.cc +++ b/source/hp/fe_values.cc @@ -62,7 +62,7 @@ namespace hp // -------------------------- FEValuesBase ------------------------- - template + template FEValuesBase::FEValuesBase( const MappingCollection & mapping_collection, @@ -82,7 +82,7 @@ namespace hp , update_flags(update_flags) {} - template + template FEValuesBase::FEValuesBase( const MappingCollection & mapping_collection, @@ -103,7 +103,7 @@ namespace hp {} - template + template FEValuesBase::FEValuesBase( const FECollection &fe_collection, const QCollection & q_collection, @@ -117,7 +117,7 @@ namespace hp {} - template + template FEValuesBase::FEValuesBase( const FECollection &fe_collection, const std::vector> & q_collection, @@ -132,7 +132,7 @@ namespace hp - template + template FEValuesBase::FEValuesBase( const FEValuesBase &other) : Subscriptor(other) @@ -171,7 +171,7 @@ namespace hp - template + template FEValuesType & FEValuesBase::select_fe_values( const unsigned int fe_index, @@ -201,7 +201,7 @@ namespace hp - template + template void FEValuesBase::precalculate_fe_values( const std::vector &fe_indices, @@ -238,7 +238,7 @@ namespace hp - template + template void FEValuesBase::precalculate_fe_values() { diff --git a/source/lac/block_sparsity_pattern.cc b/source/lac/block_sparsity_pattern.cc index c2de6c6d6a..2c71280fb3 100644 --- a/source/lac/block_sparsity_pattern.cc +++ b/source/lac/block_sparsity_pattern.cc @@ -21,7 +21,7 @@ DEAL_II_NAMESPACE_OPEN -template +template BlockSparsityPatternBase::BlockSparsityPatternBase() : block_rows(0) , block_columns(0) @@ -29,7 +29,7 @@ BlockSparsityPatternBase::BlockSparsityPatternBase() -template +template BlockSparsityPatternBase::BlockSparsityPatternBase( const size_type block_rows, const size_type block_columns) @@ -40,7 +40,7 @@ BlockSparsityPatternBase::BlockSparsityPatternBase( -template +template BlockSparsityPatternBase::BlockSparsityPatternBase( const BlockSparsityPatternBase &s) : BlockSparsityPatternBase() @@ -55,7 +55,7 @@ BlockSparsityPatternBase::BlockSparsityPatternBase( -template +template void BlockSparsityPatternBase::reinit( const size_type new_block_rows, @@ -73,7 +73,7 @@ BlockSparsityPatternBase::reinit( } -template +template BlockSparsityPatternBase & BlockSparsityPatternBase::operator=( const BlockSparsityPatternBase &bsp) @@ -92,7 +92,7 @@ BlockSparsityPatternBase::operator=( -template +template typename BlockSparsityPatternBase::size_type BlockSparsityPatternBase::compute_n_rows() const { @@ -106,7 +106,7 @@ BlockSparsityPatternBase::compute_n_rows() const -template +template typename BlockSparsityPatternBase::size_type BlockSparsityPatternBase::compute_n_cols() const { @@ -120,7 +120,7 @@ BlockSparsityPatternBase::compute_n_cols() const -template +template void BlockSparsityPatternBase::collect_sizes() { @@ -165,7 +165,7 @@ BlockSparsityPatternBase::collect_sizes() -template +template void BlockSparsityPatternBase::compress() { @@ -176,7 +176,7 @@ BlockSparsityPatternBase::compress() -template +template bool BlockSparsityPatternBase::empty() const { @@ -189,7 +189,7 @@ BlockSparsityPatternBase::empty() const -template +template typename BlockSparsityPatternBase::size_type BlockSparsityPatternBase::max_entries_per_row() const { @@ -208,7 +208,7 @@ BlockSparsityPatternBase::max_entries_per_row() const -template +template typename BlockSparsityPatternBase::size_type BlockSparsityPatternBase::n_nonzero_elements() const { @@ -221,7 +221,7 @@ BlockSparsityPatternBase::n_nonzero_elements() const -template +template void BlockSparsityPatternBase::print(std::ostream &out) const { @@ -278,7 +278,7 @@ BlockSparsityPatternBase::print(std::ostream &out) const -template +template void BlockSparsityPatternBase::print_gnuplot( std::ostream &out) const @@ -305,7 +305,7 @@ BlockSparsityPatternBase::print_gnuplot( -template +template void BlockSparsityPatternBase::print_svg( std::ostream &out) const @@ -346,7 +346,7 @@ BlockSparsityPatternBase::print_svg( -template +template std::size_t BlockSparsityPatternBase::memory_consumption() const { -- 2.39.5