ASPECT
Public Member Functions | Static Public Member Functions | Private Attributes | List of all members
aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim > Class Template Reference
Inheritance diagram for aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >:
Inheritance graph
[legend]

Public Member Functions

void initialize ()
 
double compute_value (const PhaseFunctionInputs< dim > &in) const
 
double compute_derivative () const
 
unsigned int n_phase_transitions () const
 
unsigned int n_phases () const
 
unsigned int n_phases_over_all_chemical_compositions () const
 
const std::vector< unsigned int > & n_phase_transitions_for_each_chemical_composition () const
 
const std::vector< unsigned int > & n_phases_for_each_chemical_composition () const
 
const std::vector< unsigned int > & n_phase_transitions_for_each_composition () const
 
const std::vector< unsigned int > & n_phases_for_each_composition () const
 
void parse_parameters (ParameterHandler &prm)
 
- 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
 

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

std::string data_directory
 
std::vector< std::string > material_file_names
 
std::vector< double > minimum_temperature
 
std::vector< double > maximum_temperature
 
std::vector< double > interval_temperature
 
std::vector< double > minimum_pressure
 
std::vector< double > maximum_pressure
 
std::vector< double > interval_pressure
 
std::vector< std::unique_ptr< Utilities::StructuredDataLookup< 2 > > > material_lookup
 
std::vector< unsigned int > transition_indicators
 
std::unique_ptr< std::vector< unsigned int > > n_phase_transitions_per_composition
 
std::vector< unsigned int > n_phases_per_composition
 
std::vector< unsigned int > n_phase_transitions_per_chemical_composition
 
std::vector< unsigned int > n_phases_per_chemical_composition
 
unsigned int n_phases_total
 
unsigned int n_phases_total_chemical_compositions
 

Detailed Description

template<int dim>
class aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >

A class that bundles functionality to look up the dominant phase in tables for each respective composition and export the values of phase functions. The class can handle arbitrary numbers of dominant phases for each composition, but the calling side has to determine how to use the return values of this object (e.g. in terms of density or viscosity).

Definition at line 561 of file utilities.h.

Member Function Documentation

§ initialize()

template<int dim>
void aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::initialize ( )

The initialization process loads the contents of the material files for the respective compositions.

§ compute_value()

template<int dim>
double aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::compute_value ( const PhaseFunctionInputs< dim > &  in) const

Percentage of material that has already undergone the phase transition to the higher-pressure material. For this class this function only returns 1.0 or 0.0, depending on whether the selected phase transition has been crossed or not.

§ compute_derivative()

template<int dim>
double aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::compute_derivative ( ) const

No valid implementation exists for this function, as the derivative of a discrete function is undefined at locations of phase jumps. This function raises an error to ensure that a phase derivative request is not made for this phase function.

§ n_phase_transitions()

template<int dim>
unsigned int aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phase_transitions ( ) const

Return the total number of phase transitions.

§ n_phases()

template<int dim>
unsigned int aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases ( ) const

Return the total number of phases.

§ n_phases_over_all_chemical_compositions()

template<int dim>
unsigned int aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_over_all_chemical_compositions ( ) const

Return the total number of phases over all chemical compositions.

§ n_phase_transitions_for_each_chemical_composition()

template<int dim>
const std::vector<unsigned int>& aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phase_transitions_for_each_chemical_composition ( ) const

Return how many phase transitions there are for each chemical composition.

§ n_phases_for_each_chemical_composition()

template<int dim>
const std::vector<unsigned int>& aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_for_each_chemical_composition ( ) const

Return how many phases there are for each chemical composition.

§ n_phase_transitions_for_each_composition()

template<int dim>
const std::vector<unsigned int>& aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phase_transitions_for_each_composition ( ) const

Return how many phase transitions there are for each composition. Note, that most likely you only need the number of phase transitions for each chemical composition, so use the function above instead. This function is only kept for backward compatibility.

§ n_phases_for_each_composition()

template<int dim>
const std::vector<unsigned int>& aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_for_each_composition ( ) const

Return how many phases there are for each composition. Note, that most likely you only need the number of phase transitions for each chemical composition, so use the function above instead. This function is only kept for backward compatibility.

§ declare_parameters()

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

Declare the parameters this class takes through input files. Note that this class does not declare its own subsection, i.e. the parameters will be declared in the subsection that was active before calling this function.

§ parse_parameters()

template<int dim>
void aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::parse_parameters ( ParameterHandler &  prm)

Read the parameters this class declares from the parameter file. Note that this class does not declare its own subsection, i.e. the parameters will be parsed from the subsection that was active before calling this function.

Member Data Documentation

§ data_directory

template<int dim>
std::string aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::data_directory
private

Directory path where data files are stored.

Definition at line 655 of file utilities.h.

§ material_file_names

template<int dim>
std::vector<std::string> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::material_file_names
private

List of file names containing material data for each composition.

Definition at line 660 of file utilities.h.

§ minimum_temperature

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::minimum_temperature
private

Minimum temperature values for each composition in the P-T table.

Definition at line 665 of file utilities.h.

§ maximum_temperature

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::maximum_temperature
private

Maximum temperature values for each composition in the P-T table.

Definition at line 670 of file utilities.h.

§ interval_temperature

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::interval_temperature
private

Temperature intervals used for each composition in the P-T table.

Definition at line 675 of file utilities.h.

§ minimum_pressure

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::minimum_pressure
private

Minimum pressure values for each composition in the P-T table.

Definition at line 680 of file utilities.h.

§ maximum_pressure

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::maximum_pressure
private

Maximum pressure values for each composition in the P-T table.

Definition at line 685 of file utilities.h.

§ interval_pressure

template<int dim>
std::vector<double> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::interval_pressure
private

Pressure intervals used for each composition in the P-T table.

Definition at line 690 of file utilities.h.

§ material_lookup

template<int dim>
std::vector<std::unique_ptr<Utilities::StructuredDataLookup<2> > > aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::material_lookup
private

List of pointers to objects that read and process data we get from material data files. There is one pointer/object per lookup file.

Definition at line 696 of file utilities.h.

§ transition_indicators

template<int dim>
std::vector<unsigned int> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::transition_indicators
private

List of phase indicators of the most dominant phases in the material data files to construct the different phase transitions in this class. For a description of the use of the phase indicators, please see the documentation of the input parameter 'Phase transition indicators' in the function declare_parameters().

Definition at line 704 of file utilities.h.

§ n_phase_transitions_per_composition

template<int dim>
std::unique_ptr<std::vector<unsigned int> > aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phase_transitions_per_composition
private

A vector that stores how many phase transitions there are for each compositional field.

Definition at line 709 of file utilities.h.

§ n_phases_per_composition

template<int dim>
std::vector<unsigned int> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_per_composition
private

A vector that stores how many phases there are for each compositional field.

Definition at line 714 of file utilities.h.

§ n_phase_transitions_per_chemical_composition

template<int dim>
std::vector<unsigned int> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phase_transitions_per_chemical_composition
private

A vector that stores how many phase transitions there are for each chemical compositional field.

Definition at line 719 of file utilities.h.

§ n_phases_per_chemical_composition

template<int dim>
std::vector<unsigned int> aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_per_chemical_composition
private

A vector that stores how many phases there are for each chemical compositional field.

Definition at line 724 of file utilities.h.

§ n_phases_total

template<int dim>
unsigned int aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_total
private

Total number of phases over all compositional fields

Definition at line 729 of file utilities.h.

§ n_phases_total_chemical_compositions

template<int dim>
unsigned int aspect::MaterialModel::MaterialUtilities::PhaseFunctionDiscrete< dim >::n_phases_total_chemical_compositions
private

Total number of phases over all compositional fields

Definition at line 734 of file utilities.h.


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