From: Timo Heister Date: Fri, 21 Mar 2025 20:11:04 +0000 (-0400) Subject: p::distributed::BlockVector: add MemorySpace X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=963eb679b71e6ac1ce351ebd524ede741db5c1fc;p=dealii.git p::distributed::BlockVector: add MemorySpace and instantiate for ::Host and ::Default --- diff --git a/include/deal.II/base/template_constraints.h b/include/deal.II/base/template_constraints.h index 515ee535e9..7a37c5fad7 100644 --- a/include/deal.II/base/template_constraints.h +++ b/include/deal.II/base/template_constraints.h @@ -625,7 +625,7 @@ namespace LinearAlgebra template class Vector; - template + template class BlockVector; } // namespace distributed } // namespace LinearAlgebra @@ -747,9 +747,10 @@ namespace concepts inline constexpr bool is_dealii_vector_type< dealii::LinearAlgebra::distributed::Vector> = true; - template + template inline constexpr bool is_dealii_vector_type< - dealii::LinearAlgebra::distributed::BlockVector> = true; + dealii::LinearAlgebra::distributed::BlockVector> = + true; # ifdef DEAL_II_WITH_PETSC template <> diff --git a/include/deal.II/lac/la_parallel_block_vector.h b/include/deal.II/lac/la_parallel_block_vector.h index 1ffede99de..ae85065fae 100644 --- a/include/deal.II/lac/la_parallel_block_vector.h +++ b/include/deal.II/lac/la_parallel_block_vector.h @@ -80,8 +80,8 @@ namespace LinearAlgebra * @see * @ref GlossBlockLA "Block (linear algebra)" */ - template - class BlockVector : public BlockVectorBase> + template + class BlockVector : public BlockVectorBase> { public: /** @@ -101,7 +101,7 @@ namespace LinearAlgebra /** * Typedef the base class for simpler access to its own alias. */ - using BaseClass = BlockVectorBase>; + using BaseClass = BlockVectorBase>; /** * Typedef the type of the underlying vector. @@ -143,7 +143,7 @@ namespace LinearAlgebra * Copy-Constructor. Dimension set to that of V, all components are * copied from V */ - BlockVector(const BlockVector &V); + BlockVector(const BlockVector &V); /** * Copy constructor taking a BlockVector of another data type. This will @@ -152,7 +152,7 @@ namespace LinearAlgebra * BlockVector with data elements with less accuracy. */ template - explicit BlockVector(const BlockVector &v); + explicit BlockVector(const BlockVector &v); /** * Constructor. Set the number of blocks to block_sizes.size() @@ -232,13 +232,13 @@ namespace LinearAlgebra */ template BlockVector & - operator=(const BlockVector &V); + operator=(const BlockVector &V); /** * Copy a regular vector into a block vector. */ BlockVector & - operator=(const Vector &V); + operator=(const Vector &V); #ifdef DEAL_II_WITH_PETSC /** @@ -248,7 +248,7 @@ namespace LinearAlgebra * * This operator is only available if deal.II was configured with PETSc. */ - BlockVector & + BlockVector & operator=(const PETScWrappers::MPI::BlockVector &petsc_vec); #endif @@ -261,7 +261,7 @@ namespace LinearAlgebra * This operator is only available if deal.II was configured with * Trilinos. */ - BlockVector & + BlockVector & operator=(const TrilinosWrappers::MPI::BlockVector &trilinos_vec); #endif @@ -322,8 +322,8 @@ namespace LinearAlgebra */ template void - reinit(const BlockVector &V, - const bool omit_zeroing_entries = false); + reinit(const BlockVector &V, + const bool omit_zeroing_entries = false); /** * Initialize the block vector. For each block, the local range is @@ -336,8 +336,8 @@ namespace LinearAlgebra * * This function involves global communication, so it should only be * called once for a given layout. Use the @p reinit function with - * BlockVector argument to create additional vectors with the same - * parallel layout. + * BlockVector argument to create additional vectors + * with the same parallel layout. * * @see * @ref GlossGhostedVector "vectors with ghost elements" @@ -462,7 +462,8 @@ namespace LinearAlgebra */ template void - copy_locally_owned_data_from(const BlockVector &src); + copy_locally_owned_data_from( + const BlockVector &src); /** * This is a collective add operation that adds a whole set of values @@ -478,7 +479,7 @@ namespace LinearAlgebra * s*(*this)+V. */ void - sadd(const Number s, const BlockVector &V); + sadd(const Number s, const BlockVector &V); /** * Return whether the vector contains only elements with value zero. @@ -519,7 +520,7 @@ namespace LinearAlgebra * functions. */ void - swap(BlockVector &v) noexcept; + swap(BlockVector &v) noexcept; /** @} */ /** @@ -530,26 +531,26 @@ namespace LinearAlgebra /** * Multiply the entire vector by a fixed factor. */ - BlockVector & + BlockVector & operator*=(const Number factor); /** * Divide the entire vector by a fixed factor. */ - BlockVector & + BlockVector & operator/=(const Number factor); /** * Add the vector @p V to the present one. */ - BlockVector & - operator+=(const BlockVector &V); + BlockVector & + operator+=(const BlockVector &V); /** * Subtract the vector @p V from the present one. */ - BlockVector & - operator-=(const BlockVector &V); + BlockVector & + operator-=(const BlockVector &V); /** * Import all the elements present in the vector's IndexSet from the input @@ -582,7 +583,7 @@ namespace LinearAlgebra * Return the scalar product of two vectors. */ Number - operator*(const BlockVector &V) const; + operator*(const BlockVector &V) const; /** * Calculate the scalar product between each block of this vector and @p V @@ -602,8 +603,8 @@ namespace LinearAlgebra */ template void - multivector_inner_product(FullMatrixType &matrix, - const BlockVector &V, + multivector_inner_product(FullMatrixType &matrix, + const BlockVector &V, const bool symmetric = false) const; /** @@ -624,9 +625,10 @@ namespace LinearAlgebra */ template Number - multivector_inner_product_with_metric(const FullMatrixType &matrix, - const BlockVector &V, - const bool symmetric = false) const; + multivector_inner_product_with_metric( + const FullMatrixType &matrix, + const BlockVector &V, + const bool symmetric = false) const; /** * Set each block of this vector as follows: @@ -639,10 +641,10 @@ namespace LinearAlgebra */ template void - mmult(BlockVector &V, - const FullMatrixType &matrix, - const Number s = Number(0.), - const Number b = Number(1.)) const; + mmult(BlockVector &V, + const FullMatrixType &matrix, + const Number s = Number(0.), + const Number b = Number(1.)) const; /** * Add @p a to all components. Note that @p a is a scalar not a vector. @@ -654,16 +656,16 @@ namespace LinearAlgebra * Simple addition of a multiple of a vector, i.e. *this += a*V. */ void - add(const Number a, const BlockVector &V); + add(const Number a, const BlockVector &V); /** * Multiple addition of scaled vectors, i.e. *this += a*V+b*W. */ void - add(const Number a, - const BlockVector &V, - const Number b, - const BlockVector &W); + add(const Number a, + const BlockVector &V, + const Number b, + const BlockVector &W); /** * A collective add operation: This function adds a whole set of values @@ -678,7 +680,9 @@ namespace LinearAlgebra * s*(*this)+a*V. */ void - sadd(const Number s, const Number a, const BlockVector &V); + sadd(const Number s, + const Number a, + const BlockVector &V); /** * Scale each element of this vector by the corresponding element in the @@ -686,13 +690,13 @@ namespace LinearAlgebra * immediate re-assignment) by a diagonal scaling matrix. */ void - scale(const BlockVector &scaling_factors); + scale(const BlockVector &scaling_factors); /** * Assignment *this = a*V. */ void - equ(const Number a, const BlockVector &V); + equ(const Number a, const BlockVector &V); /** * Return the l1 norm of the vector (i.e., the sum of the @@ -742,9 +746,9 @@ namespace LinearAlgebra * $\left=\sum_i v_i \bar{w_i}$. */ Number - add_and_dot(const Number a, - const BlockVector &V, - const BlockVector &W); + add_and_dot(const Number a, + const BlockVector &V, + const BlockVector &W); /** * Return the global size of the vector, equal to the sum of the number of @@ -816,10 +820,10 @@ namespace LinearAlgebra * * @relatesalso BlockVector */ -template +template inline void -swap(LinearAlgebra::distributed::BlockVector &u, - LinearAlgebra::distributed::BlockVector &v) noexcept +swap(LinearAlgebra::distributed::BlockVector &u, + LinearAlgebra::distributed::BlockVector &v) noexcept { u.swap(v); } @@ -829,8 +833,9 @@ swap(LinearAlgebra::distributed::BlockVector &u, * Declare dealii::LinearAlgebra::distributed::BlockVector as distributed * vector. */ -template -struct is_serial_vector> +template +struct is_serial_vector< + LinearAlgebra::distributed::BlockVector> : std::false_type {}; diff --git a/include/deal.II/lac/la_parallel_block_vector.templates.h b/include/deal.II/lac/la_parallel_block_vector.templates.h index e431643448..bc10b70516 100644 --- a/include/deal.II/lac/la_parallel_block_vector.templates.h +++ b/include/deal.II/lac/la_parallel_block_vector.templates.h @@ -40,42 +40,45 @@ namespace LinearAlgebra { namespace distributed { - template - BlockVector::BlockVector(const size_type n_blocks, - const size_type block_size) + template + BlockVector::BlockVector(const size_type n_blocks, + const size_type block_size) { reinit(n_blocks, block_size); } - template - BlockVector::BlockVector(const std::vector &n) + template + BlockVector::BlockVector( + const std::vector &n) { reinit(n, false); } - template - BlockVector::BlockVector(const std::vector &local_ranges, - const std::vector &ghost_indices, - const MPI_Comm communicator) + template + BlockVector::BlockVector( + const std::vector &local_ranges, + const std::vector &ghost_indices, + const MPI_Comm communicator) { reinit(local_ranges, ghost_indices, communicator); } - template - BlockVector::BlockVector(const std::vector &local_ranges, - const MPI_Comm communicator) + template + BlockVector::BlockVector( + const std::vector &local_ranges, + const MPI_Comm communicator) { reinit(local_ranges, communicator); } - template - BlockVector::BlockVector( + template + BlockVector::BlockVector( const std::vector> &partitioners, const MPI_Comm &comm_sm) @@ -85,9 +88,10 @@ namespace LinearAlgebra - template - BlockVector::BlockVector(const BlockVector &v) - : BlockVectorBase>() + template + BlockVector::BlockVector( + const BlockVector &v) + : BlockVectorBase>() { this->block_indices = v.block_indices; @@ -100,9 +104,10 @@ namespace LinearAlgebra - template + template template - BlockVector::BlockVector(const BlockVector &v) + BlockVector::BlockVector( + const BlockVector &v) { reinit(v, true); *this = v; @@ -110,21 +115,22 @@ namespace LinearAlgebra - template + template void - BlockVector::reinit(const size_type n_bl, - const size_type bl_sz, - const bool omit_zeroing_entries) + BlockVector::reinit(const size_type n_bl, + const size_type bl_sz, + const bool omit_zeroing_entries) { std::vector n(n_bl, bl_sz); reinit(n, omit_zeroing_entries); } - template + template void - BlockVector::reinit(const std::vector &block_sizes, - const bool omit_zeroing_entries) + BlockVector::reinit( + const std::vector &block_sizes, + const bool omit_zeroing_entries) { this->block_indices.reinit(block_sizes); @@ -137,11 +143,12 @@ namespace LinearAlgebra - template + template template void - BlockVector::reinit(const BlockVector &v, - const bool omit_zeroing_entries) + BlockVector::reinit( + const BlockVector &v, + const bool omit_zeroing_entries) { if (this->n_blocks() != v.n_blocks()) this->block_indices = v.get_block_indices(); @@ -155,11 +162,12 @@ namespace LinearAlgebra - template + template void - BlockVector::reinit(const std::vector &local_ranges, - const std::vector &ghost_indices, - const MPI_Comm communicator) + BlockVector::reinit( + const std::vector &local_ranges, + const std::vector &ghost_indices, + const MPI_Comm communicator) { AssertDimension(local_ranges.size(), ghost_indices.size()); @@ -179,10 +187,11 @@ namespace LinearAlgebra - template + template void - BlockVector::reinit(const std::vector &local_ranges, - const MPI_Comm communicator) + BlockVector::reinit( + const std::vector &local_ranges, + const MPI_Comm communicator) { // update the number of blocks this->block_indices.reinit(local_ranges.size(), 0); @@ -198,9 +207,9 @@ namespace LinearAlgebra - template + template void - BlockVector::reinit( + BlockVector::reinit( const std::vector> &partitioners, const MPI_Comm &comm_sm) @@ -219,9 +228,9 @@ namespace LinearAlgebra - template + template void - BlockVector::reinit( + BlockVector::reinit( const std::vector> &partitioners, const bool /*make_ghosted*/, @@ -232,9 +241,9 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator=(const value_type s) + template + BlockVector & + BlockVector::operator=(const value_type s) { AssertIsFinite(s); @@ -244,9 +253,9 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator=(const BlockVector &v) + template + BlockVector & + BlockVector::operator=(const BlockVector &v) { // we only allow assignment to vectors with the same number of blocks // or to an empty BlockVector @@ -267,9 +276,10 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator=(const Vector &v) + template + BlockVector & + BlockVector::operator=( + const Vector &v) { BaseClass::operator=(v); return *this; @@ -277,10 +287,11 @@ namespace LinearAlgebra - template + template template - BlockVector & - BlockVector::operator=(const BlockVector &v) + BlockVector & + BlockVector::operator=( + const BlockVector &v) { reinit(v, true); BaseClass::operator=(v); @@ -289,11 +300,11 @@ namespace LinearAlgebra - template + template template void - BlockVector::copy_locally_owned_data_from( - const BlockVector &v) + BlockVector::copy_locally_owned_data_from( + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); @@ -337,9 +348,9 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator=( + template + BlockVector & + BlockVector::operator=( const PETScWrappers::MPI::BlockVector &petsc_vec) { AssertDimension(this->n_blocks(), petsc_vec.n_blocks()); @@ -387,9 +398,9 @@ namespace LinearAlgebra #ifdef DEAL_II_WITH_TRILINOS - template - BlockVector & - BlockVector::operator=( + template + BlockVector & + BlockVector::operator=( const TrilinosWrappers::MPI::BlockVector &trilinos_vec) { AssertDimension(this->n_blocks(), trilinos_vec.n_blocks()); @@ -415,9 +426,10 @@ namespace LinearAlgebra - template + template void - BlockVector::compress(VectorOperation::values operation) + BlockVector::compress( + VectorOperation::values operation) { const unsigned int n_chunks = (this->n_blocks() + communication_block_size - 1) / @@ -443,9 +455,9 @@ namespace LinearAlgebra - template + template void - BlockVector::update_ghost_values() const + BlockVector::update_ghost_values() const { const unsigned int n_chunks = (this->n_blocks() + communication_block_size - 1) / @@ -469,9 +481,9 @@ namespace LinearAlgebra - template + template void - BlockVector::zero_out_ghost_values() const + BlockVector::zero_out_ghost_values() const { for (unsigned int block = 0; block < this->n_blocks(); ++block) this->block(block).zero_out_ghost_values(); @@ -479,9 +491,9 @@ namespace LinearAlgebra - template + template bool - BlockVector::has_ghost_elements() const + BlockVector::has_ghost_elements() const { bool has_ghost_elements = false; for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -492,9 +504,9 @@ namespace LinearAlgebra - template + template void - BlockVector::set_ghost_state(const bool ghosted) const + BlockVector::set_ghost_state(const bool ghosted) const { for (unsigned int block = 0; block < this->n_blocks(); ++block) this->block(block).set_ghost_state(ghosted); @@ -502,9 +514,9 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator*=(const Number factor) + template + BlockVector & + BlockVector::operator*=(const Number factor) { for (unsigned int block = 0; block < this->n_blocks(); ++block) this->block(block) *= factor; @@ -513,9 +525,9 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator/=(const Number factor) + template + BlockVector & + BlockVector::operator/=(const Number factor) { operator*=(static_cast(1.) / factor); return *this; @@ -523,9 +535,10 @@ namespace LinearAlgebra - template + template void - BlockVector::scale(const BlockVector &v) + BlockVector::scale( + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -534,9 +547,11 @@ namespace LinearAlgebra - template + template void - BlockVector::equ(const Number a, const BlockVector &v) + BlockVector::equ( + const Number a, + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -545,9 +560,10 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator+=(const BlockVector &v) + template + BlockVector & + BlockVector::operator+=( + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -558,9 +574,10 @@ namespace LinearAlgebra - template - BlockVector & - BlockVector::operator-=(const BlockVector &v) + template + BlockVector & + BlockVector::operator-=( + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -571,9 +588,9 @@ namespace LinearAlgebra - template + template void - BlockVector::add(const Number a) + BlockVector::add(const Number a) { for (unsigned int block = 0; block < this->n_blocks(); ++block) this->block(block).add(a); @@ -581,9 +598,11 @@ namespace LinearAlgebra - template + template void - BlockVector::add(const Number a, const BlockVector &v) + BlockVector::add( + const Number a, + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -592,12 +611,13 @@ namespace LinearAlgebra - template + template void - BlockVector::add(const Number a, - const BlockVector &v, - const Number b, - const BlockVector &w) + BlockVector::add( + const Number a, + const BlockVector &v, + const Number b, + const BlockVector &w) { AssertDimension(this->n_blocks(), v.n_blocks()); AssertDimension(this->n_blocks(), w.n_blocks()); @@ -608,11 +628,12 @@ namespace LinearAlgebra - template + template void - BlockVector::sadd(const Number x, - const Number a, - const BlockVector &v) + BlockVector::sadd( + const Number x, + const Number a, + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -621,9 +642,11 @@ namespace LinearAlgebra - template + template void - BlockVector::sadd(const Number x, const BlockVector &v) + BlockVector::sadd( + const Number x, + const BlockVector &v) { AssertDimension(this->n_blocks(), v.n_blocks()); for (unsigned int block = 0; block < this->n_blocks(); ++block) @@ -632,11 +655,12 @@ namespace LinearAlgebra - template + template template void - BlockVector::add(const std::vector &indices, - const ::dealii::Vector &values) + BlockVector::add( + const std::vector &indices, + const ::dealii::Vector &values) { for (size_type i = 0; i < indices.size(); ++i) (*this)(indices[i]) += values[i]; @@ -644,10 +668,10 @@ namespace LinearAlgebra - template + template void - BlockVector::add(const std::vector &indices, - const std::vector &values) + BlockVector::add(const std::vector &indices, + const std::vector &values) { for (size_type i = 0; i < indices.size(); ++i) (*this)(indices[i]) += values[i]; @@ -655,9 +679,9 @@ namespace LinearAlgebra - template + template bool - BlockVector::all_zero() const + BlockVector::all_zero() const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -677,9 +701,10 @@ namespace LinearAlgebra - template + template Number - BlockVector::operator*(const BlockVector &v) const + BlockVector::operator*( + const BlockVector &v) const { Assert(this->n_blocks() > 0, ExcEmptyObject()); AssertDimension(this->n_blocks(), v.n_blocks()); @@ -697,9 +722,9 @@ namespace LinearAlgebra - template + template inline Number - BlockVector::mean_value() const + BlockVector::mean_value() const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -720,9 +745,9 @@ namespace LinearAlgebra - template - inline typename BlockVector::real_type - BlockVector::l1_norm() const + template + inline typename BlockVector::real_type + BlockVector::l1_norm() const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -739,9 +764,9 @@ namespace LinearAlgebra - template - inline typename BlockVector::real_type - BlockVector::norm_sqr() const + template + inline typename BlockVector::real_type + BlockVector::norm_sqr() const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -758,18 +783,18 @@ namespace LinearAlgebra - template - inline typename BlockVector::real_type - BlockVector::l2_norm() const + template + inline typename BlockVector::real_type + BlockVector::l2_norm() const { return std::sqrt(norm_sqr()); } - template - inline typename BlockVector::real_type - BlockVector::lp_norm(const real_type p) const + template + inline typename BlockVector::real_type + BlockVector::lp_norm(const real_type p) const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -788,9 +813,9 @@ namespace LinearAlgebra - template - inline typename BlockVector::real_type - BlockVector::linfty_norm() const + template + inline typename BlockVector::real_type + BlockVector::linfty_norm() const { Assert(this->n_blocks() > 0, ExcEmptyObject()); @@ -808,11 +833,12 @@ namespace LinearAlgebra - template + template inline Number - BlockVector::add_and_dot(const Number a, - const BlockVector &v, - const BlockVector &w) + BlockVector::add_and_dot( + const Number a, + const BlockVector &v, + const BlockVector &w) { AssertDimension(this->n_blocks(), v.n_blocks()); AssertDimension(this->n_blocks(), w.n_blocks()); @@ -831,9 +857,10 @@ namespace LinearAlgebra - template + template inline void - BlockVector::swap(BlockVector &v) noexcept + BlockVector::swap( + BlockVector &v) noexcept { Assert(this->n_blocks() == v.n_blocks(), ExcDimensionMismatch(this->n_blocks(), v.n_blocks())); @@ -845,18 +872,18 @@ namespace LinearAlgebra - template - typename BlockVector::size_type - BlockVector::size() const + template + typename BlockVector::size_type + BlockVector::size() const { return this->block_indices.total_size(); } - template + template inline void - BlockVector::import_elements( + BlockVector::import_elements( const LinearAlgebra::ReadWriteVector &, const VectorOperation::values, const std::shared_ptr &) @@ -866,9 +893,9 @@ namespace LinearAlgebra - template + template IndexSet - BlockVector::locally_owned_elements() const + BlockVector::locally_owned_elements() const { IndexSet is(size()); @@ -885,12 +912,12 @@ namespace LinearAlgebra return is; } - template + template void - BlockVector::print(std::ostream &out, - const unsigned int precision, - const bool scientific, - const bool across) const + BlockVector::print(std::ostream &out, + const unsigned int precision, + const bool scientific, + const bool across) const { for (unsigned int b = 0; b < this->n_blocks(); ++b) this->block(b).print(out, precision, scientific, across); @@ -898,9 +925,9 @@ namespace LinearAlgebra - template + template std::size_t - BlockVector::memory_consumption() const + BlockVector::memory_consumption() const { return (MemoryConsumption::memory_consumption(this->block_indices) + MemoryConsumption::memory_consumption(this->components)); @@ -928,12 +955,13 @@ namespace LinearAlgebra - template + template template void - BlockVector::multivector_inner_product(FullMatrixType &matrix, - const BlockVector &V, - const bool symmetric) const + BlockVector::multivector_inner_product( + FullMatrixType &matrix, + const BlockVector &V, + const bool symmetric) const { const unsigned int m = this->n_blocks(); const unsigned int n = V.n_blocks(); @@ -978,13 +1006,13 @@ namespace LinearAlgebra - template + template template Number - BlockVector::multivector_inner_product_with_metric( - const FullMatrixType &matrix, - const BlockVector &V, - const bool symmetric) const + BlockVector::multivector_inner_product_with_metric( + const FullMatrixType &matrix, + const BlockVector &V, + const bool symmetric) const { Number res = Number(0.); @@ -1027,13 +1055,13 @@ namespace LinearAlgebra - template + template template void - BlockVector::mmult(BlockVector &V, - const FullMatrixType &matrix, - const Number s, - const Number b) const + BlockVector::mmult(BlockVector &V, + const FullMatrixType &matrix, + const Number s, + const Number b) const { const unsigned int m = this->n_blocks(); const unsigned int n = V.n_blocks(); diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index d476a1d4a9..566ea28ef2 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -51,7 +51,7 @@ namespace LinearAlgebra */ namespace distributed { - template + template class BlockVector; } @@ -1472,7 +1472,7 @@ namespace LinearAlgebra friend class Vector; // Make BlockVector type friends. - template + template friend class BlockVector; }; /** @} */ diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index e7a79ec2a1..c16b14a503 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -46,7 +46,7 @@ namespace LinearAlgebra { template class Vector; - template + template class BlockVector; } // namespace distributed } // namespace LinearAlgebra @@ -2334,10 +2334,11 @@ namespace internal vector.add(-mean_value); } - template + template void set_initial_guess( - ::dealii::LinearAlgebra::distributed::BlockVector &vector) + ::dealii::LinearAlgebra::distributed::BlockVector + &vector) { for (unsigned int block = 0; block < vector.n_blocks(); ++block) set_initial_guess(vector.block(block)); diff --git a/source/lac/la_parallel_block_vector.cc b/source/lac/la_parallel_block_vector.cc index a8aa8d4b29..e997e9c332 100644 --- a/source/lac/la_parallel_block_vector.cc +++ b/source/lac/la_parallel_block_vector.cc @@ -30,9 +30,10 @@ namespace LinearAlgebra { namespace distributed { -#define TEMPL_COPY_CONSTRUCTOR(S1, S2) \ - template BlockVector &BlockVector::operator= \ - (const BlockVector &) +#define TEMPL_COPY_CONSTRUCTOR(S1, S2) \ + template BlockVector & \ + BlockVector::operator= \ + (const BlockVector &) TEMPL_COPY_CONSTRUCTOR(double, float); TEMPL_COPY_CONSTRUCTOR(float, double); diff --git a/source/lac/la_parallel_block_vector.inst.in b/source/lac/la_parallel_block_vector.inst.in index e13c9a1146..da63a81c21 100644 --- a/source/lac/la_parallel_block_vector.inst.in +++ b/source/lac/la_parallel_block_vector.inst.in @@ -21,41 +21,51 @@ for (SCALAR : REAL_AND_COMPLEX_SCALARS) namespace distributed \{ #ifdef DEAL_II_HAVE_CXX20 - static_assert(concepts::is_vector_space_vector>); + static_assert(concepts::is_vector_space_vector< + BlockVector>); + // static_assert(concepts::is_vector_space_vector>); #endif - template class BlockVector; + template class BlockVector; + template class BlockVector; template void - BlockVector::multivector_inner_product( - FullMatrix &, - const BlockVector &V, - const bool) const; + BlockVector:: + multivector_inner_product( + FullMatrix &, + const BlockVector &V, + const bool) const; template void - BlockVector::multivector_inner_product( - LAPACKFullMatrix &, - const BlockVector &V, - const bool) const; + BlockVector:: + multivector_inner_product( + LAPACKFullMatrix &, + const BlockVector &V, + const bool) const; template SCALAR - BlockVector::multivector_inner_product_with_metric( - const FullMatrix &, - const BlockVector &V, - const bool) const; + BlockVector:: + multivector_inner_product_with_metric( + const FullMatrix &, + const BlockVector &V, + const bool) const; template SCALAR - BlockVector::multivector_inner_product_with_metric( - const LAPACKFullMatrix &, - const BlockVector &V, - const bool) const; + BlockVector:: + multivector_inner_product_with_metric( + const LAPACKFullMatrix &, + const BlockVector &V, + const bool) const; template void - BlockVector::mmult(BlockVector &V, - const FullMatrix &, - const SCALAR, - const SCALAR) const; + BlockVector::mmult( + BlockVector &V, + const FullMatrix &, + const SCALAR, + const SCALAR) const; template void - BlockVector::mmult(BlockVector &V, - const LAPACKFullMatrix &, - const SCALAR, - const SCALAR) const; + BlockVector::mmult( + BlockVector &V, + const LAPACKFullMatrix &, + const SCALAR, + const SCALAR) const; \} \} } @@ -67,13 +77,17 @@ for (S1 : REAL_AND_COMPLEX_SCALARS; S2 : REAL_SCALARS) namespace distributed \{ template void - BlockVector::reinit(const BlockVector &, const bool); + BlockVector::reinit( + const BlockVector &, + const bool); template void - BlockVector::copy_locally_owned_data_from( - const BlockVector &); + BlockVector:: + copy_locally_owned_data_from( + const BlockVector &); template void - BlockVector::add(const std::vector &, - const ::dealii::Vector &); + BlockVector::add( + const std::vector &, + const ::dealii::Vector &); \} \} } @@ -87,13 +101,17 @@ for (S1, S2 : COMPLEX_SCALARS) namespace distributed \{ template void - BlockVector::reinit(const BlockVector &, const bool); + BlockVector::reinit( + const BlockVector &, + const bool); template void - BlockVector::copy_locally_owned_data_from( - const BlockVector &); + BlockVector:: + copy_locally_owned_data_from( + const BlockVector &); template void - BlockVector::add(const std::vector &, - const ::dealii::Vector &); + BlockVector::add( + const std::vector &, + const ::dealii::Vector &); \} \} }