17#ifdef DEAL_II_WITH_PETSC
44 const bool is_symmetric)
54 const bool is_symmetric)
61 template <
typename SparsityPatternType>
83 const bool is_symmetric)
99 const bool is_symmetric)
111 template <
typename SparsityPatternType>
130 const bool is_symmetric)
152 const bool is_symmetric)
175 template <
typename SparsityPatternType>
183 sparsity_pattern.n_rows());
185 sparsity_pattern.n_cols());
187 std::vector<size_type>
row_lengths(sparsity_pattern.n_rows());
188 for (
size_type i = 0; i < sparsity_pattern.n_rows(); ++i)
192 sparsity_pattern.n_cols(),
213 for (
size_type i = 0; i < sparsity_pattern.n_rows(); ++i)
220 static_cast<PetscInt>(sparsity_pattern.column_number(i,
j));
size_type row_length(const size_type row) const
void mmult(MatrixBase &C, const MatrixBase &B, const VectorBase &V) const
PetscBool is_symmetric(const double tolerance=1.e-12)
MatrixBase & operator=(const MatrixBase &)=delete
void Tmmult(MatrixBase &C, const MatrixBase &B, const VectorBase &V) const
void compress(const VectorOperation::values operation)
void mmult(SparseMatrix &C, const SparseMatrix &B, const MPI::Vector &V=MPI::Vector()) const
void do_reinit(const size_type m, const size_type n, const size_type n_nonzero_per_row, const bool is_symmetric=false)
void Tmmult(SparseMatrix &C, const SparseMatrix &B, const MPI::Vector &V=MPI::Vector()) const
void reinit(const size_type m, const size_type n, const size_type n_nonzero_per_row, const bool is_symmetric=false)
SparseMatrix & operator=(const double d)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define AssertDimension(dim1, dim2)
#define AssertThrow(cond, exc)
#define AssertIntegerConversion(index1, index2)
#define AssertThrowIntegerConversion(index1, index2)
void set_keep_zero_rows(Mat &matrix)
void set_matrix_option(Mat &matrix, const MatOption option_name, const PetscBool option_value=PETSC_FALSE)
void close_matrix(Mat &matrix)