ASPECT
Classes | Public Member Functions | Protected Types | Protected Member Functions | Protected Attributes | List of all members
aspect::MaterialModel::GrainSize< dim > Class Template Reference
Inheritance diagram for aspect::MaterialModel::GrainSize< dim >:
Inheritance graph
[legend]

Classes

struct  Formulation
 

Public Member Functions

void initialize () override
 
bool is_compressible () const override
 
void evaluate (const typename Interface< dim >::MaterialModelInputs &in, typename Interface< dim >::MaterialModelOutputs &out) const override
 
double enthalpy (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
std::array< std::pair< double, unsigned int >, 2 > enthalpy_derivative (const typename Interface< dim >::MaterialModelInputs &in) const
 
- Public Member Functions inherited from aspect::MaterialModel::Interface< dim >
virtual ~Interface ()=default
 
virtual void update ()
 
virtual void evaluate (const MaterialModel::MaterialModelInputs< dim > &in, MaterialModel::MaterialModelOutputs< dim > &out) const =0
 
virtual void fill_additional_material_model_inputs (MaterialModel::MaterialModelInputs< dim > &input, const LinearAlgebra::BlockVector &solution, const FEValuesBase< dim > &fe_values, const Introspection< dim > &introspection) const
 
const NonlinearDependence::ModelDependenceget_model_dependence () 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 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
 
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
 

Protected Types

enum  formats { perplex, hefesto }
 

Protected Member Functions

double compute_partitioning_fraction (const double temperature) const
 
double diffusion_viscosity (const double temperature, const double adiabatic_temperature, const double adiabatic_pressure, const double grain_size, const double second_strain_rate_invariant, const Point< dim > &position) const
 
double dislocation_viscosity (const double temperature, const double adiabatic_temperature, const double adiabatic_pressure, const SymmetricTensor< 2, dim > &strain_rate, const Point< dim > &position, const double diffusion_viscosity, const double viscosity_guess=0) const
 
double density (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double compressibility (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double specific_heat (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double thermal_expansion_coefficient (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double seismic_Vp (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double seismic_Vs (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const Point< dim > &position) const
 
double grain_size_change (const double temperature, const double pressure, const std::vector< double > &compositional_fields, const SymmetricTensor< 2, dim > &strain_rate, const Tensor< 1, dim > &velocity, const Point< dim > &position, const unsigned int grain_size_index, const int crossed_transition) const
 
double phase_function (const Point< dim > &position, const double temperature, const double pressure, const unsigned int phase) const
 
unsigned int get_phase_index (const Point< dim > &position, const double temperature, const double pressure) const
 
void convert_log_grain_size (std::vector< double > &compositional_fields) const
 

Protected Attributes

double reference_rho
 
double reference_T
 
double eta
 
double thermal_alpha
 
double reference_specific_heat
 
double reference_compressibility
 
double k_value
 
unsigned int grain_size_index
 
std::vector< double > grain_growth_activation_energy
 
std::vector< double > grain_growth_activation_volume
 
std::vector< double > grain_growth_rate_constant
 
std::vector< double > grain_growth_exponent
 
double minimum_grain_size
 
std::vector< double > reciprocal_required_strain
 
std::vector< double > recrystallized_grain_size
 
std::vector< double > grain_boundary_energy
 
std::vector< double > boundary_area_change_work_fraction
 
std::vector< double > geometric_constant
 
Formulation::Kind grain_size_evolution_formulation
 
double grain_size_reduction_work_fraction_exponent
 
double minimum_grain_size_reduction_work_fraction
 
double maximum_grain_size_reduction_work_fraction
 
double temperature_minimum_partitioning_power
 
double temperature_maximum_partitioning_power
 
double phase_distribution
 
double roughness_to_grain_size
 
double dislocation_viscosity_iteration_threshold
 
unsigned int dislocation_viscosity_iteration_number
 
std::vector< double > dislocation_creep_exponent
 
std::vector< double > dislocation_activation_energy
 
std::vector< double > dislocation_activation_volume
 
std::vector< double > dislocation_creep_prefactor
 
std::vector< double > diffusion_creep_exponent
 
std::vector< double > diffusion_activation_energy
 
std::vector< double > diffusion_activation_volume
 
std::vector< double > diffusion_creep_prefactor
 
std::vector< double > diffusion_creep_grain_size_exponent
 
double max_temperature_dependence_of_eta
 
double min_eta
 
double max_eta
 
double min_specific_heat
 
double max_specific_heat
 
double min_thermal_expansivity
 
double max_thermal_expansivity
 
unsigned int max_latent_heat_substeps
 
double min_grain_size
 
double pv_grain_size_scaling
 
bool advect_log_grainsize
 
std::vector< double > transition_depths
 
std::vector< double > transition_temperatures
 
std::vector< double > transition_slopes
 
std::vector< double > transition_widths
 
std::string datadirectory
 
std::vector< std::string > material_file_names
 
std::vector< std::string > derivatives_file_names
 
unsigned int n_material_data
 
bool use_table_properties
 
bool use_enthalpy
 
bool use_bilinear_interpolation
 
enum aspect::MaterialModel::GrainSize::formats material_file_format
 
std::vector< std::unique_ptr< MaterialModel::MaterialUtilities::Lookup::MaterialLookup > > material_lookup
 
std::unique_ptr< FEPointEvaluation< 1, dim > > temperature_evaluator
 
std::unique_ptr< FEPointEvaluation< 1, dim > > pressure_evaluator
 
- Protected Attributes inherited from aspect::MaterialModel::Interface< dim >
NonlinearDependence::ModelDependence model_dependence
 

Functions used in dealing with run-time parameters

void parse_parameters (ParameterHandler &prm) override
 
void create_additional_named_outputs (MaterialModel::MaterialModelOutputs< dim > &out) const override
 
static void declare_parameters (ParameterHandler &prm)
 

Additional Inherited Members

- Public Types inherited from aspect::MaterialModel::Interface< dim >
using MaterialModelInputs = MaterialModel::MaterialModelInputs< dim >
 
using MaterialModelOutputs = MaterialModel::MaterialModelOutputs< dim >
 
- Static Public Member Functions inherited from aspect::MaterialModel::Interface< dim >
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)
 

Detailed Description

template<int dim>
class aspect::MaterialModel::GrainSize< dim >

A material model that relies on compositional fields that stand for average grain sizes of a mineral phase and source terms for them that determine the grain size evolution in dependence of the strain rate, temperature, phase transitions, and the creep regime. This material model only works if a compositional field named 'grain_size' is present. In the diffusion creep regime, the viscosity depends on this grain size. We use the grain size evolution laws described in Behn et al., 2009. Implications of grain size evolution on the seismic structure of the oceanic upper mantle, Earth Planet. Sci. Letters, 282, 178–189. Other material parameters are either prescribed similar to the 'simple' material model, or read from data files that were generated by the Perplex or Hefesto software. The material model is described in more detail in Dannberg, J., Z. Eilon, U. Faul, R. Gassmöller, P. Moulik, and R. Myhill (2017), The importance of grain size to mantle dynamics and seismological observations, Geochem. Geophys. Geosyst., 18, 3034–3061, doi:10.1002/2017GC006944., which is the canonical reference for this material model.

Definition at line 90 of file grain_size.h.

Member Enumeration Documentation

§ formats

template<int dim>
enum aspect::MaterialModel::GrainSize::formats
protected

The format of the provided material files. Currently we support the PERPLEX and HeFESTo data formats.

Enumerator
perplex 
hefesto 

Definition at line 479 of file grain_size.h.

Member Function Documentation

§ initialize()

template<int dim>
void aspect::MaterialModel::GrainSize< dim >::initialize ( )
overridevirtual

Initialization function. Loads the material data and sets up pointers.

Reimplemented from aspect::MaterialModel::Interface< dim >.

§ is_compressible()

template<int dim>
bool aspect::MaterialModel::GrainSize< dim >::is_compressible ( ) const
overridevirtual

Return whether the model is compressible or not. Incompressibility does not necessarily imply that the density is constant; rather, it may still depend on temperature or pressure. In the current context, compressibility means whether we should solve the continuity equation as \(\nabla \cdot (\rho \mathbf u)=0\) (compressible Stokes) or as \(\nabla \cdot \mathbf{u}=0\) (incompressible Stokes).

Implements aspect::MaterialModel::Interface< dim >.

§ evaluate()

template<int dim>
void aspect::MaterialModel::GrainSize< dim >::evaluate ( const typename Interface< dim >::MaterialModelInputs in,
typename Interface< dim >::MaterialModelOutputs out 
) const
override

§ declare_parameters()

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

Declare the parameters this class takes through input files.

§ parse_parameters()

template<int dim>
void aspect::MaterialModel::GrainSize< dim >::parse_parameters ( ParameterHandler &  prm)
overridevirtual

Read the parameters this class declares from the parameter file.

Reimplemented from aspect::MaterialModel::Interface< dim >.

§ create_additional_named_outputs()

template<int dim>
void aspect::MaterialModel::GrainSize< dim >::create_additional_named_outputs ( MaterialModel::MaterialModelOutputs< dim > &  outputs) const
overridevirtual

If this material model can produce additional named outputs that are derived from NamedAdditionalOutputs, create them in here. By default, this does nothing.

Reimplemented from aspect::MaterialModel::Interface< dim >.

§ enthalpy()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::enthalpy ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const

Returns the enthalpy as calculated by HeFESTo.

§ enthalpy_derivative()

template<int dim>
std::array<std::pair<double, unsigned int>,2> aspect::MaterialModel::GrainSize< dim >::enthalpy_derivative ( const typename Interface< dim >::MaterialModelInputs in) const

Returns the cell-wise averaged enthalpy derivatives for the evaluate function and postprocessors. The function returns two pairs, the first one represents the temperature derivative, the second one the pressure derivative. The first member of each pair is the derivative, the second one the number of vertex combinations the function could use to compute the derivative. The second member is useful to handle the case no suitable combination of vertices could be found (e.g. if the temperature and pressure on all vertices of the current cell is identical.

§ compute_partitioning_fraction()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::compute_partitioning_fraction ( const double  temperature) const
protected

This function returns the fraction of shear heating energy partitioned into grain damage using the implementation by Mulyukova and Bercovici (2018) Collapse of passive margins by lithospheric damage and plunging grain size. Earth and Planetary Science Letters, 484, 341-352.

§ diffusion_viscosity()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::diffusion_viscosity ( const double  temperature,
const double  adiabatic_temperature,
const double  adiabatic_pressure,
const double  grain_size,
const double  second_strain_rate_invariant,
const Point< dim > &  position 
) const
protected

§ dislocation_viscosity()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::dislocation_viscosity ( const double  temperature,
const double  adiabatic_temperature,
const double  adiabatic_pressure,
const SymmetricTensor< 2, dim > &  strain_rate,
const Point< dim > &  position,
const double  diffusion_viscosity,
const double  viscosity_guess = 0 
) const
protected

This function calculates the dislocation viscosity. For this purpose we need the dislocation component of the strain rate, which we can only compute by knowing the dislocation viscosity. Therefore, we iteratively solve for the dislocation viscosity and update the dislocation strain rate in each iteration using the new value obtained for the dislocation viscosity. The iteration is started with a dislocation viscosity calculated for the whole strain rate unless a guess for the viscosity is provided, which can reduce the number of iterations significantly.

§ density()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::density ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

§ compressibility()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::compressibility ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

§ specific_heat()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::specific_heat ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

§ thermal_expansion_coefficient()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::thermal_expansion_coefficient ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

§ seismic_Vp()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::seismic_Vp ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

Returns the p-wave velocity as calculated by HeFESTo.

§ seismic_Vs()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::seismic_Vs ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const Point< dim > &  position 
) const
protected

Returns the s-wave velocity as calculated by HeFESTo.

§ grain_size_change()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::grain_size_change ( const double  temperature,
const double  pressure,
const std::vector< double > &  compositional_fields,
const SymmetricTensor< 2, dim > &  strain_rate,
const Tensor< 1, dim > &  velocity,
const Point< dim > &  position,
const unsigned int  grain_size_index,
const int  crossed_transition 
) const
protected

Rate of grain size growth (Ostwald ripening) or reduction (due to dynamic recrystallization and phase transformations) in dependence on temperature, pressure, strain rate, mineral phase and creep regime. We use the grain size growth laws as for example described in Behn, M. D., Hirth, G., & Elsenbeck, J. R. (2009). Implications of grain size evolution on the seismic structure of the oceanic upper mantle. Earth and Planetary Science Letters, 282(1), 178-189.

For the rate of grain size reduction due to dynamic crystallization there is the choice between the paleowattmeter (Austins and Evans, 2007) and the paleopiezometer (Hall and Parmentier, 2003) as described in the parameter use_paleowattmeter.

§ phase_function()

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::phase_function ( const Point< dim > &  position,
const double  temperature,
const double  pressure,
const unsigned int  phase 
) const
protected

Function that defines the phase transition interface (0 above, 1 below the phase transition).This is done individually for each transition and summed up in the end.

§ get_phase_index()

template<int dim>
unsigned int aspect::MaterialModel::GrainSize< dim >::get_phase_index ( const Point< dim > &  position,
const double  temperature,
const double  pressure 
) const
protected

Function that returns the phase for a given position, temperature, pressure and compositional field index.

§ convert_log_grain_size()

template<int dim>
void aspect::MaterialModel::GrainSize< dim >::convert_log_grain_size ( std::vector< double > &  compositional_fields) const
protected

Function that takes an object in the same format as in.composition as argument and converts the vector that corresponds to the grain size to its logarithms and limits the grain size to a global minimum. The input argument compositional_fields is modified in-place.

Member Data Documentation

§ reference_rho

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::reference_rho
protected

Definition at line 161 of file grain_size.h.

§ reference_T

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::reference_T
protected

Definition at line 162 of file grain_size.h.

§ eta

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::eta
protected

Definition at line 163 of file grain_size.h.

§ thermal_alpha

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::thermal_alpha
protected

Definition at line 164 of file grain_size.h.

§ reference_specific_heat

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::reference_specific_heat
protected

Definition at line 165 of file grain_size.h.

§ reference_compressibility

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::reference_compressibility
protected

The constant compressibility.

Definition at line 170 of file grain_size.h.

§ k_value

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::k_value
protected

The thermal conductivity.

Definition at line 175 of file grain_size.h.

§ grain_size_index

template<int dim>
unsigned int aspect::MaterialModel::GrainSize< dim >::grain_size_index
protected

The index of the compositional field that represents the grain size.

Definition at line 180 of file grain_size.h.

§ grain_growth_activation_energy

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::grain_growth_activation_energy
protected

Parameters controlling the grain size evolution.

Definition at line 185 of file grain_size.h.

§ grain_growth_activation_volume

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::grain_growth_activation_volume
protected

Definition at line 186 of file grain_size.h.

§ grain_growth_rate_constant

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::grain_growth_rate_constant
protected

Definition at line 187 of file grain_size.h.

§ grain_growth_exponent

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::grain_growth_exponent
protected

Definition at line 188 of file grain_size.h.

§ minimum_grain_size

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::minimum_grain_size
protected

Definition at line 189 of file grain_size.h.

§ reciprocal_required_strain

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::reciprocal_required_strain
protected

Definition at line 190 of file grain_size.h.

§ recrystallized_grain_size

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::recrystallized_grain_size
protected

Definition at line 191 of file grain_size.h.

§ grain_boundary_energy

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::grain_boundary_energy
protected

Parameters controlling the dynamic grain recrystallization.

Definition at line 196 of file grain_size.h.

§ boundary_area_change_work_fraction

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::boundary_area_change_work_fraction
protected

Definition at line 197 of file grain_size.h.

§ geometric_constant

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::geometric_constant
protected

Definition at line 198 of file grain_size.h.

§ grain_size_evolution_formulation

template<int dim>
Formulation::Kind aspect::MaterialModel::GrainSize< dim >::grain_size_evolution_formulation
protected

A variable that records the formulation of how to evolve grain size. See the type of this variable for a description of available options.

Definition at line 258 of file grain_size.h.

§ grain_size_reduction_work_fraction_exponent

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::grain_size_reduction_work_fraction_exponent
protected

Parameters controlling the partitioning of energy into grain damage in the pinned state.

Definition at line 272 of file grain_size.h.

§ minimum_grain_size_reduction_work_fraction

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::minimum_grain_size_reduction_work_fraction
protected

Definition at line 273 of file grain_size.h.

§ maximum_grain_size_reduction_work_fraction

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::maximum_grain_size_reduction_work_fraction
protected

Definition at line 274 of file grain_size.h.

§ temperature_minimum_partitioning_power

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::temperature_minimum_partitioning_power
protected

Definition at line 275 of file grain_size.h.

§ temperature_maximum_partitioning_power

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::temperature_maximum_partitioning_power
protected

Definition at line 276 of file grain_size.h.

§ phase_distribution

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::phase_distribution
protected

Functions and parameters controlling conversion from interface roughness to grain size, used in pinned state formulation of grain damage. This conversion depends on the proportion of the two mineral phases.

A detailed description of this approach can be found in Appendix H.1, in Equation (8) in the main manuscript, and in equation (F.28) of Bercovici, David, and Yanick Ricard (2012). Mechanisms for the generation of plate tectonics by two-phase grain-damage and pinning. Physics of the Earth and Planetary Interiors 202 (2012): 27-55.

Definition at line 288 of file grain_size.h.

§ roughness_to_grain_size

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::roughness_to_grain_size
protected

The factor used to convert roughness into the equivalent mean grain size for a given volume fraction of a mineral in the two-phase damage model.

Definition at line 294 of file grain_size.h.

§ dislocation_viscosity_iteration_threshold

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::dislocation_viscosity_iteration_threshold
protected

Parameters controlling the viscosity.

Definition at line 299 of file grain_size.h.

§ dislocation_viscosity_iteration_number

template<int dim>
unsigned int aspect::MaterialModel::GrainSize< dim >::dislocation_viscosity_iteration_number
protected

Definition at line 300 of file grain_size.h.

§ dislocation_creep_exponent

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::dislocation_creep_exponent
protected

Definition at line 301 of file grain_size.h.

§ dislocation_activation_energy

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::dislocation_activation_energy
protected

Definition at line 302 of file grain_size.h.

§ dislocation_activation_volume

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::dislocation_activation_volume
protected

Definition at line 303 of file grain_size.h.

§ dislocation_creep_prefactor

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::dislocation_creep_prefactor
protected

Definition at line 304 of file grain_size.h.

§ diffusion_creep_exponent

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::diffusion_creep_exponent
protected

Definition at line 305 of file grain_size.h.

§ diffusion_activation_energy

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::diffusion_activation_energy
protected

Definition at line 306 of file grain_size.h.

§ diffusion_activation_volume

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::diffusion_activation_volume
protected

Definition at line 307 of file grain_size.h.

§ diffusion_creep_prefactor

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::diffusion_creep_prefactor
protected

Definition at line 308 of file grain_size.h.

§ diffusion_creep_grain_size_exponent

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::diffusion_creep_grain_size_exponent
protected

Definition at line 309 of file grain_size.h.

§ max_temperature_dependence_of_eta

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::max_temperature_dependence_of_eta
protected

Because of the nonlinear nature of this material model many parameters need to be kept within bounds to ensure stability of the solution. These bounds can be adjusted as input parameters.

Definition at line 316 of file grain_size.h.

§ min_eta

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::min_eta
protected

Definition at line 317 of file grain_size.h.

§ max_eta

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::max_eta
protected

Definition at line 318 of file grain_size.h.

§ min_specific_heat

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::min_specific_heat
protected

Definition at line 319 of file grain_size.h.

§ max_specific_heat

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::max_specific_heat
protected

Definition at line 320 of file grain_size.h.

§ min_thermal_expansivity

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::min_thermal_expansivity
protected

Definition at line 321 of file grain_size.h.

§ max_thermal_expansivity

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::max_thermal_expansivity
protected

Definition at line 322 of file grain_size.h.

§ max_latent_heat_substeps

template<int dim>
unsigned int aspect::MaterialModel::GrainSize< dim >::max_latent_heat_substeps
protected

Definition at line 323 of file grain_size.h.

§ min_grain_size

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::min_grain_size
protected

Definition at line 324 of file grain_size.h.

§ pv_grain_size_scaling

template<int dim>
double aspect::MaterialModel::GrainSize< dim >::pv_grain_size_scaling
protected

Definition at line 325 of file grain_size.h.

§ advect_log_grainsize

template<int dim>
bool aspect::MaterialModel::GrainSize< dim >::advect_log_grainsize
protected

Whether to advect the real grain size, or the logarithm of the grain size. The logarithm reduces jumps.

Definition at line 331 of file grain_size.h.

§ transition_depths

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::transition_depths
protected

list of depth, width and Clapeyron slopes for the different phase transitions and in which phase they occur

Definition at line 456 of file grain_size.h.

§ transition_temperatures

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::transition_temperatures
protected

Definition at line 457 of file grain_size.h.

§ transition_slopes

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::transition_slopes
protected

Definition at line 458 of file grain_size.h.

§ transition_widths

template<int dim>
std::vector<double> aspect::MaterialModel::GrainSize< dim >::transition_widths
protected

Definition at line 459 of file grain_size.h.

§ datadirectory

template<int dim>
std::string aspect::MaterialModel::GrainSize< dim >::datadirectory
protected

The following variables are properties of the material files we read in.

Definition at line 466 of file grain_size.h.

§ material_file_names

template<int dim>
std::vector<std::string> aspect::MaterialModel::GrainSize< dim >::material_file_names
protected

Definition at line 467 of file grain_size.h.

§ derivatives_file_names

template<int dim>
std::vector<std::string> aspect::MaterialModel::GrainSize< dim >::derivatives_file_names
protected

Definition at line 468 of file grain_size.h.

§ n_material_data

template<int dim>
unsigned int aspect::MaterialModel::GrainSize< dim >::n_material_data
protected

Definition at line 469 of file grain_size.h.

§ use_table_properties

template<int dim>
bool aspect::MaterialModel::GrainSize< dim >::use_table_properties
protected

Definition at line 470 of file grain_size.h.

§ use_enthalpy

template<int dim>
bool aspect::MaterialModel::GrainSize< dim >::use_enthalpy
protected

Definition at line 471 of file grain_size.h.

§ use_bilinear_interpolation

template<int dim>
bool aspect::MaterialModel::GrainSize< dim >::use_bilinear_interpolation
protected

Definition at line 472 of file grain_size.h.

§ material_file_format

template<int dim>
enum aspect::MaterialModel::GrainSize::formats aspect::MaterialModel::GrainSize< dim >::material_file_format
protected

§ material_lookup

template<int dim>
std::vector<std::unique_ptr<MaterialModel::MaterialUtilities::Lookup::MaterialLookup> > aspect::MaterialModel::GrainSize< dim >::material_lookup
protected

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

Definition at line 490 of file grain_size.h.

§ temperature_evaluator

template<int dim>
std::unique_ptr<FEPointEvaluation<1, dim> > aspect::MaterialModel::GrainSize< dim >::temperature_evaluator
mutableprotected

We cache the evaluators that are necessary to evaluate the temperature and pressure at the vertices of the current cell. By caching the evaluators, we can avoid recreating them every time we need them.

Definition at line 498 of file grain_size.h.

§ pressure_evaluator

template<int dim>
std::unique_ptr<FEPointEvaluation<1, dim> > aspect::MaterialModel::GrainSize< dim >::pressure_evaluator
mutableprotected

Definition at line 499 of file grain_size.h.


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