add(const double a) | LinearAlgebra::EpetraWrappers::Vector | |
add(const double a, const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
add(const double a, const Vector &V, const double b, const Vector &W) | LinearAlgebra::EpetraWrappers::Vector | |
add_and_dot(const double a, const Vector &V, const Vector &W) | LinearAlgebra::EpetraWrappers::Vector | |
all_zero() const | LinearAlgebra::EpetraWrappers::Vector | |
check_no_subscribers() const noexcept | Subscriptor | private |
compress(const VectorOperation::values operation) | LinearAlgebra::EpetraWrappers::Vector | |
const_reference typedef | LinearAlgebra::EpetraWrappers::Vector | |
counter | Subscriptor | mutableprivate |
counter_map | Subscriptor | mutableprivate |
create_epetra_comm_pattern(const IndexSet &source_index_set, const MPI_Comm mpi_comm) | LinearAlgebra::EpetraWrappers::Vector | private |
epetra_comm_pattern | LinearAlgebra::EpetraWrappers::Vector | private |
equ(const double a, const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
ExcDifferentParallelPartitioning() | LinearAlgebra::EpetraWrappers::Vector | static |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcTrilinosError(int arg1) | LinearAlgebra::EpetraWrappers::Vector | static |
ExcVectorTypeNotCompatible() | LinearAlgebra::EpetraWrappers::Vector | static |
extract_subvector_to(const ArrayView< const types::global_dof_index > &indices, ArrayView< double > &elements) const override | LinearAlgebra::EpetraWrappers::Vector | virtual |
ReadVector< VectorTraits::value_type >::extract_subvector_to(const ArrayView< const types::global_dof_index > &indices, ArrayView< VectorTraits::value_type > &elements) const=0 | ReadVector< VectorTraits::value_type > | pure virtual |
get_mpi_communicator() const | LinearAlgebra::EpetraWrappers::Vector | |
has_ghost_elements() const | LinearAlgebra::EpetraWrappers::Vector | inline |
import(const ReadWriteVector< double > &V, const VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={}) | LinearAlgebra::EpetraWrappers::Vector | inline |
import_elements(const ReadWriteVector< double > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={}) | LinearAlgebra::EpetraWrappers::Vector | |
internal::VectorReference class | LinearAlgebra::EpetraWrappers::Vector | friend |
l1_norm() const | LinearAlgebra::EpetraWrappers::Vector | |
l2_norm() const | LinearAlgebra::EpetraWrappers::Vector | |
linfty_norm() const | LinearAlgebra::EpetraWrappers::Vector | |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
locally_owned_elements() const | LinearAlgebra::EpetraWrappers::Vector | |
locally_owned_size() const | LinearAlgebra::EpetraWrappers::Vector | |
map_iterator typedef | Subscriptor | private |
map_value_type typedef | Subscriptor | private |
mean_value() const | LinearAlgebra::EpetraWrappers::Vector | |
memory_consumption() const | LinearAlgebra::EpetraWrappers::Vector | |
mutex | Subscriptor | privatestatic |
n_subscriptions() const | Subscriptor | inline |
object_info | Subscriptor | mutableprivate |
operator()(const size_type index) | LinearAlgebra::EpetraWrappers::Vector | inline |
operator()(const size_type index) const | LinearAlgebra::EpetraWrappers::Vector | |
operator*(const Vector &V) const | LinearAlgebra::EpetraWrappers::Vector | |
operator*=(const double factor) | LinearAlgebra::EpetraWrappers::Vector | |
operator+=(const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
operator-=(const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
operator/=(const double factor) | LinearAlgebra::EpetraWrappers::Vector | |
operator=(const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
operator=(const double s) | LinearAlgebra::EpetraWrappers::Vector | |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | inline |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
operator[](const size_type index) | LinearAlgebra::EpetraWrappers::Vector | inline |
operator[](const size_type index) const | LinearAlgebra::EpetraWrappers::Vector | inline |
print(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const bool across=true) const | LinearAlgebra::EpetraWrappers::Vector | |
real_type typedef | LinearAlgebra::EpetraWrappers::Vector | |
reference typedef | LinearAlgebra::EpetraWrappers::Vector | |
reinit(const IndexSet ¶llel_partitioner, const MPI_Comm communicator, const bool omit_zeroing_entries=false) | LinearAlgebra::EpetraWrappers::Vector | |
reinit(const Vector &V, const bool omit_zeroing_entries=false) | LinearAlgebra::EpetraWrappers::Vector | |
sadd(const double s, const double a, const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
scale(const Vector &scaling_factors) | LinearAlgebra::EpetraWrappers::Vector | |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
size() const override | LinearAlgebra::EpetraWrappers::Vector | virtual |
size_type typedef | LinearAlgebra::EpetraWrappers::Vector | |
source_stored_elements | LinearAlgebra::EpetraWrappers::Vector | private |
subscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
Subscriptor() | Subscriptor | inline |
Subscriptor(const Subscriptor &) | Subscriptor | inline |
Subscriptor(Subscriptor &&) noexcept | Subscriptor | |
trilinos_vector() const | LinearAlgebra::EpetraWrappers::Vector | |
trilinos_vector() | LinearAlgebra::EpetraWrappers::Vector | |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
validity_pointers | Subscriptor | mutableprivate |
value_type typedef | LinearAlgebra::EpetraWrappers::Vector | |
Vector() | LinearAlgebra::EpetraWrappers::Vector | |
Vector(const Vector &V) | LinearAlgebra::EpetraWrappers::Vector | |
Vector(const IndexSet ¶llel_partitioner, const MPI_Comm communicator) | LinearAlgebra::EpetraWrappers::Vector | explicit |
vector | LinearAlgebra::EpetraWrappers::Vector | private |
~Subscriptor() | Subscriptor | virtual |