|
Reference documentation for deal.II version 9.2.0
|
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\)
\(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\)
\(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\)
\(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Go to the documentation of this file.
16 #ifndef dealii_petsc_block_sparse_matrix_h
17 #define dealii_petsc_block_sparse_matrix_h
22 #ifdef DEAL_II_WITH_PETSC
156 reinit(
const std::vector<IndexSet> & rows,
157 const std::vector<IndexSet> & cols,
166 reinit(
const std::vector<IndexSet> & sizes,
243 std::vector<IndexSet>
251 std::vector<IndexSet>
357 #endif // DEAL_II_WITH_PETSC
359 #endif // dealii_petsc_block_sparse_matrix_h
void vmult(BlockVector &dst, const BlockVector &src) const
MatrixIterator< BlockMatrixIterators::Accessor< BlockMatrixBase, true > > const_iterator
void Tvmult(BlockVector &dst, const BlockVector &src) const
BaseClass::const_pointer const_pointer
void vmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const
void reinit(const size_type n_block_rows, const size_type n_block_columns)
unsigned int n_block_cols() const
types::global_dof_index size_type
void Tvmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const
void vmult_nonblock_nonblock(VectorType &dst, const VectorType &src) const
unsigned int n_block_rows() const
SymmetricTensor< 2, dim, Number > d(const Tensor< 2, dim, Number > &F, const Tensor< 2, dim, Number > &dF_dt)
void Tvmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const
typename BlockType::value_type value_type
BlockType & block(const unsigned int row, const unsigned int column)
void vmult_nonblock_block(VectorType &dst, const BlockVectorType &src) const
const value_type & const_reference
BaseClass::value_type value_type
#define DEAL_II_NAMESPACE_OPEN
BaseClass::pointer pointer
const value_type * const_pointer
BlockSparseMatrix()=default
void vmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const
~BlockSparseMatrix() override=default
BaseClass::reference reference
#define Assert(cond, exc)
std::vector< IndexSet > locally_owned_domain_indices() const
void Tvmult_block_nonblock(BlockVectorType &dst, const VectorType &src) const
BaseClass::size_type size_type
MatrixIterator< BlockMatrixIterators::Accessor< BlockMatrixBase, false > > iterator
BaseClass::const_reference const_reference
static ::ExceptionBase & ExcScalarAssignmentOnlyForZeroValue()
#define DEAL_II_NAMESPACE_CLOSE
BlockSparseMatrix & operator=(const BlockSparseMatrix &)
void Tvmult_block_block(BlockVectorType &dst, const BlockVectorType &src) const
const MPI_Comm & get_mpi_communicator() const
std::vector< IndexSet > locally_owned_range_indices() const