16 #ifndef dealii_relaxation_block_h 17 #define dealii_relaxation_block_h 19 #include <deal.II/base/subscriptor.h> 20 #include <deal.II/base/smartpointer.h> 21 #include <deal.II/lac/vector.h> 22 #include <deal.II/lac/precondition_block_base.h> 23 #include <deal.II/lac/sparsity_pattern.h> 28 DEAL_II_NAMESPACE_OPEN
53 template <
typename MatrixType,
54 typename InverseNumberType =
typename MatrixType::value_type,
63 typedef typename MatrixType::value_type
number;
172 std::vector<std::vector<unsigned int> >
order;
237 const VectorType &prev,
238 const VectorType &src,
239 const bool backward)
const;
277 template <
typename MatrixType,
278 typename InverseNumberType =
typename MatrixType::value_type,
292 typedef typename MatrixType::value_type
number;
332 void step (VectorType &dst,
const VectorType &rhs)
const;
337 void Tstep (VectorType &dst,
const VectorType &rhs)
const;
343 void vmult (VectorType &dst,
const VectorType &rhs)
const;
349 void Tvmult (VectorType &dst,
const VectorType &rhs)
const;
368 template <
typename MatrixType,
369 typename InverseNumberType =
typename MatrixType::value_type,
383 typedef typename MatrixType::value_type
number;
423 void step (VectorType &dst,
const VectorType &rhs)
const;
428 void Tstep (VectorType &dst,
const VectorType &rhs)
const;
434 void vmult (VectorType &dst,
const VectorType &rhs)
const;
440 void Tvmult (VectorType &dst,
const VectorType &rhs)
const;
459 template <
typename MatrixType,
460 typename InverseNumberType =
typename MatrixType::value_type,
469 typedef typename MatrixType::value_type
number;
509 void step (VectorType &dst,
const VectorType &rhs)
const;
514 void Tstep (VectorType &dst,
const VectorType &rhs)
const;
520 void vmult (VectorType &dst,
const VectorType &rhs)
const;
526 void Tvmult (VectorType &dst,
const VectorType &rhs)
const;
530 DEAL_II_NAMESPACE_CLOSE
void vmult(VectorType &dst, const VectorType &rhs) const
std::size_t memory_consumption() const
void Tvmult(VectorType &dst, const VectorType &rhs) const
SmartPointer< const AdditionalData, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > additional_data
InverseNumberType value_type
void vmult(VectorType &dst, const VectorType &rhs) const
PreconditionBlockBase< InverseNumberType >::Inversion inversion
MatrixType::value_type number
VectorType * temp_ghost_vector
void Tvmult(VectorType &dst, const VectorType &rhs) const
void block_kernel(const size_type block_begin, const size_type block_end)
SmartPointer< const MatrixType, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > A
void Tstep(VectorType &dst, const VectorType &rhs) const
unsigned int global_dof_index
AdditionalData(const double relaxation=1., const bool invert_diagonal=true, const bool same_diagonal=false, const typename PreconditionBlockBase< InverseNumberType >::Inversion inversion=PreconditionBlockBase< InverseNumberType >::gauss_jordan, const double threshold=0., VectorType *temp_ghost_vector=nullptr)
void step(VectorType &dst, const VectorType &rhs) const
void vmult(VectorType &dst, const VectorType &rhs) const
MatrixType::value_type number
void Tvmult(VectorType &dst, const VectorType &rhs) const
MatrixType::value_type number
void Tstep(VectorType &dst, const VectorType &rhs) const
std::vector< std::vector< unsigned int > > order
void Tstep(VectorType &dst, const VectorType &rhs) const
SparsityPattern block_list
types::global_dof_index size_type
void step(VectorType &dst, const VectorType &rhs) const
MatrixType::value_type number
void initialize(const MatrixType &A, const AdditionalData ¶meters)
void step(VectorType &dst, const VectorType &rhs) const
void do_step(VectorType &dst, const VectorType &prev, const VectorType &src, const bool backward) const