15#ifndef dealii_relaxation_block_h
16#define dealii_relaxation_block_h
52template <
typename MatrixType,
53 typename InverseNumberType =
typename MatrixType::value_type,
61 using number =
typename MatrixType::value_type;
171 std::vector<std::vector<unsigned int>>
order;
239 const VectorType &prev,
240 const VectorType &src,
241 const bool backward)
const;
282template <
typename MatrixType,
283 typename InverseNumberType =
typename MatrixType::value_type,
298 using number =
typename MatrixType::value_type;
341 step(VectorType &dst,
const VectorType &rhs)
const;
347 Tstep(VectorType &dst,
const VectorType &rhs)
const;
354 vmult(VectorType &dst,
const VectorType &rhs)
const;
361 Tvmult(VectorType &dst,
const VectorType &rhs)
const;
378template <
typename MatrixType,
379 typename InverseNumberType =
typename MatrixType::value_type,
394 using number =
typename MatrixType::value_type;
437 step(VectorType &dst,
const VectorType &rhs)
const;
443 Tstep(VectorType &dst,
const VectorType &rhs)
const;
450 vmult(VectorType &dst,
const VectorType &rhs)
const;
457 Tvmult(VectorType &dst,
const VectorType &rhs)
const;
474template <
typename MatrixType,
475 typename InverseNumberType =
typename MatrixType::value_type,
485 using number =
typename MatrixType::value_type;
528 step(VectorType &dst,
const VectorType &rhs)
const;
534 Tstep(VectorType &dst,
const VectorType &rhs)
const;
541 vmult(VectorType &dst,
const VectorType &rhs)
const;
548 Tvmult(VectorType &dst,
const VectorType &rhs)
const;
void log_statistics() const
Householder< typename MatrixType::value_type > & inverse_householder(size_type i)
unsigned int size() const
FullMatrix< typename MatrixType::value_type > & inverse(size_type i)
LAPACKFullMatrix< typename MatrixType::value_type > & inverse_svd(size_type i)
void Tstep(VectorType &dst, const VectorType &rhs) const
void Tvmult(VectorType &dst, const VectorType &rhs) const
void vmult(VectorType &dst, const VectorType &rhs) const
void step(VectorType &dst, const VectorType &rhs) const
typename MatrixType::value_type number
void Tvmult(VectorType &dst, const VectorType &rhs) const
void step(VectorType &dst, const VectorType &rhs) const
void vmult(VectorType &dst, const VectorType &rhs) const
typename MatrixType::value_type number
void Tstep(VectorType &dst, const VectorType &rhs) const
void Tstep(VectorType &dst, const VectorType &rhs) const
void Tvmult(VectorType &dst, const VectorType &rhs) const
typename MatrixType::value_type number
void step(VectorType &dst, const VectorType &rhs) const
void vmult(VectorType &dst, const VectorType &rhs) const
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)
PreconditionBlockBase< InverseNumberType >::Inversion inversion
SparsityPattern block_list
std::size_t memory_consumption() const
VectorType * temp_ghost_vector
std::vector< std::vector< unsigned int > > order
void initialize(const MatrixType &A, const AdditionalData ¶meters)
void block_kernel(const size_type block_begin, const size_type block_end)
void do_step(VectorType &dst, const VectorType &prev, const VectorType &src, const bool backward) const
SmartPointer< const AdditionalData, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > additional_data
SmartPointer< const MatrixType, RelaxationBlock< MatrixType, InverseNumberType, VectorType > > A
typename MatrixType::value_type number
InverseNumberType value_type
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
unsigned int global_dof_index