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

Public Member Functions

void initialize_one_particle_property (const Point< dim > &position, std::vector< double > &particle_properties) const override
 
void update_particle_properties (const ParticleUpdateInputs< dim > &inputs, typename ParticleHandler< dim >::particle_iterator_range &particles) const override
 
InitializationModeForLateParticles late_initialization_mode () const override
 
UpdateTimeFlags need_update () const override
 
std::vector< std::pair< std::string, unsigned int > > get_property_information () const override
 
void parse_parameters (ParameterHandler &prm) override
 
- Public Member Functions inherited from aspect::Particle::Property::Interface< dim >
virtual DEAL_II_DEPRECATED void update_particle_property (const unsigned int data_position, const Vector< double > &solution, const std::vector< Tensor< 1, dim >> &gradients, typename ParticleHandler< dim >::particle_iterator &particle) const
 
virtual UpdateFlags get_update_flags (const unsigned int component) const
 
virtual DEAL_II_DEPRECATED UpdateFlags get_needed_update_flags () const
 
virtual void set_data_position (const unsigned int data_position)
 
virtual unsigned int get_data_position () const
 
- Public Member Functions inherited from aspect::Particle::ParticleInterfaceBase
 ParticleInterfaceBase ()
 
void set_particle_manager_index (unsigned int particle_manager_index)
 Set which particle manager the plugin belongs to. More...
 
unsigned int get_particle_manager_index () const
 Gets which particle manager the plugin belong to. More...
 
- Public Member Functions inherited from aspect::Plugins::InterfaceBase
virtual ~InterfaceBase ()=default
 
virtual void initialize ()
 
virtual void update ()
 
- 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
 

Static Public Member Functions

static void declare_parameters (ParameterHandler &prm)
 
- Static Public Member Functions inherited from aspect::Plugins::InterfaceBase
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

std::unique_ptr< Functions::ParsedFunction< dim > > reaction_area
 
Utilities::Coordinates::CoordinateSystem coordinate_system
 
std::unique_ptr< Functions::ParsedFunction< 2 > > reaction_rate
 
std::vector< unsigned int > reactant_indices
 
std::vector< unsigned int > product_indices
 
std::vector< double > reaction_times
 

Static Private Attributes

static constexpr unsigned int background_index = numbers::invalid_unsigned_int
 

Additional Inherited Members

- Protected Attributes inherited from aspect::Particle::Property::Interface< dim >
unsigned int data_position
 

Detailed Description

template<int dim>
class aspect::Particle::Property::CompositionReaction< dim >

A class that initializes particle properties based on the initial value of the compositional fields in the model and updates them based on a description of reactions between the fields.

Definition at line 45 of file composition_reaction.h.

Member Function Documentation

§ initialize_one_particle_property()

template<int dim>
void aspect::Particle::Property::CompositionReaction< dim >::initialize_one_particle_property ( const Point< dim > &  position,
std::vector< double > &  particle_properties 
) const
overridevirtual

Initialization function. This function is called once at the creation of every particle for every property to initialize its value.

Parameters
[in]positionThe current particle position.
[in,out]particle_propertiesThe properties of the particle that is initialized within the call of this function. The purpose of this function should be to extend this vector by a number of properties.

Reimplemented from aspect::Particle::Property::Interface< dim >.

§ update_particle_properties()

template<int dim>
void aspect::Particle::Property::CompositionReaction< dim >::update_particle_properties ( const ParticleUpdateInputs< dim > &  inputs,
typename ParticleHandler< dim >::particle_iterator_range &  particles 
) const
overridevirtual

Update function. This function is called every time an update is requested by need_update() for every cell for every property. It is expected to update the properties of all particles in the given range particles, which are all in one cell. It is obvious that this function is called a lot, so its code should be efficient. The interface provides a default implementation that does nothing, therefore derived plugins that do not require an update do not need to implement this function.

Parameters
[in]inputsA struct of type ParticleUpdateInputs that contains all necessary inputs to compute the particle updates. See the documentation of this struct in include/aspect/particle/property/interface.h for a list of all available inputs.
[in,out]particlesThe particles that are to be updated within this function.

Reimplemented from aspect::Particle::Property::Interface< dim >.

§ late_initialization_mode()

template<int dim>
InitializationModeForLateParticles aspect::Particle::Property::CompositionReaction< dim >::late_initialization_mode ( ) const
overridevirtual

Returns an enum, which determines how this particle property is initialized for particles that are created later than the initial particle generation. For this property the value of generated particles is interpolated from existing particles, unless the particle is in a boundary cell that has a Dirichlet boundary condition, in which case it uses the boundary condition value.

Reimplemented from aspect::Particle::Property::Interface< dim >.

§ need_update()

template<int dim>
UpdateTimeFlags aspect::Particle::Property::CompositionReaction< dim >::need_update ( ) const
overridevirtual

Returns an enum, which determines at what times particle properties are updated. The default implementation returns update_never, which signals that particle properties should never be updated. See the documentation of UpdateTimeFlags for a list of possible values and examples for their use. Every plugin that implements this function should return the value appropriate for its purpose, unless it does not need any update, which is the default. This option saves considerable computation time in cases, when no plugin needs to update particle properties over time.

Reimplemented from aspect::Particle::Property::Interface< dim >.

§ get_property_information()

template<int dim>
std::vector<std::pair<std::string, unsigned int> > aspect::Particle::Property::CompositionReaction< dim >::get_property_information ( ) const
overridevirtual

Set up the information about the names and number of components this property requires.

Returns
A vector that contains pairs of the property names and the number of components this property plugin defines.

Implements aspect::Particle::Property::Interface< dim >.

§ declare_parameters()

template<int dim>
static void aspect::Particle::Property::CompositionReaction< dim >::declare_parameters ( ParameterHandler &  prm)
static

Declare the parameters this class takes through input files.

§ parse_parameters()

template<int dim>
void aspect::Particle::Property::CompositionReaction< dim >::parse_parameters ( ParameterHandler &  prm)
overridevirtual

Read the parameters this class declares from the parameter file.

Reimplemented from aspect::Plugins::InterfaceBase.

Member Data Documentation

§ reaction_area

template<int dim>
std::unique_ptr<Functions::ParsedFunction<dim> > aspect::Particle::Property::CompositionReaction< dim >::reaction_area
private

A function object representing the area where each reaction occurs.

Definition at line 115 of file composition_reaction.h.

§ coordinate_system

The coordinate representation to evaluate the reaction_area function. Possible choices are depth, cartesian and spherical.

Definition at line 121 of file composition_reaction.h.

§ reaction_rate

template<int dim>
std::unique_ptr<Functions::ParsedFunction<2> > aspect::Particle::Property::CompositionReaction< dim >::reaction_rate
private

A function object representing the change in composition during a reaction. Inputs to this function are the reactant and the product of the reaction, so that the values of the compositions themselves can affect the reaction.

Definition at line 130 of file composition_reaction.h.

§ reactant_indices

template<int dim>
std::vector<unsigned int> aspect::Particle::Property::CompositionReaction< dim >::reactant_indices
private

Vectors that store the indices of the compositional fields taking part in each reaction.

Definition at line 136 of file composition_reaction.h.

§ product_indices

template<int dim>
std::vector<unsigned int> aspect::Particle::Property::CompositionReaction< dim >::product_indices
private

Definition at line 137 of file composition_reaction.h.

§ reaction_times

template<int dim>
std::vector<double> aspect::Particle::Property::CompositionReaction< dim >::reaction_times
private

Vector of the times when each reaction should occur.

Definition at line 142 of file composition_reaction.h.

§ background_index

template<int dim>
constexpr unsigned int aspect::Particle::Property::CompositionReaction< dim >::background_index = numbers::invalid_unsigned_int
staticprivate

Reactions can include a 'background' field, meaning that reactants vanish or products are created out of nowhere. To facilitate this functionality, this (non-existing) background field needs an index.

Definition at line 150 of file composition_reaction.h.


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