ASPECT
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Modules Pages
Public Member Functions | Static Public Member Functions | Private Types | Private Member Functions | Private Attributes | List of all members
aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree > Class Template Reference
Inheritance diagram for aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >:
Inheritance graph
[legend]

Public Member Functions

 StokesMatrixFreeHandlerImplementation (Simulator< dim > &simulator, const Parameters< dim > &parameters)
 
 ~StokesMatrixFreeHandlerImplementation () override=default
 
void initialize () override
 
std::string name () const override
 
StokesSolver::SolverOutputs solve (const LinearAlgebra::BlockSparseMatrix &system_matrix, const LinearAlgebra::BlockVector &system_rhs, const bool solve_newton_system, const double last_pressure_normalization_adjustment, LinearAlgebra::BlockVector &solution_vector) override
 
void setup_dofs () override
 
void assemble () override
 
void build_preconditioner () override
 
void parse_parameters (ParameterHandler &prm) override
 
const DoFHandler< dim > & get_dof_handler_v () const override
 
const DoFHandler< dim > & get_dof_handler_p () const override
 
const DoFHandler< dim > & get_dof_handler_projection () const override
 
const AffineConstraints< double > & get_constraints_v () const override
 
const AffineConstraints< double > & get_constraints_p () const override
 
const MGTransferMF< dim, GMGNumberType > & get_mg_transfer_A () const override
 
const MGTransferMF< dim, GMGNumberType > & get_mg_transfer_S () const override
 
std::size_t get_cell_data_memory_consumption () const override
 
- Public Member Functions inherited from aspect::SimulatorAccess< dim >
 SimulatorAccess ()
 
 SimulatorAccess (const Simulator< dim > &simulator_object)
 
virtual ~SimulatorAccess ()=default
 
virtual void initialize_simulator (const Simulator< dim > &simulator_object)
 
const Introspection< dim > & introspection () const
 
const Simulator< dim > & get_simulator () const
 
const Parameters< dim > & get_parameters () const
 
SimulatorSignals< dim > & get_signals () const
 
MPI_Comm get_mpi_communicator () const
 
TimerOutput & get_computing_timer () const
 
const ConditionalOStream & get_pcout () const
 
double get_time () const
 
double get_timestep () const
 
double get_old_timestep () const
 
unsigned int get_timestep_number () const
 
const TimeStepping::Manager< dim > & get_timestepping_manager () const
 
unsigned int get_nonlinear_iteration () const
 
const parallel::distributed::Triangulation< dim > & get_triangulation () const
 
double get_volume () const
 
const Mapping< dim > & get_mapping () const
 
std::string get_output_directory () const
 
bool include_adiabatic_heating () const
 
bool include_latent_heat () const
 
bool include_melt_transport () const
 
int get_stokes_velocity_degree () const
 
double get_adiabatic_surface_temperature () const
 
double get_surface_pressure () const
 
bool convert_output_to_years () const
 
unsigned int get_pre_refinement_step () const
 
unsigned int n_compositional_fields () const
 
double get_end_time () const
 
void get_refinement_criteria (Vector< float > &estimated_error_per_cell) const
 
void get_artificial_viscosity (Vector< float > &viscosity_per_cell, const bool skip_interior_cells=false) const
 
void get_artificial_viscosity_composition (Vector< float > &viscosity_per_cell, const unsigned int compositional_variable) const
 
const LinearAlgebra::BlockVectorget_current_linearization_point () const
 
const LinearAlgebra::BlockVectorget_solution () const
 
const LinearAlgebra::BlockVectorget_old_solution () const
 
const LinearAlgebra::BlockVectorget_old_old_solution () const
 
const LinearAlgebra::BlockVectorget_reaction_vector () const
 
const LinearAlgebra::BlockVectorget_mesh_velocity () const
 
const DoFHandler< dim > & get_dof_handler () const
 
const FiniteElement< dim > & get_fe () const
 
const LinearAlgebra::BlockSparseMatrixget_system_matrix () const
 
const LinearAlgebra::BlockSparseMatrixget_system_preconditioner_matrix () const
 
const MaterialModel::Interface< dim > & get_material_model () const
 
const GravityModel::Interface< dim > & get_gravity_model () const
 
const InitialTopographyModel::Interface< dim > & get_initial_topography_model () const
 
const GeometryModel::Interface< dim > & get_geometry_model () const
 
const AdiabaticConditions::Interface< dim > & get_adiabatic_conditions () const
 
bool has_boundary_temperature () const
 
const BoundaryTemperature::Manager< dim > & get_boundary_temperature_manager () const
 
const BoundaryHeatFlux::Interface< dim > & get_boundary_heat_flux () const
 
bool has_boundary_composition () const
 
const BoundaryComposition::Manager< dim > & get_boundary_composition_manager () const
 
const BoundaryTraction::Manager< dim > & get_boundary_traction_manager () const
 
std::shared_ptr< const InitialTemperature::Manager< dim > > get_initial_temperature_manager_pointer () const
 
const InitialTemperature::Manager< dim > & get_initial_temperature_manager () const
 
std::shared_ptr< const InitialComposition::Manager< dim > > get_initial_composition_manager_pointer () const
 
const InitialComposition::Manager< dim > & get_initial_composition_manager () const
 
const std::set< types::boundary_id > & get_fixed_temperature_boundary_indicators () const
 
const std::set< types::boundary_id > & get_fixed_heat_flux_boundary_indicators () const
 
const std::set< types::boundary_id > & get_fixed_composition_boundary_indicators () const
 
const std::set< types::boundary_id > & get_mesh_deformation_boundary_indicators () const
 
const BoundaryVelocity::Manager< dim > & get_boundary_velocity_manager () const
 
const HeatingModel::Manager< dim > & get_heating_model_manager () const
 
const MeshRefinement::Manager< dim > & get_mesh_refinement_manager () const
 
const MeltHandler< dim > & get_melt_handler () const
 
const VolumeOfFluidHandler< dim > & get_volume_of_fluid_handler () const
 
const NewtonHandler< dim > & get_newton_handler () const
 
const MeshDeformation::MeshDeformationHandler< dim > & get_mesh_deformation_handler () const
 
const LateralAveraging< dim > & get_lateral_averaging () const
 
const AffineConstraints< double > & get_current_constraints () const
 
bool simulator_is_past_initialization () const
 
double get_pressure_scaling () const
 
bool pressure_rhs_needs_compatibility_modification () const
 
bool model_has_prescribed_stokes_solution () const
 
TableHandler & get_statistics_object () const
 
const Postprocess::Manager< dim > & get_postprocess_manager () const
 
unsigned int n_particle_managers () const
 
const Particle::Manager< dim > & get_particle_manager (const unsigned int particle_manager_index) const
 
Particle::Manager< dim > & get_particle_manager (const unsigned int particle_manager_index)
 
bool is_stokes_matrix_free ()
 
const StokesMatrixFreeHandler< dim > & get_stokes_matrix_free () const
 
RotationProperties< dim > compute_net_angular_momentum (const bool use_constant_density, const LinearAlgebra::BlockVector &solution, const bool limit_to_top_faces=false) const
 
void remove_nullspace (LinearAlgebra::BlockVector &solution, LinearAlgebra::BlockVector &distributed_stokes_solution) const
 
double normalize_pressure (LinearAlgebra::BlockVector &vector) const
 
void denormalize_pressure (const double pressure_adjustment, LinearAlgebra::BlockVector &vector) const
 
- Public Member Functions inherited from aspect::Plugins::InterfaceBase
virtual ~InterfaceBase ()=default
 
virtual void update ()
 

Static Public Member Functions

static void declare_parameters (ParameterHandler &prm)
 
- Static Public Member Functions inherited from aspect::StokesMatrixFreeHandler< dim >
static void declare_parameters (ParameterHandler &prm)
 
- Static Public Member Functions inherited from aspect::SimulatorAccess< dim >
static void get_composition_values_at_q_point (const std::vector< std::vector< double >> &composition_values, const unsigned int q, std::vector< double > &composition_values_at_q_point)
 
- Static Public Member Functions inherited from aspect::Plugins::InterfaceBase
static void declare_parameters (ParameterHandler &prm)
 

Private Types

using StokesMatrixType = MatrixFreeStokesOperators::StokesOperator< dim, velocity_degree, double >
 
using SchurComplementMatrixType = MatrixFreeStokesOperators::MassMatrixOperator< dim, velocity_degree-1, double >
 
using ABlockMatrixType = MatrixFreeStokesOperators::ABlockOperator< dim, velocity_degree, double >
 
using GMGSchurComplementMatrixType = MatrixFreeStokesOperators::MassMatrixOperator< dim, velocity_degree-1, GMGNumberType >
 
using GMGABlockMatrixType = MatrixFreeStokesOperators::ABlockOperator< dim, velocity_degree, GMGNumberType >
 

Private Member Functions

void evaluate_material_model ()
 
void correct_stokes_rhs ()
 

Private Attributes

Simulator< dim > & sim
 
bool print_details
 
bool do_timings
 
double minimum_viscosity
 
double maximum_viscosity
 
DoFHandler< dim > dof_handler_v
 
DoFHandler< dim > dof_handler_p
 
DoFHandler< dim > dof_handler_projection
 
FESystem< dim > fe_v
 
FESystem< dim > fe_p
 
FESystem< dim > fe_projection
 
MatrixFreeStokesOperators::OperatorCellData< dim, GMGNumberTypeactive_cell_data
 
MGLevelObject< MatrixFreeStokesOperators::OperatorCellData< dim, GMGNumberType > > level_cell_data
 
StokesMatrixType stokes_matrix
 
ABlockMatrixType A_block_matrix
 
SchurComplementMatrixType Schur_complement_block_matrix
 
AffineConstraints< double > constraints_v
 
AffineConstraints< double > constraints_p
 
MGLevelObject< GMGABlockMatrixTypemg_matrices_A_block
 
MGLevelObject< GMGSchurComplementMatrixTypemg_matrices_Schur_complement
 
MGConstrainedDoFs mg_constrained_dofs_A_block
 
MGConstrainedDoFs mg_constrained_dofs_Schur_complement
 
MGConstrainedDoFs mg_constrained_dofs_projection
 
MGTransferMF< dim, GMGNumberTypemg_transfer_A_block
 
MGTransferMF< dim, GMGNumberTypemg_transfer_Schur_complement
 
std::vector< std::shared_ptr< MatrixFree< dim, double > > > matrix_free_objects
 

Detailed Description

template<int dim, int velocity_degree>
class aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >

Main class of the Matrix-free method. Here are all the functions for setup, assembly and solving the Stokes system.

We need to derive from StokesMatrixFreeHandler to be able to introduce a second template argument for the degree of the Stokes finite element. This way, the main simulator does not need to know about the degree by using a pointer to the base class and we can pick the desired velocity degree at runtime.

Definition at line 94 of file simulator.h.

Member Typedef Documentation

§ StokesMatrixType

template<int dim, int velocity_degree>
using aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::StokesMatrixType = MatrixFreeStokesOperators::StokesOperator<dim,velocity_degree,double>
private

Definition at line 691 of file stokes_matrix_free.h.

§ SchurComplementMatrixType

template<int dim, int velocity_degree>
using aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::SchurComplementMatrixType = MatrixFreeStokesOperators::MassMatrixOperator<dim,velocity_degree-1,double>
private

Definition at line 692 of file stokes_matrix_free.h.

§ ABlockMatrixType

template<int dim, int velocity_degree>
using aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::ABlockMatrixType = MatrixFreeStokesOperators::ABlockOperator<dim,velocity_degree,double>
private

Definition at line 693 of file stokes_matrix_free.h.

§ GMGSchurComplementMatrixType

template<int dim, int velocity_degree>
using aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::GMGSchurComplementMatrixType = MatrixFreeStokesOperators::MassMatrixOperator<dim,velocity_degree-1,GMGNumberType>
private

Definition at line 695 of file stokes_matrix_free.h.

§ GMGABlockMatrixType

template<int dim, int velocity_degree>
using aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::GMGABlockMatrixType = MatrixFreeStokesOperators::ABlockOperator<dim,velocity_degree,GMGNumberType>
private

Definition at line 696 of file stokes_matrix_free.h.

Constructor & Destructor Documentation

§ StokesMatrixFreeHandlerImplementation()

template<int dim, int velocity_degree>
aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::StokesMatrixFreeHandlerImplementation ( Simulator< dim > &  simulator,
const Parameters< dim > &  parameters 
)

Constructor. Give it a reference to the Simulator that owns it, since it needs to make fairly extensive changes to the internals of the simulator.

§ ~StokesMatrixFreeHandlerImplementation()

template<int dim, int velocity_degree>
aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::~StokesMatrixFreeHandlerImplementation ( )
overridedefault

Destructor.

Member Function Documentation

§ initialize()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::initialize ( )
overridevirtual

Initialize the matrix-free solver.

Reimplemented from aspect::Plugins::InterfaceBase.

§ name()

template<int dim, int velocity_degree>
std::string aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::name ( ) const
overridevirtual

Return the name of the solver for screen output.

Implements aspect::StokesSolver::Interface< dim >.

§ solve()

template<int dim, int velocity_degree>
StokesSolver::SolverOutputs aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::solve ( const LinearAlgebra::BlockSparseMatrix system_matrix,
const LinearAlgebra::BlockVector system_rhs,
const bool  solve_newton_system,
const double  last_pressure_normalization_adjustment,
LinearAlgebra::BlockVector solution_vector 
)
overridevirtual

Solves the Stokes linear system using the matrix-free solver.

Parameters
system_matrixThe system matrix. Note that we do not actually use this matrix for this matrix free solver.
system_rhsThe right hand side vector of the system.
solve_newton_systemA flag indicating whether the system to be solved is the normal linear system or the Newton system. If the Newton system is solved, some operations have to change, e.g. the residual is computed differently.
solution_vectorThe solution vector that will be updated with the new solution. This vector is expected to have the block structure of the full solution vector, and its velocity and pressure blocks will be updated with the new solution.
Returns
A structure that contains information about the solver, like the initial and final residual.

Implements aspect::StokesSolver::Interface< dim >.

§ setup_dofs()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::setup_dofs ( )
overridevirtual

Allocates and sets up the members of the StokesMatrixFreeHandler. This is called by Simulator<dim>::setup_dofs()

Implements aspect::StokesMatrixFreeHandler< dim >.

§ assemble()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::assemble ( )
overridevirtual

Perform various tasks to update the linear system to solve for. Note that we are not assembling a matrix (as this is a matrix-free algorithm), but we are evaluating the material model and storing the information necessary for a later call to solve().

Implements aspect::StokesMatrixFreeHandler< dim >.

§ build_preconditioner()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::build_preconditioner ( )
overridevirtual

Computes and sets the diagonal for both the mass matrix operator and the A-block operators on each level for the purpose of smoothing inside the multigrid v-cycle.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ declare_parameters()

template<int dim, int velocity_degree>
static void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::declare_parameters ( ParameterHandler &  prm)
static

Declare parameters.

§ parse_parameters()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::parse_parameters ( ParameterHandler &  prm)
overridevirtual

Parse parameters.

Reimplemented from aspect::Plugins::InterfaceBase.

§ get_dof_handler_v()

template<int dim, int velocity_degree>
const DoFHandler<dim>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_dof_handler_v ( ) const
overridevirtual

Return a reference to the DoFHandler that is used for velocity in the block GMG solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_dof_handler_p()

template<int dim, int velocity_degree>
const DoFHandler<dim>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_dof_handler_p ( ) const
overridevirtual

Return a reference to the DoFHandler that is used for pressure in the block GMG solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_dof_handler_projection()

template<int dim, int velocity_degree>
const DoFHandler<dim>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_dof_handler_projection ( ) const
overridevirtual

Return a reference to the DoFHandler that is used for the coefficient projection in the block GMG solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_constraints_v()

template<int dim, int velocity_degree>
const AffineConstraints<double>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_constraints_v ( ) const
overridevirtual

Return a pointer to the object that describes the velocity DoF constraints for the block GMG Stokes solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_constraints_p()

template<int dim, int velocity_degree>
const AffineConstraints<double>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_constraints_p ( ) const
overridevirtual

Return a pointer to the object that describes the pressure DoF constraints for the block GMG Stokes solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_mg_transfer_A()

template<int dim, int velocity_degree>
const MGTransferMF<dim,GMGNumberType>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_mg_transfer_A ( ) const
overridevirtual

Return a pointer to the MGTransfer object used for the A block of the block GMG Stokes solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_mg_transfer_S()

template<int dim, int velocity_degree>
const MGTransferMF<dim,GMGNumberType>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_mg_transfer_S ( ) const
overridevirtual

Return a pointer to the MGTransfer object used for the Schur complement block of the block GMG Stokes solver.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ get_cell_data_memory_consumption()

template<int dim, int velocity_degree>
std::size_t aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::get_cell_data_memory_consumption ( ) const
overridevirtual

Return the memory consumption in bytes that are used to store equation data like viscosity to be able to apply the operators.

Implements aspect::StokesMatrixFreeHandler< dim >.

§ evaluate_material_model()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::evaluate_material_model ( )
private

Evaluate the MaterialModel to query information like the viscosity and project this viscosity to the multigrid hierarchy. Also queries other parameters like pressure scaling.

§ correct_stokes_rhs()

template<int dim, int velocity_degree>
void aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::correct_stokes_rhs ( )
private

Add correction to system RHS for non-zero boundary condition. See description in StokesMatrixFreeHandler::correct_stokes_rhs() for more information.

Member Data Documentation

§ sim

template<int dim, int velocity_degree>
Simulator<dim>& aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::sim
private

Definition at line 657 of file stokes_matrix_free.h.

§ print_details

template<int dim, int velocity_degree>
bool aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::print_details
private

Definition at line 659 of file stokes_matrix_free.h.

§ do_timings

template<int dim, int velocity_degree>
bool aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::do_timings
private

If true, it will time the key components of this matrix-free implementation, such as vmult of different matrices, solver IDR with the cheap preconditioner, etc.

Definition at line 665 of file stokes_matrix_free.h.

§ minimum_viscosity

template<int dim, int velocity_degree>
double aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::minimum_viscosity
private

The max/min of the evaluated viscosities.

Definition at line 670 of file stokes_matrix_free.h.

§ maximum_viscosity

template<int dim, int velocity_degree>
double aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::maximum_viscosity
private

Definition at line 671 of file stokes_matrix_free.h.

§ dof_handler_v

template<int dim, int velocity_degree>
DoFHandler<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::dof_handler_v
private

Definition at line 673 of file stokes_matrix_free.h.

§ dof_handler_p

template<int dim, int velocity_degree>
DoFHandler<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::dof_handler_p
private

Definition at line 674 of file stokes_matrix_free.h.

§ dof_handler_projection

template<int dim, int velocity_degree>
DoFHandler<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::dof_handler_projection
private

Definition at line 675 of file stokes_matrix_free.h.

§ fe_v

template<int dim, int velocity_degree>
FESystem<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::fe_v
private

Definition at line 677 of file stokes_matrix_free.h.

§ fe_p

template<int dim, int velocity_degree>
FESystem<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::fe_p
private

Definition at line 678 of file stokes_matrix_free.h.

§ fe_projection

template<int dim, int velocity_degree>
FESystem<dim> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::fe_projection
private

Definition at line 679 of file stokes_matrix_free.h.

§ active_cell_data

template<int dim, int velocity_degree>
MatrixFreeStokesOperators::OperatorCellData<dim, GMGNumberType> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::active_cell_data
private

Store the data for the Stokes operator (viscosity, etc.) for the active cells.

Definition at line 684 of file stokes_matrix_free.h.

§ level_cell_data

template<int dim, int velocity_degree>
MGLevelObject<MatrixFreeStokesOperators::OperatorCellData<dim, GMGNumberType> > aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::level_cell_data
private

Store the data for the Stokes operator (viscosity, etc.) for each multigrid level.

Definition at line 689 of file stokes_matrix_free.h.

§ stokes_matrix

template<int dim, int velocity_degree>
StokesMatrixType aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::stokes_matrix
private

Definition at line 698 of file stokes_matrix_free.h.

§ A_block_matrix

template<int dim, int velocity_degree>
ABlockMatrixType aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::A_block_matrix
private

Definition at line 699 of file stokes_matrix_free.h.

§ Schur_complement_block_matrix

template<int dim, int velocity_degree>
SchurComplementMatrixType aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::Schur_complement_block_matrix
private

Definition at line 700 of file stokes_matrix_free.h.

§ constraints_v

template<int dim, int velocity_degree>
AffineConstraints<double> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::constraints_v
private

Definition at line 702 of file stokes_matrix_free.h.

§ constraints_p

template<int dim, int velocity_degree>
AffineConstraints<double> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::constraints_p
private

Definition at line 703 of file stokes_matrix_free.h.

§ mg_matrices_A_block

template<int dim, int velocity_degree>
MGLevelObject<GMGABlockMatrixType> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_matrices_A_block
private

Definition at line 705 of file stokes_matrix_free.h.

§ mg_matrices_Schur_complement

template<int dim, int velocity_degree>
MGLevelObject<GMGSchurComplementMatrixType> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_matrices_Schur_complement
private

Definition at line 706 of file stokes_matrix_free.h.

§ mg_constrained_dofs_A_block

template<int dim, int velocity_degree>
MGConstrainedDoFs aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_constrained_dofs_A_block
private

Definition at line 708 of file stokes_matrix_free.h.

§ mg_constrained_dofs_Schur_complement

template<int dim, int velocity_degree>
MGConstrainedDoFs aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_constrained_dofs_Schur_complement
private

Definition at line 709 of file stokes_matrix_free.h.

§ mg_constrained_dofs_projection

template<int dim, int velocity_degree>
MGConstrainedDoFs aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_constrained_dofs_projection
private

Definition at line 710 of file stokes_matrix_free.h.

§ mg_transfer_A_block

template<int dim, int velocity_degree>
MGTransferMF<dim,GMGNumberType> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_transfer_A_block
private

Definition at line 712 of file stokes_matrix_free.h.

§ mg_transfer_Schur_complement

template<int dim, int velocity_degree>
MGTransferMF<dim,GMGNumberType> aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::mg_transfer_Schur_complement
private

Definition at line 713 of file stokes_matrix_free.h.

§ matrix_free_objects

template<int dim, int velocity_degree>
std::vector<std::shared_ptr<MatrixFree<dim,double> > > aspect::StokesMatrixFreeHandlerImplementation< dim, velocity_degree >::matrix_free_objects
private

Definition at line 715 of file stokes_matrix_free.h.


The documentation for this class was generated from the following files: