Reference documentation for deal.II version 9.1.1
|
This is the complete list of members for SparseMatrix< number >, including all inherited members.
add(const size_type i, const size_type j, const number value) | SparseMatrix< number > | |
add(const std::vector< size_type > &indices, const FullMatrix< number2 > &full_matrix, const bool elide_zero_values=true) | SparseMatrix< number > | |
add(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< number2 > &full_matrix, const bool elide_zero_values=true) | SparseMatrix< number > | |
add(const size_type row, const std::vector< size_type > &col_indices, const std::vector< number2 > &values, const bool elide_zero_values=true) | SparseMatrix< number > | |
add(const size_type row, const size_type n_cols, const size_type *col_indices, const number2 *values, const bool elide_zero_values=true, const bool col_indices_are_sorted=false) | SparseMatrix< number > | |
add(const number factor, const SparseMatrix< somenumber > &matrix) | SparseMatrix< number > | |
begin() const | SparseMatrix< number > | |
begin() | SparseMatrix< number > | |
begin(const size_type r) const | SparseMatrix< number > | |
begin(const size_type r) | SparseMatrix< number > | |
block_read(std::istream &in) | SparseMatrix< number > | |
block_write(std::ostream &out) const | SparseMatrix< number > | |
BlockMatrixBase class | SparseMatrix< number > | friend |
clear() | SparseMatrix< number > | virtual |
cols | SparseMatrix< number > | private |
compress(::VectorOperation::values) | SparseMatrix< number > | |
const_iterator typedef | SparseMatrix< number > | |
copy_from(const SparseMatrix< somenumber > &source) | SparseMatrix< number > | |
copy_from(const ForwardIterator begin, const ForwardIterator end) | SparseMatrix< number > | |
copy_from(const FullMatrix< somenumber > &matrix) | SparseMatrix< number > | |
copy_from(const TrilinosWrappers::SparseMatrix &matrix) | SparseMatrix< number > | |
diag_element(const size_type i) const | SparseMatrix< number > | |
diag_element(const size_type i) | SparseMatrix< number > | |
el(const size_type i, const size_type j) const | SparseMatrix< number > | |
empty() const | SparseMatrix< number > | |
end() const | SparseMatrix< number > | |
end() | SparseMatrix< number > | |
end(const size_type r) const | SparseMatrix< number > | |
end(const size_type r) | SparseMatrix< number > | |
ExcDifferentSparsityPatterns() | SparseMatrix< number > | static |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcInvalidIndex(int arg1, int arg2) | SparseMatrix< number > | static |
ExcIteratorRange(int arg1, int arg2) | SparseMatrix< number > | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcSourceEqualsDestination() | SparseMatrix< number > | static |
frobenius_norm() const | SparseMatrix< number > | |
get_row_length(const size_type row) const | SparseMatrix< number > | |
get_sparsity_pattern() const | SparseMatrix< number > | |
iterator typedef | SparseMatrix< number > | |
Jacobi_step(Vector< somenumber > &v, const Vector< somenumber > &b, const number om=1.) const | SparseMatrix< number > | |
l1_norm() const | SparseMatrix< number > | |
linfty_norm() const | SparseMatrix< number > | |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
m() const | SparseMatrix< number > | |
matrix_norm_square(const Vector< somenumber > &v) const | SparseMatrix< number > | |
matrix_scalar_product(const Vector< somenumber > &u, const Vector< somenumber > &v) const | SparseMatrix< number > | |
max_len | SparseMatrix< number > | private |
memory_consumption() const | SparseMatrix< number > | |
mmult(SparseMatrix< numberC > &C, const SparseMatrix< numberB > &B, const Vector< number > &V=Vector< number >(), const bool rebuild_sparsity_pattern=true) const | SparseMatrix< number > | |
n() const | SparseMatrix< number > | |
n_actually_nonzero_elements(const double threshold=0.) const | SparseMatrix< number > | |
n_nonzero_elements() const | SparseMatrix< number > | |
n_subscriptions() const | Subscriptor | inline |
operator()(const size_type i, const size_type j) const | SparseMatrix< number > | |
operator()(const size_type i, const size_type j) | SparseMatrix< number > | |
operator*=(const number factor) | SparseMatrix< number > | |
operator/=(const number factor) | SparseMatrix< number > | |
operator=(const SparseMatrix< number > &) | SparseMatrix< number > | |
operator=(SparseMatrix< number > &&m) noexcept | SparseMatrix< number > | |
operator=(const IdentityMatrix &id) | SparseMatrix< number > | |
operator=(const double d) | SparseMatrix< number > | |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | inline |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
precondition_Jacobi(Vector< somenumber > &dst, const Vector< somenumber > &src, const number omega=1.) const | SparseMatrix< number > | |
precondition_SOR(Vector< somenumber > &dst, const Vector< somenumber > &src, const number om=1.) const | SparseMatrix< number > | |
precondition_SSOR(Vector< somenumber > &dst, const Vector< somenumber > &src, const number omega=1., const std::vector< std::size_t > &pos_right_of_diagonal=std::vector< std::size_t >()) const | SparseMatrix< number > | |
precondition_TSOR(Vector< somenumber > &dst, const Vector< somenumber > &src, const number om=1.) const | SparseMatrix< number > | |
prepare_add() | SparseMatrix< number > | protected |
prepare_set() | SparseMatrix< number > | protected |
print(StreamType &out, const bool across=false, const bool diagonal_first=true) const | SparseMatrix< number > | |
print_formatted(std::ostream &out, const unsigned int precision=3, const bool scientific=true, const unsigned int width=0, const char *zero_string=" ", const double denominator=1.) const | SparseMatrix< number > | |
print_pattern(std::ostream &out, const double threshold=0.) const | SparseMatrix< number > | |
PSOR(Vector< somenumber > &v, const std::vector< size_type > &permutation, const std::vector< size_type > &inverse_permutation, const number om=1.) const | SparseMatrix< number > | |
real_type typedef | SparseMatrix< number > | |
reinit(const SparsityPattern &sparsity) | SparseMatrix< number > | virtual |
residual(Vector< somenumber > &dst, const Vector< somenumber > &x, const Vector< somenumber > &b) const | SparseMatrix< number > | |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set(const size_type i, const size_type j, const number value) | SparseMatrix< number > | |
set(const std::vector< size_type > &indices, const FullMatrix< number2 > &full_matrix, const bool elide_zero_values=false) | SparseMatrix< number > | |
set(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< number2 > &full_matrix, const bool elide_zero_values=false) | SparseMatrix< number > | |
set(const size_type row, const std::vector< size_type > &col_indices, const std::vector< number2 > &values, const bool elide_zero_values=false) | SparseMatrix< number > | |
set(const size_type row, const size_type n_cols, const size_type *col_indices, const number2 *values, const bool elide_zero_values=false) | SparseMatrix< number > | |
size_type typedef | SparseMatrix< number > | |
SOR(Vector< somenumber > &v, const number om=1.) const | SparseMatrix< number > | |
SOR_step(Vector< somenumber > &v, const Vector< somenumber > &b, const number om=1.) const | SparseMatrix< number > | |
SparseMatrix class | SparseMatrix< number > | friend |
SparseMatrix() | SparseMatrix< number > | |
SparseMatrix(const SparseMatrix &) | SparseMatrix< number > | |
SparseMatrix(SparseMatrix< number > &&m) noexcept | SparseMatrix< number > | |
SparseMatrix(const SparsityPattern &sparsity) | SparseMatrix< number > | explicit |
SparseMatrix(const SparsityPattern &sparsity, const IdentityMatrix &id) | SparseMatrix< number > | |
SparseMatrixIterators::Iterator class | SparseMatrix< number > | friend |
SSOR(Vector< somenumber > &v, const number omega=1.) const | SparseMatrix< number > | |
SSOR_step(Vector< somenumber > &v, const Vector< somenumber > &b, const number om=1.) const | SparseMatrix< 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 | |
sum(const SparseMatrix< Number > &local, const MPI_Comm &mpi_communicator, SparseMatrix< Number > &global) | SparseMatrix< number > | related |
symmetrize() | SparseMatrix< number > | |
Tmmult(SparseMatrix< numberC > &C, const SparseMatrix< numberB > &B, const Vector< number > &V=Vector< number >(), const bool rebuild_sparsity_pattern=true) const | SparseMatrix< number > | |
TPSOR(Vector< somenumber > &v, const std::vector< size_type > &permutation, const std::vector< size_type > &inverse_permutation, const number om=1.) const | SparseMatrix< number > | |
TSOR(Vector< somenumber > &v, const number om=1.) const | SparseMatrix< number > | |
TSOR_step(Vector< somenumber > &v, const Vector< somenumber > &b, const number om=1.) const | SparseMatrix< number > | |
Tvmult(OutVector &dst, const InVector &src) const | SparseMatrix< number > | |
Tvmult_add(OutVector &dst, const InVector &src) const | SparseMatrix< number > | |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
Utilities::MPI::sum(const SparseMatrix< Number > &, const MPI_Comm &, SparseMatrix< Number > &) | SparseMatrix< number > | friend |
val | SparseMatrix< number > | private |
value_type typedef | SparseMatrix< number > | |
vmult(OutVector &dst, const InVector &src) const | SparseMatrix< number > | |
vmult_add(OutVector &dst, const InVector &src) const | SparseMatrix< number > | |
~SparseMatrix() override | SparseMatrix< number > | virtual |
~Subscriptor() | Subscriptor | virtual |