add(const size_type i, const size_type j, const value_type value) | BlockMatrixBase< SparseMatrix > | |
add(const std::vector< size_type > &indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=true) | BlockMatrixBase< SparseMatrix > | |
add(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=true) | BlockMatrixBase< SparseMatrix > | |
add(const size_type row, const std::vector< size_type > &col_indices, const std::vector< number > &values, const bool elide_zero_values=true) | BlockMatrixBase< SparseMatrix > | |
add(const size_type row, const size_type n_cols, const size_type *col_indices, const number *values, const bool elide_zero_values=true, const bool col_indices_are_sorted=false) | BlockMatrixBase< SparseMatrix > | |
add(const value_type factor, const BlockMatrixBase< SparseMatrix > &matrix) | BlockMatrixBase< SparseMatrix > | |
BaseClass typedef | PETScWrappers::MPI::BlockSparseMatrix | |
begin() | BlockMatrixBase< SparseMatrix > | |
begin(const size_type r) | BlockMatrixBase< SparseMatrix > | |
begin() const | BlockMatrixBase< SparseMatrix > | |
begin(const size_type r) const | BlockMatrixBase< SparseMatrix > | |
block(const unsigned int row, const unsigned int column) | BlockMatrixBase< SparseMatrix > | |
block(const unsigned int row, const unsigned int column) const | BlockMatrixBase< SparseMatrix > | |
BlockMatrixBase()=default | BlockMatrixBase< SparseMatrix > | |
BlockSparseMatrix() | PETScWrappers::MPI::BlockSparseMatrix | inline |
BlockSparseMatrix(const Mat &) | PETScWrappers::MPI::BlockSparseMatrix | inlineexplicit |
BlockSparseMatrix(const std::array< std::array< Mat, block_columns >, block_rows > &) | PETScWrappers::MPI::BlockSparseMatrix | inlineexplicit |
BlockType typedef | PETScWrappers::MPI::BlockSparseMatrix | |
check_no_subscribers() const noexcept | Subscriptor | private |
clear() | BlockMatrixBase< SparseMatrix > | protected |
collect_sizes() | PETScWrappers::MPI::BlockSparseMatrix | |
column_block_indices | BlockMatrixBase< SparseMatrix > | protected |
compress(VectorOperation::values operation) | PETScWrappers::MPI::BlockSparseMatrix | |
const_iterator typedef | PETScWrappers::MPI::BlockSparseMatrix | |
const_pointer typedef | PETScWrappers::MPI::BlockSparseMatrix | |
const_reference typedef | PETScWrappers::MPI::BlockSparseMatrix | |
copy_from(const BlockMatrixType &source) | BlockMatrixBase< SparseMatrix > | |
counter | Subscriptor | mutableprivate |
counter_map | Subscriptor | mutableprivate |
create_empty_matrices_if_needed() | PETScWrappers::MPI::BlockSparseMatrix | private |
diag_element(const size_type i) const | BlockMatrixBase< SparseMatrix > | |
el(const size_type i, const size_type j) const | BlockMatrixBase< SparseMatrix > | |
end() | BlockMatrixBase< SparseMatrix > | |
end(const size_type r) | BlockMatrixBase< SparseMatrix > | |
end() const | BlockMatrixBase< SparseMatrix > | |
end(const size_type r) const | BlockMatrixBase< SparseMatrix > | |
ExcIncompatibleColNumbers(int arg1, int arg2, int arg3, int arg4) | BlockMatrixBase< SparseMatrix > | static |
ExcIncompatibleRowNumbers(int arg1, int arg2, int arg3, int arg4) | BlockMatrixBase< SparseMatrix > | static |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
frobenius_norm() const | BlockMatrixBase< SparseMatrix > | |
get_column_indices() const | BlockMatrixBase< SparseMatrix > | |
get_mpi_communicator() const | PETScWrappers::MPI::BlockSparseMatrix | |
get_row_indices() const | BlockMatrixBase< SparseMatrix > | |
iterator typedef | PETScWrappers::MPI::BlockSparseMatrix | |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
locally_owned_domain_indices() const | PETScWrappers::MPI::BlockSparseMatrix | |
locally_owned_range_indices() const | PETScWrappers::MPI::BlockSparseMatrix | |
m() const | BlockMatrixBase< SparseMatrix > | |
map_iterator typedef | Subscriptor | private |
map_value_type typedef | Subscriptor | private |
matrix_norm_square(const BlockVectorType &v) const | BlockMatrixBase< SparseMatrix > | |
matrix_scalar_product(const BlockVectorType &u, const BlockVectorType &v) const | BlockMatrixBase< SparseMatrix > | |
memory_consumption() const | BlockMatrixBase< SparseMatrix > | |
mutex | Subscriptor | privatestatic |
n() const | BlockMatrixBase< SparseMatrix > | |
n_block_cols() const | BlockMatrixBase< SparseMatrix > | |
n_block_rows() const | BlockMatrixBase< SparseMatrix > | |
n_nonzero_elements() const | PETScWrappers::MPI::BlockSparseMatrix | |
n_subscriptions() const | Subscriptor | inline |
object_info | Subscriptor | mutableprivate |
operator const Mat &() const | PETScWrappers::MPI::BlockSparseMatrix | |
operator()(const size_type i, const size_type j) const | BlockMatrixBase< SparseMatrix > | |
operator*=(const value_type factor) | BlockMatrixBase< SparseMatrix > | |
operator/=(const value_type factor) | BlockMatrixBase< SparseMatrix > | |
operator=(const BlockSparseMatrix &) | PETScWrappers::MPI::BlockSparseMatrix | |
operator=(const double d) | PETScWrappers::MPI::BlockSparseMatrix | inline |
BlockMatrixBase< SparseMatrix >::operator=(const Subscriptor &) | Subscriptor | inline |
BlockMatrixBase< SparseMatrix >::operator=(Subscriptor &&) noexcept | Subscriptor | |
petsc_matrix() | PETScWrappers::MPI::BlockSparseMatrix | |
petsc_nest_matrix | PETScWrappers::MPI::BlockSparseMatrix | private |
pointer typedef | PETScWrappers::MPI::BlockSparseMatrix | |
prepare_add_operation() | BlockMatrixBase< SparseMatrix > | protected |
prepare_set_operation() | BlockMatrixBase< SparseMatrix > | protected |
print(std::ostream &out, const bool alternative_output=false) const | BlockMatrixBase< SparseMatrix > | |
real_type typedef | BlockMatrixBase< SparseMatrix > | |
reference typedef | PETScWrappers::MPI::BlockSparseMatrix | |
reinit(const size_type n_block_rows, const size_type n_block_columns) | PETScWrappers::MPI::BlockSparseMatrix | |
reinit(const std::vector< IndexSet > &rows, const std::vector< IndexSet > &cols, const BlockDynamicSparsityPattern &bdsp, const MPI_Comm com) | PETScWrappers::MPI::BlockSparseMatrix | |
reinit(const std::vector< IndexSet > &sizes, const BlockDynamicSparsityPattern &bdsp, const MPI_Comm com) | PETScWrappers::MPI::BlockSparseMatrix | |
reinit(Mat A) | PETScWrappers::MPI::BlockSparseMatrix | |
residual(BlockVectorType &dst, const BlockVectorType &x, const BlockVectorType &b) const | BlockMatrixBase< SparseMatrix > | |
row_block_indices | BlockMatrixBase< SparseMatrix > | protected |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set(const size_type i, const size_type j, const value_type value) | BlockMatrixBase< SparseMatrix > | |
set(const std::vector< size_type > &indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=false) | BlockMatrixBase< SparseMatrix > | |
set(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< number > &full_matrix, const bool elide_zero_values=false) | BlockMatrixBase< SparseMatrix > | |
set(const size_type row, const std::vector< size_type > &col_indices, const std::vector< number > &values, const bool elide_zero_values=false) | BlockMatrixBase< SparseMatrix > | |
set(const size_type row, const size_type n_cols, const size_type *col_indices, const number *values, const bool elide_zero_values=false) | BlockMatrixBase< SparseMatrix > | |
setup_nest_mat() | PETScWrappers::MPI::BlockSparseMatrix | private |
size_type typedef | PETScWrappers::MPI::BlockSparseMatrix | |
sub_objects | BlockMatrixBase< SparseMatrix > | protected |
subscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
Subscriptor() | Subscriptor | inline |
Subscriptor(const Subscriptor &) | Subscriptor | inline |
Subscriptor(Subscriptor &&) noexcept | Subscriptor | |
temporary_data | BlockMatrixBase< SparseMatrix > | private |
Tvmult(BlockVector &dst, const BlockVector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
Tvmult(BlockVector &dst, const Vector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
Tvmult(Vector &dst, const BlockVector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
Tvmult(Vector &dst, const Vector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
Tvmult_add(BlockVectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | |
Tvmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
Tvmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
Tvmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
Tvmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
validity_pointers | Subscriptor | mutableprivate |
value_type typedef | PETScWrappers::MPI::BlockSparseMatrix | |
vmult(BlockVector &dst, const BlockVector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
vmult(BlockVector &dst, const Vector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
vmult(Vector &dst, const BlockVector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
vmult(Vector &dst, const Vector &src) const | PETScWrappers::MPI::BlockSparseMatrix | inline |
vmult_add(BlockVectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | |
vmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
vmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
vmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
vmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const | BlockMatrixBase< SparseMatrix > | protected |
~BlockMatrixBase() override | BlockMatrixBase< SparseMatrix > | |
~BlockSparseMatrix() override | PETScWrappers::MPI::BlockSparseMatrix | |
~Subscriptor() | Subscriptor | virtual |