|
ASPECT
|
Classes | |
| struct | AdvectionFieldMethod |
| struct | AdvectionStabilizationMethod |
| struct | Formulation |
| struct | NonlinearSolver |
| struct | NonlinearSolverFailureStrategy |
| struct | NullspaceRemoval |
| The NullspaceRemoval struct. More... | |
| struct | ReactionSolverType |
| struct | StokesGMGType |
| struct | StokesKrylovType |
| struct | StokesSolverType |
Public Types | |
| using | DEAL_II_DEPRECATED = aspect::CompositionalFieldDescription |
Public Member Functions | |
| Parameters (ParameterHandler &prm, const MPI_Comm mpi_communicator) | |
| void | parse_parameters (ParameterHandler &prm, const MPI_Comm mpi_communicator) |
| void | parse_geometry_dependent_parameters (ParameterHandler &prm, const GeometryModel::Interface< dim > &geometry_model) |
Static Public Member Functions | |
| static bool | is_defect_correction (const typename NonlinearSolver::Kind &input) |
| static void | declare_parameters (ParameterHandler &prm, const unsigned int mpi_rank) |
A structure that holds run-time parameters. These parameters are all declared for the ParameterHandler class in the declare_parameters() member function, and read in the parse_parameters() function.
Each of the member variables of this class corresponds to a parameter declared for the ParameterHandler class. Rather than duplicating the documentation of each of these parameters for the member variables here, please refer to the documentation of run-time parameters in the ASPECT manual for more information.
Definition at line 56 of file parameters.h.
| using aspect::Parameters< dim >::DEAL_II_DEPRECATED = aspect::CompositionalFieldDescription |
Definition at line 480 of file parameters.h.
| aspect::Parameters< dim >::Parameters | ( | ParameterHandler & | prm, |
| const MPI_Comm | mpi_communicator | ||
| ) |
Constructor. Fills the values of member functions from the given parameter object.
| prm | The parameter object that has previously been filled with content by reading an input file. |
| mpi_communicator | The MPI communicator we will use for this simulation. We need this when calling parse_parameters() so that we can verify some of the input arguments. |
|
inlinestatic |
Definition at line 86 of file parameters.h.
|
static |
Declare the run-time parameters this class takes, and call the respective declare_parameters functions of the namespaces that describe geometries, material models, etc.
| prm | The object in which the run-time parameters are to be declared. |
| mpi_rank | The MPI rank of the current process. This is needed to only print deprecation warnings from rank 0. |
| void aspect::Parameters< dim >::parse_parameters | ( | ParameterHandler & | prm, |
| const MPI_Comm | mpi_communicator | ||
| ) |
Read run-time parameters from an object that has previously parsed an input file. This reads all parameters that do not require knowledge of the geometry model we use. There is a separate function parse_geometry_dependent_parameters() that is called as soon as the geometry object has been created and that can translate between the symbolic names for boundary components that the geometry model publishes and the boundary indicators used internally.
| prm | The object from which to obtain the run-time parameters. |
| mpi_communicator | The MPI communicator we will use for this simulation. We need this when calling parse_parameters() so that we can verify some of the input arguments. |
| void aspect::Parameters< dim >::parse_geometry_dependent_parameters | ( | ParameterHandler & | prm, |
| const GeometryModel::Interface< dim > & | geometry_model | ||
| ) |
Read those run-time parameters from a ParameterHandler object that depend on knowing which geometry object we use. This function complements parse_parameters() but is only called once the geometry object has been created. This function is separate because we allow the use of symbolic names in defining which boundary components have which boundary conditions, and the names one can specify there are not available until after the geometry object has been created.
This function is called from the GeometryModel::create_geometry() function.
| prm | The object from which to obtain the run-time parameters. |
| geometry_model | The geometry model that provides boundary names etc. |
| NonlinearSolver::Kind aspect::Parameters< dim >::nonlinear_solver |
Definition at line 550 of file parameters.h.
| NonlinearSolverFailureStrategy::Kind aspect::Parameters< dim >::nonlinear_solver_failure_strategy |
Definition at line 551 of file parameters.h.
| AdvectionStabilizationMethod::Kind aspect::Parameters< dim >::advection_stabilization_method |
Definition at line 553 of file parameters.h.
| double aspect::Parameters< dim >::nonlinear_tolerance |
Definition at line 554 of file parameters.h.
| bool aspect::Parameters< dim >::resume_computation |
Definition at line 555 of file parameters.h.
| double aspect::Parameters< dim >::start_time |
Definition at line 556 of file parameters.h.
| double aspect::Parameters< dim >::end_time |
Definition at line 557 of file parameters.h.
| double aspect::Parameters< dim >::CFL_number |
Definition at line 558 of file parameters.h.
| double aspect::Parameters< dim >::maximum_time_step |
Definition at line 559 of file parameters.h.
| double aspect::Parameters< dim >::maximum_relative_increase_time_step |
Definition at line 560 of file parameters.h.
| double aspect::Parameters< dim >::maximum_first_time_step |
Definition at line 561 of file parameters.h.
| bool aspect::Parameters< dim >::use_artificial_viscosity_smoothing |
Definition at line 562 of file parameters.h.
| bool aspect::Parameters< dim >::use_conduction_timestep |
Definition at line 563 of file parameters.h.
| bool aspect::Parameters< dim >::convert_to_years |
Definition at line 564 of file parameters.h.
| std::string aspect::Parameters< dim >::output_directory |
Definition at line 565 of file parameters.h.
| double aspect::Parameters< dim >::surface_pressure |
Definition at line 566 of file parameters.h.
| double aspect::Parameters< dim >::adiabatic_surface_temperature |
Definition at line 567 of file parameters.h.
| unsigned int aspect::Parameters< dim >::timing_output_frequency |
Definition at line 568 of file parameters.h.
| unsigned int aspect::Parameters< dim >::max_nonlinear_iterations |
Definition at line 569 of file parameters.h.
| unsigned int aspect::Parameters< dim >::max_nonlinear_iterations_in_prerefinement |
Definition at line 570 of file parameters.h.
| bool aspect::Parameters< dim >::use_operator_splitting |
Definition at line 571 of file parameters.h.
| std::string aspect::Parameters< dim >::world_builder_file |
Definition at line 572 of file parameters.h.
| unsigned int aspect::Parameters< dim >::n_particle_managers |
Definition at line 573 of file parameters.h.
| double aspect::Parameters< dim >::temperature_solver_tolerance |
Definition at line 583 of file parameters.h.
| double aspect::Parameters< dim >::composition_solver_tolerance |
Definition at line 584 of file parameters.h.
| unsigned int aspect::Parameters< dim >::advection_gmres_restart_length |
Definition at line 587 of file parameters.h.
| bool aspect::Parameters< dim >::use_direct_stokes_solver |
Definition at line 590 of file parameters.h.
| bool aspect::Parameters< dim >::use_bfbt |
Definition at line 591 of file parameters.h.
| StokesSolverType::Kind aspect::Parameters< dim >::stokes_solver_type |
Definition at line 592 of file parameters.h.
| StokesGMGType::Kind aspect::Parameters< dim >::stokes_gmg_type |
Definition at line 593 of file parameters.h.
| StokesKrylovType::Kind aspect::Parameters< dim >::stokes_krylov_type |
Definition at line 594 of file parameters.h.
| unsigned int aspect::Parameters< dim >::idr_s_parameter |
Definition at line 595 of file parameters.h.
| double aspect::Parameters< dim >::linear_stokes_solver_tolerance |
Definition at line 597 of file parameters.h.
| unsigned int aspect::Parameters< dim >::n_cheap_stokes_solver_steps |
Definition at line 598 of file parameters.h.
| unsigned int aspect::Parameters< dim >::n_expensive_stokes_solver_steps |
Definition at line 599 of file parameters.h.
| double aspect::Parameters< dim >::linear_solver_A_block_tolerance |
Definition at line 600 of file parameters.h.
| bool aspect::Parameters< dim >::use_full_A_block_preconditioner |
Definition at line 601 of file parameters.h.
| bool aspect::Parameters< dim >::force_nonsymmetric_A_block_solver |
Definition at line 602 of file parameters.h.
| double aspect::Parameters< dim >::linear_solver_S_block_tolerance |
Definition at line 603 of file parameters.h.
| unsigned int aspect::Parameters< dim >::stokes_gmres_restart_length |
Definition at line 604 of file parameters.h.
| std::string aspect::Parameters< dim >::AMG_smoother_type |
Definition at line 607 of file parameters.h.
| unsigned int aspect::Parameters< dim >::AMG_smoother_sweeps |
Definition at line 608 of file parameters.h.
| double aspect::Parameters< dim >::AMG_aggregation_threshold |
Definition at line 609 of file parameters.h.
| bool aspect::Parameters< dim >::AMG_output_details |
Definition at line 610 of file parameters.h.
| ReactionSolverType::Kind aspect::Parameters< dim >::reaction_solver_type |
Definition at line 613 of file parameters.h.
| double aspect::Parameters< dim >::ARKode_relative_tolerance |
Definition at line 614 of file parameters.h.
| double aspect::Parameters< dim >::reaction_time_step |
Definition at line 615 of file parameters.h.
| unsigned int aspect::Parameters< dim >::reaction_steps_per_advection_step |
Definition at line 616 of file parameters.h.
| double aspect::Parameters< dim >::diffusion_length_scale |
Definition at line 619 of file parameters.h.
| Formulation::Kind aspect::Parameters< dim >::formulation |
This variable determines which of the several ways to formulate the equations ASPECT will solve. Common formulations are the Boussinesq or Anelastic Liquid Approximations (BA, ALA). ASPECT's original formulation is termed 'isentropic compression'. 'Custom' allows to set the approximations individually per equation.
Definition at line 638 of file parameters.h.
| Formulation::MassConservation::Kind aspect::Parameters< dim >::formulation_mass_conservation |
Determines how to formulate the mass conservation equation in ASPECT. Common approximations are 'incompressible' or 'reference density profile'. ASPECT's original formulation is termed 'isentropic compression'. See the manual for more details about the individual terms.
Definition at line 646 of file parameters.h.
| Formulation::TemperatureEquation::Kind aspect::Parameters< dim >::formulation_temperature_equation |
Determines how to formulate the density in the temperature equation in ASPECT. Possible approximations are 'reference density profile' or 'real density'.
Definition at line 653 of file parameters.h.
| bool aspect::Parameters< dim >::enable_elasticity |
This variable determines whether additional terms related to elastic forces are added to the Stokes equation.
Definition at line 659 of file parameters.h.
| bool aspect::Parameters< dim >::include_melt_transport |
Definition at line 669 of file parameters.h.
| bool aspect::Parameters< dim >::enable_additional_stokes_rhs |
Definition at line 670 of file parameters.h.
| bool aspect::Parameters< dim >::enable_prescribed_dilation |
Definition at line 671 of file parameters.h.
| std::set<types::boundary_id> aspect::Parameters< dim >::fixed_heat_flux_boundary_indicators |
A set of boundary ids on which the boundary_heat_flux objects will be applied.
Definition at line 677 of file parameters.h.
| NullspaceRemoval::Kind aspect::Parameters< dim >::nullspace_removal |
Selection of operations to perform to remove nullspace from velocity field.
Definition at line 683 of file parameters.h.
| unsigned int aspect::Parameters< dim >::initial_global_refinement |
Definition at line 692 of file parameters.h.
| unsigned int aspect::Parameters< dim >::initial_adaptive_refinement |
Definition at line 693 of file parameters.h.
| double aspect::Parameters< dim >::refinement_fraction |
Definition at line 694 of file parameters.h.
| double aspect::Parameters< dim >::coarsening_fraction |
Definition at line 695 of file parameters.h.
| bool aspect::Parameters< dim >::adapt_by_fraction_of_cells |
Definition at line 696 of file parameters.h.
| unsigned int aspect::Parameters< dim >::min_grid_level |
Definition at line 697 of file parameters.h.
| std::vector<double> aspect::Parameters< dim >::additional_refinement_times |
Definition at line 698 of file parameters.h.
| unsigned int aspect::Parameters< dim >::adaptive_refinement_interval |
Definition at line 699 of file parameters.h.
| bool aspect::Parameters< dim >::skip_solvers_on_initial_refinement |
Definition at line 700 of file parameters.h.
| bool aspect::Parameters< dim >::skip_setup_initial_conditions_on_initial_refinement |
Definition at line 701 of file parameters.h.
| bool aspect::Parameters< dim >::run_postprocessors_on_initial_refinement |
Definition at line 702 of file parameters.h.
| bool aspect::Parameters< dim >::run_postprocessors_on_nonlinear_iterations |
Definition at line 703 of file parameters.h.
| unsigned int aspect::Parameters< dim >::stabilization_alpha |
Definition at line 713 of file parameters.h.
| std::vector<double> aspect::Parameters< dim >::stabilization_c_R |
Definition at line 714 of file parameters.h.
| std::vector<double> aspect::Parameters< dim >::stabilization_beta |
Definition at line 715 of file parameters.h.
| double aspect::Parameters< dim >::stabilization_gamma |
Definition at line 716 of file parameters.h.
| double aspect::Parameters< dim >::discontinuous_penalty |
Definition at line 717 of file parameters.h.
| bool aspect::Parameters< dim >::use_limiter_for_discontinuous_temperature_solution |
Definition at line 718 of file parameters.h.
| std::vector<bool> aspect::Parameters< dim >::use_limiter_for_discontinuous_composition_solution |
Definition at line 719 of file parameters.h.
| double aspect::Parameters< dim >::global_temperature_max_preset |
Definition at line 720 of file parameters.h.
| double aspect::Parameters< dim >::global_temperature_min_preset |
Definition at line 721 of file parameters.h.
| std::vector<double> aspect::Parameters< dim >::global_composition_max_preset |
Definition at line 722 of file parameters.h.
| std::vector<double> aspect::Parameters< dim >::global_composition_min_preset |
Definition at line 723 of file parameters.h.
| std::vector<std::string> aspect::Parameters< dim >::compositional_fields_with_disabled_boundary_entropy_viscosity |
Definition at line 725 of file parameters.h.
| int aspect::Parameters< dim >::checkpoint_time_secs |
Definition at line 734 of file parameters.h.
| int aspect::Parameters< dim >::checkpoint_steps |
Definition at line 735 of file parameters.h.
| unsigned int aspect::Parameters< dim >::stokes_velocity_degree |
Definition at line 744 of file parameters.h.
| bool aspect::Parameters< dim >::use_locally_conservative_discretization |
Definition at line 745 of file parameters.h.
| bool aspect::Parameters< dim >::use_equal_order_interpolation_for_stokes |
Definition at line 746 of file parameters.h.
| bool aspect::Parameters< dim >::use_discontinuous_temperature_discretization |
Definition at line 747 of file parameters.h.
| std::vector<bool> aspect::Parameters< dim >::use_discontinuous_composition_discretization |
Definition at line 748 of file parameters.h.
| bool aspect::Parameters< dim >::have_discontinuous_composition_discretization |
Definition at line 749 of file parameters.h.
| unsigned int aspect::Parameters< dim >::temperature_degree |
Definition at line 750 of file parameters.h.
| std::vector<unsigned int> aspect::Parameters< dim >::composition_degrees |
Definition at line 751 of file parameters.h.
| unsigned int aspect::Parameters< dim >::max_composition_degree |
Definition at line 752 of file parameters.h.
| std::string aspect::Parameters< dim >::pressure_normalization |
Definition at line 753 of file parameters.h.
| MaterialModel::MaterialAveraging::AveragingOperation aspect::Parameters< dim >::material_averaging |
Definition at line 754 of file parameters.h.
| AdvectionFieldMethod::Kind aspect::Parameters< dim >::temperature_method |
Definition at line 765 of file parameters.h.
| unsigned int aspect::Parameters< dim >::n_compositional_fields |
Definition at line 775 of file parameters.h.
| std::vector<std::string> aspect::Parameters< dim >::names_of_compositional_fields |
Definition at line 776 of file parameters.h.
| std::vector<aspect::CompositionalFieldDescription> aspect::Parameters< dim >::composition_descriptions |
Definition at line 777 of file parameters.h.
| unsigned int aspect::Parameters< dim >::n_chemical_compositions |
Definition at line 778 of file parameters.h.
| std::vector<unsigned int> aspect::Parameters< dim >::chemical_composition_indices |
Definition at line 779 of file parameters.h.
| std::vector<typename AdvectionFieldMethod::Kind> aspect::Parameters< dim >::compositional_field_methods |
A vector that contains the advection field method for every compositional field. Consequently the vector has n_compositional_fields entries.
Definition at line 785 of file parameters.h.
| std::map<unsigned int, std::pair<std::string,unsigned int> > aspect::Parameters< dim >::mapped_particle_properties |
Map from compositional index to a pair "particle property", "component", where particle property is a string that can be mapped to one of the particle property plugins. Component denotes which component of the particle property is to be mapped in case there are several. Therefore, it is optional to specify the component and it is of the format "[0][1][2]". In case no component is specified it defaults to 0.
Definition at line 796 of file parameters.h.
| std::vector<unsigned int> aspect::Parameters< dim >::normalized_fields |
Definition at line 798 of file parameters.h.
| bool aspect::Parameters< dim >::mesh_deformation_enabled |
Definition at line 806 of file parameters.h.
| bool aspect::Parameters< dim >::volume_of_fluid_tracking_enabled |
Definition at line 815 of file parameters.h.