![]() |
ASPECT
|
Public Member Functions | |
CompositeViscoPlastic () | |
void | parse_parameters (ParameterHandler &prm, const std::unique_ptr< std::vector< unsigned int >> &expected_n_phases_per_composition=nullptr) |
double | compute_viscosity (const double pressure, const double temperature, const double grain_size, const std::vector< double > &volume_fractions, const SymmetricTensor< 2, dim > &strain_rate, std::vector< double > &partial_strain_rates, const std::vector< double > &phase_function_values=std::vector< double >(), const std::vector< unsigned int > &n_phase_transitions_per_composition=std::vector< unsigned int >()) const |
![]() | |
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::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 |
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 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 Member Functions | |
double | compute_isostress_viscosity (const double pressure, const double temperature, const double grain_size, const std::vector< double > &volume_fractions, const SymmetricTensor< 2, dim > &strain_rate, std::vector< double > &partial_strain_rates, const std::vector< double > &phase_function_values=std::vector< double >(), const std::vector< unsigned int > &n_phase_transitions_per_composition=std::vector< unsigned int >()) const |
std::pair< double, double > | calculate_isostress_log_strain_rate_and_derivative (const std::vector< std::array< std::pair< double, double >, 4 >> &logarithmic_strain_rates_and_stress_derivatives, const double viscoplastic_stress, std::vector< double > &partial_strain_rates) const |
double | compute_isostrain_viscosity (const double pressure, const double temperature, const double grain_size, const std::vector< double > &volume_fractions, const SymmetricTensor< 2, dim > &strain_rate, std::vector< double > &partial_strain_rates, const std::vector< double > &phase_function_values=std::vector< double >(), const std::vector< unsigned int > &n_phase_transitions_per_composition=std::vector< unsigned int >()) const |
double | compute_composition_viscosity (const double pressure, const double temperature, const double grain_size, const unsigned int composition, const SymmetricTensor< 2, dim > &strain_rate, std::vector< double > &partial_strain_rates, const std::vector< double > &phase_function_values=std::vector< double >(), const std::vector< unsigned int > &n_phase_transitions_per_composition=std::vector< unsigned int >()) const |
std::pair< double, double > | calculate_composition_log_strain_rate_and_derivative (const std::array< std::pair< double, double >, 4 > &logarithmic_strain_rates_and_stress_derivatives, const double viscoplastic_stress, std::vector< double > &partial_strain_rates) const |
Private Attributes | |
ViscosityAveraging::Kind | viscosity_averaging_scheme |
bool | use_diffusion_creep |
bool | use_dislocation_creep |
bool | use_peierls_creep |
bool | use_drucker_prager |
std::vector< unsigned int > | active_flow_mechanisms |
std::unique_ptr< Rheology::DiffusionCreep< dim > > | diffusion_creep |
std::unique_ptr< Rheology::DislocationCreep< dim > > | dislocation_creep |
std::unique_ptr< Rheology::PeierlsCreep< dim > > | peierls_creep |
std::unique_ptr< Rheology::DruckerPragerPower< dim > > | drucker_prager |
unsigned int | number_of_chemical_compositions |
double | maximum_viscosity |
double | damper_viscosity |
double | strain_rate_scaling_factor |
double | minimum_strain_rate |
double | log_strain_rate_residual_threshold |
unsigned int | stress_max_iteration_number |
const double | logmin = std::log(std::numeric_limits<double>::min()) |
Static Private Attributes | |
static constexpr unsigned int | n_decomposed_strain_rates = 5 |
Definition at line 66 of file composite_visco_plastic.h.
aspect::MaterialModel::Rheology::CompositeViscoPlastic< dim >::CompositeViscoPlastic | ( | ) |
Constructor.
|
static |
Declare the parameters this function takes through input files.
void aspect::MaterialModel::Rheology::CompositeViscoPlastic< dim >::parse_parameters | ( | ParameterHandler & | prm, |
const std::unique_ptr< std::vector< unsigned int >> & | expected_n_phases_per_composition = nullptr |
||
) |
Read the parameters this class declares from the parameter file. If expected_n_phases_per_composition
points to a vector of unsigned integers this is considered the number of phases for each compositional field and will be checked against the parsed parameters.
double aspect::MaterialModel::Rheology::CompositeViscoPlastic< dim >::compute_viscosity | ( | const double | pressure, |
const double | temperature, | ||
const double | grain_size, | ||
const std::vector< double > & | volume_fractions, | ||
const SymmetricTensor< 2, dim > & | strain_rate, | ||
std::vector< double > & | partial_strain_rates, | ||
const std::vector< double > & | phase_function_values = std::vector< double >() , |
||
const std::vector< unsigned int > & | n_phase_transitions_per_composition = std::vector< unsigned int >() |
||
) | const |
Compute the viscosity based on the composite viscous creep law. If n_phase_transitions_per_composition
points to a vector of unsigned integers this is considered the number of phase transitions for each compositional field and viscosity will be first computed on each phase and then averaged for each compositional field.
|
private |
Compute the isostress viscosity over all compositional fields based on the composite viscous creep law. If expected_n_phases_per_composition
points to a vector of unsigned integers this is considered the number of phase transitions for each compositional field and viscosity will be first computed on each phase and then averaged for each compositional field.
|
private |
Compute the total strain rate and the first derivative of log strain rate with respect to log viscoplastic stress from individual log strain rate components over all compositional fields. Also updates the partial_strain_rates vector.
|
private |
Compute the isostrain viscosity over all compositional fields based on the composite viscous creep law. If expected_n_phases_per_composition
points to a vector of unsigned integers this is considered the number of phase transitions for each compositional field and viscosity will be first computed on each phase and then averaged for each compositional field.
|
private |
Compute the viscosity for a single compositional field based on the composite viscous creep law. If n_phase_transitions_per_composition
points to a vector of unsigned integers this is considered the number of phase transitions for each compositional field and viscosity will be first computed on each phase and then averaged for each compositional field.
|
private |
Compute the total strain rate and the first derivative of log strain rate with respect to log viscoplastic stress from individual log strain rate components for a single compositional field. Also updates the partial_strain_rates vector.
|
private |
Enumeration for selecting which type of viscosity averaging to use.
Definition at line 189 of file composite_visco_plastic.h.
|
private |
Whether to use different deformation mechanisms.
Definition at line 194 of file composite_visco_plastic.h.
|
private |
Definition at line 195 of file composite_visco_plastic.h.
|
private |
Definition at line 196 of file composite_visco_plastic.h.
|
private |
Definition at line 197 of file composite_visco_plastic.h.
|
private |
Vector storing which flow mechanisms are active.
Definition at line 202 of file composite_visco_plastic.h.
|
staticprivate |
Total number of decomposed strain rates. This includes the maximum viscosity limiter but not the minimum viscosity limiter, which is arranged in parallel with the viscoplastic elements and therefore does not contribute to the total strain rate.
Definition at line 210 of file composite_visco_plastic.h.
|
private |
Pointers to objects for computing deformation mechanism strain rates and effective viscosities.
Definition at line 216 of file composite_visco_plastic.h.
|
private |
Definition at line 217 of file composite_visco_plastic.h.
|
private |
Definition at line 218 of file composite_visco_plastic.h.
|
private |
Definition at line 219 of file composite_visco_plastic.h.
|
private |
The expected number of chemical compositional fields.
Definition at line 224 of file composite_visco_plastic.h.
|
private |
The maximum viscosity, imposed via an isoviscous damper in series with the composite viscoplastic element.
Definition at line 230 of file composite_visco_plastic.h.
|
private |
The viscosity of an isoviscous damper placed in parallel with the flow law components. The viscosity is equal to the product of the minimum and maximum viscosities divided by the difference between the maximum and minimum viscosities.
Definition at line 241 of file composite_visco_plastic.h.
|
private |
A factor used to scale the viscoplastic strain rate up to the total strain rate. The scaling factor is equal to the maximum viscosity divided by the difference between the maximum and minimum viscosities.
Definition at line 250 of file composite_visco_plastic.h.
|
private |
The minimum strain rate allowed by the rheology.
Definition at line 255 of file composite_visco_plastic.h.
|
private |
The log strain rate threshold which must be passed before successful termination of the Newton iteration to determine the creep stress.
Definition at line 262 of file composite_visco_plastic.h.
|
private |
The maximum number of iterations allowed to determine the creep stress.
Definition at line 268 of file composite_visco_plastic.h.
|
private |
Useful number to aid in adding together exponentials.
Definition at line 273 of file composite_visco_plastic.h.