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

Public Member Functions

void parse_parameters (ParameterHandler &prm)
 
double compute_friction_angle (const double current_edot_ii, const unsigned int volume_fraction_index, const double static_friction_angle, const Point< dim > &position) const
 
FrictionMechanism get_friction_mechanism () 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
 

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

FrictionMechanism friction_mechanism
 
std::vector< double > dynamic_angles_of_internal_friction
 
double dynamic_characteristic_strain_rate
 
double dynamic_friction_smoothness_exponent
 
std::unique_ptr< Functions::ParsedFunction< dim > > friction_function
 
Utilities::Coordinates::CoordinateSystem coordinate_system_friction_function
 

Detailed Description

template<int dim>
class aspect::MaterialModel::Rheology::FrictionModels< dim >

Definition at line 56 of file friction_models.h.

Member Function Documentation

§ declare_parameters()

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

Declare the parameters this function takes through input files.

§ parse_parameters()

template<int dim>
void aspect::MaterialModel::Rheology::FrictionModels< dim >::parse_parameters ( ParameterHandler &  prm)

Read the parameters from the parameter file.

§ compute_friction_angle()

template<int dim>
double aspect::MaterialModel::Rheology::FrictionModels< dim >::compute_friction_angle ( const double  current_edot_ii,
const unsigned int  volume_fraction_index,
const double  static_friction_angle,
const Point< dim > &  position 
) const

A function that computes the new friction angle when it is not independent. Given a volume fraction with the index and a vector of all compositional fields, it returns the newly calculated friction angle.

§ get_friction_mechanism()

template<int dim>
FrictionMechanism aspect::MaterialModel::Rheology::FrictionModels< dim >::get_friction_mechanism ( ) const

A function that returns the selected type of friction dependence.

Member Data Documentation

§ friction_mechanism

template<int dim>
FrictionMechanism aspect::MaterialModel::Rheology::FrictionModels< dim >::friction_mechanism
private

Select the mechanism to be used for the friction dependence. Possible options: static friction | dynamic friction | function

Definition at line 94 of file friction_models.h.

§ dynamic_angles_of_internal_friction

template<int dim>
std::vector<double> aspect::MaterialModel::Rheology::FrictionModels< dim >::dynamic_angles_of_internal_friction
private

Dynamic friction input parameters Dynamic angles of internal friction that are used at high strain rates.

Definition at line 103 of file friction_models.h.

§ dynamic_characteristic_strain_rate

template<int dim>
double aspect::MaterialModel::Rheology::FrictionModels< dim >::dynamic_characteristic_strain_rate
private

The characteristic strain rate value at which the angle of friction is taken as the mean of the dynamic and the static angle of friction. When the effective strain rate in a cell is very high the dynamic angle of friction is taken, when it is very low the static angle of internal friction is chosen.

Definition at line 111 of file friction_models.h.

§ dynamic_friction_smoothness_exponent

template<int dim>
double aspect::MaterialModel::Rheology::FrictionModels< dim >::dynamic_friction_smoothness_exponent
private

An exponential factor in the equation for the calculation of the friction angle to make the transition between static and dynamic friction angle more smooth or more step-like.

Definition at line 118 of file friction_models.h.

§ friction_function

template<int dim>
std::unique_ptr<Functions::ParsedFunction<dim> > aspect::MaterialModel::Rheology::FrictionModels< dim >::friction_function
private

Parsed functions that specify the friction angle which must be given in the input file using the function method.

Definition at line 124 of file friction_models.h.

§ coordinate_system_friction_function

template<int dim>
Utilities::Coordinates::CoordinateSystem aspect::MaterialModel::Rheology::FrictionModels< dim >::coordinate_system_friction_function
private

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

Definition at line 130 of file friction_models.h.


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