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

Public Member Functions

void parse_parameters (ParameterHandler &prm)
 
void calculate_reaction_terms (const typename Interface< dim >::MaterialModelInputs &in, typename Interface< dim >::MaterialModelOutputs &out) const
 
- 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 std::shared_ptr< const InitialTopographyModel::Interface< dim > > get_initial_topography_model_pointer () 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 BoundaryConvectiveHeating::Manager< dim > & get_boundary_convective_heating_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_convective_heating_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
 

Static Public Member Functions

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)
 

Private Attributes

double crustal_thickness
 
double lithosphere_thickness
 
unsigned int basalt_index
 
unsigned int harzburgite_index
 

Detailed Description

template<int dim>
class aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >

A simplified model to calculate the change in composition upon melting of average mantle as it approaches the surface to produce a basaltic crust and a harzburgitic lithosphere. The model assumes that the crust is generated at a constant depth, and that the lithosphere is generated below the crust at a constant depth. The reaction producing crust and lithosphere only occurs in material that is upwelling, but does not take into account the temperature of the upwelling material.

Definition at line 48 of file crust_and_lithosphere_formation.h.

Member Function Documentation

§ declare_parameters()

template<int dim>
static void aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::declare_parameters ( ParameterHandler &  prm)
static

Declare the parameters this function takes through input files.

§ parse_parameters()

template<int dim>
void aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::parse_parameters ( ParameterHandler &  prm)

Read the parameters from the parameter file.

§ calculate_reaction_terms()

template<int dim>
void aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::calculate_reaction_terms ( const typename Interface< dim >::MaterialModelInputs in,
typename Interface< dim >::MaterialModelOutputs out 
) const

Compute the change in composition for the basalt and harzburgite chemical fields upon melting as mantle material reaches the surface. We assume that all upwelling material is converted to basalt or harzburgite as it reaches the crustal and lithospheric depths, respectively. The reaction terms are computed for as many points as are provided in in and they are stored in the material model outputs object out.

Member Data Documentation

§ crustal_thickness

template<int dim>
double aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::crustal_thickness
private

Parameters controlling where the generation of crust and lithosphere occurs. Crust is generated above the crustal_thickness, and lithosphere is generated below the crustal_thickness and down to a depth that is the sum of crustal_thickness and lithosphere_thickness.

Definition at line 83 of file crust_and_lithosphere_formation.h.

§ lithosphere_thickness

template<int dim>
double aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::lithosphere_thickness
private

Definition at line 84 of file crust_and_lithosphere_formation.h.

§ basalt_index

template<int dim>
unsigned int aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::basalt_index
private

The indices of the compositional fields that store the basalt and harzburgite chemical compositions.

Definition at line 90 of file crust_and_lithosphere_formation.h.

§ harzburgite_index

template<int dim>
unsigned int aspect::MaterialModel::ReactionModel::CrustLithosphereFormation< dim >::harzburgite_index
private

Definition at line 91 of file crust_and_lithosphere_formation.h.


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