3.1-git
DUNE for Multi-{Phase, Component, Scale, Physics, ...} flow and transport in porous media
Public Types | Public Member Functions | List of all members

Non-isothermal 2D problem where steam is injected on the lower left side of the domain. More...

#include <test/porousmediumflow/2p1c/implicit/problem.hh>

Inheritance diagram for Dumux::InjectionProblem< TypeTag >:
Inheritance graph

Description

template<class TypeTag>
class Dumux::InjectionProblem< TypeTag >

Non-isothermal 2D problem where steam is injected on the lower left side of the domain.

Problem where air is injected under a low permeable layer in a depth of 2700m.

This problem uses the 2p1c.

The domain is sized 60m times 40m and consists of two layers, a moderately permeable one ( \( K=10e-12\)) for \( y<22m\) and one with a lower permeablility ( \( K=10e-13\)) in the rest of the domain.

A mixture of Nitrogen and Water vapor, which is composed according to the prevailing conditions (temperature, pressure) enters a water-filled aquifer. This is realized with a solution-dependent Neumann boundary condition at the right boundary ( \( 5m<y<15m\)). The aquifer is situated 2700m below sea level. The injected fluid phase migrates upwards due to buoyancy. It accumulates and partially enters the lower permeable aquitard.

The model is able to use either mole or mass fractions. The property useMoles can be set to either true or false in the problem file. Make sure that the according units are used in the problem set-up. The default setting for useMoles is true.

This problem uses the 2p2c.

To run the simulation execute the following line in shell: ./test_box2p2c or ./test_cc2p2c

Public Types

using SpatialParams = GetPropType< TypeTag, Properties::SpatialParams >
 Export spatial parameter type. More...
 

Public Member Functions

 InjectionProblem (std::shared_ptr< const GridGeometry > gridGeometry)
 
 InjectionProblem (std::shared_ptr< const GridGeometry > gridGeometry)
 
void setName (const std::string &newName)
 Set the problem name. More...
 
Problem parameters
NumEqVector source (const Element &element, const FVElementGeometry &fvGeometry, const ElementVolumeVariables &elemVolVars, const SubControlVolume &scv) const
 Evaluate the source term for all phases within a given sub-control-volume. More...
 
const std::string & name () const
 Returns the problem name. More...
 
Scalar temperature () const
 Returns the temperature [K]. More...
 
Boundary conditions
BoundaryTypes boundaryTypesAtPos (const GlobalPosition &globalPos) const
 Specifies which kind of boundary condition should be used for which equation on a given boundary segment. More...
 
PrimaryVariables dirichletAtPos (const GlobalPosition &globalPos) const
 Evaluates the boundary conditions for a Dirichlet boundary segment. More...
 
NumEqVector neumann (const Element &element, const FVElementGeometry &fvGeometry, const ElementVolumeVariables &elemVolVars, const ElementFluxVariablesCache &elemFluxVarsCache, const SubControlVolumeFace &scvf) const
 Evaluates the boundary conditions for a Neumann boundary segment. More...
 
BoundaryTypes boundaryTypesAtPos (const GlobalPosition &globalPos) const
 Specifies which kind of boundary condition should be used for which equation on a given boundary segment. More...
 
PrimaryVariables dirichletAtPos (const GlobalPosition &globalPos) const
 Evaluates the boundary conditions for a Dirichlet boundary segment. More...
 
NumEqVector neumann (const Element &element, const FVElementGeometry &fvGeometry, const ElementVolumeVariables &elemVolVars, const ElementFluxVariablesCache &elemFluxVarsCache, const SubControlVolumeFace &scvf) const
 Evaluates the boundary conditions for a Neumann boundary segment in dependency on the current solution. More...
 

Volume terms

PrimaryVariables initialAtPos (const GlobalPosition &globalPos) const
 Evaluates the initial values for a control volume. More...
 
PrimaryVariables initialAtPos (const GlobalPosition &globalPos) const
 Evaluates the initial values for a control volume. More...
 

Physical parameters for porous media problems

Scalar temperatureAtPos (const GlobalPosition &globalPos) const
 Returns the temperature \(\mathrm{[K]}\) at a given global position. More...
 
const GravityVector & gravityAtPos (const GlobalPosition &pos) const
 Returns the acceleration due to gravity \(\mathrm{[m/s^2]}\). More...
 
const GravityVector & gravity () const
 Returns the acceleration due to gravity \(\mathrm{[m/s^2]}\). More...
 
SpatialParamsspatialParams ()
 Returns the spatial parameters object. More...
 
const SpatialParamsspatialParams () const
 Returns the spatial parameters object. More...
 
GravityVector gravity_
 The gravity acceleration vector. More...
 
std::shared_ptr< SpatialParamsspatialParams_
 

Boundary conditions and sources defining the problem

BoundaryTypes boundaryTypes (const Element &element, const SubControlVolume &scv) const
 Specifies which kind of boundary condition should be used for which equation on a given boundary segment. More...
 
BoundaryTypes boundaryTypes (const Element &element, const SubControlVolumeFace &scvf) const
 Specifies which kind of boundary condition should be used for which equation on a given boundary segment. More...
 
PrimaryVariables dirichlet (const Element &element, const SubControlVolumeFace &scvf) const
 Evaluate the boundary conditions for a dirichlet control volume face. More...
 
PrimaryVariables dirichlet (const Element &element, const SubControlVolume &scv) const
 Evaluate the boundary conditions for a dirichlet control volume. More...
 
NumEqVector neumannAtPos (const GlobalPosition &globalPos) const
 Evaluate the boundary conditions for a neumann boundary segment. More...
 
NumEqVector sourceAtPos (const GlobalPosition &globalPos) const
 Evaluate the source term for all phases within a given sub-control-volume. More...
 
void addPointSources (std::vector< PointSource > &pointSources) const
 Applies a vector of point sources. The point sources are possibly solution dependent. More...
 
void pointSource (PointSource &source, const Element &element, const FVElementGeometry &fvGeometry, const ElementVolumeVariables &elemVolVars, const SubControlVolume &scv) const
 Evaluate the point sources (added by addPointSources) for all phases within a given sub-control-volume. More...
 
void pointSourceAtPos (PointSource &pointSource, const GlobalPosition &globalPos) const
 Evaluate the point sources (added by addPointSources) for all phases within a given sub-control-volume. More...
 
template<class MatrixBlock >
void addSourceDerivatives (MatrixBlock &block, const Element &element, const FVElementGeometry &fvGeometry, const VolumeVariables &volVars, const SubControlVolume &scv) const
 Add source term derivative to the Jacobian. More...
 
NumEqVector scvPointSources (const Element &element, const FVElementGeometry &fvGeometry, const ElementVolumeVariables &elemVolVars, const SubControlVolume &scv) const
 Adds contribution of point sources for a specific sub control volume to the values. Caution: Only overload this method in the implementation if you know what you are doing. More...
 
void computePointSourceMap ()
 Compute the point source map, i.e. which scvs have point source contributions. More...
 
const PointSourceMap & pointSourceMap () const
 Get the point source map. It stores the point sources per scv. More...
 
void applyInitialSolution (SolutionVector &sol) const
 Applies the initial solution for all degrees of freedom of the grid. More...
 
template<class Entity >
PrimaryVariables initial (const Entity &entity) const
 Evaluate the initial value for an element (for cell-centered models) or vertex (for box / vertex-centered models) More...
 
template<class ElementSolution >
Scalar extrusionFactor (const Element &element, const SubControlVolume &scv, const ElementSolution &elemSol) const
 Return how much the domain is extruded at a given sub-control volume. More...
 
Scalar extrusionFactorAtPos (const GlobalPosition &globalPos) const
 Return how much the domain is extruded at a given position. More...
 
const GridGeometry & fvGridGeometry () const
 The finite volume grid geometry. More...
 
const GridGeometry & gridGeometry () const
 The finite volume grid geometry. More...
 
const std::string & paramGroup () const
 The parameter group in which to retrieve runtime parameters. More...
 
static constexpr bool enableInternalDirichletConstraints ()
 If internal Dirichlet contraints are enabled Enables / disables internal (non-boundary) Dirichlet constraints. If this is overloaded to return true, the assembler calls problem.hasInternalDirichletConstraint(element, scv). This means you have to implement the following member function. More...
 
Implementation & asImp_ ()
 Returns the implementation of the problem (i.e. static polymorphism) More...
 
const Implementation & asImp_ () const
 Returns the implementation of the problem (i.e. static polymorphism) More...
 

Member Typedef Documentation

◆ SpatialParams

template<class TypeTag >
using Dumux::PorousMediumFlowProblem< TypeTag >::SpatialParams = GetPropType<TypeTag, Properties::SpatialParams>
inherited

Export spatial parameter type.

Constructor & Destructor Documentation

◆ InjectionProblem() [1/2]

template<class TypeTag >
Dumux::InjectionProblem< TypeTag >::InjectionProblem ( std::shared_ptr< const GridGeometry >  gridGeometry)
inline

◆ InjectionProblem() [2/2]

template<class TypeTag >
Dumux::InjectionProblem< TypeTag >::InjectionProblem ( std::shared_ptr< const GridGeometry >  gridGeometry)
inline

Member Function Documentation

◆ addPointSources()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::addPointSources ( std::vector< PointSource > &  pointSources) const
inlineinherited

Applies a vector of point sources. The point sources are possibly solution dependent.

Parameters
pointSourcesA vector of PointSource s that contain source values for all phases and space positions.

For this method, the values method of the point source has to return the absolute rate values in units \( [ \textnormal{unit of conserved quantity} / s ] \). Positive values mean that the conserved quantity is created, negative ones mean that it vanishes. E.g. for the mass balance that would be a mass rate in \( [ kg / s ] \).

◆ addSourceDerivatives()

template<class TypeTag >
template<class MatrixBlock >
void Dumux::FVProblem< TypeTag >::addSourceDerivatives ( MatrixBlock &  block,
const Element &  element,
const FVElementGeometry &  fvGeometry,
const VolumeVariables &  volVars,
const SubControlVolume &  scv 
) const
inlineinherited

Add source term derivative to the Jacobian.

Note
Only needed in case of analytic differentiation and solution dependent sources

◆ applyInitialSolution()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::applyInitialSolution ( SolutionVector &  sol) const
inlineinherited

Applies the initial solution for all degrees of freedom of the grid.

Parameters
solthe initial solution vector

◆ asImp_() [1/2]

template<class TypeTag >
Implementation & Dumux::FVProblem< TypeTag >::asImp_ ( )
inlineprotectedinherited

Returns the implementation of the problem (i.e. static polymorphism)

◆ asImp_() [2/2]

template<class TypeTag >
const Implementation & Dumux::FVProblem< TypeTag >::asImp_ ( ) const
inlineprotectedinherited

Returns the implementation of the problem (i.e. static polymorphism)

◆ boundaryTypes() [1/2]

template<class TypeTag >
BoundaryTypes Dumux::FVProblem< TypeTag >::boundaryTypes ( const Element &  element,
const SubControlVolume &  scv 
) const
inlineinherited

Specifies which kind of boundary condition should be used for which equation on a given boundary segment.

Parameters
elementThe finite element
scvThe sub control volume

◆ boundaryTypes() [2/2]

template<class TypeTag >
BoundaryTypes Dumux::FVProblem< TypeTag >::boundaryTypes ( const Element &  element,
const SubControlVolumeFace &  scvf 
) const
inlineinherited

Specifies which kind of boundary condition should be used for which equation on a given boundary segment.

Parameters
elementThe finite element
scvfThe sub control volume face

◆ boundaryTypesAtPos() [1/2]

template<class TypeTag >
BoundaryTypes Dumux::InjectionProblem< TypeTag >::boundaryTypesAtPos ( const GlobalPosition &  globalPos) const
inline

Specifies which kind of boundary condition should be used for which equation on a given boundary segment.

Parameters
globalPosThe global position

◆ boundaryTypesAtPos() [2/2]

template<class TypeTag >
BoundaryTypes Dumux::InjectionProblem< TypeTag >::boundaryTypesAtPos ( const GlobalPosition &  globalPos) const
inline

Specifies which kind of boundary condition should be used for which equation on a given boundary segment.

Parameters
globalPosThe global position

◆ computePointSourceMap()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::computePointSourceMap ( )
inlineinherited

Compute the point source map, i.e. which scvs have point source contributions.

Note
Call this on the problem before assembly if you want to enable point sources set via the addPointSources member function.

◆ dirichlet() [1/2]

template<class TypeTag >
PrimaryVariables Dumux::FVProblem< TypeTag >::dirichlet ( const Element &  element,
const SubControlVolume &  scv 
) const
inlineinherited

Evaluate the boundary conditions for a dirichlet control volume.

Parameters
elementThe finite element
scvthe sub control volume
Note
used for cell-centered discretization schemes

The method returns the boundary types information.

◆ dirichlet() [2/2]

template<class TypeTag >
PrimaryVariables Dumux::FVProblem< TypeTag >::dirichlet ( const Element &  element,
const SubControlVolumeFace &  scvf 
) const
inlineinherited

Evaluate the boundary conditions for a dirichlet control volume face.

Parameters
elementThe finite element
scvfthe sub control volume face
Note
used for cell-centered discretization schemes

The method returns the boundary types information.

◆ dirichletAtPos() [1/2]

template<class TypeTag >
PrimaryVariables Dumux::InjectionProblem< TypeTag >::dirichletAtPos ( const GlobalPosition &  globalPos) const
inline

Evaluates the boundary conditions for a Dirichlet boundary segment.

Parameters
globalPosThe global position

◆ dirichletAtPos() [2/2]

template<class TypeTag >
PrimaryVariables Dumux::InjectionProblem< TypeTag >::dirichletAtPos ( const GlobalPosition &  globalPos) const
inline

Evaluates the boundary conditions for a Dirichlet boundary segment.

Parameters
globalPosThe global position

◆ enableInternalDirichletConstraints()

template<class TypeTag >
static constexpr bool Dumux::FVProblem< TypeTag >::enableInternalDirichletConstraints ( )
inlinestaticconstexprinherited

If internal Dirichlet contraints are enabled Enables / disables internal (non-boundary) Dirichlet constraints. If this is overloaded to return true, the assembler calls problem.hasInternalDirichletConstraint(element, scv). This means you have to implement the following member function.

bool hasInternalDirichletConstraint(const Element& element, const SubControlVolume& scv) const;

which returns a bool signifying whether the dof associated with the element/scv pair is contraint. If true is returned for a dof, the assembler calls problem.internalDiririchlet(element, scv). This means you have to additionally implement the following member function

PrimaryVariables internalDiririchlet(const Element& element, const SubControlVolume& scv) const;

which returns the enforced Dirichlet values the dof associated with the element/scv pair.

◆ extrusionFactor()

template<class TypeTag >
template<class ElementSolution >
Scalar Dumux::FVProblem< TypeTag >::extrusionFactor ( const Element &  element,
const SubControlVolume &  scv,
const ElementSolution &  elemSol 
) const
inlineinherited

Return how much the domain is extruded at a given sub-control volume.

This means the factor by which a lower-dimensional (1D or 2D) entity needs to be expanded to get a full dimensional cell. The default is 1.0 which means that 1D problems are actually thought as pipes with a cross section of 1 m^2 and 2D problems are assumed to extend 1 m to the back.

◆ extrusionFactorAtPos()

template<class TypeTag >
Scalar Dumux::FVProblem< TypeTag >::extrusionFactorAtPos ( const GlobalPosition &  globalPos) const
inlineinherited

Return how much the domain is extruded at a given position.

This means the factor by which a lower-dimensional (1D or 2D) entity needs to be expanded to get a full dimensional cell. The default is 1.0 which means that 1D problems are actually thought as pipes with a cross section of 1 m^2 and 2D problems are assumed to extend 1 m to the back.

◆ fvGridGeometry()

template<class TypeTag >
const GridGeometry & Dumux::FVProblem< TypeTag >::fvGridGeometry ( ) const
inlineinherited

The finite volume grid geometry.

◆ gravity()

template<class TypeTag >
const GravityVector & Dumux::PorousMediumFlowProblem< TypeTag >::gravity ( ) const
inlineinherited

Returns the acceleration due to gravity \(\mathrm{[m/s^2]}\).

This method is used for problems where the gravitational acceleration does not depend on the spatial position. The default behaviour is that if the ProblemEnableGravity property is true, \(\boldsymbol{g} = ( 0,\dots,\ -9.81)^T \) holds, else \(\boldsymbol{g} = ( 0,\dots, 0)^T \).

◆ gravityAtPos()

template<class TypeTag >
const GravityVector & Dumux::PorousMediumFlowProblem< TypeTag >::gravityAtPos ( const GlobalPosition &  pos) const
inlineinherited

Returns the acceleration due to gravity \(\mathrm{[m/s^2]}\).

This is discretization independent interface. By default it just calls gravity().

◆ gridGeometry()

template<class TypeTag >
const GridGeometry & Dumux::FVProblem< TypeTag >::gridGeometry ( ) const
inlineinherited

The finite volume grid geometry.

◆ initial()

template<class TypeTag >
template<class Entity >
PrimaryVariables Dumux::FVProblem< TypeTag >::initial ( const Entity &  entity) const
inlineinherited

Evaluate the initial value for an element (for cell-centered models) or vertex (for box / vertex-centered models)

Parameters
entityThe dof entity (element or vertex)

◆ initialAtPos() [1/2]

template<class TypeTag >
PrimaryVariables Dumux::InjectionProblem< TypeTag >::initialAtPos ( const GlobalPosition &  globalPos) const
inline

Evaluates the initial values for a control volume.

Parameters
globalPosThe global position

◆ initialAtPos() [2/2]

template<class TypeTag >
PrimaryVariables Dumux::InjectionProblem< TypeTag >::initialAtPos ( const GlobalPosition &  globalPos) const
inline

Evaluates the initial values for a control volume.

Parameters
globalPosThe global position

◆ name()

template<class TypeTag >
const std::string & Dumux::InjectionProblem< TypeTag >::name ( ) const
inline

Returns the problem name.

This is used as a prefix for files generated by the simulation.

◆ neumann() [1/2]

template<class TypeTag >
NumEqVector Dumux::InjectionProblem< TypeTag >::neumann ( const Element &  element,
const FVElementGeometry &  fvGeometry,
const ElementVolumeVariables &  elemVolVars,
const ElementFluxVariablesCache &  elemFluxVarsCache,
const SubControlVolumeFace &  scvf 
) const
inline

Evaluates the boundary conditions for a Neumann boundary segment.

This is the method for the case where the Neumann condition is potentially solution dependent and requires some quantities that are specific to the fully-implicit method.

Parameters
elementThe finite element
fvGeometryThe finite-volume geometry
elemVolVarsAll volume variables for the element
elemFluxVarsCacheFlux variables caches for all faces in stencil
scvfThe sub-control volume face

For this method, the values parameter stores the flux in normal direction of each phase. Negative values mean influx. E.g. for the mass balance that would the mass flux in \( [ kg / (m^2 \cdot s)] \).

◆ neumann() [2/2]

template<class TypeTag >
NumEqVector Dumux::InjectionProblem< TypeTag >::neumann ( const Element &  element,
const FVElementGeometry &  fvGeometry,
const ElementVolumeVariables &  elemVolVars,
const ElementFluxVariablesCache &  elemFluxVarsCache,
const SubControlVolumeFace &  scvf 
) const
inline

Evaluates the boundary conditions for a Neumann boundary segment in dependency on the current solution.

Parameters
elementThe finite element
fvGeometryThe finite volume geometry of the element
elemVolVarsAll volume variables for the element
elemFluxVarsCacheFlux variables caches for all faces in stencil
scvfThe sub-control volume face

This method is used for cases, when the Neumann condition depends on the solution and requires some quantities that are specific to the fully-implicit method. The values store the mass flux of each phase normal to the boundary. Negative values indicate an inflow.

◆ neumannAtPos()

template<class TypeTag >
NumEqVector Dumux::FVProblem< TypeTag >::neumannAtPos ( const GlobalPosition &  globalPos) const
inlineinherited

Evaluate the boundary conditions for a neumann boundary segment.

Parameters
globalPosThe position of the boundary face's integration point in global coordinates

Negative values mean influx. E.g. for the mass balance that would be the mass flux in \( [ kg / (m^2 \cdot s)] \).

As a default, i.e. if the user's problem does not overload any neumann method return no-flow Neumann boundary conditions at all Neumann boundaries

◆ paramGroup()

template<class TypeTag >
const std::string & Dumux::FVProblem< TypeTag >::paramGroup ( ) const
inlineinherited

The parameter group in which to retrieve runtime parameters.

◆ pointSource()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::pointSource ( PointSource &  source,
const Element &  element,
const FVElementGeometry &  fvGeometry,
const ElementVolumeVariables &  elemVolVars,
const SubControlVolume &  scv 
) const
inlineinherited

Evaluate the point sources (added by addPointSources) for all phases within a given sub-control-volume.

This is the method for the case where the point source is solution dependent

Parameters
sourceA single point source
elementThe finite element
fvGeometryThe finite-volume geometry
elemVolVarsAll volume variables for the element
scvThe sub control volume

For this method, the values() method of the point sources returns the absolute conserved quantity rate generated or annihilate in units \( [ \textnormal{unit of conserved quantity} / s ] \). Positive values mean that the conserved quantity is created, negative ones mean that it vanishes. E.g. for the mass balance that would be a mass rate in \( [ kg / s ] \).

◆ pointSourceAtPos()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::pointSourceAtPos ( PointSource &  pointSource,
const GlobalPosition &  globalPos 
) const
inlineinherited

Evaluate the point sources (added by addPointSources) for all phases within a given sub-control-volume.

This is the method for the case where the point source is space dependent

Parameters
pointSourceA single point source
globalPosThe point source position in global coordinates

For this method, the values() method of the point sources returns the absolute conserved quantity rate generated or annihilate in units \( [ \textnormal{unit of conserved quantity} / s ] \). Positive values mean that the conserved quantity is created, negative ones mean that it vanishes. E.g. for the mass balance that would be a mass rate in \( [ kg / s ] \).

◆ pointSourceMap()

template<class TypeTag >
const PointSourceMap & Dumux::FVProblem< TypeTag >::pointSourceMap ( ) const
inlineinherited

Get the point source map. It stores the point sources per scv.

◆ scvPointSources()

template<class TypeTag >
NumEqVector Dumux::FVProblem< TypeTag >::scvPointSources ( const Element &  element,
const FVElementGeometry &  fvGeometry,
const ElementVolumeVariables &  elemVolVars,
const SubControlVolume &  scv 
) const
inlineinherited

Adds contribution of point sources for a specific sub control volume to the values. Caution: Only overload this method in the implementation if you know what you are doing.

◆ setName()

template<class TypeTag >
void Dumux::FVProblem< TypeTag >::setName ( const std::string &  newName)
inlineinherited

Set the problem name.

This static method sets the simulation name, which should be called before the application problem is declared! If not, the default name "sim" will be used.

Parameters
newNameThe problem's name

◆ source()

template<class TypeTag >
NumEqVector Dumux::InjectionProblem< TypeTag >::source ( const Element &  element,
const FVElementGeometry &  fvGeometry,
const ElementVolumeVariables &  elemVolVars,
const SubControlVolume &  scv 
) const
inline

Evaluate the source term for all phases within a given sub-control-volume.

This is the method for the case where the source term is potentially solution dependent and requires some quantities that are specific to the fully-implicit method.

Parameters
elementThe finite element
fvGeometryThe finite-volume geometry
elemVolVarsAll volume variables for the element
scvThe sub control volume

For this method, the return parameter stores the conserved quantity rate generated or annihilate per volume unit. Positive values mean that the conserved quantity is created, negative ones mean that it vanishes. E.g. for the mass balance that would be a mass rate in \( [ kg / (m^3 \cdot s)] \).

◆ sourceAtPos()

template<class TypeTag >
NumEqVector Dumux::FVProblem< TypeTag >::sourceAtPos ( const GlobalPosition &  globalPos) const
inlineinherited

Evaluate the source term for all phases within a given sub-control-volume.

Parameters
globalPosThe position of the center of the finite volume for which the source term ought to be specified in global coordinates

For this method, the values parameter stores the conserved quantity rate generated or annihilate per volume unit. Positive values mean that the conserved quantity is created, negative ones mean that it vanishes. E.g. for the mass balance that would be a mass rate in \( [ kg / (m^3 \cdot s)] \).

As a default, i.e. if the user's problem does not overload any source method return 0.0 (no source terms)

◆ spatialParams() [1/2]

template<class TypeTag >
SpatialParams & Dumux::PorousMediumFlowProblem< TypeTag >::spatialParams ( )
inlineinherited

Returns the spatial parameters object.

◆ spatialParams() [2/2]

template<class TypeTag >
const SpatialParams & Dumux::PorousMediumFlowProblem< TypeTag >::spatialParams ( ) const
inlineinherited

Returns the spatial parameters object.

◆ temperature()

template<class TypeTag >
Scalar Dumux::InjectionProblem< TypeTag >::temperature ( ) const
inline

Returns the temperature [K].

◆ temperatureAtPos()

template<class TypeTag >
Scalar Dumux::PorousMediumFlowProblem< TypeTag >::temperatureAtPos ( const GlobalPosition &  globalPos) const
inlineinherited

Returns the temperature \(\mathrm{[K]}\) at a given global position.

This is not specific to the discretization. By default it just calls temperature().

Parameters
globalPosThe position in global coordinates where the temperature should be specified.

Member Data Documentation

◆ gravity_

template<class TypeTag >
GravityVector Dumux::PorousMediumFlowProblem< TypeTag >::gravity_
protectedinherited

The gravity acceleration vector.

◆ spatialParams_

template<class TypeTag >
std::shared_ptr<SpatialParams> Dumux::PorousMediumFlowProblem< TypeTag >::spatialParams_
protectedinherited

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