add(const Number a) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
add(const Number a, const VectorSpaceVector< Number > &V) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
add(const Number a, const VectorSpaceVector< Number > &V, const Number b, const VectorSpaceVector< Number > &W) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
add(const std::vector< size_type > &indices, const std::vector< Number > &values) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
add(const std::vector< size_type > &indices, const ::Vector< OtherNumber > &values) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
add(const size_type n_elements, const size_type *indices, const OtherNumber *values) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
add_and_dot(const Number a, const VectorSpaceVector< Number > &V, const VectorSpaceVector< Number > &W) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
add_and_dot_local(const Number a, const Vector< Number, MemorySpace > &V, const Vector< Number, MemorySpace > &W) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
add_local(const Number a, const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
all_zero() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
allocated_size | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
begin() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
begin() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
BlockVector class | LinearAlgebra::distributed::Vector< Number, MemorySpace > | friend |
clear_mpi_requests() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
compress(::VectorOperation::values operation) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
LinearAlgebra::VectorSpaceVector::compress(VectorOperation::values) | LinearAlgebra::VectorSpaceVector< Number > | inlinevirtual |
compress_finish(::VectorOperation::values operation) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
compress_requests | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
compress_start(const unsigned int communication_channel=0, ::VectorOperation::values operation=VectorOperation::add) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
copy_locally_owned_data_from(const Vector< Number2, MemorySpace > &src) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
data | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
end() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
end() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
equ(const Number a, const VectorSpaceVector< Number > &V) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
equ(const Number a, const Vector< Number, MemorySpace > &u, const Number b, const Vector< Number, MemorySpace > &v) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
ExcAccessToNonLocalElement(size_type arg1, size_type arg2, size_type arg3, size_type arg4) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | static |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcNonMatchingElements(Number arg1, Number arg2, unsigned int arg3) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcNotAllowedForCuda() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | static |
ExcVectorTypeNotCompatible() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | static |
extract_subvector_to(const std::vector< size_type > &indices, std::vector< OtherNumber > &values) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
extract_subvector_to(ForwardIterator indices_begin, const ForwardIterator indices_end, OutputIterator values_begin) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
get_mpi_communicator() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
get_partitioner() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
get_values() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
ghost_elements() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
has_ghost_elements() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
import(const LinearAlgebra::ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const CommunicationPatternBase > communication_pattern=std::shared_ptr< const CommunicationPatternBase >()) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
import_data | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
in_local_range(const size_type global_index) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
inner_product_local(const Vector< Number2, MemorySpace > &V) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
is_ghost_entry(const types::global_dof_index global_index) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
l1_norm() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
l1_norm_local() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
l2_norm() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
linfty_norm() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
linfty_norm_local() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
local_element(const size_type local_index) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
local_element(const size_type local_index) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
local_range() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
local_size() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
locally_owned_elements() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
lp_norm(const real_type p) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
lp_norm_local(const real_type p) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
mean_value() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
mean_value_local() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
memory_consumption() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
mutex | LinearAlgebra::distributed::Vector< Number, MemorySpace > | mutableprivate |
n_ghost_entries() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
n_subscriptions() const | Subscriptor | inline |
norm_sqr() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
norm_sqr_local() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
operator()(const size_type global_index) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator()(const size_type global_index) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator*(const VectorSpaceVector< Number > &V) const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
operator*=(const Number factor) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
operator+=(const VectorSpaceVector< Number > &V) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
operator-=(const VectorSpaceVector< Number > &V) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
operator/=(const Number factor) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
operator=(const Vector< Number, MemorySpace > &in_vector) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator=(const Vector< Number2, MemorySpace > &in_vector) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator=(const PETScWrappers::MPI::Vector &petsc_vec) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator=(const TrilinosWrappers::MPI::Vector &trilinos_vec) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator=(const Number s) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | inline |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
operator[](const size_type global_index) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
operator[](const size_type global_index) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
partitioner | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
partitioners_are_compatible(const Utilities::MPI::Partitioner &part) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
partitioners_are_globally_compatible(const Utilities::MPI::Partitioner &part) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
reinit(const size_type size, const bool omit_zeroing_entries=false) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
reinit(const Vector< Number2, MemorySpace > &in_vector, const bool omit_zeroing_entries=false) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
reinit(const IndexSet &local_range, const IndexSet &ghost_indices, const MPI_Comm communicator) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
reinit(const IndexSet &local_range, const MPI_Comm communicator) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
reinit(const std::shared_ptr< const Utilities::MPI::Partitioner > &partitioner) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
reinit(const VectorSpaceVector< Number > &V, const bool omit_zeroing_entries=false) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
resize_val(const size_type new_allocated_size) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
sadd(const Number s, const Number a, const VectorSpaceVector< Number > &V) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
sadd(const Number s, const Vector< Number, MemorySpace > &V) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
sadd(const Number s, const Number a, const Vector< Number, MemorySpace > &V, const Number b, const Vector< Number, MemorySpace > &W) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
sadd_local(const Number s, const Number a, const VectorSpaceVector< Number > &V) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | private |
scale(const VectorSpaceVector< Number > &scaling_factors) override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set_ghost_state(const bool ghosted) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
size() const override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
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(Vector< Number, MemorySpace > &v) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
thread_loop_partitioner | LinearAlgebra::distributed::Vector< Number, MemorySpace > | mutableprivate |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
update_ghost_values() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
update_ghost_values_finish() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
update_ghost_values_requests | LinearAlgebra::distributed::Vector< Number, MemorySpace > | mutableprivate |
update_ghost_values_start(const unsigned int communication_channel=0) const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector class | LinearAlgebra::distributed::Vector< Number, MemorySpace > | friend |
Vector() | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector(const Vector< Number, MemorySpace > &in_vector) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector(const size_type size) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector(const IndexSet &local_range, const IndexSet &ghost_indices, const MPI_Comm communicator) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector(const IndexSet &local_range, const MPI_Comm communicator) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
Vector(const std::shared_ptr< const Utilities::MPI::Partitioner > &partitioner) | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
vector_is_ghosted | LinearAlgebra::distributed::Vector< Number, MemorySpace > | mutableprivate |
zero_out_ghosts() const | LinearAlgebra::distributed::Vector< Number, MemorySpace > | |
~Subscriptor() | Subscriptor | virtual |
~Vector() override | LinearAlgebra::distributed::Vector< Number, MemorySpace > | virtual |
~VectorSpaceVector()=default | LinearAlgebra::VectorSpaceVector< Number > | virtual |