add(const std::vector< size_type > &indices, const ::Vector< OtherNumber > &values) | LinearAlgebra::distributed::BlockVector< Number > | |
add(const Number a) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
add(const Number a, const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
add(const Number a, const VectorSpaceVector< Number > &V, const Number b, const VectorSpaceVector< Number > &W) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
add(const std::vector< size_type > &indices, const std::vector< Number > &values) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
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 BlockVectorBase &V) 1 | 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 VectorSpaceVector< Number > &V, const VectorSpaceVector< Number > &W) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
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 > | |
BlockVectorBase() | BlockVectorBase< Vector< Number > > | |
BlockVectorBase(const BlockVectorBase &V)=default | BlockVectorBase< Vector< Number > > | |
BlockVectorBase(BlockVectorBase &&)=default | BlockVectorBase< Vector< Number > > | |
collect_sizes() | BlockVectorBase< Vector< Number > > | |
components | BlockVectorBase< Vector< Number > > | protected |
compress(::VectorOperation::values operation) | LinearAlgebra::distributed::BlockVector< Number > | |
LinearAlgebra::VectorSpaceVector::compress(VectorOperation::values) | LinearAlgebra::VectorSpaceVector< Number > | inlinevirtual |
end() | BlockVectorBase< Vector< Number > > | |
end() const | BlockVectorBase< Vector< Number > > | |
equ(const Number a, const BlockVector< Number > &u, const Number b, const BlockVector< Number > &v) 1 | LinearAlgebra::distributed::BlockVector< Number > | |
equ(const Number a, const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::equ(const value_type a, const BlockVector2 &V) | BlockVectorBase< Vector< Number > > | |
BlockVectorBase< Vector< Number > >::equ(const value_type a, const BlockVectorBase &V, const value_type b, const BlockVectorBase &W) | BlockVectorBase< Vector< Number > > | |
ExcInUse(int arg1, char *arg2, std::string &arg3) | Subscriptor | static |
ExcIteratorRangeDoesNotMatchVectorSize() | LinearAlgebra::distributed::BlockVector< Number > | static |
ExcNoSubscriber(char *arg1, char *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(ForwardIterator indices_begin, const ForwardIterator indices_end, OutputIterator values_begin) const | BlockVectorBase< Vector< Number > > | |
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_cxx11::shared_ptr< const CommunicationPatternBase > communication_pattern=std_cxx11::shared_ptr< const CommunicationPatternBase >()) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
in_local_range(const size_type global_index) const | BlockVectorBase< Vector< Number > > | |
is_non_negative() const | BlockVectorBase< Vector< Number > > | |
l1_norm() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
l2_norm() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
linfty_norm() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
list_subscribers() const | Subscriptor | |
locally_owned_elements() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
lp_norm(const real_type p) const | LinearAlgebra::distributed::BlockVector< Number > | |
mean_value() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
memory_consumption() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
n_blocks() const | BlockVectorBase< Vector< Number > > | |
n_subscriptions() const | Subscriptor | |
norm_sqr() const | BlockVectorBase< Vector< Number > > | |
operator()(const size_type i) const | BlockVectorBase< Vector< Number > > | |
operator()(const size_type i) | BlockVectorBase< Vector< Number > > | |
operator*(const VectorSpaceVector< Number > &V) const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::operator*(const BlockVectorBase &V) const | BlockVectorBase< Vector< Number > > | |
operator*=(const Number factor) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::operator*=(const value_type factor) | BlockVectorBase< Vector< Number > > | |
operator+=(const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::operator+=(const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
operator-=(const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::operator-=(const BlockVectorBase &V) | BlockVectorBase< Vector< Number > > | |
operator/=(const Number factor) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
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 | |
Subscriptor::operator=(Subscriptor &&) | 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 > > | |
print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
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 > &N, 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 > | |
sadd(const Number s, const BlockVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | |
sadd(const Number s, const Number a, const BlockVector< Number > &V, const Number b, const BlockVector< Number > &W) 1 | LinearAlgebra::distributed::BlockVector< Number > | |
sadd(const Number s, const Number a, const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
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 VectorSpaceVector< Number > &scaling_factors) | LinearAlgebra::distributed::BlockVector< Number > | virtual |
BlockVectorBase< Vector< Number > >::scale(const BlockVector2 &v) | BlockVectorBase< Vector< Number > > | |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
size() const | LinearAlgebra::distributed::BlockVector< Number > | virtual |
subscribe(const char *identifier=0) const | Subscriptor | |
Subscriptor() | Subscriptor | |
Subscriptor(const Subscriptor &) | Subscriptor | |
Subscriptor(Subscriptor &&) | Subscriptor | |
supports_distributed_data | BlockVectorBase< Vector< Number > > | static |
swap(BlockVector< Number > &v) | LinearAlgebra::distributed::BlockVector< Number > | |
unsubscribe(const char *identifier=0) const | Subscriptor | |
update_ghost_values() const | LinearAlgebra::distributed::BlockVector< Number > | |
value_type typedef | LinearAlgebra::distributed::BlockVector< Number > | |
zero_out_ghosts() | LinearAlgebra::distributed::BlockVector< Number > | |
~Subscriptor() | Subscriptor | virtual |
~VectorSpaceVector() | LinearAlgebra::VectorSpaceVector< Number > | virtual |