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

Public Member Functions

 GPlates ()
 
Tensor< 1, dim > boundary_velocity (const types::boundary_id boundary_indicator, const Point< dim > &position) const override
 
void initialize () override
 
void update () override
 
void parse_parameters (ParameterHandler &prm) override
 
- Public Member Functions inherited from aspect::BoundaryVelocity::Interface< dim >
virtual ~Interface ()=default
 
- 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::BoundaryVelocity::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)
 

Private Member Functions

void update_data (const bool load_both_files)
 
void end_time_dependence ()
 
std::string create_filename (const int timestep) const
 

Private Attributes

int current_file_number
 
double first_data_file_model_time
 
int first_data_file_number
 
bool decreasing_file_order
 
double data_file_time_step
 
double time_weight
 
bool time_dependent
 
std::string data_directory
 
std::string velocity_file_name
 
double velocity_scaling_factor
 
std::string point1
 
std::string point2
 
Tensor< 1, 2 > pointone
 
Tensor< 1, 2 > pointtwo
 
double lithosphere_thickness
 
std::unique_ptr< internal::GPlatesLookup< dim > > lookup
 
std::unique_ptr< internal::GPlatesLookup< dim > > old_lookup
 

Detailed Description

template<int dim>
class aspect::BoundaryVelocity::GPlates< dim >

A class that implements prescribed velocity boundary conditions determined from GPlates input files. The interpolation in time is performed between two objects of the GPlatesLookup class.

Definition at line 169 of file gplates.h.

Constructor & Destructor Documentation

§ GPlates()

template<int dim>
aspect::BoundaryVelocity::GPlates< dim >::GPlates ( )

Empty Constructor.

Member Function Documentation

§ boundary_velocity()

template<int dim>
Tensor<1,dim> aspect::BoundaryVelocity::GPlates< dim >::boundary_velocity ( const types::boundary_id  boundary_indicator,
const Point< dim > &  position 
) const
overridevirtual

Return the boundary velocity as a function of position. For the current class, this function returns value from gplates.

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

§ initialize()

template<int dim>
void aspect::BoundaryVelocity::GPlates< dim >::initialize ( )
overridevirtual

Initialization function. This function is called once at the beginning of the program. Checks preconditions.

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

§ update()

template<int dim>
void aspect::BoundaryVelocity::GPlates< dim >::update ( )
overridevirtual

A function that is called at the beginning of each time step. For the current plugin, this function loads the next velocity files if necessary and outputs a warning if the end of the set of velocity files is reached.

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

§ declare_parameters()

template<int dim>
static void aspect::BoundaryVelocity::GPlates< dim >::declare_parameters ( ParameterHandler &  prm)
static

Declare the parameters this class takes through input files.

§ parse_parameters()

template<int dim>
void aspect::BoundaryVelocity::GPlates< dim >::parse_parameters ( ParameterHandler &  prm)
overridevirtual

Read the parameters this class declares from the parameter file.

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

§ update_data()

template<int dim>
void aspect::BoundaryVelocity::GPlates< dim >::update_data ( const bool  load_both_files)
private

Handles the update of the velocity data in lookup. The input parameter makes sure that both velocity files (n and n+1) can be reloaded if the model time step is larger than the velocity file time step.

§ end_time_dependence()

template<int dim>
void aspect::BoundaryVelocity::GPlates< dim >::end_time_dependence ( )
private

Handles settings and user notification in case the time-dependent part of the boundary condition is over.

§ create_filename()

template<int dim>
std::string aspect::BoundaryVelocity::GPlates< dim >::create_filename ( const int  timestep) const
private

Create a filename out of the name template.

Member Data Documentation

§ current_file_number

template<int dim>
int aspect::BoundaryVelocity::GPlates< dim >::current_file_number
private

A variable that stores the currently used data file of a series. It gets updated if necessary by update().

Definition at line 223 of file gplates.h.

§ first_data_file_model_time

template<int dim>
double aspect::BoundaryVelocity::GPlates< dim >::first_data_file_model_time
private

Time from which on the data file with number 'First data file number' is used as boundary condition. Previous to this time, 0 is returned for every field. Depending on the setting of the global 'Use years in output instead of seconds' flag in the input file, this number is either interpreted as seconds or as years."

Definition at line 232 of file gplates.h.

§ first_data_file_number

template<int dim>
int aspect::BoundaryVelocity::GPlates< dim >::first_data_file_number
private

Number of the first data file to be loaded when the model time is larger than 'First data file model time'.

Definition at line 238 of file gplates.h.

§ decreasing_file_order

template<int dim>
bool aspect::BoundaryVelocity::GPlates< dim >::decreasing_file_order
private

In some cases the boundary files are not numbered in increasing but in decreasing order (e.g. 'Ma BP'). If this flag is set to 'True' the plugin will first load the file with the number 'First data file number' and decrease the file number during the model run.

Definition at line 246 of file gplates.h.

§ data_file_time_step

template<int dim>
double aspect::BoundaryVelocity::GPlates< dim >::data_file_time_step
private

Time in model units (depends on other model inputs) between two velocity files.

Definition at line 252 of file gplates.h.

§ time_weight

template<int dim>
double aspect::BoundaryVelocity::GPlates< dim >::time_weight
private

Weight between velocity file n and n+1 while the current time is between the two values t(n) and t(n+1).

Definition at line 258 of file gplates.h.

§ time_dependent

template<int dim>
bool aspect::BoundaryVelocity::GPlates< dim >::time_dependent
private

State whether we have time_dependent boundary conditions. Switched off after finding no more velocity files to suppress attempts to read in new files.

Definition at line 265 of file gplates.h.

§ data_directory

template<int dim>
std::string aspect::BoundaryVelocity::GPlates< dim >::data_directory
private

Directory in which the gplates velocity files are present.

Definition at line 270 of file gplates.h.

§ velocity_file_name

template<int dim>
std::string aspect::BoundaryVelocity::GPlates< dim >::velocity_file_name
private

First part of filename of velocity files. The files have to have the pattern velocity_file_name.n.gpml where n is the number of the current timestep (starts from 0).

Definition at line 277 of file gplates.h.

§ velocity_scaling_factor

template<int dim>
double aspect::BoundaryVelocity::GPlates< dim >::velocity_scaling_factor
private

Scale the velocity boundary condition by a scalar factor.

Definition at line 282 of file gplates.h.

§ point1

template<int dim>
std::string aspect::BoundaryVelocity::GPlates< dim >::point1
private

Two user defined points that prescribe the plane from which the 2D model takes the velocity boundary condition. One can think of this, as if the model is lying in this plane although no actual model coordinate is changed. The strings need to have the format "a,b" where a and b are doubles and define theta and phi on a sphere.

Definition at line 291 of file gplates.h.

§ point2

template<int dim>
std::string aspect::BoundaryVelocity::GPlates< dim >::point2
private

Definition at line 292 of file gplates.h.

§ pointone

template<int dim>
Tensor<1,2> aspect::BoundaryVelocity::GPlates< dim >::pointone
private

Parsed user input of point1 and point2

Definition at line 297 of file gplates.h.

§ pointtwo

template<int dim>
Tensor<1,2> aspect::BoundaryVelocity::GPlates< dim >::pointtwo
private

Definition at line 298 of file gplates.h.

§ lithosphere_thickness

template<int dim>
double aspect::BoundaryVelocity::GPlates< dim >::lithosphere_thickness
private

Determines the depth of the lithosphere. The user might want to apply the GPlates velocities not only at the surface of the model, but also in the whole lithosphere. At every side boundary point with a depth smaller than this value (and thus being located in the lithosphere), the surface velocity will be described.

Definition at line 307 of file gplates.h.

§ lookup

template<int dim>
std::unique_ptr<internal::GPlatesLookup<dim> > aspect::BoundaryVelocity::GPlates< dim >::lookup
private

Pointer to an object that reads and processes data we get from gplates files.

Definition at line 313 of file gplates.h.

§ old_lookup

template<int dim>
std::unique_ptr<internal::GPlatesLookup<dim> > aspect::BoundaryVelocity::GPlates< dim >::old_lookup
private

Pointer to an object that reads and processes data we get from gplates files. This saves the previous data time step.

Definition at line 319 of file gplates.h.


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