Reference documentation for deal.II version 9.0.0
|
This is the complete list of members for PETScWrappers::MatrixFree, including all inherited members.
add(const size_type i, const size_type j, const PetscScalar value) | PETScWrappers::MatrixBase | |
add(const std::vector< size_type > &indices, const FullMatrix< PetscScalar > &full_matrix, const bool elide_zero_values=true) | PETScWrappers::MatrixBase | |
add(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< PetscScalar > &full_matrix, const bool elide_zero_values=true) | PETScWrappers::MatrixBase | |
add(const size_type row, const std::vector< size_type > &col_indices, const std::vector< PetscScalar > &values, const bool elide_zero_values=true) | PETScWrappers::MatrixBase | |
add(const size_type row, const size_type n_cols, const size_type *col_indices, const PetscScalar *values, const bool elide_zero_values=true, const bool col_indices_are_sorted=false) | PETScWrappers::MatrixBase | |
add(const PetscScalar factor, const MatrixBase &other) | PETScWrappers::MatrixBase | |
add(const MatrixBase &other, const PetscScalar factor) | PETScWrappers::MatrixBase | |
assert_is_compressed() | PETScWrappers::MatrixBase | protected |
begin() const | PETScWrappers::MatrixBase | |
begin(const size_type r) const | PETScWrappers::MatrixBase | |
clear() | PETScWrappers::MatrixFree | |
clear_row(const size_type row, const PetscScalar new_diag_value=0) | PETScWrappers::MatrixBase | |
clear_rows(const std::vector< size_type > &rows, const PetscScalar new_diag_value=0) | PETScWrappers::MatrixBase | |
communicator | PETScWrappers::MatrixFree | private |
compress(const VectorOperation::values operation) | PETScWrappers::MatrixBase | |
const_iterator typedef | PETScWrappers::MatrixBase | |
diag_element(const size_type i) const | PETScWrappers::MatrixBase | |
do_reinit(const unsigned int m, const unsigned int n, const unsigned int local_rows, const unsigned int local_columns) | PETScWrappers::MatrixFree | private |
el(const size_type i, const size_type j) const | PETScWrappers::MatrixBase | |
end() const | PETScWrappers::MatrixBase | |
end(const size_type r) const | PETScWrappers::MatrixBase | |
ExcInUse(int arg1, std::string arg2, std::string arg3) | Subscriptor | static |
ExcNoSubscriber(std::string arg1, std::string arg2) | Subscriptor | static |
ExcSourceEqualsDestination() | PETScWrappers::MatrixBase | static |
ExcWrongMode(int arg1, int arg2) | PETScWrappers::MatrixBase | static |
frobenius_norm() const | PETScWrappers::MatrixBase | |
get_mpi_communicator() const | PETScWrappers::MatrixFree | inlinevirtual |
in_local_range(const size_type index) const | PETScWrappers::MatrixBase | |
is_hermitian(const double tolerance=1.e-12) | PETScWrappers::MatrixBase | |
is_symmetric(const double tolerance=1.e-12) | PETScWrappers::MatrixBase | |
l1_norm() const | PETScWrappers::MatrixBase | |
last_action | PETScWrappers::MatrixBase | protected |
linfty_norm() const | PETScWrappers::MatrixBase | |
list_subscribers() const | Subscriptor | |
local_range() const | PETScWrappers::MatrixBase | |
local_size() const | PETScWrappers::MatrixBase | |
m() const | PETScWrappers::MatrixBase | |
matrix | PETScWrappers::MatrixBase | protected |
matrix_free_mult(Mat A, Vec src, Vec dst) | PETScWrappers::MatrixFree | privatestatic |
matrix_norm_square(const VectorBase &v) const | PETScWrappers::MatrixBase | |
matrix_scalar_product(const VectorBase &u, const VectorBase &v) const | PETScWrappers::MatrixBase | |
MatrixBase() | PETScWrappers::MatrixBase | |
MatrixBase(const MatrixBase &)=delete | PETScWrappers::MatrixBase | |
MatrixFree() | PETScWrappers::MatrixFree | |
MatrixFree(const MPI_Comm &communicator, const unsigned int m, const unsigned int n, const unsigned int local_rows, const unsigned int local_columns) | PETScWrappers::MatrixFree | |
MatrixFree(const MPI_Comm &communicator, const unsigned int m, const unsigned int n, const std::vector< unsigned int > &local_rows_per_process, const std::vector< unsigned int > &local_columns_per_process, const unsigned int this_process) | PETScWrappers::MatrixFree | |
MatrixFree(const unsigned int m, const unsigned int n, const unsigned int local_rows, const unsigned int local_columns) | PETScWrappers::MatrixFree | |
MatrixFree(const unsigned int m, const unsigned int n, const std::vector< unsigned int > &local_rows_per_process, const std::vector< unsigned int > &local_columns_per_process, const unsigned int this_process) | PETScWrappers::MatrixFree | |
memory_consumption() const | PETScWrappers::MatrixBase | |
mmult(MatrixBase &C, const MatrixBase &B, const VectorBase &V) const | PETScWrappers::MatrixBase | protected |
n() const | PETScWrappers::MatrixBase | |
n_nonzero_elements() const | PETScWrappers::MatrixBase | |
n_subscriptions() const | Subscriptor | |
operator Mat() const | PETScWrappers::MatrixBase | |
operator()(const size_type i, const size_type j) const | PETScWrappers::MatrixBase | |
operator*=(const PetscScalar factor) | PETScWrappers::MatrixBase | |
operator/=(const PetscScalar factor) | PETScWrappers::MatrixBase | |
operator=(const MatrixBase &)=delete | PETScWrappers::MatrixBase | |
operator=(const value_type d) | PETScWrappers::MatrixBase | |
Subscriptor::operator=(const Subscriptor &) | Subscriptor | |
Subscriptor::operator=(Subscriptor &&) noexcept | Subscriptor | |
petsc_matrix() | PETScWrappers::MatrixBase | |
prepare_action(const VectorOperation::values new_action) | PETScWrappers::MatrixBase | protected |
prepare_add() | PETScWrappers::MatrixBase | protected |
prepare_set() | PETScWrappers::MatrixBase | protected |
print(std::ostream &out, const bool alternative_output=false) const | PETScWrappers::MatrixBase | |
reinit(const MPI_Comm &communicator, const unsigned int m, const unsigned int n, const unsigned int local_rows, const unsigned int local_columns) | PETScWrappers::MatrixFree | |
reinit(const MPI_Comm &communicator, const unsigned int m, const unsigned int n, const std::vector< unsigned int > &local_rows_per_process, const std::vector< unsigned int > &local_columns_per_process, const unsigned int this_process) | PETScWrappers::MatrixFree | |
reinit(const unsigned int m, const unsigned int n, const unsigned int local_rows, const unsigned int local_columns) | PETScWrappers::MatrixFree | |
reinit(const unsigned int m, const unsigned int n, const std::vector< unsigned int > &local_rows_per_process, const std::vector< unsigned int > &local_columns_per_process, const unsigned int this_process) | PETScWrappers::MatrixFree | |
residual(VectorBase &dst, const VectorBase &x, const VectorBase &b) const | PETScWrappers::MatrixBase | |
row_length(const size_type row) const | PETScWrappers::MatrixBase | |
serialize(Archive &ar, const unsigned int version) | Subscriptor | inline |
set(const size_type i, const size_type j, const PetscScalar value) | PETScWrappers::MatrixBase | |
set(const std::vector< size_type > &indices, const FullMatrix< PetscScalar > &full_matrix, const bool elide_zero_values=false) | PETScWrappers::MatrixBase | |
set(const std::vector< size_type > &row_indices, const std::vector< size_type > &col_indices, const FullMatrix< PetscScalar > &full_matrix, const bool elide_zero_values=false) | PETScWrappers::MatrixBase | |
set(const size_type row, const std::vector< size_type > &col_indices, const std::vector< PetscScalar > &values, const bool elide_zero_values=false) | PETScWrappers::MatrixBase | |
set(const size_type row, const size_type n_cols, const size_type *col_indices, const PetscScalar *values, const bool elide_zero_values=false) | PETScWrappers::MatrixBase | |
size_type typedef | PETScWrappers::MatrixBase | |
subscribe(const char *identifier=nullptr) const | Subscriptor | |
Subscriptor() | Subscriptor | |
Subscriptor(const Subscriptor &) | Subscriptor | |
Subscriptor(Subscriptor &&) noexcept | Subscriptor | |
Tmmult(MatrixBase &C, const MatrixBase &B, const VectorBase &V) const | PETScWrappers::MatrixBase | protected |
trace() const | PETScWrappers::MatrixBase | |
transpose() | PETScWrappers::MatrixBase | |
Tvmult(VectorBase &dst, const VectorBase &src) const =0 | PETScWrappers::MatrixFree | pure virtual |
Tvmult_add(VectorBase &dst, const VectorBase &src) const =0 | PETScWrappers::MatrixFree | pure virtual |
unsubscribe(const char *identifier=nullptr) const | Subscriptor | |
value_type typedef | PETScWrappers::MatrixBase | |
vmult(VectorBase &dst, const VectorBase &src) const =0 | PETScWrappers::MatrixFree | pure virtual |
vmult(Vec &dst, const Vec &src) const | PETScWrappers::MatrixFree | virtual |
vmult_add(VectorBase &dst, const VectorBase &src) const =0 | PETScWrappers::MatrixFree | pure virtual |
write_ascii(const PetscViewerFormat format=PETSC_VIEWER_DEFAULT) | PETScWrappers::MatrixBase | |
~MatrixBase() | PETScWrappers::MatrixBase | virtual |
~Subscriptor() | Subscriptor | virtual |