|
void | initialize () override |
|
void | set_topography_model (const InitialTopographyModel::Interface< dim > *topo_pointer) |
|
void | create_coarse_mesh (parallel::distributed::Triangulation< dim > &coarse_grid) const override |
|
std::set< types::boundary_id > | get_used_boundary_indicators () const override |
|
std::map< std::string, types::boundary_id > | get_symbolic_boundary_names_map () const override |
|
double | length_scale () const override |
|
double | depth (const Point< dim > &position) const override |
|
double | height_above_reference_surface (const Point< dim > &position) const override |
|
Point< dim > | representative_point (const double depth) const override |
|
double | depth_wrt_topo (const Point< dim > &position) const |
|
virtual double | west_longitude () const |
|
virtual double | east_longitude () const |
|
virtual double | longitude_range () const |
|
virtual double | south_latitude () const |
|
virtual double | north_latitude () const |
|
virtual double | latitude_range () const |
|
double | maximal_depth () const override |
|
virtual double | inner_radius () const |
|
virtual double | outer_radius () const |
|
bool | has_curved_elements () const override |
|
bool | point_is_in_domain (const Point< dim > &point) const override |
|
aspect::Utilities::Coordinates::CoordinateSystem | natural_coordinate_system () const override |
|
std::array< double, dim > | cartesian_to_natural_coordinates (const Point< dim > &position) const override |
|
Point< dim > | natural_to_cartesian_coordinates (const std::array< double, dim > &position) const override |
|
void | parse_parameters (ParameterHandler &prm) override |
|
virtual | ~Interface ()=default |
|
Utilities::NaturalCoordinate< dim > | cartesian_to_other_coordinates (const Point< dim > &position, const Utilities::Coordinates::CoordinateSystem &coordinate_system) const |
|
types::boundary_id | translate_symbolic_boundary_name_to_id (const std::string &name) const |
|
std::vector< types::boundary_id > | translate_symbolic_boundary_names_to_ids (const std::vector< std::string > &names) const |
|
std::string | translate_id_to_symbol_name (const types::boundary_id boundary_id) const |
|
virtual std::set< std::pair< std::pair< types::boundary_id, types::boundary_id >, unsigned int > > | get_periodic_boundary_pairs () const |
|
virtual void | adjust_positions_for_periodicity (Point< dim > &position, const ArrayView< Point< dim >> &connected_positions={}) const |
|
virtual void | make_periodicity_constraints (const DoFHandler< dim > &dof_handler, AffineConstraints< double > &constraints) const |
|
| SimulatorAccess () |
|
| SimulatorAccess (const Simulator< dim > &simulator_object) |
|
virtual | ~SimulatorAccess ()=default |
|
virtual void | initialize_simulator (const Simulator< dim > &simulator_object) |
|
template<typename PostprocessorType > |
PostprocessorType * | find_postprocessor () const |
|
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 |
|
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 |
|
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::BlockVector & | get_current_linearization_point () const |
|
const LinearAlgebra::BlockVector & | get_solution () const |
|
const LinearAlgebra::BlockVector & | get_old_solution () const |
|
const LinearAlgebra::BlockVector & | get_old_old_solution () const |
|
const LinearAlgebra::BlockVector & | get_reaction_vector () const |
|
const LinearAlgebra::BlockVector & | get_mesh_velocity () const |
|
const DoFHandler< dim > & | get_dof_handler () const |
|
const FiniteElement< dim > & | get_fe () const |
|
const LinearAlgebra::BlockSparseMatrix & | get_system_matrix () const |
|
const LinearAlgebra::BlockSparseMatrix & | get_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 |
|
DEAL_II_DEPRECATED const BoundaryTemperature::Interface< dim > & | get_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 |
|
DEAL_II_DEPRECATED const BoundaryComposition::Interface< dim > & | get_boundary_composition () const |
|
const BoundaryComposition::Manager< dim > & | get_boundary_composition_manager () const |
|
const std::map< types::boundary_id, std::unique_ptr< BoundaryTraction::Interface< dim > > > & | get_boundary_traction () const |
|
DEAL_II_DEPRECATED const InitialTemperature::Interface< dim > & | get_initial_temperature () const |
|
std::shared_ptr< const InitialTemperature::Manager< dim > > | get_initial_temperature_manager_pointer () const |
|
const InitialTemperature::Manager< dim > & | get_initial_temperature_manager () const |
|
DEAL_II_DEPRECATED const InitialComposition::Interface< dim > & | get_initial_composition () 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 |
|
template<typename PostprocessorType > |
DEAL_II_DEPRECATED PostprocessorType * | find_postprocessor () const |
|
const Postprocess::Manager< dim > & | get_postprocess_manager () const |
|
const Particle::World< dim > & | get_particle_world () const |
|
Particle::World< dim > & | get_particle_world () |
|
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 |
|
template<int dim>
class aspect::GeometryModel::TwoMergedChunks< dim >
A geometry model class that describes a chunk of a spherical shell, but with two boundary indicators per side boundary. This allows for specifying two different types of boundary conditions on the side boundaries, for example prescribed plate motions along the edge of the lithosphere and an open boundary underneath. In 2D, this class simulates a sector with inner and outer radius, and minimum and maximum longitude. Longitude increases anticlockwise from the positive x-axis, as per the mathematical convention of phi. In 3D, the class simulates a chunk of a sphere, bounded by arbitrary lines of longitude, latitude and radius. Boundary indicator names are lowerwest, upperwest, lowereast, uppereast, lowersouth, uppersouth, lowernorth, uppernorth, bottom and top.
The parameters that describe this geometry and that are read from the input file are the inner, outer and middle boundary radius of the shell, the minimum and maximum longitude, minimum and maximum longitude, and the number of cells initialised in each dimension. In the radial direction, this number should be specified for both the lower and the upper part of the chunk (with their boundary lying at the middle boundary radius).
Initial topography can be added through a radial displacement of the mesh nodes.
Definition at line 65 of file two_merged_chunks.h.