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

Public Member Functions

std::pair< std::string, std::string > execute (TableHandler &statistics) override
 
std::list< std::string > required_other_postprocessors () const override
 
void parse_parameters (ParameterHandler &prm) override
 
void initialize () override
 
double evaluate (const Point< dim > &) const
 
- Public Member Functions inherited from aspect::Postprocess::Interface< dim >
virtual ~Interface ()=default
 
virtual void update ()
 
virtual void save (std::map< std::string, std::string > &status_strings) const
 
virtual void load (const std::map< std::string, std::string > &status_strings)
 
- 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::Postprocess::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

std::pair< std::vector< double >, std::vector< double > > to_spherical_harmonic_coefficients (const std::vector< std::vector< double >> &spherical_function) const
 
std::pair< std::vector< double >, std::vector< double > > density_contribution (const double &outer_radius) const
 
std::pair< std::pair< double, std::pair< std::vector< double >, std::vector< double > > >, std::pair< double, std::pair< std::vector< double >, std::vector< double > > > > topography_contribution (const double &outer_radius, const double &inner_radius) const
 

Private Attributes

unsigned int max_degree
 
unsigned int min_degree
 
bool output_in_lat_lon
 
bool output_geoid_anomaly_SH_coes
 
bool output_surface_topo_contribution_SH_coes
 
bool output_CMB_topo_contribution_SH_coes
 
bool output_density_anomaly_contribution_SH_coes
 
bool output_gravity_anomaly
 
double density_above
 
double density_below
 
bool include_surface_topo_contribution
 
bool include_CMB_topo_contribution
 
bool use_free_surface_topography
 
bool use_free_CMB_topography
 
std::vector< double > geoid_coecos
 
std::vector< double > geoid_coesin
 

Detailed Description

template<int dim>
class aspect::Postprocess::Geoid< dim >

A postprocessor that computes the geoid anomaly at the surface.

Definition at line 39 of file geoid.h.

Member Function Documentation

§ execute()

template<int dim>
std::pair<std::string,std::string> aspect::Postprocess::Geoid< dim >::execute ( TableHandler &  statistics)
overridevirtual

Evaluate the solution for the geoid in spherical harmonics and then transfer it to grid output.

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

§ required_other_postprocessors()

template<int dim>
std::list<std::string> aspect::Postprocess::Geoid< dim >::required_other_postprocessors ( ) const
overridevirtual

Register with the simulator the other postprocessors that we need (namely: dynamic topography).

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

§ declare_parameters()

template<int dim>
static void aspect::Postprocess::Geoid< dim >::declare_parameters ( ParameterHandler &  prm)
static

Declare the parameters this class takes through input files.

§ parse_parameters()

template<int dim>
void aspect::Postprocess::Geoid< dim >::parse_parameters ( ParameterHandler &  prm)
overridevirtual

Read the parameters this class declares from the parameter file.

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

§ initialize()

template<int dim>
void aspect::Postprocess::Geoid< dim >::initialize ( )
overridevirtual

Find if the top or bottom boundaries are free surfaces.

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

§ evaluate()

template<int dim>
double aspect::Postprocess::Geoid< dim >::evaluate ( const Point< dim > &  ) const

Evaluate the geoid solution at a point. The evaluation point must be outside of the model domain, and it must be called after execute().

§ to_spherical_harmonic_coefficients()

template<int dim>
std::pair<std::vector<double>,std::vector<double> > aspect::Postprocess::Geoid< dim >::to_spherical_harmonic_coefficients ( const std::vector< std::vector< double >> &  spherical_function) const
private

Function to compute the real spherical harmonic coefficients (cos and sin part) from min degree to max degree The input spherical_function is a vector of vectors. The inner vector stores theta, phi, spherical infinitesimal, and function value on a spherical surface. The outer vector stores the inner vector associated with each quadrature point on a spherical surface.

§ density_contribution()

template<int dim>
std::pair<std::vector<double>,std::vector<double> > aspect::Postprocess::Geoid< dim >::density_contribution ( const double &  outer_radius) const
private

Function to compute the density contribution in spherical harmonic expansion throughout the mantle The input outer radius is needed to evaluate the density integral contribution of whole model domain at the surface This function returns a pair containing real spherical harmonics of density integral (cos and sin part) from min degree to max degree.

§ topography_contribution()

template<int dim>
std::pair<std::pair<double, std::pair<std::vector<double>,std::vector<double> > >, std::pair<double, std::pair<std::vector<double>,std::vector<double> > > > aspect::Postprocess::Geoid< dim >::topography_contribution ( const double &  outer_radius,
const double &  inner_radius 
) const
private

Function to compute the surface and CMB topography contribution in spherical harmonic expansion The input inner and outer radius are used to calculate spherical infinitesimal area, i.e., sin(theta)*d_theta*d_phi associated with each quadrature point on surface and bottom respectively. This function returns a pair containing surface and CMB topography's real spherical harmonic coefficients (cos and sin part) from min degree to max degree. The surface and CMB average density are also included as the first single element of each subpair respectively. The topography is based on the dynamic topography postprocessor in case of no free surface, and based on the real surface from the geometry model in case of a free surface.

Member Data Documentation

§ max_degree

template<int dim>
unsigned int aspect::Postprocess::Geoid< dim >::max_degree
private

Parameters to set the maximum and minimum degree when computing geoid from spherical harmonics

Definition at line 85 of file geoid.h.

§ min_degree

template<int dim>
unsigned int aspect::Postprocess::Geoid< dim >::min_degree
private

Definition at line 86 of file geoid.h.

§ output_in_lat_lon

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_in_lat_lon
private

A parameter to control whether to output the data in geographical coordinates. If true, output the data in longitudes and latitudes; if false, output data in x y z.

Definition at line 92 of file geoid.h.

§ output_geoid_anomaly_SH_coes

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_geoid_anomaly_SH_coes
private

A parameter to control whether to output the spherical harmonic coefficients of the geoid anomaly

Definition at line 97 of file geoid.h.

§ output_surface_topo_contribution_SH_coes

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_surface_topo_contribution_SH_coes
private

A parameter to control whether to output the spherical harmonic coefficients of the surface topography contribution

Definition at line 102 of file geoid.h.

§ output_CMB_topo_contribution_SH_coes

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_CMB_topo_contribution_SH_coes
private

A parameter to control whether to output the spherical harmonic coefficients of the CMB topography contribution

Definition at line 107 of file geoid.h.

§ output_density_anomaly_contribution_SH_coes

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_density_anomaly_contribution_SH_coes
private

A parameter to control whether to output the spherical harmonic coefficients of the density anomaly

Definition at line 112 of file geoid.h.

§ output_gravity_anomaly

template<int dim>
bool aspect::Postprocess::Geoid< dim >::output_gravity_anomaly
private

A parameter to control whether to output the free-air gravity anomaly

Definition at line 117 of file geoid.h.

§ density_above

template<int dim>
double aspect::Postprocess::Geoid< dim >::density_above
private

Parameters to set the density value out of the surface and CMB boundary

Definition at line 122 of file geoid.h.

§ density_below

template<int dim>
double aspect::Postprocess::Geoid< dim >::density_below
private

Definition at line 123 of file geoid.h.

§ include_surface_topo_contribution

template<int dim>
bool aspect::Postprocess::Geoid< dim >::include_surface_topo_contribution
private

A parameter to control whether to include the surface topography contribution on geoid

Definition at line 128 of file geoid.h.

§ include_CMB_topo_contribution

template<int dim>
bool aspect::Postprocess::Geoid< dim >::include_CMB_topo_contribution
private

A parameter to control whether to include the CMB topography contribution on geoid

Definition at line 133 of file geoid.h.

§ use_free_surface_topography

template<int dim>
bool aspect::Postprocess::Geoid< dim >::use_free_surface_topography
private

A parameter to specify if the top boundary is an active free surface

Definition at line 138 of file geoid.h.

§ use_free_CMB_topography

template<int dim>
bool aspect::Postprocess::Geoid< dim >::use_free_CMB_topography
private

A parameter to specify if the bottom boundary is an active free surface

Definition at line 143 of file geoid.h.

§ geoid_coecos

template<int dim>
std::vector<double> aspect::Postprocess::Geoid< dim >::geoid_coecos
private

A vector to store the cosine terms of the geoid anomaly spherical harmonic coefficients.

Definition at line 178 of file geoid.h.

§ geoid_coesin

template<int dim>
std::vector<double> aspect::Postprocess::Geoid< dim >::geoid_coesin
private

A vector to store the sine terms of the geoid anomaly spherical harmonic coefficients.

Definition at line 182 of file geoid.h.


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