Flow123d  JS_before_hm-2158-g8a5161593
Public Member Functions | List of all members
TransportDG< Model >::EqData Class Reference

#include <transport_dg.hh>

Inheritance diagram for TransportDG< Model >::EqData:
Inheritance graph
[legend]
Collaboration diagram for TransportDG< Model >::EqData:
Collaboration graph
[legend]

Public Member Functions

 EqData ()
 
void set_DG_parameters_boundary (Side side, const int K_size, const std::vector< arma::mat33 > &K, const double flux, const arma::vec3 &normal_vector, const double alpha, double &gamma)
 Sets up parameters of the DG method on a given boundary edge. More...
 
void set_time_governor (TimeGovernor *time)
 
double elem_anisotropy (ElementAccessor< 3 > e) const
 Compute and return anisotropy of given element. More...
 

Public Attributes

Parameters of the numerical method
std::vector< std::vector< double > > gamma
 Penalty parameters. More...
 
int dg_variant
 DG variant ((non-)symmetric/incomplete. More...
 
unsigned int dg_order
 Polynomial order of finite elements. More...
 
std::vector< Vec > ret_vec
 Auxiliary vectors for calculation of sources in balance due to retardation (e.g. sorption). More...
 
LinSys ** ls
 Linear algebra system for the transport equation. More...
 
LinSys ** ls_dt
 Linear algebra system for the time derivative (actually it is used only for handling the matrix structures). More...
 
Auxiliary fields used during assembly
vector< vector< arma::mat33 > > dif_coef
 Diffusion coefficients. More...
 
unsigned int max_edg_sides
 Maximal number of edge sides (evaluate from dim 1,2,3) More...
 
std::shared_ptr< DOFHandlerMultiDimdh_
 Object for distribution of dofs. More...
 
std::vector< VectorMPIoutput_vec
 Vector of solution data. More...
 
FieldFEScalarVec conc_fe
 
std::shared_ptr< DOFHandlerMultiDimdh_p0
 
TimeGovernortime_
 
std::shared_ptr< Balancebalance_
 

Detailed Description

template<class Model>
class TransportDG< Model >::EqData

Definition at line 161 of file transport_dg.hh.

Constructor & Destructor Documentation

◆ EqData()

template<class Model >
TransportDG< Model >::EqData::EqData ( )
inline

Definition at line 164 of file transport_dg.hh.

Member Function Documentation

◆ elem_anisotropy()

template<class Model >
double TransportDG< Model >::EqData::elem_anisotropy ( ElementAccessor< 3 >  e) const

Compute and return anisotropy of given element.

Definition at line 155 of file transport_dg.cc.

Here is the caller graph for this function:

◆ set_DG_parameters_boundary()

template<class Model >
void TransportDG< Model >::EqData::set_DG_parameters_boundary ( Side  side,
const int  K_size,
const std::vector< arma::mat33 > &  K,
const double  flux,
const arma::vec3 normal_vector,
const double  alpha,
double &  gamma 
)

Sets up parameters of the DG method on a given boundary edge.

Assumption is that the edge consists of only 1 side.

Parameters
sideThe boundary side.
K_sizeSize of vector of tensors K.
KDispersivity tensor.
ad_vectorAdvection vector.
normal_vectorNormal vector (assumed constant along the edge).
alphaPenalty parameter that influences the continuity of the solution (large value=more continuity).
gammaComputed penalty parameters.

Definition at line 171 of file transport_dg.cc.

Here is the caller graph for this function:

◆ set_time_governor()

template<class Model >
void TransportDG< Model >::EqData::set_time_governor ( TimeGovernor time)
inline

Definition at line 188 of file transport_dg.hh.

Member Data Documentation

◆ balance_

template<class Model >
std::shared_ptr<Balance> TransportDG< Model >::EqData::balance_

Definition at line 241 of file transport_dg.hh.

◆ conc_fe

template<class Model >
FieldFEScalarVec TransportDG< Model >::EqData::conc_fe

Definition at line 238 of file transport_dg.hh.

◆ dg_order

template<class Model >
unsigned int TransportDG< Model >::EqData::dg_order

Polynomial order of finite elements.

Definition at line 208 of file transport_dg.hh.

◆ dg_variant

template<class Model >
int TransportDG< Model >::EqData::dg_variant

DG variant ((non-)symmetric/incomplete.

Definition at line 205 of file transport_dg.hh.

◆ dh_

template<class Model >
std::shared_ptr<DOFHandlerMultiDim> TransportDG< Model >::EqData::dh_

Object for distribution of dofs.

Definition at line 233 of file transport_dg.hh.

◆ dh_p0

template<class Model >
std::shared_ptr<DOFHandlerMultiDim> TransportDG< Model >::EqData::dh_p0

Definition at line 239 of file transport_dg.hh.

◆ dif_coef

template<class Model >
vector<vector<arma::mat33> > TransportDG< Model >::EqData::dif_coef

Diffusion coefficients.

Definition at line 226 of file transport_dg.hh.

◆ gamma

template<class Model >
std::vector<std::vector<double> > TransportDG< Model >::EqData::gamma

Penalty parameters.

Definition at line 202 of file transport_dg.hh.

◆ ls

template<class Model >
LinSys** TransportDG< Model >::EqData::ls

Linear algebra system for the transport equation.

Definition at line 217 of file transport_dg.hh.

◆ ls_dt

template<class Model >
LinSys** TransportDG< Model >::EqData::ls_dt

Linear algebra system for the time derivative (actually it is used only for handling the matrix structures).

Definition at line 220 of file transport_dg.hh.

◆ max_edg_sides

template<class Model >
unsigned int TransportDG< Model >::EqData::max_edg_sides

Maximal number of edge sides (evaluate from dim 1,2,3)

Definition at line 228 of file transport_dg.hh.

◆ output_vec

template<class Model >
std::vector<VectorMPI> TransportDG< Model >::EqData::output_vec

Vector of solution data.

Definition at line 236 of file transport_dg.hh.

◆ ret_vec

template<class Model >
std::vector<Vec> TransportDG< Model >::EqData::ret_vec

Auxiliary vectors for calculation of sources in balance due to retardation (e.g. sorption).

Definition at line 214 of file transport_dg.hh.

◆ time_

template<class Model >
TimeGovernor* TransportDG< Model >::EqData::time_

Definition at line 240 of file transport_dg.hh.


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