add(const std::vector< size_type > &indices, const ::Vector< OtherNumber > &values) | LinearAlgebra::distributed::BlockVector< Number > | |
add(const Number a) | LinearAlgebra::distributed::BlockVector< Number > | |
add(const Number a, const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
add(const Number a, const BlockVector< Number > &V, const Number b, const BlockVector< Number > &W) | LinearAlgebra::distributed::BlockVector< Number > | |
add(const std::vector< size_type > &indices, const std::vector< Number > &values) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::add(const std::vector< size_type > &indices, const Vector< Number > &values) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::add(const size_type n_elements, const size_type *indices, const Number *values) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::add(const value_type s) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::add(const value_type a, const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::add(const value_type a, const BlockVectorBase &V, const value_type b, const BlockVectorBase &W) | BlockVectorBase< Vector< Number > > | |
add_and_dot(const Number a, const BlockVector< Number > &V, const BlockVector< Number > &W) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::add_and_dot(const value_type a, const BlockVectorBase &V, const BlockVectorBase &W) | BlockVectorBase< Vector< Number > > | |
all_zero() const | LinearAlgebra::distributed::BlockVector< Number > | |
BaseClass typedef | LinearAlgebra::distributed::BlockVector< Number > | |
begin() | BlockVectorBase< Vector< Number > > | |
begin() const | BlockVectorBase< Vector< Number > > | |
block(const unsigned int i) | BlockVectorBase< Vector< Number > > | |
block(const unsigned int i) const | BlockVectorBase< Vector< Number > > | |
block_indices | BlockVectorBase< Vector< Number > > | protected |
BlockType typedef | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVector(const size_type num_blocks=0, const size_type block_size=0) | LinearAlgebra::distributed::BlockVector< Number > | explicit |
BlockVector(const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVector(const BlockVector< OtherNumber > &v) | LinearAlgebra::distributed::BlockVector< Number > | explicit |
BlockVector(const std::vector< size_type > &block_sizes) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVector(const std::vector< IndexSet > &local_ranges, const std::vector< IndexSet > &ghost_indices, const MPI_Comm communicator) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVector(const std::vector< IndexSet > &local_ranges, const MPI_Comm communicator) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVector(const std::vector< std::shared_ptr< const Utilities::MPI::Partitioner > > &partitioners, const MPI_Comm &comm_sm=MPI_COMM_SELF) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase()=default | BlockVectorBase< Vector< Number > > | |
BlockVectorBase(const BlockVectorBase &)=default | BlockVectorBase< Vector< Number > > | |
BlockVectorBase(BlockVectorBase &&) noexcept=default | BlockVectorBase< Vector< Number > > | |
check_no_subscribers() const noexcept | Subscriptor | private |
collect_sizes() | BlockVectorBase< Vector< Number > > | |
communication_block_size | LinearAlgebra::distributed::BlockVector< Number > | static |
components | BlockVectorBase< Vector< Number > > | protected |
compress(VectorOperation::values operation) | LinearAlgebra::distributed::BlockVector< Number > | |
const_iterator typedef | LinearAlgebra::distributed::BlockVector< Number > | |
const_pointer typedef | LinearAlgebra::distributed::BlockVector< Number > | |
const_reference typedef | LinearAlgebra::distributed::BlockVector< Number > | |
copy_locally_owned_data_from(const BlockVector< Number2 > &src) | LinearAlgebra::distributed::BlockVector< Number > | |
counter | Subscriptor | mutableprivate |
counter_map | Subscriptor | mutableprivate |
end() | BlockVectorBase< Vector< Number > > | |
end() const | BlockVectorBase< Vector< Number > > | |
equ(const Number a, const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::equ(const value_type a, const BlockVector2 &V) | BlockVectorBase< Vector< Number > > | |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcIteratorRangeDoesNotMatchVectorSize() | LinearAlgebra::distributed::BlockVector< Number > | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcVectorTypeNotCompatible() | LinearAlgebra::distributed::BlockVector< Number > | static |
extract_subvector_to(const std::vector< size_type > &indices, std::vector< OtherNumber > &values) const | BlockVectorBase< Vector< Number > > | |
extract_subvector_to(const ArrayView< const types::global_dof_index > &indices, ArrayView< value_type > &entries) const override | BlockVectorBase< Vector< Number > > | virtual |
extract_subvector_to(ForwardIterator indices_begin, const ForwardIterator indices_end, OutputIterator values_begin) const | BlockVectorBase< Vector< Number > > | |
ReadVector< Vector< Number >::value_type >::extract_subvector_to(const ArrayView< const types::global_dof_index > &indices, ArrayView< Number > &elements) const=0 | ReadVector< Vector< Number >::value_type > | pure virtual |
get_block_indices() const | BlockVectorBase< Vector< Number > > | |
has_ghost_elements() const | LinearAlgebra::distributed::BlockVector< Number > | |
import(const LinearAlgebra::ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) | LinearAlgebra::distributed::BlockVector< Number > | inline |
import_elements(const LinearAlgebra::ReadWriteVector< Number > &V, const VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={}) | LinearAlgebra::distributed::BlockVector< Number > | |
in_local_range(const size_type global_index) const | BlockVectorBase< Vector< Number > > | |
is_non_negative() const | BlockVectorBase< Vector< Number > > | |
iterator typedef | LinearAlgebra::distributed::BlockVector< Number > | |
l1_norm() const | LinearAlgebra::distributed::BlockVector< Number > | |
l2_norm() const | LinearAlgebra::distributed::BlockVector< Number > | |
linfty_norm() const | LinearAlgebra::distributed::BlockVector< Number > | |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
locally_owned_elements() const | LinearAlgebra::distributed::BlockVector< Number > | |
locally_owned_size() const | BlockVectorBase< Vector< Number > > | |
lp_norm(const real_type p) const | LinearAlgebra::distributed::BlockVector< Number > | |
map_iterator typedef | Subscriptor | private |
map_value_type typedef | Subscriptor | private |
mean_value() const | LinearAlgebra::distributed::BlockVector< Number > | |
memory_consumption() const | LinearAlgebra::distributed::BlockVector< Number > | |
mmult(BlockVector< Number > &V, const FullMatrixType &matrix, const Number s=Number(0.), const Number b=Number(1.)) const | LinearAlgebra::distributed::BlockVector< Number > | |
multivector_inner_product(FullMatrixType &matrix, const BlockVector< Number > &V, const bool symmetric=false) const | LinearAlgebra::distributed::BlockVector< Number > | |
multivector_inner_product_with_metric(const FullMatrixType &matrix, const BlockVector< Number > &V, const bool symmetric=false) const | LinearAlgebra::distributed::BlockVector< Number > | |
mutex | Subscriptor | privatestatic |
n_blocks() const | BlockVectorBase< Vector< Number > > | |
n_subscriptions() const | Subscriptor | inline |
norm_sqr() const | LinearAlgebra::distributed::BlockVector< Number > | |
object_info | Subscriptor | mutableprivate |
operator()(const size_type i) const | BlockVectorBase< Vector< Number > > | |
operator()(const size_type i) | BlockVectorBase< Vector< Number > > | |
operator*(const BlockVector< Number > &V) const | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator*(const BlockVectorBase &V) const | BlockVectorBase< Vector< Number > > | |
operator*=(const Number factor) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator*=(const value_type factor) | BlockVectorBase< Vector< Number > > | |
operator+=(const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator+=(const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
operator-=(const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator-=(const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
operator/=(const Number factor) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator/=(const value_type factor) | BlockVectorBase< Vector< Number > > | |
operator=(const value_type s) | LinearAlgebra::distributed::BlockVector< Number > | |
operator=(const BlockVector &V) | LinearAlgebra::distributed::BlockVector< Number > | |
operator=(const BlockVector< Number2 > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
operator=(const Vector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
operator=(const PETScWrappers::MPI::BlockVector &petsc_vec) | LinearAlgebra::distributed::BlockVector< Number > | |
operator=(const TrilinosWrappers::MPI::BlockVector &trilinos_vec) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::operator=(const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::operator=(BlockVectorBase &&)=default | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::operator=(const BlockVectorBase< VectorType2 > &V) | BlockVectorBase< Vector< Number > > | |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | inline |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
operator==(const BlockVectorBase< VectorType2 > &v) const | BlockVectorBase< Vector< Number > > | |
operator[](const size_type i) const | BlockVectorBase< Vector< Number > > | |
operator[](const size_type i) | BlockVectorBase< Vector< Number > > | |
pointer typedef | LinearAlgebra::distributed::BlockVector< Number > | |
print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const | LinearAlgebra::distributed::BlockVector< Number > | |
real_type typedef | LinearAlgebra::distributed::BlockVector< Number > | |
reference typedef | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const size_type num_blocks, const size_type block_size=0, const bool omit_zeroing_entries=false) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const std::vector< size_type > &block_sizes, const bool omit_zeroing_entries=false) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const BlockVector< Number2 > &V, const bool omit_zeroing_entries=false) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const std::vector< IndexSet > &local_ranges, const std::vector< IndexSet > &ghost_indices, const MPI_Comm communicator) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const std::vector< IndexSet > &local_ranges, const MPI_Comm communicator) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const std::vector< std::shared_ptr< const Utilities::MPI::Partitioner > > &partitioners, const MPI_Comm &comm_sm=MPI_COMM_SELF) | LinearAlgebra::distributed::BlockVector< Number > | |
reinit(const std::vector< std::shared_ptr< const Utilities::MPI::Partitioner > > &partitioners, const bool make_ghosted, const MPI_Comm &comm_sm=MPI_COMM_SELF) | LinearAlgebra::distributed::BlockVector< Number > | |
sadd(const Number s, const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
sadd(const Number s, const Number a, const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::sadd(const value_type s, const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::sadd(const value_type s, const value_type a, const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::sadd(const value_type s, const value_type a, const BlockVectorBase &V, const value_type b, const BlockVectorBase &W) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::sadd(const value_type s, const value_type a, const BlockVectorBase &V, const value_type b, const BlockVectorBase &W, const value_type c, const BlockVectorBase &X) | BlockVectorBase< Vector< Number > > | |
scale(const BlockVector< Number > &scaling_factors) | LinearAlgebra::distributed::BlockVector< Number > | |
BlockVectorBase< Vector< Number > >::scale(const BlockVector2 &v) | BlockVectorBase< Vector< Number > > | |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set_ghost_state(const bool ghosted) const | LinearAlgebra::distributed::BlockVector< Number > | |
size() const override | LinearAlgebra::distributed::BlockVector< Number > | virtual |
size_type typedef | LinearAlgebra::distributed::BlockVector< Number > | |
subscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
Subscriptor() | Subscriptor | inline |
Subscriptor(const Subscriptor &) | Subscriptor | inline |
Subscriptor(Subscriptor &&) noexcept | Subscriptor | |
swap(BlockVector< Number > &v) noexcept | LinearAlgebra::distributed::BlockVector< Number > | |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
update_ghost_values() const | LinearAlgebra::distributed::BlockVector< Number > | |
validity_pointers | Subscriptor | mutableprivate |
value_type typedef | LinearAlgebra::distributed::BlockVector< Number > | |
zero_out_ghost_values() const | LinearAlgebra::distributed::BlockVector< Number > | |
~BlockVector()=default | LinearAlgebra::distributed::BlockVector< Number > | |
~Subscriptor() | Subscriptor | virtual |