![]() |
Reference documentation for deal.II version 9.2.0
|
#include <deal.II/matrix_free/operators.h>
Public Types | |
using | value_type = typename Base< dim, VectorType, VectorizedArrayType >::value_type |
using | size_type = typename Base< dim, VectorType, VectorizedArrayType >::size_type |
![]() | |
using | value_type = typename LinearAlgebra::distributed::Vector< double > ::value_type |
using | size_type = typename LinearAlgebra::distributed::Vector< double > ::size_type |
Private Member Functions | |
virtual void | apply_add (VectorType &dst, const VectorType &src) const override |
void | local_apply_cell (const MatrixFree< dim, value_type, VectorizedArrayType > &data, VectorType &dst, const VectorType &src, const std::pair< unsigned int, unsigned int > &cell_range) const |
This class implements the operation of the action of a mass matrix.
Note that this class only supports the non-blocked vector variant of the Base operator because only a single FEEvaluation object is used in the apply function.
Definition at line 747 of file operators.h.
using MatrixFreeOperators::MassOperator< dim, fe_degree, n_q_points_1d, n_components, VectorType, VectorizedArrayType >::value_type = typename Base<dim, VectorType, VectorizedArrayType>::value_type |
Number alias.
Definition at line 754 of file operators.h.
using MatrixFreeOperators::MassOperator< dim, fe_degree, n_q_points_1d, n_components, VectorType, VectorizedArrayType >::size_type = typename Base<dim, VectorType, VectorizedArrayType>::size_type |
size_type needed for preconditioner classes.
Definition at line 760 of file operators.h.
MatrixFreeOperators::MassOperator< dim, fe_degree, n_q_points_1d, n_components, VectorType, VectorizedArrayType >::MassOperator |
Constructor.
Definition at line 1775 of file operators.h.
|
overridevirtual |
For preconditioning, we store a lumped mass matrix at the diagonal entries.
Definition at line 1793 of file operators.h.
|
overrideprivatevirtual |
Applies the mass matrix operation on an input vector. It is assumed that the passed input and output vector are correctly initialized using initialize_dof_vector().
Definition at line 1837 of file operators.h.
|
private |
For this operator, there is just a cell contribution.
Definition at line 1859 of file operators.h.