Reference documentation for deal.II version 9.1.1
|
This is the complete list of members for FullMatrix< number >, including all inherited members.
add(const number a, const FullMatrix< number2 > &A) | FullMatrix< number > | |
add(const number a, const FullMatrix< number2 > &A, const number b, const FullMatrix< number2 > &B) | FullMatrix< number > | |
add(const number a, const FullMatrix< number2 > &A, const number b, const FullMatrix< number2 > &B, const number c, const FullMatrix< number2 > &C) | FullMatrix< number > | |
add(const FullMatrix< number2 > &src, const number factor, const size_type dst_offset_i=0, const size_type dst_offset_j=0, const size_type src_offset_i=0, const size_type src_offset_j=0) | FullMatrix< number > | |
add(const size_type row, const size_type column, const number value) | FullMatrix< number > | |
add(const size_type row, const size_type n_cols, const index_type *col_indices, const number2 *values, const bool elide_zero_values=true, const bool col_indices_are_sorted=false) | FullMatrix< number > | |
add_col(const size_type i, const number s, const size_type j) | FullMatrix< number > | |
add_col(const size_type i, const number s, const size_type j, const number t, const size_type k) | FullMatrix< number > | |
add_row(const size_type i, const number s, const size_type j) | FullMatrix< number > | |
add_row(const size_type i, const number s, const size_type j, const number t, const size_type k) | FullMatrix< number > | |
all_zero() const | FullMatrix< number > | |
backward(Vector< number2 > &dst, const Vector< number2 > &src) const | FullMatrix< number > | |
begin(const size_type r) | FullMatrix< number > | |
begin(const size_type r) const | FullMatrix< number > | |
cholesky(const FullMatrix< number2 > &A) | FullMatrix< number > | |
const_iterator typedef | FullMatrix< number > | |
copy_from(const MatrixType &) | FullMatrix< number > | |
copy_from(const Tensor< 2, dim > &T, const unsigned int src_r_i=0, const unsigned int src_r_j=dim - 1, const unsigned int src_c_i=0, const unsigned int src_c_j=dim - 1, const size_type dst_r=0, const size_type dst_c=0) | FullMatrix< number > | |
copy_to(Tensor< 2, dim > &T, const size_type src_r_i=0, const size_type src_r_j=dim - 1, const size_type src_c_i=0, const size_type src_c_j=dim - 1, const unsigned int dst_r=0, const unsigned int dst_c=0) const | FullMatrix< number > | |
copy_transposed(const MatrixType &) | FullMatrix< number > | |
determinant() const | FullMatrix< number > | |
diagadd(const number s) | FullMatrix< number > | |
el(const TableIndices< N > &indices) | TableBase< N, T > | protected |
el(const TableIndices< N > &indices) const | TableBase< N, T > | protected |
empty() const | TableBase< N, T > | |
end(const size_type r) | FullMatrix< number > | |
end(const size_type r) const | FullMatrix< number > | |
equ(const number a, const FullMatrix< number2 > &A) | FullMatrix< number > | |
equ(const number a, const FullMatrix< number2 > &A, const number b, const FullMatrix< number2 > &B) | FullMatrix< number > | |
equ(const number a, const FullMatrix< number2 > &A, const number b, const FullMatrix< number2 > &B, const number c, const FullMatrix< number2 > &C) | FullMatrix< number > | |
ExcEmptyMatrix() | FullMatrix< number > | static |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcInvalidDestination(size_type arg1, size_type arg2, size_type arg3) | FullMatrix< number > | static |
ExcMatrixNotPositiveDefinite() | FullMatrix< number > | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcNotRegular(number arg1) | FullMatrix< number > | static |
ExcSourceEqualsDestination() | FullMatrix< number > | static |
extract_submatrix_from(const MatrixType &matrix, const std::vector< index_type > &row_index_set, const std::vector< index_type > &column_index_set) | FullMatrix< number > | |
fill(const FullMatrix< number2 > &src, const size_type dst_offset_i=0, const size_type dst_offset_j=0, const size_type src_offset_i=0, const size_type src_offset_j=0) | FullMatrix< number > | |
fill(const number2 *) | FullMatrix< number > | |
Table< 2, number >::fill(InputIterator entries, const bool C_style_indexing=true) | TableBase< N, T > | |
Table< 2, number >::fill(const T &value) | TableBase< N, T > | |
fill_permutation(const FullMatrix< number2 > &src, const std::vector< size_type > &p_rows, const std::vector< size_type > &p_cols) | FullMatrix< number > | |
forward(Vector< number2 > &dst, const Vector< number2 > &src) const | FullMatrix< number > | |
frobenius_norm() const | FullMatrix< number > | |
FullMatrix(const size_type n=0) | FullMatrix< number > | explicit |
FullMatrix(const size_type rows, const size_type cols) | FullMatrix< number > | |
FullMatrix(const size_type rows, const size_type cols, const number *entries) | FullMatrix< number > | |
FullMatrix(const IdentityMatrix &id) | FullMatrix< number > | |
gauss_jordan() | FullMatrix< number > | |
invert(const FullMatrix< number2 > &M) | FullMatrix< number > | |
iterator typedef | FullMatrix< number > | |
l1_norm() const | FullMatrix< number > | |
left_invert(const FullMatrix< number2 > &M) | FullMatrix< number > | |
linfty_norm() const | FullMatrix< number > | |
list_subscribers(StreamType &stream) const | Subscriptor | inline |
list_subscribers() const | Subscriptor | |
m() const | FullMatrix< number > | |
matrix_norm_square(const Vector< number2 > &v) const | FullMatrix< number > | |
matrix_scalar_product(const Vector< number2 > &u, const Vector< number2 > &v) const | FullMatrix< number > | |
memory_consumption() const | FullMatrix< number > | |
mmult(FullMatrix< number2 > &C, const FullMatrix< number2 > &B, const bool adding=false) const | FullMatrix< number > | |
mTmult(FullMatrix< number2 > &C, const FullMatrix< number2 > &B, const bool adding=false) const | FullMatrix< number > | |
n() const | FullMatrix< number > | |
n_elements() const | TableBase< N, T > | |
n_subscriptions() const | Subscriptor | inline |
operator()(const TableIndices< N > &indices) | TableBase< N, T > | |
operator()(const TableIndices< N > &indices) const | TableBase< N, T > | |
operator*=(const number factor) | FullMatrix< number > | |
operator/=(const number factor) | FullMatrix< number > | |
operator=(const FullMatrix< number2 > &) | FullMatrix< number > | |
operator=(const number d) | FullMatrix< number > | |
operator=(const IdentityMatrix &id) | FullMatrix< number > | |
operator=(const LAPACKFullMatrix< number2 > &) | FullMatrix< number > | |
Table< 2, number >::operator=(const TableBase< N, T > &src) | TableBase< N, T > | |
Table< 2, number >::operator=(const TableBase< N, T2 > &src) | TableBase< N, T > | |
Table< 2, number >::operator=(TableBase< N, T > &&src) noexcept | TableBase< N, T > | |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | inline |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
operator==(const FullMatrix< number > &) const | FullMatrix< number > | |
Table< 2, number >::operator==(const TableBase< N, T > &T2) const | TableBase< N, T > | |
outer_product(const Vector< number2 > &V, const Vector< number2 > &W) | FullMatrix< number > | |
position(const TableIndices< N > &indices) const | TableBase< N, T > | protected |
precondition_Jacobi(Vector< somenumber > &dst, const Vector< somenumber > &src, const number omega=1.) const | FullMatrix< number > | |
print(StreamType &s, const unsigned int width=5, const unsigned int precision=2) const | FullMatrix< 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 double threshold=0.) const | FullMatrix< number > | |
real_type typedef | FullMatrix< number > | |
reinit(const TableIndices< N > &new_size, const bool omit_default_initialization=false) | TableBase< N, T > | |
relative_symmetry_norm2() const | FullMatrix< number > | |
reset_values() | TableBase< N, T > | |
residual(Vector< number2 > &dst, const Vector< number2 > &x, const Vector< number3 > &b) const | FullMatrix< number > | |
right_invert(const FullMatrix< number2 > &M) | FullMatrix< number > | |
scatter_matrix_to(const std::vector< index_type > &row_index_set, const std::vector< index_type > &column_index_set, MatrixType &matrix) const | FullMatrix< number > | |
serialize(Archive &ar, const unsigned int version) | TableBase< N, T > | |
set(const size_type i, const size_type j, const number value) | FullMatrix< number > | |
size(const unsigned int i) const | TableBase< N, T > | |
size() const | TableBase< N, T > | |
size_type typedef | FullMatrix< 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 | |
swap(TableBase< N, T > &v) | TableBase< N, T > | |
swap_col(const size_type i, const size_type j) | FullMatrix< number > | |
swap_row(const size_type i, const size_type j) | FullMatrix< number > | |
symmetrize() | FullMatrix< number > | |
table_size | TableBase< N, T > | protected |
TableBase()=default | TableBase< N, T > | |
TableBase(const TableIndices< N > &sizes) | TableBase< N, T > | |
TableBase(const TableIndices< N > &sizes, InputIterator entries, const bool C_style_indexing=true) | TableBase< N, T > | |
TableBase(const TableBase< N, T > &src) | TableBase< N, T > | |
TableBase(const TableBase< N, T2 > &src) | TableBase< N, T > | |
TableBase(TableBase< N, T > &&src) noexcept | TableBase< N, T > | |
Tadd(const number s, const FullMatrix< number2 > &B) | FullMatrix< number > | |
Tadd(const FullMatrix< number2 > &src, const number factor, const size_type dst_offset_i=0, const size_type dst_offset_j=0, const size_type src_offset_i=0, const size_type src_offset_j=0) | FullMatrix< number > | |
Tmmult(FullMatrix< number2 > &C, const FullMatrix< number2 > &B, const bool adding=false) const | FullMatrix< number > | |
TmTmult(FullMatrix< number2 > &C, const FullMatrix< number2 > &B, const bool adding=false) const | FullMatrix< number > | |
trace() const | FullMatrix< number > | |
triple_product(const FullMatrix< number > &A, const FullMatrix< number > &B, const FullMatrix< number > &D, const bool transpose_B=false, const bool transpose_D=false, const number scaling=number(1.)) | FullMatrix< number > | |
Tvmult(Vector< number2 > &w, const Vector< number2 > &v, const bool adding=false) const | FullMatrix< number > | |
Tvmult_add(Vector< number2 > &w, const Vector< number2 > &v) const | FullMatrix< number > | |
unsubscribe(std::atomic< bool > *const validity, const std::string &identifier="") const | Subscriptor | |
value_type typedef | FullMatrix< number > | |
values | TableBase< N, T > | protected |
vmult(Vector< number2 > &w, const Vector< number2 > &v, const bool adding=false) const | FullMatrix< number > | |
vmult_add(Vector< number2 > &w, const Vector< number2 > &v) const | FullMatrix< number > | |
~Subscriptor() | Subscriptor | virtual |
~TableBase() override=default | TableBase< N, T > |