3.6-git
DUNE for Multi-{Phase, Component, Scale, Physics, ...} flow and transport in porous media
Namespaces | Classes | Typedefs | Enumerations | Functions | Variables
Dumux Namespace Reference

Adaption of the non-isothermal two-phase two-component flow model to problems with CO2. More...

Description

Adaption of the non-isothermal two-phase two-component flow model to problems with CO2.

TODO: Put a doxgyen link reference here See TwoPTwoCModel for reference to the equations used. The CO2 model is derived from the 2p2c model. In the CO2 model the phase switch criterion is different from the 2p2c model. The phase switch occurs when the equilibrium concentration of a component in a phase is exceeded, instead of the sum of the components in the virtual phase (the phase which is not present) being greater that unity as done in the 2p2c model. The CO2VolumeVariables do not use a constraint solver for calculating the mole fractions as is the case in the 2p2c model. Instead mole fractions are calculated in the FluidSystem with a given temperature, pressure and salinity. 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 setup. useMoles is set to false by default.

Namespaces

namespace  BinaryCoeff
 
namespace  CCMpfa
 
namespace  CCMpfaDataHandleBases
 
namespace  Components
 
namespace  Detail
 Distance implementation details.
 
namespace  DiscretizationMethods
 
namespace  Embedded1d3dCouplingMode
 
namespace  EmbeddedCoupling
 
namespace  Experimental
 
namespace  FacetCoupling
 
namespace  FCGridManagerChecks
 
namespace  FluidMatrix
 
namespace  FluidSystems
 
namespace  FluxVariablesCaching
 
namespace  Fmt
 Formatting tools in the style of std::format (C++20)
 
namespace  FreeFlowPoreNetworkDetail
 
namespace  FreeFlowPorousMediumCoupling
 
namespace  FreeFlowPorousMediumDetail
 
namespace  Gnuplot
 Helper functions related to gnuplot.
 
namespace  Grid
 
namespace  IAPWS
 
namespace  InterpolationPolicy
 forward declaration of the linear interpolation policy (default)
 
namespace  IntersectionPolicy
 
namespace  IOName
 
namespace  Json
 
namespace  MetaData
 
namespace  MPNCInitialConditions
 
namespace  Multidomain
 
namespace  Multithreading
 
namespace  PoreNetwork
 
namespace  Properties
 
namespace  Python
 
namespace  ShallowWater
 
namespace  SolidSystems
 
namespace  Temp
 
namespace  TriangulationPolicy
 
namespace  Utility
 
namespace  Vtk
 

Classes

class  AABBDistanceField
 Class to calculate the closest distance from a point to a given set of geometries describing the domain's boundaries. Internally uses an AABB tree representation of the geometries for logarithmic distance queries. More...
 
class  AdaptiveGridRestart
 Indices denoting the different grid types. More...
 
class  AdaptiveGridRestart< Grid, true >
 Provides a restart functionality for adaptive grids. More...
 
class  AdvectionCacheChooser
 
class  AdvectionCacheChooser< TypeTag, true >
 
class  AdvectionDataHandle
 Data handle for quantities related to advection. More...
 
class  AdvectionDataHandle< MatVecTraits, PhysicsTraits, false >
 Process-dependent data handles when related process is disabled. More...
 
struct  AdvectiveFlux< NavierStokesEnergyModelTraits< NavierStokesMassOnePModelTraits > >
 
struct  AdvectiveFlux< NavierStokesMassOnePModelTraits, T >
 Helper struct defining the advective fluxes of the single-phase flow Navier-Stokes mass model. More...
 
struct  AlwaysFalse
 Template which always yields a false value. More...
 
struct  AlwaysFalse< Components::Detail::DisableStaticAssert >
 
struct  AlwaysFalse< Dumux::Python::Detail::DisableStaticAssert >
 Specialization of Dumux::AlwaysFalse for the struct defined above. This is done in order to deactivate the static_assert in the base classes of components. If the base class function is compiled we do not call it (see below). More...
 
class  AMGBiCGSTABBackend
 A linear solver based on the ISTL AMG preconditioner and the ISTL BiCGSTAB solver. More...
 
class  BalanceEquationOptions
 Traits class to set options used by the local residual when when evaluating the balance equations. More...
 
class  BaseGridGeometry
 Base class for all grid geometries. More...
 
class  BaseStaggeredGeometryHelper
 Base class for a staggered grid geometry helper. More...
 
class  BasicGridGeometry
 An implementation of a grid geometry with some basic features. More...
 
class  BlockDiagAMGBiCGSTABSolver
 A simple ilu0 block diagonal preconditioned BiCGSTABSolver. More...
 
class  BlockDiagAMGPreconditioner
 A simple ilu0 block diagonal preconditioner. More...
 
class  BlockDiagILU0BiCGSTABSolver
 A simple ilu0 block diagonal preconditioned BiCGSTABSolver. More...
 
class  BlockDiagILU0Preconditioner
 A simple ilu0 block diagonal preconditioner. More...
 
class  BlockDiagILU0RestartedGMResSolver
 A simple ilu0 block diagonal preconditioned RestartedGMResSolver. More...
 
class  BoundaryFlag
 Boundary flag to store e.g. in sub control volume faces. More...
 
class  BoundarySegmentIndexFlag
 Class for accessing boundary flags. More...
 
class  BoundaryTypes
 Class to specify the type of a boundary. More...
 
class  BoundingBoxTree
 An axis-aligned bounding box volume tree implementation. More...
 
class  BoundingBoxTreePointSourceHelper
 A helper class calculating a sub control volume to point source map This class uses the bounding box tree implementation to identify in which sub control volume(s) a point source falls. More...
 
class  BoxDarcysLaw
 Darcy's law for the box scheme. More...
 
struct  BoxDefaultGridFVCTraits
 Flux variable caches traits. More...
 
struct  BoxDefaultGridGeometryTraits
 The default traits for the box finite volume grid geometry Defines the scv and scvf types and the mapper types. More...
 
struct  BoxDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the box scheme. More...
 
struct  BoxDefaultScvGeometryTraits
 Default traits class to be used for the sub-control volumes for the box scheme. More...
 
struct  BoxDfmDefaultGridGeometryTraits
 The default traits for the box finite volume grid geometry. More...
 
struct  BoxDfmDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the box discrete fracture scheme. More...
 
struct  BoxDfmDefaultScvGeometryTraits
 Default traits class to be used for the sub-control volumes for the box discrete fracture scheme. More...
 
class  BoxDfmFluxVariablesCache
 We only store discretization-related quantities for the box method. However, we cannot reuse the cache of the standard box method as we have to take into account the scvs that lie on fracture facets. More...
 
class  BoxDfmFVElementGeometry
 Base class for the finite volume geometry vector for box discrete fracture model. More...
 
class  BoxDfmFVElementGeometry< GG, false >
 Specialization in case the FVElementGeometries are not stored. More...
 
class  BoxDfmFVElementGeometry< GG, true >
 Specialization in case the FVElementGeometries are stored. More...
 
class  BoxDfmFVGridGeometry
 Base class for the finite volume geometry vector for box schemes. More...
 
class  BoxDfmFVGridGeometry< Scalar, GV, false, Traits >
 Base class for the finite volume geometry vector for box schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxDfmFVGridGeometry< Scalar, GV, true, Traits >
 Base class for the finite volume geometry vector for box schemes that consider extra connectivity between grid vertices on marked codim one entities. More...
 
class  BoxDfmGeometryHelper
 Create sub control volumes and sub control volume face geometries. More...
 
class  BoxDfmGeometryHelper< GridView, 2, ScvType, ScvfType >
 A class to create sub control volume and sub control volume face geometries per element. More...
 
class  BoxDfmGeometryHelper< GridView, 3, ScvType, ScvfType >
 A class to create sub control volume and sub control volume face geometries per element. More...
 
struct  BoxDfmMLGeometryTraits
 
class  BoxDfmSubControlVolume
 the sub control volume for the box discrete fracture scheme More...
 
class  BoxDfmSubControlVolumeFace
 Class for a sub control volume face in the box discrete fracture method, i.e a part of the boundary of a sub control volume we compute fluxes on. More...
 
class  BoxDfmVtkOutputModule
 A VTK output module to simplify writing dumux simulation data to VTK format. More...
 
class  BoxElementSolution
 The element solution vector. More...
 
class  BoxFacetCouplingDarcysLaw
 Darcy's law for the box scheme in the context of coupled models where coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain living on these facets. More...
 
struct  BoxFacetCouplingDefaultGridGeometryTraits
 The default traits for the finite volume grid geometry of the box scheme with coupling occurring across the element facets. Defines the scv and scvf types and the mapper types. More...
 
class  BoxFacetCouplingFicksLaw
 Ficks's law for the box scheme in the context of coupled models where coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain living on these facets. More...
 
class  BoxFacetCouplingFouriersLaw
 Fourier's law for the box scheme in the context of coupled models where coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain living on these facets. More...
 
class  BoxFacetCouplingFVElementGeometry
 Base class for the element-local finite volume geometry for box models in the context of models considering coupling of different domains across the bulk grid facets. This builds up the sub control volumes and sub control volume faces for an element. More...
 
class  BoxFacetCouplingFVElementGeometry< GG, false >
 specialization in case the geometries are not stored grid-wide More...
 
class  BoxFacetCouplingFVElementGeometry< GG, true >
 specialization in case the FVElementGeometries are stored More...
 
class  BoxFacetCouplingFVGridGeometry
 Base class for the finite volume geometry vector for box schemes in the context of coupled models where the coupling occurs across the element facets. This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxFacetCouplingFVGridGeometry< Scalar, GV, false, Traits >
 Base class for the finite volume geometry vector for box schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxFacetCouplingFVGridGeometry< Scalar, GV, true, Traits >
 Base class for the finite volume geometry vector for box schemes in the context of coupled models where the coupling occurs across the element facets. This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxFacetCouplingLocalResidual
 The element-wise residual for the box scheme. More...
 
class  BoxFacetCouplingSubControlVolumeFace
 Class for a sub control volume face in the box method, i.e a part of the boundary of a sub control volume we compute fluxes on. This is a specialization for models considering coupling of different domains across the bulk grid facets. More...
 
class  BoxFacetCouplingUpwindScheme
 The upwind scheme used for the advective fluxes. This is a modified scheme for models involving coupling with a lower-dimensional domain across the element facets. More...
 
class  BoxForchheimersLaw
 Forchheimer's law for box scheme. More...
 
class  BoxFVElementGeometry
 Base class for the finite volume geometry vector for box models This builds up the sub control volumes and sub control volume faces for each element. More...
 
class  BoxFVElementGeometry< GG, false >
 specialization in case the FVElementGeometries are not stored More...
 
class  BoxFVElementGeometry< GG, true >
 specialization in case the FVElementGeometries are stored More...
 
class  BoxFVGridGeometry
 Base class for the finite volume geometry vector for box schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxFVGridGeometry< Scalar, GV, false, Traits >
 Base class for the finite volume geometry vector for box schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxFVGridGeometry< Scalar, GV, true, Traits >
 Base class for the finite volume geometry vector for box schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  BoxGeometryHelper
 Create sub control volumes and sub control volume face geometries. More...
 
class  BoxGeometryHelper< GridView, 1, ScvType, ScvfType >
 A class to create sub control volume and sub control volume face geometries per element. More...
 
class  BoxGeometryHelper< GridView, 2, ScvType, ScvfType >
 A class to create sub control volume and sub control volume face geometries per element. More...
 
class  BoxGeometryHelper< GridView, 3, ScvType, ScvfType >
 A class to create sub control volume and sub control volume face geometries per element. More...
 
class  BoxLocalAssembler
 An assembler for Jacobian and residual contribution per element (box methods) More...
 
class  BoxLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, false >
 Box local assembler using analytic differentiation and explicit time discretization. More...
 
class  BoxLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, true >
 Box local assembler using analytic differentiation and implicit time discretization. More...
 
class  BoxLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, false >
 Box local assembler using numeric differentiation and explicit time discretization. More...
 
class  BoxLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, true >
 Box local assembler using numeric differentiation and implicit time discretization. More...
 
class  BoxLocalAssemblerBase
 A base class for all local box assemblers. More...
 
class  BoxMaterialInterfaces
 Class that determines the material with the lowest capillary pressure (under fully water-saturated conditions) around the nodes of a grid. More...
 
struct  BoxMLGeometryTraits
 Traits for an efficient corner storage for box method sub control volumes. More...
 
class  BoxSubControlVolume
 the sub control volume for the box scheme More...
 
class  BoxSubControlVolumeFace
 Class for a sub control volume face in the box method, i.e a part of the boundary of a sub control volume we compute fluxes on. We simply use the base class here. More...
 
class  CakeGridManager
 Provides a grid manager with a method for creating creating vectors with polar Coordinates and one for creating a Cartesian grid from these polar coordinates. More...
 
struct  CCDefaultScvGeometryTraits
 Default traits class to be used for the sub-control volumes for the cell-centered finite volume scheme using TPFA. More...
 
class  CCElementBoundaryTypes
 Boundary types gathered on an element. More...
 
class  CCElementSolution
 The element solution vector. More...
 
class  CCFacetCouplingLocalResidual
 Calculates the element-wise residual for cell-centered discretization schemes in models where coupling occurs across the element facets. We only overwrite the function for the computation of a flux across a single sub-control volume face, as we need to additionally check if a boundary face couples to a facet element. More...
 
class  CCFacetCouplingUpwindScheme
 The upwind scheme used for the advective fluxes. This is a modified scheme for models involving coupling with a lower-dimensional domain across the element facets. More...
 
class  CCGridVolumeVariables
 Base class for the grid volume variables. More...
 
class  CCGridVolumeVariables< Traits, false >
 Specialization when the current volume variables are not stored globally. More...
 
class  CCGridVolumeVariables< Traits, true >
 specialization in case of storing the volume variables More...
 
class  CCLocalAssembler
 An assembler for Jacobian and residual contribution per element (cell-centered methods) More...
 
class  CCLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, false >
 Cell-centered scheme local assembler using analytic (hand-coded) differentiation and explicit time discretization. More...
 
class  CCLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, true >
 Cell-centered scheme local assembler using analytic (hand-coded) differentiation and implicit time discretization. More...
 
class  CCLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, false >
 Cell-centered scheme local assembler using numeric differentiation and explicit time discretization. More...
 
class  CCLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, true >
 Cell-centered scheme local assembler using numeric differentiation and implicit time discretization. More...
 
class  CCLocalAssemblerBase
 A base class for all local cell-centered assemblers. More...
 
class  CCLocalResidual
 Calculates the element-wise residual for the cell-centered discretization schemes. More...
 
class  CCMpfaConnectivityMap
 Forward declaration of method specific implementation of the assembly map. More...
 
class  CCMpfaConnectivityMap< GridGeometry, MpfaMethods::oMethod >
 The o-method can use the simple (symmetric) assembly map. More...
 
struct  CCMpfaDefaultGridFluxVariablesCacheTraits
 Data handle physics traits. More...
 
struct  CCMpfaDefaultGridVolumeVariablesTraits
 Traits for the base class for the grid volume variables. More...
 
struct  CCMpfaDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the cell-centered finite volume scheme using MPFA. More...
 
class  CCMpfaDualGridIndexSet
 Class for the index sets of the dual grid in mpfa schemes. More...
 
class  CCMpfaDualGridNodalIndexSet
 Nodal index set for mpfa schemes, constructed around grid vertices. More...
 
class  CCMpfaElementFluxVariablesCache
 The flux variables caches for an element. More...
 
class  CCMpfaElementFluxVariablesCache< GFVC, false >
 The flux variables caches for an element with caching disabled. More...
 
class  CCMpfaElementFluxVariablesCache< GFVC, true >
 The flux variables caches for an element with caching enabled. More...
 
class  CCMpfaElementVolumeVariables
 The local (stencil) volume variables class for cell centered mpfa models. More...
 
class  CCMpfaElementVolumeVariables< GVV, false >
 The local (stencil) volume variables class for cell centered tpfa models with caching. More...
 
class  CCMpfaElementVolumeVariables< GVV, true >
 The local (stencil) volume variables class for cell centered mpfa models with caching. More...
 
class  CCMpfaFVElementGeometry
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered mpfa models This builds up the sub control volumes and sub control volume faces for each element in the local scope we are restricting to, e.g. stencil or element. More...
 
class  CCMpfaFVElementGeometry< GG, false >
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered TPFA models Specialization for grid caching disabled. More...
 
class  CCMpfaFVElementGeometry< GG, true >
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered mpfa models Specialization for grid caching enabled. More...
 
class  CCMpfaFVGridGeometry
 The finite volume geometry (scvs and scvfs) for cell-centered mpfa models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
class  CCMpfaFVGridGeometry< GV, Traits, false >
 The finite volume geometry (scvs and scvfs) for cell-centered mpfa models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
class  CCMpfaFVGridGeometry< GV, Traits, true >
 The finite volume geometry (scvs and scvfs) for cell-centered mpfa models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
struct  CCMpfaFVGridGeometryTraits
 Traits class to be used for the CCMpfaFVGridGeometry. More...
 
class  CCMpfaGridFluxVariablesCache
 Flux variable caches on a gridview. More...
 
class  CCMpfaGridFluxVariablesCache< TheTraits, false >
 Flux variable caches on a gridview with grid caching disabled. More...
 
class  CCMpfaGridFluxVariablesCache< TheTraits, true >
 Flux variable caches on a gridview with grid caching enabled. More...
 
class  CCMpfaGridInteractionVolumeIndexSets
 Class that holds all interaction volume index sets on a grid view. More...
 
class  CCMpfaGridVolumeVariables
 Base class for the grid volume variables. More...
 
class  CCMpfaHelper
 Helper class to get the required information on an interaction volume. More...
 
class  CCMpfaInteractionVolumeBase
 Base class for the interaction volumes of mpfa methods. It defines the interface and actual implementations should derive from this class. More...
 
struct  CCMpfaODefaultInteractionVolumeTraits
 The default interaction volume traits class for the mpfa-o method. This uses dynamic types types for matrices/vectors in order to work on general grids. For interaction volumes known at compile time use the static interaction volume implementation. More...
 
struct  CCMpfaODefaultStaticInteractionVolumeTraits
 The default interaction volume traits class for the mpfa-o method with known size of the interaction volumes at compile time. It uses statically sized containers for the iv-local data structures and static matrices and vectors. More...
 
struct  CCMpfaOFacetCouplingDefaultInteractionVolumeTraits
 The default interaction volume traits class for the mpfa-o method in the context of facet coupling. This uses dynamic types types for matrices/vectors in order to work on general grids. More...
 
class  CCMpfaOFacetCouplingInteractionVolume
 Forward declaration of the facet coupling MPFA-O interaction volume. More...
 
class  CCMpfaOFacetCouplingInteractionVolumeLocalScv
 Class for the interaction volume-local sub-control volume used in the mpfa-o scheme in the context of facet coupling. More...
 
struct  CCMpfaOFacetCouplingInteractionVolumeLocalScvf
 Class for the interaction volume-local sub-control volume face used in the mpfa-o scheme in the context of facet coupling. More...
 
class  CCMpfaOInteractionVolume
 Forward declaration of the o-method's interaction volume. More...
 
class  CCMpfaOInteractionVolumeIndexSet
 The interaction volume index set class for the mpfa-o scheme. More...
 
class  CCMpfaOInteractionVolumeLocalScv
 Class for the interaction volume-local sub-control volume used in the mpfa-o scheme. More...
 
struct  CCMpfaOInteractionVolumeLocalScvf
 Class for the interaction volume-local sub-control volume face used in the mpfa-o scheme. More...
 
class  CCMpfaOScvGeometryHelper
 Helper class providing functionality to compute the geometry of the interaction-volume local sub-control volumes of mpfa-o type. More...
 
class  CCMpfaOStaticInteractionVolume
 Forward declaration of the o-method's static interaction volume. More...
 
class  CCMpfaScvGradients
 Class providing functionality for the reconstruction of the gradients in the sub-control volumes involved in mpfa schemes. More...
 
class  CCMpfaSubControlVolumeFace
 Class for a sub control volume face in mpfa methods, i.e a part of the boundary of a control volume we compute fluxes on. More...
 
class  CCSimpleConnectivityMap
 A simple version of the connectivity map for cellcentered schemes. This implementation works for schemes in which for a given cell I only those cells J have to be prepared in whose stencil the cell I appears. This means that for the flux calculations in the cells J (in order to compute the derivatives with respect to cell I), we do not need data on any additional cells J to compute these fluxes. The same holds for scvfs in the cells J, i.e. we need only those scvfs in the cells J in which the cell I is in the stencil. More...
 
class  CCSubControlVolume
 Sub control volumes for cell-centered discretization schemes. More...
 
class  CCTpfaDarcysLaw
 Darcy's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  CCTpfaDarcysLaw< ScalarType, GridGeometry, false >
 Specialization of the CCTpfaDarcysLaw grids where dim=dimWorld. More...
 
class  CCTpfaDarcysLaw< ScalarType, GridGeometry, true >
 Specialization of the CCTpfaDarcysLaw grids where dim < dimWorld (network/surface grids) More...
 
struct  CCTpfaDefaultGridFVCTraits
 Flux variable caches traits. More...
 
struct  CCTpfaDefaultGridGeometryTraits
 The default traits for the tpfa finite volume grid geometry Defines the scv and scvf types and the mapper types. More...
 
struct  CCTpfaDefaultGridVolumeVariablesTraits
 
struct  CCTpfaDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the cell-centered finite volume scheme using TPFA. More...
 
class  CCTpfaElementFluxVariablesCache
 The flux variables caches for an element. More...
 
class  CCTpfaElementFluxVariablesCache< GFVC, false >
 The flux variables caches for an element with caching disabled. More...
 
class  CCTpfaElementFluxVariablesCache< GFVC, true >
 The flux variables caches for an element with caching enabled. More...
 
class  CCTpfaElementVolumeVariables
 The local (stencil) volume variables class for cell centered tpfa models. More...
 
class  CCTpfaElementVolumeVariables< GVV, false >
 The local (stencil) volume variables class for cell centered tpfa models with caching. More...
 
class  CCTpfaElementVolumeVariables< GVV, true >
 The local (stencil) volume variables class for cell centered tpfa models with caching. More...
 
class  CCTpfaFacetCouplingDarcysLawCache
 The cache corresponding to tpfa Darcy's Law with facet coupling. More...
 
class  CCTpfaFacetCouplingDarcysLawCache< AdvectionType, GridGeometry, false >
 Specialization of FacetCouplingTpfaDarcysLawCache for non-network grids. More...
 
class  CCTpfaFacetCouplingDarcysLawCache< AdvectionType, GridGeometry, true >
 Specialization of FacetCouplingTpfaDarcysLawCache for network grids. More...
 
class  CCTpfaFacetCouplingDarcysLawImpl
 Forward declaration of the implementation. More...
 
class  CCTpfaFacetCouplingDarcysLawImpl< ScalarType, GridGeometry, false >
 Specialization of CCTpfaFacetCouplingDarcysLawImpl for dim=dimWorld. More...
 
class  CCTpfaFacetCouplingDarcysLawImpl< ScalarType, GridGeometry, true >
 Specialization of CCTpfaFacetCouplingDarcysLawImpl for dim<dimWorld. More...
 
class  CCTpfaFacetCouplingFicksLawImpl
 Forward declaration of the implementation. More...
 
class  CCTpfaFacetCouplingFicksLawImpl< TypeTag, referenceSystem, false >
 Specialization of CCTpfaFacetCouplingFicksLawImpl for dim=dimWorld. More...
 
class  CCTpfaFacetCouplingFicksLawImpl< TypeTag, referenceSystem, true >
 Specialization of CCTpfaFacetCouplingFicksLawImpl for dim<dimWorld. More...
 
class  CCTpfaFacetCouplingFouriersLawImpl
 Forward declaration of the implementation. More...
 
class  CCTpfaFacetCouplingFouriersLawImpl< TypeTag, false >
 Specialization of CCTpfaFacetCouplingFouriersLawImpl for dim=dimWorld. More...
 
class  CCTpfaFacetCouplingFouriersLawImpl< TypeTag, true >
 Specialization of CCTpfaFacetCouplingFouriersLawImpl for dim<dimWorld. More...
 
class  CCTpfaForchheimersLaw
 Forchheimer's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  CCTpfaForchheimersLaw< ScalarType, GridGeometry, ForchheimerVelocity, false >
 Specialization of the CCTpfaForchheimersLaw grids where dim=dimWorld. More...
 
class  CCTpfaForchheimersLaw< ScalarType, GridGeometry, ForchheimerVelocity, true >
 Specialization of the CCTpfaForchheimersLaw grids where dim<dimWorld. More...
 
class  CCTpfaFVElementGeometry
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered TPFA models This builds up the sub control volumes and sub control volume faces for each element in the local scope we are restricting to, e.g. stencil or element. More...
 
class  CCTpfaFVElementGeometry< GG, false >
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered TPFA models Specialization for grid caching disabled. More...
 
class  CCTpfaFVElementGeometry< GG, true >
 Stencil-local finite volume geometry (scvs and scvfs) for cell-centered TPFA models Specialization for grid caching enabled. More...
 
class  CCTpfaFVGridGeometry
 The finite volume geometry (scvs and scvfs) for cell-centered TPFA models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
class  CCTpfaFVGridGeometry< GV, false, Traits >
 The finite volume geometry (scvs and scvfs) for cell-centered TPFA models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
class  CCTpfaFVGridGeometry< GV, true, Traits >
 The finite volume geometry (scvs and scvfs) for cell-centered TPFA models on a grid view This builds up the sub control volumes and sub control volume faces. More...
 
class  CCTpfaGridFluxVariablesCache
 Flux variable caches on a gridview. More...
 
class  CCTpfaGridFluxVariablesCache< P, FVC, FVCF, false, TheTraits >
 Flux variable caches on a gridview with grid caching disabled. More...
 
class  CCTpfaGridFluxVariablesCache< P, FVC, FVCF, true, TheTraits >
 Flux variable caches on a gridview with grid caching enabled. More...
 
class  CCTpfaGridVolumeVariables
 Base class for the grid volume variables. More...
 
class  CCTpfaSubControlVolumeFace
 The sub control volume face. More...
 
class  CellCenterFVGridGeometry
 Cell center specific auxiliary FvGridGeometry classes. Required for the Dumux multi-domain framework. More...
 
class  CellCenterGridVariablesView
 Cell center specific auxiliary GridVariables classes. Required for the Dumux multi-domain framework. More...
 
struct  CheckOverlapSize
 Check if the overlap size is valid for a given discretization method. More...
 
struct  CheckOverlapSize< DiscretizationMethods::Box >
 specialization for the box method which requires an overlap size of 0 More...
 
struct  CheckOverlapSize< DiscretizationMethods::FCStaggered >
 
struct  CheckOverlapSize< DiscretizationMethods::FEM >
 
class  CheckPointTimeLoop
 A time loop with a check point mechanism. More...
 
struct  CircleAveragePointSourceTraits
 point source traits for the circle average coupling mode More...
 
class  CodimOneGridAdapter
 Adapter that allows retrieving information on a d-dimensional grid for entities of a (d-1)-dimensional grid. This lower-dimensional grid is assumed to be facet-conforming to the d-dimensional grid. This class can be used in the context of models where a sub-domain lives on the facets of a bulk grid. More...
 
struct  ComponentTraits
 Component traits, i.e. information extracted from components. More...
 
struct  ComponentTraits< Components::TabulatedComponent< RawComponent, useVaporPressure > >
 component traits for tabulated component More...
 
class  CompositionalFlash
 Flash calculation routines for compositional sequential models. More...
 
class  CompositionalFluidState
 Represents all relevant thermodynamic quantities of a multi-phase, multi-component fluid system assuming thermodynamic equilibrium. More...
 
class  CompositionalLocalResidual
 Element-wise calculation of the local residual for problems using compositional fully implicit model. More...
 
class  CompositionalSolidState
 Represents all relevant thermodynamic quantities of a compositional solid system. More...
 
class  CompositionFromFugacities
 Calculates the chemical equilibrium from the component fugacities \( f^\kappa \) in the phase \( \alpha \). More...
 
class  ComputeFromReferencePhase
 Computes all quantities of a generic fluid state if a reference phase has been specified. More...
 
class  ConformingGridIntersectionMapper
 defines a standard intersection mapper for mapping of global DOFs assigned to faces. It only works for conforming grids, without hanging nodes. More...
 
class  ConformingIntersectionWriter
 Conforming intersection writer. More...
 
struct  ConsistentlyOrientedGrid
 Helper type to determine whether a grid is guaranteed to be oriented consistently. This means that the intersection indices always correspond to the ones of a reference element or, in other words, the elements are never rotated. More...
 
struct  ConsistentlyOrientedGrid< Dune::SubGrid< dim, Dune::YaspGrid< dim, Coords >, mapIndexStorage > >
 
struct  ConsistentlyOrientedGrid< Dune::YaspGrid< dim, Coords > >
 
class  Constants
 A central place for various physical constants occurring in some equations. More...
 
struct  ConvergenceWriterInterface
 
class  CouplingManager
 The interface of the coupling manager for multi domain problems. More...
 
struct  CouplingManagerSupportsMultithreadedAssembly
 trait that is specialized for coupling manager supporting multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Kernel > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Line > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Projection > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Surface > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< EmbeddedCouplingManager2d3d< MDTraits > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< FCDiamondFreeFlowCouplingManager< T > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< FCStaggeredFreeFlowCouplingManager< T > >
 we support multithreaded assembly More...
 
struct  CouplingManagerSupportsMultithreadedAssembly< PQ1BubbleFreeFlowCouplingManager< T > >
 TODO The infrastructure for multithreaded assembly is implemented (see code in the class above) but the current implementation seems to have a bug and may cause race conditions. The result is different when running in parallel. After this has been fixed activate multithreaded assembly by inheriting from std::true_type here. More...
 
class  CubicSpline
 A simple implementation of a natural cubic spline. More...
 
struct  CubicSplineHermiteBasis
 The cubic spline hermite basis. More...
 
class  CVFEDarcysLaw
 Darcy's law for control-volume finite element schemes. More...
 
struct  CVFEDefaultGridFVCTraits
 Flux variable caches traits. More...
 
struct  CVFEDefaultGridVolumeVariablesTraits
 
class  CVFEElementBoundaryTypes
 This class stores an array of BoundaryTypes objects. More...
 
class  CVFEElementFluxVariablesCache
 The flux variables caches for an element. More...
 
class  CVFEElementFluxVariablesCache< GFVC, false >
 The flux variables caches for an element with caching disabled. More...
 
class  CVFEElementFluxVariablesCache< GFVC, true >
 The flux variables caches for an element with caching enabled. More...
 
class  CVFEElementVolumeVariables
 The local (stencil) volume variables class for control-volume finite element. More...
 
class  CVFEElementVolumeVariables< GVV, false >
 The local (stencil) volume variables class for control-volume finite element without caching. More...
 
class  CVFEElementVolumeVariables< GVV, true >
 The local (stencil) volume variables class for control-volume finite element with caching. More...
 
class  CVFEFluxVariablesCache
 Flux variables cache class for control-volume finite element schemes. For control-volume finite element schemes, this class does not contain any physics-/process-dependent data. It solely stores disretization-/grid-related data. More...
 
class  CVFEGridFluxVariablesCache
 Flux variable caches on a gridview. More...
 
class  CVFEGridFluxVariablesCache< P, FVC, false, Traits >
 Flux variable caches on a gridview with grid caching disabled. More...
 
class  CVFEGridFluxVariablesCache< P, FVC, true, Traits >
 Flux variable caches on a gridview with grid caching enabled. More...
 
class  CVFEGridVolumeVariables
 Base class for the grid volume variables. More...
 
class  CVFEGridVolumeVariables< Traits, false >
 
class  CVFEGridVolumeVariables< Traits, true >
 
class  CVFELocalResidual
 The element-wise residual for control-volume finite element schemes. More...
 
class  DarcyDarcyBoundaryCouplingManager
 Coupling manager for equal-dimension boundary coupling of darcy models. More...
 
class  DarcyDarcyBoundaryCouplingMapper
 the default mapper for conforming equal dimension boundary coupling between two domains (box or cc) More...
 
class  DarcysLawImplementation
 forward declaration of the method-specific implementation More...
 
class  DarcysLawImplementation< TypeTag, DiscretizationMethods::Box >
 Specialization of Darcy's Law for the box method. More...
 
class  DarcysLawImplementation< TypeTag, DiscretizationMethods::CCMpfa >
 Darcy's law for cell-centered finite volume schemes with multi-point flux approximation. More...
 
class  DarcysLawImplementation< TypeTag, DiscretizationMethods::CCTpfa >
 Darcy's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  DarcysLawImplementation< TypeTag, DiscretizationMethods::CVFE< DM > >
 Specialization of Darcy's Law for control-volume finite element schemes. More...
 
struct  DefaultFEGridGeometryTraits
 Default Traits class for the fem grid geometry. More...
 
class  DefaultIOFields
 Adds output fields to a given output module. More...
 
struct  DefaultMapperTraits
 
class  DefaultPartialReassembler
 
struct  DefaultPointSourceTraits
 the default point source traits More...
 
class  DiamondGeometryHelper
 Helper class to construct SCVs and SCVFs for the diamond scheme. More...
 
class  DiffusionCacheChooser
 
class  DiffusionCacheChooser< TypeTag, true >
 
class  DiffusionDataHandle
 Data handle for quantities related to diffusion. More...
 
class  DiffusionDataHandle< MatVecTraits, PhysicsTraits, false >
 
class  DiffusivityConstantTortuosity
 Relation for the saturation-dependent effective diffusion coefficient. More...
 
class  DiffusivityMillingtonQuirk
 Relation for the saturation-dependent effective diffusion coefficient. More...
 
class  DimensionlessNumbers
 Collection of functions which calculate dimensionless numbers. Each number has it's own function. All the parameters for the calculation have to be handed over. Rendering this collection generic in the sense that it can be used by any model. More...
 
class  DispersionFluxImplementation
 
class  DispersionFluxImplementation< TypeTag, DiscretizationMethods::Box, referenceSystem >
 Specialization of a dispersion flux for the box method. More...
 
class  DispersionFluxImplementation< TypeTag, DiscretizationMethods::CCTpfa, referenceSystem >
 Specialization of a Dispersion flux for the cctpfa method. More...
 
class  DofBackend
 Class providing operations with primary variable vectors. More...
 
class  DofBackend< Dune::MultiTypeBlockVector< Blocks... >, false >
 Specialization providing operations for multitype block vectors. More...
 
class  DofBackend< Scalar, true >
 Specialization providing operations for scalar/number types. More...
 
class  DofBackend< Vector, false >
 Specialization providing operations for block vectors. More...
 
class  DoubleExponentialIntegrator
 Numerical integration in one dimension using the double exponential method of M. Mori. More...
 
class  DumuxMessage
 DuMux start and end message. More...
 
class  EffectiveStressLaw
 This computes the stress tensor and surface forces resulting from poro-mechanical deformation. More...
 
class  EffectiveStressLaw< StressType, GridGeometry, typename GridGeometry::DiscretizationMethod >
 Effective stress law for box scheme. More...
 
struct  ElasticIndices
 The indices for the linear elasticity model. More...
 
class  ElasticLocalResidual
 Element-wise calculation of the local residual for problems using the elastic model considering linear elasticity. More...
 
struct  ElasticModelTraits
 Specifies a number properties of the elastic model. More...
 
class  ElasticVolumeVariables
 Contains the quantities which are constant within a finite volume in the elastic model. More...
 
struct  ElasticVolumeVariablesTraits
 Traits class for the volume variables of the elastic model. More...
 
class  ElectroChemistry
 This class calculates source terms and current densities for fuel cells with the electrochemical models suggested by Ochs (2008) [50] or Acosta et al. (2006) [1]. More...
 
class  ElectroChemistryNI
 Class calculating source terms and current densities for fuel cells with the electrochemical models suggested by Ochs (2008) [50] or Acosta (2006) [1] for the non-isothermal case. More...
 
class  Embedded1d3dCouplingManager
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Kernel >
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Line >
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Projection >
 Manages the coupling between bulk elements and lower dimensional elements. More...
 
class  Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Surface >
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  EmbeddedCouplingManager2d3d
 Coupling manager for embedded fractures. More...
 
class  EmbeddedCouplingManagerBase
 Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...
 
class  EmptyDataHandle
 Empty data handle class. More...
 
struct  EmptyElementSolution
 
class  EnergyCacheChooser
 
class  EnergyCacheChooser< TypeTag, true >
 
struct  EnergyIndices
 Indices for the non-isothermal two-phase two-component model. More...
 
class  EnergyIOFields
 Adds I/O fields specific to non-isothermal models. More...
 
class  EnergyIOFields< void >
 Adds I/O fields specific to non-isothermal models. More...
 
class  EnergyLocalResidualImplementation
 
class  EnergyLocalResidualImplementation< TypeTag, false >
 Element-wise calculation of the energy residual for non-isothermal problems. More...
 
class  EnergyLocalResidualImplementation< TypeTag, true >
 TODO docme! More...
 
class  EnergyLocalResidualNonEquilibrium
 This file contains the parts of the local residual to calculate the heat conservation in the thermal non-equilibrium model. More...
 
class  EnergyLocalResidualNonEquilibrium< TypeTag, 1 >
 
class  EnergyLocalResidualNonEquilibrium< TypeTag, 2 >
 
class  EnergyVolumeVariablesImplementation
 
class  EnergyVolumeVariablesImplementation< IsothermalTraits, Impl, false >
 The isothermal base class. More...
 
class  EnergyVolumeVariablesImplementation< Traits, Impl, true >
 The non-isothermal implicit volume variables base class. More...
 
class  EnrichedVertexDofMapper
 A vertex mapper that allows for enrichment of nodes. Indication on where to enrich the nodes is done on the basis of a grid of codimension one living on the facets of the bulk grid. More...
 
class  EnrichmentIndicator
 An indicator class used to mark vertices for enrichment. This implementation marks all vertices of a given grid of codimension one for enrichment, except those that are connected to inmersed boundaries. More...
 
class  EntityMap
 A map from indices to entities using grid entity seeds. More...
 
class  ExplicitDiagonalSolver
 Solver for simple block-diagonal matrices (e.g. from explicit time stepping schemes) More...
 
struct  ExtendedRichardsIndices
 Index names for the extended Richards model. More...
 
class  ExtendedRichardsIOFields
 Adds I/O fields specific to the extended Richards model. More...
 
class  ExtendedRichardsLocalResidual
 Element-wise calculation of the Jacobian matrix for problems using the extended Richards fully implicit models. More...
 
struct  ExtendedRichardsModelTraits
 Specifies a number properties of the extended Richards model. More...
 
class  ExtendedRichardsPrimaryVariableSwitch
 The primary variable switch controlling the phase presence state variable. More...
 
class  ExtendedRichardsVolumeVariables
 Volume averaged quantities required by the extended Richards model. More...
 
struct  ExtendedRichardsVolumeVariablesTraits
 Traits class for the Richards model. More...
 
class  Extrusion
 Traits extracting the public Extrusion type from T Defaults to NoExtrusion if no such type is found. More...
 
struct  FaceCenteredDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume face for the face-centered staggered finite volume scheme. More...
 
struct  FaceCenteredDefaultScvGeometryTraits
 Default traits class to be used for the sub-control volumes for the face-centered staggered scheme. More...
 
struct  FaceCenteredDiamondDefaultGridGeometryTraits
 The default traits for the face-centered diamond finite volume grid geometry Defines the scv and scvf types and the mapper types. More...
 
class  FaceCenteredDiamondElementSolution
 The global face variables class for face-centered diamond models. More...
 
class  FaceCenteredDiamondFVElementGeometry
 Element-wise grid geometry (local view) More...
 
class  FaceCenteredDiamondFVElementGeometry< GG, true >
 Element-wise grid geometry (local view) More...
 
class  FaceCenteredDiamondFVGridGeometry
 Grid geometry for the diamond discretization. More...
 
class  FaceCenteredDiamondLocalAssembler
 An assembler for Jacobian and residual contribution per element (Face-centered methods) More...
 
class  FaceCenteredDiamondLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, false >
 TODO docme. More...
 
class  FaceCenteredDiamondLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, true >
 TODO docme. More...
 
class  FaceCenteredDiamondLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, false >
 TODO docme. More...
 
class  FaceCenteredDiamondLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, true, Implementation >
 Face-centered scheme local assembler using numeric differentiation and implicit time discretization. More...
 
class  FaceCenteredDiamondLocalAssemblerBase
 A base class for all local face-centered assemblers. More...
 
struct  FaceCenteredDiamondScvfGeometryTraits
 Default traits class to be used for the sub-control volumes for the cell-centered finite volume scheme using TPFA. More...
 
struct  FaceCenteredDiamondScvGeometryTraits
 Default traits class to be used for the sub-control volumes. More...
 
class  FaceCenteredDiamondSubControlVolume
 Face centered diamond subcontrolvolume face. More...
 
class  FaceCenteredDiamondSubControlVolumeFace
 The SCVF implementation for diamond. More...
 
class  FaceCenteredLocalAssembler
 An assembler for Jacobian and residual contribution per element (Face-centered methods) More...
 
class  FaceCenteredLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, false, Implementation >
 TODO docme. More...
 
class  FaceCenteredLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, true, Implementation >
 TODO docme. More...
 
class  FaceCenteredLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, false, Implementation >
 TODO docme. More...
 
class  FaceCenteredLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, true, Implementation >
 Face-centered scheme local assembler using numeric differentiation and implicit time discretization. More...
 
class  FaceCenteredLocalAssemblerBase
 A base class for all local cell-centered assemblers. More...
 
class  FaceCenteredLocalResidual
 The element-wise residual for the box scheme. More...
 
class  FaceCenteredStaggeredConnectivityMap
 Stores the dof indices corresponding to the neighboring scvs that contribute to the derivative calculation. More...
 
struct  FaceCenteredStaggeredDefaultGridFVCTraits
 Flux variable caches traits. More...
 
struct  FaceCenteredStaggeredDefaultGridGeometryTraits
 The default traits for the face-center staggered finite volume grid geometry Defines the scv and scvf types and the mapper types. More...
 
struct  FaceCenteredStaggeredDefaultGridVolumeVariablesTraits
 
class  FaceCenteredStaggeredElementBoundaryTypes
 This class stores an array of BoundaryTypes objects. More...
 
class  FaceCenteredStaggeredElementFluxVariablesCache
 The flux variables caches for an element. More...
 
class  FaceCenteredStaggeredElementFluxVariablesCache< GFVC, false >
 The flux variables caches for an element with caching disabled. More...
 
class  FaceCenteredStaggeredElementFluxVariablesCache< GFVC, true >
 The flux variables caches for an element with caching enabled. More...
 
class  FaceCenteredStaggeredElementSolution
 The global face variables class for staggered models. More...
 
class  FaceCenteredStaggeredElementVolumeVariables
 Base class for the face variables vector. More...
 
class  FaceCenteredStaggeredElementVolumeVariables< GVV, false >
 Class for the face variables vector. Specialization for the case of not storing the face variables globally. More...
 
class  FaceCenteredStaggeredElementVolumeVariables< GVV, true >
 Class for the face variables vector. Specialization for the case of storing the face variables globally. More...
 
class  FaceCenteredStaggeredFVElementGeometry
 
class  FaceCenteredStaggeredFVElementGeometry< GG, false >
 Stencil-local finite volume geometry (scvs and scvfs) for face-centered staggered models Specialization for grid caching disabled. More...
 
class  FaceCenteredStaggeredFVElementGeometry< GG, true >
 Stencil-local finite volume geometry (scvs and scvfs) for face-centered staggered models Specialization for grid caching enabled. More...
 
class  FaceCenteredStaggeredFVGridGeometry
 Base class for the finite volume geometry vector for face-centered staggered models This builds up the sub control volumes and sub control volume faces for each element. More...
 
class  FaceCenteredStaggeredFVGridGeometry< GV, false, Traits >
 Base class for the finite volume geometry vector for face-centered staggered models This builds up the sub control volumes and sub control volume faces for each element. Specialization in case the FVElementGeometries are stored. More...
 
class  FaceCenteredStaggeredFVGridGeometry< GV, true, Traits >
 Base class for the finite volume geometry vector for staggered models This builds up the sub control volumes and sub control volume faces for each element. Specialization in case the FVElementGeometries are stored. More...
 
class  FaceCenteredStaggeredGeometryHelper
 Face centered staggered geometry helper. More...
 
class  FaceCenteredStaggeredGridFluxVariablesCache
 Flux variable caches on a gridview. More...
 
class  FaceCenteredStaggeredGridFluxVariablesCache< P, FVC, FVCF, false, Traits >
 Flux variable caches on a gridview with grid caching disabled. More...
 
class  FaceCenteredStaggeredGridFluxVariablesCache< P, FVC, FVCF, true, Traits >
 Flux variable caches on a gridview with grid caching enabled. More...
 
class  FaceCenteredStaggeredGridVolumeVariables
 Base class for the grid volume variables. More...
 
class  FaceCenteredStaggeredGridVolumeVariables< Traits, false >
 Specialization when the current volume variables are not stored globally. More...
 
class  FaceCenteredStaggeredGridVolumeVariables< Traits, true >
 specialization in case of storing the volume variables More...
 
class  FaceCenteredStaggeredSubControlVolume
 Face centered staggered sub control volume. More...
 
class  FaceCenteredStaggeredSubControlVolumeFace
 Face centered staggered sub control volume face. More...
 
class  FaceFVGridGeometry
 Face specific auxiliary FvGridGeometry classes. Required for the Dumux multi-domain framework. More...
 
class  FaceGridVariablesView
 Face specific auxiliary GridVariables classes. Required for the Dumux multi-domain framework. More...
 
class  FacetCouplingEmbeddings
 Contains the embeddings between grids with codimension one among the grid hierarchy. All these embedments are given in insertion indices as they are read directly from the grid. Therefore, this class furthermore allows access to the insertion indices of entities. Additionally, it gives access to the grid views of the different grids on the hierarchy. More...
 
class  FacetCouplingGmshReader
 Reads gmsh files where (n-1)-dimensional grids are defined on the faces or edges of n-dimensional grids. More...
 
class  FacetCouplingGridDataWrapper
 Grid data object to store element and boundary segment markers for all grids of the hierarchy. More...
 
class  FacetCouplingGridManager
 Creates the grids in the context of hybrid-dimensional coupled models, where the (n-1)-dimensional domains live on the element facets of the n-dimensional domains. More...
 
class  FacetCouplingManager
 Implementation for the coupling manager between two domains of dimension d and (d-1) for models considering coupling across the bulk domain element facets. The implementations are specificto the discretization method used in the bulk domain, which is extracted automatically from the grid geometry corresponding to the provided bulk domain id. Implementations for the different methods have to be provided and included at the end of this file. More...
 
class  FacetCouplingManager< MDTraits, CouplingMapper, bulkDomainId, lowDimDomainId, DiscretizationMethods::Box >
 Manages the coupling between bulk elements and lower dimensional elements where the coupling occurs across the facets of the bulk grid. This implementation is to be used in conjunction with models using the box scheme in the bulk domain. More...
 
class  FacetCouplingManager< MDTraits, CouplingMapper, bulkDomainId, lowDimDomainId, DiscretizationMethods::CCMpfa >
 Manages the coupling between bulk elements and lower dimensional elements where the coupling occurs across the facets of the bulk grid. This implementation is to be used in conjunction with models using the cell-centered mpfa scheme. More...
 
class  FacetCouplingManager< MDTraits, CouplingMapper, bulkDomainId, lowDimDomainId, DiscretizationMethods::CCTpfa >
 Manages the coupling between bulk elements and lower dimensional elements where the coupling occurs across the facets of the bulk grid. This implementation is to be used in conjunction with models using the cell-centered tpfa scheme. More...
 
class  FacetCouplingMapper
 Implementation for the coupling mapper that sets up and stores the coupling maps between two domains of dimension d and (d-1). The implementations are specific to the discretization method used in the bulk domain, which is extracted automatically from the bulk grid geometry. Implementations for the different methods have to be provided and included at the end of this file. More...
 
class  FacetCouplingMapper< BulkFVG, LowDimFVG, bulkId, lowDimId, DiscretizationMethods::Box >
 Base class for the coupling mapper that sets up and stores the coupling maps between two domains of dimension d and (d-1). This specialization is for the bulk domain using the box scheme. More...
 
class  FacetCouplingMapper< BulkFVG, LowDimFVG, bulkId, lowDimId, DiscretizationMethods::CCMpfa >
 Base class for the coupling mapper that sets up and stores the coupling maps between two domains of dimension d and (d-1). This specialization is for the bulk domain using the cell-centered scheme with multi-point flux approximation. More...
 
class  FacetCouplingMapper< BulkFVG, LowDimFVG, bulkId, lowDimId, DiscretizationMethods::CCTpfa >
 Base class for the coupling mapper that sets up and stores the coupling maps between two domains of dimension d and (d-1). This specialization is for the bulk domain using the cell-centered scheme with two-point flux approximation. More...
 
class  FacetCouplingMapperBase
 Base class for the coupling mapper that sets up and stores the coupling maps between two domains of dimension d and (d-1). More...
 
class  FacetCouplingThreeDomainManager
 Class that handles the coupling between three sub-domains in models where the coupling between the two occurs across the facets of the d- and (d-1)- dimensional domains. More...
 
class  FacetCouplingThreeDomainMapper
 Specialization of the mapper class for the case of three domains with the grid dimensions d, (d-1) & (d-2). More...
 
class  FCDiamondFreeFlowCouplingManager
 The interface of the coupling manager for free flow systems. More...
 
struct  FCDiamondMLGeometryTraits
 Traits for an efficient corner storage for fc diamond method. More...
 
class  FCStaggeredFreeFlowCouplingManager
 The interface of the coupling manager for free flow systems. More...
 
class  FEElementGeometry
 Grid geometry local view, which is a wrapper around a finite element basis local view. More...
 
class  FEGridGeometry
 The grid geometry class for models using finite element schemes. This is basically a wrapper around a function space basis. More...
 
class  FickianDiffusionCoefficients
 Container storing the diffusion coefficients required by Fick's law. Uses the minimal possible container size and provides unified access. More...
 
class  FicksLawImplementation
 forward declaration of the method-specific implementation More...
 
class  FicksLawImplementation< TypeTag, DiscretizationMethods::Box, referenceSystem >
 Specialization of Fick's Law for the box method. More...
 
class  FicksLawImplementation< TypeTag, DiscretizationMethods::CCMpfa, referenceSystem >
 Fick's law for cell-centered finite volume schemes with multi-point flux approximation. More...
 
class  FicksLawImplementation< TypeTag, DiscretizationMethods::CCTpfa, referenceSystem >
 Fick's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  FicksLawImplementation< TypeTag, DiscretizationMethods::Staggered, referenceSystem >
 Specialization of Fick's Law for the staggered free flow method. More...
 
struct  FluidMatrixInteraction
 Wrapper type to combine an arbitrary number of different laws for fluid-matrix interaction (e.g., pc-Sw-curves). More...
 
class  FluidSolidInterfacialAreaShiWang
 Description of a interfacial area between solid and fluid phase. More...
 
class  FluidStateAdapter
 Adapter class for fluid states with different indices. More...
 
class  FluxOverAxisAlignedSurface
 Class used to calculate fluxes over axis-aligned surfaces. More...
 
class  FluxOverSurface
 Class used to calculate fluxes over surfaces. This only works for the staggered grid discretization. More...
 
class  FluxStencil
 The flux stencil specialized for different discretization schemes. More...
 
class  FluxStencil< FVElementGeometry, DiscretizationMethods::CCMpfa >
 
class  FluxStencil< FVElementGeometry, DiscretizationMethods::CCTpfa >
 
struct  FluxTraits
 Traits of a flux variables type. More...
 
class  FluxVariablesBase
 Base class for the flux variables living on a sub control volume face. More...
 
class  ForchheimersLawImplementation
 forward declare More...
 
class  ForchheimersLawImplementation< TypeTag, ForchheimerVelocity, DiscretizationMethods::Box >
 Forchheimer's law for box scheme. More...
 
class  ForchheimersLawImplementation< TypeTag, ForchheimerVelocity, DiscretizationMethods::CCTpfa >
 Forchheimer's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  ForchheimerVelocity
 Forchheimer's law For a detailed description see dumux/flow/forchheimerslaw.hh. More...
 
class  FouriersLawImplementation
 forward declaration of the method-specific implementation More...
 
class  FouriersLawImplementation< TypeTag, DiscretizationMethods::Box >
 Specialization of Fourier's Law for the box method. More...
 
class  FouriersLawImplementation< TypeTag, DiscretizationMethods::CCMpfa >
 Fourier's law for cell-centered finite volume schemes with multi-point flux approximation. More...
 
class  FouriersLawImplementation< TypeTag, DiscretizationMethods::CCTpfa >
 Fourier's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  FouriersLawImplementation< TypeTag, DiscretizationMethods::Staggered >
 Specialization of Fourier's Law for the staggered free flow method. More...
 
class  FouriersLawNonEquilibriumImplementation
 
class  FouriersLawNonEquilibriumImplementation< TypeTag, DiscretizationMethods::Box >
 Specialization of Fourier's Law for the box method for thermal nonequilibrium models. More...
 
class  FouriersLawNonEquilibriumImplementation< TypeTag, DiscretizationMethods::CCTpfa >
 Fourier's law for cell-centered finite volume schemes with two-point flux approximation. More...
 
class  FreeFlowDefaultSpatialParams
 Definition of the spatial parameters for the freeflow problems. More...
 
class  FreeFlowEnergyLocalResidualImplementation
 
class  FreeFlowEnergyLocalResidualImplementation< GridGeometry, FluxVariables, DiscretizationMethod, false, isCompositional >
 Specialization for isothermal models, does nothing. More...
 
class  FreeFlowEnergyLocalResidualImplementation< GridGeometry, FluxVariables, DiscretizationMethods::Staggered, true, false >
 Specialization for staggered one-phase, non-isothermal models. More...
 
class  FreeFlowEnergyLocalResidualImplementation< GridGeometry, FluxVariables, DiscretizationMethods::Staggered, true, true >
 Specialization for staggered compositional, non-isothermal models. More...
 
class  FreeFlowMassPoreNetworkCouplingManager
 Coupling manager for free-flow mass and pore-network models. More...
 
class  FreeFlowMassPorousMediumCouplingManager
 Coupling manager for Stokes and Darcy domains with equal dimension. More...
 
class  FreeFlowMomentumPoreNetworkCouplingManager
 Coupling manager for free-flow momentum and pore-network models. More...
 
class  FreeFlowMomentumPorousMediumCouplingManager
 Coupling manager for Stokes and Darcy domains with equal dimension. More...
 
class  FreeFlowMomentumPorousMediumCouplingMapper
 the default mapper for conforming equal dimension boundary coupling between two domains (box or cc) More...
 
class  FreeflowNCFluxVariablesImpl
 The flux variables class for the multi-component free-flow model using the staggered grid discretization. More...
 
class  FreeflowNCFluxVariablesImpl< TypeTag, DiscretizationMethods::Staggered >
 
struct  FreeflowNCIOFields
 Adds I/O fields specific to the FreeflowNC model. More...
 
class  FreeflowNCResidualImpl
 Element-wise calculation of the multi-component free-flow residual for models using the staggered discretization. More...
 
class  FreeflowNCResidualImpl< TypeTag, DiscretizationMethods::Staggered >
 
class  FreeflowNCVolumeVariables
 Volume variables for the single-phase, multi-component free-flow model. More...
 
struct  FreeflowNIModelTraits
 Specifies a number properties of non-isothermal free-flow flow models based on the specifics of a given isothermal model. More...
 
class  FreeflowNonIsothermalIndices
 Indices for the non-isothermal Navier-Stokes model. More...
 
struct  FreeflowNonIsothermalIOFields
 Adds I/O fields specific to non-isothermal free-flow models. More...
 
class  FreeFlowPoreNetworkCouplingConditionsImplementation
 
class  FreeFlowPoreNetworkCouplingConditionsImplementation< MDTraits, CouplingManager, enableEnergyBalance, false >
 Coupling conditions specialization for non-compositional models. More...
 
class  FreeFlowPoreNetworkCouplingConditionsImplementationBase
 A base class which provides some common methods used for free-flow/pore-network coupling. More...
 
class  FreeFlowPoreNetworkCouplingManager
 Coupling manager for coupling freeflow and pore-network models. More...
 
class  FreeFlowPorousMediumCouplingConditionsImplementation
 
class  FreeFlowPorousMediumCouplingConditionsImplementation< MDTraits, CouplingManager, enableEnergyBalance, false >
 Coupling data specialization for non-compositional models. More...
 
class  FreeFlowPorousMediumCouplingConditionsImplementationBase
 A base class which provides some common methods used for Stokes-Darcy coupling. More...
 
class  FreeFlowPorousMediumCouplingManager
 Coupling manager for coupling freeflow and porous medium flow models. More...
 
struct  FreeFlowPorousMediumCouplingOptions
 This structs holds a set of options which allow to modify the Stokes-Darcy coupling mechanism during runtime. More...
 
class  FreeFlowScalarFluxVariablesCacheFillerImplementation
 
class  FreeFlowScalarFluxVariablesCacheFillerImplementation< Problem, ModelTraits, diffusionIsSolDependent, heatConductionIsSolDependent, DiscretizationMethods::CCTpfa >
 Specialization of the flux variables cache filler for the cell centered tpfa method. More...
 
class  FreeFlowSpatialParams
 Definition of the spatial parameters for the freeflow problems. More...
 
struct  FreeFlowStaggeredDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the free-flow staggered finite volume scheme. More...
 
class  FreeFlowStaggeredGeometryHelper
 Helper class constructing the dual grid finite volume geometries for the free flow staggered discretization method. More...
 
class  FreeflowStaggeredSCV
 
class  FreeflowStaggeredSCVF
 
class  FreeFlowStaggeredSubControlVolumeFace
 Class for a sub control volume face in the staggered method, i.e a part of the boundary of a sub control volume we compute fluxes on. This is a specialization for free flow models. More...
 
class  FreeFlowVolumeVariablesImplementation
 
class  FreeFlowVolumeVariablesImplementation< Traits, Impl, false >
 Volume variables for isothermal free-flow models. More...
 
class  FreeFlowVolumeVariablesImplementation< Traits, Impl, true >
 Volume variables for the non-isothermal free-flow models. More...
 
class  FrictionLaw
 Implementation of the abstract base class for friction laws. More...
 
class  FrictionLawManning
 Implementation of the friction law after Manning. More...
 
class  FrictionLawNikuradse
 Implementation of the friction law after Nikuradse. More...
 
class  FrictionLawNoFriction
 A pseudo friction law with no bottom friction. More...
 
class  FullDispersionTensor
 Full dispersion tensor. More...
 
class  FVAssembler
 A linear system assembler (residual and Jacobian) for finite volume schemes (box, tpfa, mpfa, ...) More...
 
class  FVElasticSpatialParams
 The base class for spatial parameters of linear elastic geomechanical problems. More...
 
class  FVGridVariables
 The grid variable class for finite volume schemes storing variables on scv and scvf (volume and flux variables) More...
 
class  FVLocalAssemblerBase
 A base class for all local assemblers. More...
 
class  FVLocalResidual
 The element-wise residual for finite volume schemes. More...
 
class  FVPoroElasticSpatialParams
 The base class for spatial parameters of poro-elastic geomechanical problems. More...
 
class  FVPorousMediumFlowSpatialParams
 The base class for spatial parameters of porous-medium-flow problems. More...
 
class  FVPorousMediumFlowSpatialParamsMP
 The base class for spatial parameters of multi-phase problems. More...
 
class  FVPorousMediumFlowSpatialParamsNonEquilibrium
 Definition of the spatial parameters for non-equilibrium. More...
 
class  FVPorousMediumFlowSpatialParamsOneP
 The base class for spatial parameters of single-phase problems. More...
 
class  FVPorousMediumFlowSpatialParamsOnePConstant
 A spatial params implementation for 1p problem with constant properties. More...
 
class  FVPorousMediumSpatialParams
 The base class for spatial parameters of porous-medium problems. More...
 
class  FVProblem
 Base class for all finite-volume problems. More...
 
class  FVProblemWithSpatialParams
 Base class for all finite-volume problems using spatial parameters. More...
 
class  FVSpatialParams
 The base class for spatial parameters used with finite-volume schemes. More...
 
class  GeomechanicsFVProblem
 Base class for all geomechanical problems. More...
 
class  GeomechanicsVelocityOutput
 Velocity output for geomechanical models. This class could be used to compute the temporal derivative of the displacement. Currently this is not implemented and we simply define this here in order to be able to reuse the VtkOutputModule which expects a VelocityOutput class. More...
 
class  GeometriesEntitySet
 An interface for a set of geometric entities. More...
 
class  GeometryIntersection
 A class for geometry collision detection and intersection calculation The class can be specialized for combinations of dimworld, dim1, dim2, where dimworld is the world dimension embedding a grid of dim1 and a grid of dim2. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 2, 1, 1 >
 A class for segment–segment intersection in 2d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 2, 1, 2 >
 A class for segment–polygon intersection in 2d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 2, 2, 1 >
 A class for polygon–segment intersection in 2d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 2, 2, 2 >
 A class for polygon–polygon intersection in 2d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 1, 1 >
 A class for segment–segment intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 1, 2 >
 A class for segment–polygon intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 1, 3 >
 A class for segment–polyhedron intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 2, 1 >
 A class for polygon–segment intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 2, 2 >
 A class for polygon–polygon intersections in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 2, 3 >
 A class for polygon–polyhedron intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 3, 1 >
 A class for polyhedron–segment intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 3, 2 >
 A class for polyhedron–polygon intersection in 3d space. More...
 
class  GeometryIntersection< Geometry1, Geometry2, Policy, 3, 3, 3 >
 A class for polyhedron–polyhedron intersection in 3d space. More...
 
struct  GmshGridDataHandle
 A data handle for commucating grid data for gmsh grids. More...
 
class  GnuplotInterface
 Interface for passing data sets to a file and plotting them, if gnuplot is installed. More...
 
class  GridAdaptInitializationIndicator
 Class defining an initialization indicator for grid adaption. Refines at sources and boundaries. Use before computing on the grid. More...
 
class  GridData
 Class for grid data attached to dgf or gmsh grid files. More...
 
class  GridDataTransfer
 Interface to be used by classes transferring grid data on adaptive grids. More...
 
class  GridGeometryView
 Base class for cell center of face specific auxiliary FvGridGeometry classes. Provides a common interface and a pointer to the actual gridGeometry. More...
 
class  GridManager
 The grid manager (this is the class used by the user) for all supported grid managers that constructs a grid from information in the input file and handles the data. More...
 
class  GridManager< Dune::OneDGrid >
 Provides a grid manager for OneDGrids from information in the input file. More...
 
class  GridManager< Dune::YaspGrid< dim, Coordinates > >
 Provides a grid manager for YaspGrids from information in the input file. More...
 
class  GridManager< Dune::YaspGrid< dim, Dune::TensorProductCoordinates< ctype, dim > > >
 Provides a grid manager for YaspGrids with different zones and grading. More...
 
class  GridManagerBase
 The grid manager base interface (public) and methods common to most grid manager specializations (protected). More...
 
struct  GridSupportsConcaveCorners
 Type trait to determine if a grid supports concave corners (e.g. by cutting out a hole from the domain interior) More...
 
struct  GridSupportsConcaveCorners< Dune::YaspGrid< dim, Coords > >
 
class  GridViewGeometricEntitySet
 An interface for a set of geometric entities based on a GridView. More...
 
class  GSBiCGSTABBackend
 Sequential GS-preconditioned BiCGSTAB solver. More...
 
class  GSCGBackend
 Sequential GS-preconditioned CG solver. More...
 
class  GstatRandomField
 Creating random fields using gstat. More...
 
struct  HasStationaryVelocityField
 Trait of an advection type stating whether it implements a stationary velocity field. More...
 
struct  HasStationaryVelocityField< StationaryVelocityField< Scalar > >
 Set stationary velocity field to true in the FluxTraits. More...
 
struct  hasVertexColor
 helper struct to determine whether the an engine class has vertex colors More...
 
class  HeatConductionDataHandle
 Data handle for quantities related to heat conduction. More...
 
class  HeatConductionDataHandle< MatVecTraits, PhysicsTraits, false >
 
class  HookesLaw
 This computes the stress tensor and surface forces resulting from mechanical deformation. More...
 
class  HookesLaw< ScalarType, GridGeometry, typename GridGeometry::DiscretizationMethod >
 Hooke's law for box scheme. More...
 
class  IdealGas
 Relations valid for an ideal gas. More...
 
class  IdPointSource
 A point source class with an identifier to attach data. More...
 
class  ILU0BiCGSTABBackend
 Sequential ILU(0)-preconditioned BiCGSTAB solver. More...
 
class  ILU0CGBackend
 Sequential ILU(0)-preconditioned CG solver. More...
 
class  ILU0RestartedGMResBackend
 Sequential ILU0-preconditioned GMRes solver. More...
 
class  ILUnBiCGSTABBackend
 Sequential ILU(n)-preconditioned BiCSTAB solver. More...
 
class  ILUnCGBackend
 Sequential ILU(n)-preconditioned CG solver. More...
 
class  ILUnRestartedGMResBackend
 Sequential ILU(n)-preconditioned GMRes solver. More...
 
class  ImmiscibleFlash
 Determines the pressures and saturations of all fluid phases given the total mass of all components. More...
 
class  ImmiscibleFluidState
 Represents all relevant thermodynamic quantities of a multi-phase fluid system assuming immiscibility and thermodynamic equilibrium. More...
 
class  ImmiscibleLocalResidual
 Element-wise calculation of the residual for problems using the n-phase immiscible fully implicit models. More...
 
struct  IndexHelper
 Helper struct to choose the correct index for phases and components. This is need if the porous-medium-flow model features more fluid phases than the free-flow model. More...
 
struct  IndexHelper< stokesIdx, darcyIdx, FFFS, false >
 Helper struct to choose the correct index for phases and components. This is need if the porous-medium-flow model features more fluid phases than the free-flow model. Specialization for the case that no adapter is used. More...
 
struct  IndexHelper< stokesIdx, darcyIdx, FFFS, true >
 Helper struct to choose the correct index for phases and components. This is need if the porous-medium-flow model features more fluid phases than the free-flow model. Specialization for the case that a adapter is used. More...
 
struct  IndexTraits
 Structure to define the index types used for grid and local indices. More...
 
class  InertSolidState
 Represents all relevant thermodynamic quantities of a inert solid system. More...
 
class  IntegrationPointSource
 An integration point source class with an identifier to attach data and a quadrature weight and integration element. More...
 
class  IntegrationPointSourceHelper
 A helper class calculating a DOF-index to point source map. More...
 
class  InteractionVolumeAssemblerBase
 Defines the general interface of the local assembler classes for the assembly of the interaction volume-local transmissibility matrix. Specializations have to be provided for the available interaction volume implementations. these should derive from this base class. More...
 
class  InteractionVolumeAssemblerHelper
 A class that contains helper functions as well as functionality which is common to different mpfa schemes and which solely operate on the interaction volume. More...
 
class  InteractionVolumeDataHandle
 Class for the interaction volume data handle. More...
 
struct  InteractionVolumeDataStorage
 Structure to store interaction volumes and data handles. More...
 
class  InteractionVolumeLocalFaceData
 General implementation of a data structure holding interaction volume-local information for a grid sub-control volume face embedded in it. More...
 
class  IntersectionEntitySet
 A class representing the intersection entities two geometric entity sets. More...
 
class  IntersectionInfo
 An intersection object resulting from the intersection of two primitives in an entity set. More...
 
class  IntersectionMapper
 defines an intersection mapper for mapping of global DOFs assigned to faces which also works for adaptive grids. More...
 
struct  isBCRSMatrix
 Helper type to determine whether a given type is a Dune::BCRSMatrix. More...
 
struct  isBCRSMatrix< Dune::BCRSMatrix< B, A > >
 
struct  IsFicksLaw
 This structs indicates that Fick's law is not used for diffusion. More...
 
struct  IsFicksLaw< FicksLawImplementation< T, DiscretizationMethod, referenceSystem > >
 This structs indicates that Fick's law is used for diffusion. More...
 
struct  isMultiTypeBlockMatrix
 Helper type to determine whether a given type is a Dune::MultiTypeBlockMatrix. More...
 
struct  isMultiTypeBlockMatrix< Dune::MultiTypeBlockMatrix< Args... > >
 
struct  isMultiTypeBlockVector
 Helper type to determine whether a given type is a Dune::MultiTypeBlockVector. More...
 
struct  isMultiTypeBlockVector< Dune::MultiTypeBlockVector< T... > >
 Helper type to determine whether a given type is a Dune::MultiTypeBlockVector. More...
 
class  IsothermalImmiscibleFluidState
 Represents all relevant thermodynamic quantities of a multi-phase fluid system assuming immiscibility and thermodynamic equilibrium. More...
 
struct  IsSameFluidSystem
 This structs helps to check if the two sub models use the same fluidsystem. Specialization for the case of using an adapter only for the free-flow model. More...
 
struct  IsSameFluidSystem< FS, FS >
 This structs helps to check if the two sub models use the same fluidsystem. More...
 
class  IstlSolverFactoryBackend
 A linear solver using the dune-istl solver factory to choose the solver and preconditioner at runtime. More...
 
class  IterativePreconditionedSolverImpl
 A general solver backend allowing arbitrary preconditioners and solvers. More...
 
struct  IvDataHandlePhysicsTraits
 Data handle physics traits. More...
 
class  JacBiCGSTABBackend
 Sequential Jacobi-preconditioned BiCSTAB solver. More...
 
class  JacCGBackend
 Sequential Jacobi-preconditioned CG solver. More...
 
class  KEpsilonFluxVariablesImpl
 The flux variables class for the k-epsilon model using the staggered grid discretization. More...
 
class  KEpsilonFluxVariablesImpl< TypeTag, BaseFluxVariables, DiscretizationMethods::Staggered >
 
struct  KEpsilonIOFields
 Adds I/O fields for the k-epsilon turbulence model. More...
 
class  KEpsilonResidualImpl
 Element-wise calculation of the residual for k-epsilon models using the staggered discretization. More...
 
class  KEpsilonResidualImpl< TypeTag, BaseLocalResidual, DiscretizationMethods::Staggered >
 
class  KEpsilonVolumeVariables
 Volume variables for the isothermal single-phase k-epsilon model. More...
 
class  KOmegaFluxVariablesImpl
 The flux variables class for the k-omega model using the staggered grid discretization. More...
 
class  KOmegaFluxVariablesImpl< TypeTag, BaseFluxVariables, DiscretizationMethods::Staggered >
 
struct  KOmegaIOFields
 Adds I/O fields for the Reynolds-Averaged Navier-Stokes model. More...
 
class  KOmegaResidualImpl
 Element-wise calculation of the residual for k-omega models using the staggered discretization. More...
 
class  KOmegaResidualImpl< TypeTag, BaseLocalResidual, DiscretizationMethods::Staggered >
 
class  KOmegaVolumeVariables
 Volume variables for the isothermal single-phase k-omega 2-Eq model. More...
 
struct  LameParams
 Structure encapsulating the lame parameters. More...
 
class  LinearPDESolver
 An implementation of a linear PDE solver. More...
 
class  LinearSolver
 Base class for linear solvers. More...
 
struct  linearSolverAcceptsMultiTypeMatrix
 The default. More...
 
struct  linearSolverAcceptsMultiTypeMatrix< ILU0BiCGSTABBackend >
 
struct  linearSolverAcceptsMultiTypeMatrix< ILU0CGBackend >
 
struct  linearSolverAcceptsMultiTypeMatrix< ILU0RestartedGMResBackend >
 
struct  linearSolverAcceptsMultiTypeMatrix< ILUnBiCGSTABBackend >
 
struct  linearSolverAcceptsMultiTypeMatrix< ILUnCGBackend >
 
struct  linearSolverAcceptsMultiTypeMatrix< ILUnRestartedGMResBackend >
 
class  LinearSolverParameters
 Generates a parameter tree required for the linear solvers and precondioners of the Dune ISTL. More...
 
struct  LinearSolverTraitsBase
 
struct  LinearSolverTraitsImpl
 The implementation is specialized for the different discretizations. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::Box >
 Box: use overlapping or non-overlapping model depending on the grid. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::CCMpfa >
 Cell-centered mpfa: use overlapping model. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::CCTpfa >
 Cell-centered tpfa: use overlapping model. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::FCDiamond >
 Face-centered diamond scheme: use overlapping or non-overlapping model depending on the grid. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::FCStaggered >
 Face-centered staggered: use overlapping model. More...
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::PQ1Bubble >
 
struct  LinearSolverTraitsImpl< GridGeometry, DiscretizationMethods::Staggered >
 staggered: use overlapping model More...
 
class  LoadSolutionDataHandle
 a data handle to communicate the solution on ghosts and overlaps when reading from vtk file in parallel More...
 
class  LocalRefinementSimplexQuadrature
 A quadrature rule using local refinement to approximate partitioned elements. More...
 
class  LoggingParameterTree
 A parameter tree that logs which parameters have been used. More...
 
class  LowReKEpsilonFluxVariablesImpl
 The flux variables class for the low-Reynolds k-epsilon model using the staggered grid discretization. More...
 
class  LowReKEpsilonFluxVariablesImpl< TypeTag, BaseFluxVariables, DiscretizationMethods::Staggered >
 
struct  LowReKEpsilonIOFields
 Adds I/O fields for the low-Re k-epsilon turbulence model. More...
 
class  LowReKEpsilonResidualImpl
 Element-wise calculation of the residual for low-Reynolds k-epsilon models using the staggered discretization. More...
 
class  LowReKEpsilonResidualImpl< TypeTag, BaseLocalResidual, DiscretizationMethods::Staggered >
 
class  LowReKEpsilonVolumeVariables
 Volume variables for the isothermal single-phase low-Re k-epsilons model. More...
 
struct  makeFromIndexedType
 
struct  makeFromIndexedType< Variadic, Indexed, std::index_sequence< IndexSeq... > >
 
class  MatrixConverter
 A helper class that converts a Dune::MultiTypeBlockMatrix into a plain Dune::BCRSMatrix TODO: allow block sizes for BCRSMatrix other than 1x1 ? More...
 
class  MaxwellStefanDiffusionCoefficients
 Container storing the diffusion coefficients required by the Maxwell- Stefan diffusion law. Uses the minimal possible container size and provides unified access. More...
 
class  MaxwellStefansLawImplementation
 
class  MaxwellStefansLawImplementation< TypeTag, DiscretizationMethods::Box, referenceSystem >
 Specialization of Maxwell Stefan's Law for the Box method. More...
 
class  MaxwellStefansLawImplementation< TypeTag, DiscretizationMethods::CCTpfa, referenceSystem >
 Specialization of Maxwell Stefan's Law for the CCTpfa method. More...
 
class  MaxwellStefansLawImplementation< TypeTag, DiscretizationMethods::Staggered, referenceSystem >
 Specialization of Maxwell Stefan's Law for the Staggered method. More...
 
class  MineralizationIOFields
 Adds I/O fields specific to a NCMin model. More...
 
class  MineralizationLocalResidual
 Element-wise calculation of the local residual for problems using a one/two-phase n-component mineralization model. More...
 
struct  MineralizationModelTraits
 Specifies a number properties of models that consider mineralization processes. More...
 
class  MineralizationVolumeVariables
 Contains the quantities which are are constant within a sub-control volume of the finite volume grid in an m-phase, n-component, mineralization model. More...
 
class  MiscibleMultiPhaseComposition
 Computes the composition of all phases of a N-phase, N-component fluid system assuming that all N phases are present. More...
 
class  MonotoneCubicSpline
 A monotone cubic spline. More...
 
class  MpfaDimensionHelper
 Dimension-specific helper class to get data required for mpfa scheme. More...
 
class  MpfaDimensionHelper< GridGeometry, 2, 2 >
 Dimension-specific mpfa helper class for dim == 2 & dimWorld == 2. More...
 
class  MpfaDimensionHelper< GridGeometry, 2, 3 >
 Dimension-specific mpfa helper class for dim == 2 & dimWorld == 3. Reuses some functionality of the specialization for dim = dimWorld = 2. More...
 
class  MpfaDimensionHelper< GridGeometry, 3, 3 >
 Dimension-specific mpfa helper class for dim == 3 & dimWorld == 3. More...
 
class  MpfaOFacetCouplingInteractionVolumeAssembler
 Specialization of the interaction volume-local assembler class for the schemes using an mpfa-o type assembly in the context of facet coupling. More...
 
class  MpfaOInteractionVolumeAssembler
 Specialization of the interaction volume-local assembler class for the schemes using an mpfa-o type assembly. More...
 
struct  MPNCIndices
 The primary variable and equation indices for the MpNc model. More...
 
class  MPNCInitialConditionHelper
 
class  MPNCIOFields
 Adds I/O fields specific to the mpnc model. More...
 
class  MPNCLocalResidual
 MpNc specific details needed to approximately calculate the local defect in the fully implicit scheme. More...
 
struct  MPNCModelTraits
 Specifies a number properties of the m-phase n-component model. More...
 
struct  MPNCNonequilibriumModelTraits
 Specifies a number properties of the m-phase n-component model in conjunction with non-equilibrium. This is necessary because the mpnc indices are affected by the non-equilibrium which can thus not be plugged on top of it that easily. More...
 
class  MPNCVolumeVariablesImplementation
 
class  MPNCVolumeVariablesImplementation< Traits, false >
 
class  MPNCVolumeVariablesImplementation< Traits, true >
 
struct  MPNCVolumeVariablesTraits
 Traits class for the mpnc volume variables. More...
 
class  MultiBinaryCouplingManager
 Coupling manager that combines an arbitrary number of binary coupling manager (coupling two domains each) More...
 
class  MultiDomainFVAssembler
 A linear system assembler (residual and Jacobian) for finite volume schemes (box, tpfa, mpfa, ...) with multiple domains. More...
 
class  MultiDomainFVGridGeometry
 A multidomain wrapper for multiple grid geometries. More...
 
class  MultiDomainFVGridVariables
 A multidomain wrapper for multiple grid variables. More...
 
class  MultiDomainFVProblem
 A multidomain wrapper for multiple problems. More...
 
class  MultiDomainNewtonConvergenceWriter
 Writes the intermediate solutions for every Newton iteration. More...
 
class  MultiDomainNewtonSolver
 Newton solver for coupled problems. More...
 
struct  MultiDomainTraits
 
class  MultiDomainVtkOutputModule
 A multidomain wrapper for multiple vtk output modules. More...
 
class  NavierStokesBoundaryTypes
 Class to specify the type of a boundary condition for the Navier-Stokes model. More...
 
class  NavierStokesEnergyIndices
 Indices for the non-isothermal Navier-Stokes model. More...
 
struct  NavierStokesEnergyIOFields
 Adds I/O fields specific to non-isothermal free-flow models. More...
 
struct  NavierStokesEnergyModelTraits
 Specifies a number properties of non-isothermal free-flow flow models based on the specifics of a given isothermal model. More...
 
class  NavierStokesEnergyVolumeVariables
 The isothermal base class. More...
 
class  NavierStokesFluxVariablesImpl
 The flux variables class for the Navier-Stokes model using the staggered grid discretization. More...
 
class  NavierStokesFluxVariablesImpl< TypeTag, DiscretizationMethods::Staggered >
 
struct  NavierStokesIndices
 The common indices for the isothermal Navier-Stokes model. More...
 
class  NavierStokesIOFields
 Adds I/O fields for the Navier-Stokes model. More...
 
class  NavierStokesMassOnePFluxVariables
 The flux variables class for the single-phase flow Navier-Stokes model. More...
 
struct  NavierStokesMassOnePIndices
 The common indices for the isothermal Navier-Stokes mass conservation model. More...
 
class  NavierStokesMassOnePLocalResidual
 Element-wise calculation of the Navier-Stokes residual for single-phase flow. More...
 
struct  NavierStokesMassOnePModelTraits
 Traits for the single-phase flow Navier-Stokes mass model. More...
 
class  NavierStokesMassOnePVolumeVariables
 Volume variables for the single-phase Navier-Stokes model. More...
 
struct  NavierStokesMassOnePVolumeVariablesTraits
 Traits class for the volume variables of the Navier-Stokes model. More...
 
class  NavierStokesMassProblemImpl
 
struct  NavierStokesModelTraits
 Traits for the Navier-Stokes model. More...
 
struct  NavierStokesMomentumBoundaryFluxHelper
 Struct containing flux helper functions to be used in the momentum problem's Neumann function. More...
 
class  NavierStokesMomentumBoundaryTypes
 Class to specify the type of a boundary condition for the Navier-Stokes model. More...
 
struct  NavierStokesMomentumDiamondIndices
 The common indices for the isothermal Navier-Stokes model. More...
 
struct  NavierStokesMomentumDiamondModelTraits
 Traits for the Navier-Stokes model. More...
 
class  NavierStokesMomentumDiamondResidual
 Element-wise calculation of the Navier-Stokes residual for models using the diamond discretization. More...
 
class  NavierStokesMomentumDiamondVolumeVariables
 Volume variables for the single-phase Navier-Stokes model. More...
 
struct  NavierStokesMomentumDiamondVolumeVariablesTraits
 Traits class for the volume variables of the Navier-Stokes model. More...
 
class  NavierStokesMomentumFluxContext
 Context for computing fluxes. More...
 
class  NavierStokesMomentumFluxCVFE
 The flux variables class for the Navier-Stokes model using control-volume finite element schemes. More...
 
class  NavierStokesMomentumFluxVariables
 The flux variables class for the Navier-Stokes model using the staggered grid discretization. More...
 
struct  NavierStokesMomentumIndices
 The common indices for the isothermal Navier-Stokes model. More...
 
struct  NavierStokesMomentumModelTraits
 Traits for the Navier-Stokes model. More...
 
class  NavierStokesMomentumPQ1BubbleLocalResidual
 Element-wise calculation of the Navier-Stokes residual for models using the pq1bubble discretization. More...
 
struct  NavierStokesMomentumPQ1BubbleModelTraits
 Traits for the Navier-Stokes model. More...
 
struct  NavierStokesMomentumPQ1BubbleVolumeVariablesTraits
 Traits class for the volume variables of the Navier-Stokes model. More...
 
class  NavierStokesMomentumProblemImpl
 
class  NavierStokesMomentumProblemImpl< TypeTag, DiscretizationMethods::CVFE< DM > >
 Navier-Stokes default problem implementation for FCDiamond discretizations. More...
 
class  NavierStokesMomentumProblemImpl< TypeTag, DiscretizationMethods::FCStaggered >
 
class  NavierStokesMomentumResidual
 Element-wise calculation of the Navier-Stokes residual for models using the staggered discretization. More...
 
class  NavierStokesMomentumVolumeVariables
 Volume variables for the single-phase Navier-Stokes model. More...
 
struct  NavierStokesMomentumVolumeVariablesTraits
 Traits class for the volume variables of the Navier-Stokes model. More...
 
struct  NavierStokesNCModelTraits
 Traits for the multi-component free-flow model. More...
 
struct  NavierStokesParentProblemImpl
 The implementation is specialized for the different discretizations. More...
 
struct  NavierStokesParentProblemImpl< TypeTag, DiscretizationMethods::Staggered >
 
class  NavierStokesProblemImpl
 
class  NavierStokesProblemImpl< TypeTag, DiscretizationMethods::CCTpfa >
 
class  NavierStokesProblemImpl< TypeTag, DiscretizationMethods::FCDiamond >
 
class  NavierStokesProblemImpl< TypeTag, DiscretizationMethods::FCStaggered >
 
class  NavierStokesProblemImpl< TypeTag, DiscretizationMethods::Staggered >
 
class  NavierStokesResidualImpl
 Element-wise calculation of the Navier-Stokes residual for models using the staggered discretization. More...
 
class  NavierStokesResidualImpl< TypeTag, DiscretizationMethods::Staggered >
 
struct  NavierStokesScalarBoundaryFluxHelper
 Navier Stokes scalar boundary flux helper. More...
 
class  NavierStokesScalarConservationModelFluxVariables
 The flux variables base class for scalar quantities balanced in the Navier-Stokes model. More...
 
class  NavierStokesScalarConservationModelVolumeVariables
 Volume variables for the single-phase Navier-Stokes model. More...
 
class  NavierStokesStaggeredProblem
 Navier-Stokes staggered problem base class. More...
 
class  NavierStokesVelocityOutput
 Velocity output for staggered free-flow models. More...
 
class  NavierStokesVolumeVariables
 Volume variables for the single-phase Navier-Stokes model. More...
 
struct  NavierStokesVolumeVariablesTraits
 Traits class for the volume variables of the Navier-Stokes model. More...
 
class  NcpFlash
 Determines the phase compositions, pressures and saturations given the total mass of all components. More...
 
class  NetPBMReader
 A simple reader class for the Netpbm format (https://en.wikipedia.org/wiki/Netpbm_format). So far, only black and white (*.pbm) and grayscale (*pgm) images are supported. More...
 
class  NewtonConvergenceWriter
 Writes the intermediate solutions for every Newton iteration. More...
 
class  NewtonSolver
 An implementation of a Newton solver. More...
 
struct  NodalIndexSetDefaultTraits
 Default traits to be used in conjunction with the dual grid nodal index set. More...
 
struct  NoExtrusion
 Default implementation that performs no extrusion (extrusion with identity) More...
 
class  NonconformingFECache
 
class  NonConformingGridIntersectionMapper
 defines an intersection mapper for mapping of global DOFs assigned to faces which also works for non-conforming grids and corner-point grids. More...
 
class  NonEquilbriumIndices
 The primary variable and equation indices for the MpNc model. More...
 
class  NonEquilibriumFluidState
 Represents all relevant thermodynamic quantities of a multi-phase, multi-component fluid system without using any assumptions. More...
 
class  NonEquilibriumGridVariables
 This class stores the velocities which are used to compute Reynolds numbers for the source terms of non-equilibrium models. More...
 
class  NonEquilibriumIOFieldsImplementation
 
class  NonEquilibriumIOFieldsImplementation< ModelTraits, EquilibriumIOFields, false >
 
class  NonEquilibriumIOFieldsImplementation< ModelTraits, EquilibriumIOFields, true >
 Adds I/O fields specific to non-equilibrium models with chemical and thermal nonequilbirum or thermal non-equilibrium only. More...
 
class  NonEquilibriumLocalResidualImplementation
 
class  NonEquilibriumLocalResidualImplementation< TypeTag, false >
 The local residual for a model without chemical non-equilibrium but potentially with thermal non-equilibrium. More...
 
class  NonEquilibriumLocalResidualImplementation< TypeTag, true >
 The local residual for a model assuming chemical non-equilibrium and potentially thermal non-equilibrium. More...
 
class  NonEquilibriumMassFluidState
 Represents all relevant thermodynamic quantities of a multi-phase, multi-component fluid system. More...
 
struct  NonEquilibriumModelTraits
 Specifies a number properties of porous-medium flow non-equilibrium models. More...
 
class  NonEquilibriumNewtonSolver
 A nonequilibrium specific newton solver. More...
 
class  NonEquilibriumVolumeVariablesImplementation
 This class contains the volume variables required for the modules which require the specific interfacial area between fluid phases. More...
 
class  NonEquilibriumVolumeVariablesImplementation< Traits, EquilibriumVolumeVariables, false, true, 1 >
 
class  NonEquilibriumVolumeVariablesImplementation< Traits, EquilibriumVolumeVariables, false, true, 2 >
 
class  NonEquilibriumVolumeVariablesImplementation< Traits, EquilibriumVolumeVariables, true, false, 0 >
 
class  NonEquilibriumVolumeVariablesImplementation< Traits, EquilibriumVolumeVariables, true, true, 2 >
 
struct  NonoverlappingSolverTraits
 
class  NoPrimaryVariableSwitch
 Empty class for models without pri var switch. More...
 
class  NullParameterCache
 The a parameter cache which does nothing. More...
 
struct  NumEqVectorTraits
 
struct  NumEqVectorTraits< Deprecated::RichardsSwitchablePrimaryVariables< PrimaryVariables, StateType > >
 The corresponding NumEqVectorTraits for the primary variables with switchable state. More...
 
struct  NumEqVectorTraits< SwitchablePrimaryVariables< PrimaryVariables, StateType > >
 The corresponding NumEqVectorTraits for the primary variables with switchable state. More...
 
class  NumericalProblem
 Exception thrown if a fixable numerical problem occurs. More...
 
class  NumericDifferentiation
 A class for numeric differentiation with respect to a scalar parameter. More...
 
class  NumericEpsilon
 A helper class for local assemblers using numeric differentiation to determine the epsilon. More...
 
class  OneEqFluxVariablesImpl
 The flux variables class for the one-equation model by Spalart-Allmaras using the staggered grid discretization. More...
 
class  OneEqFluxVariablesImpl< TypeTag, BaseFluxVariables, DiscretizationMethods::Staggered >
 
struct  OneEqIndices
 The common indices for the isothermal one-equation turbulence model by Spalart-Allmaras. More...
 
struct  OneEqIOFields
 Adds I/O fields for the one-equation turbulence model by Spalart-Allmaras. More...
 
class  OneEqResidualImpl
 Element-wise calculation of the residual for one-equation turbulence models using the staggered discretization. More...
 
class  OneEqResidualImpl< TypeTag, BaseLocalResidual, DiscretizationMethods::Staggered >
 
class  OneEqVolumeVariables
 Volume variables for the isothermal single-phase one-equation turbulence model by Spalart-Allmaras. More...
 
class  OnePIncompressibleLocalResidual
 Element-wise calculation of the residual and its derivatives for a single-phase, incompressible, test problem. More...
 
struct  OnePIndices
 Indices for the one-phase model. More...
 
class  OnePIOFields
 Adds I/O fields specific to the one phase model. More...
 
struct  OnePModelTraits
 Specifies a number properties of single-phase models. More...
 
struct  OnePNCIndices
 The indices for the isothermal one-phase n-component model. More...
 
class  OnePNCIOFields
 Adds I/O fields specific to the OnePNC model. More...
 
struct  OnePNCModelTraits
 Specifies a number properties of models that consider a single-phase with multiple components. More...
 
struct  OnePNCUnconstrainedModelTraits
 
class  OnePNCVolumeVariables
 Contains the quantities which are are constant within a finite volume in the one-phase, n-component model. More...
 
class  OnePVolumeVariables
 Contains the quantities which are constant within a sub-control volume in the one-phase model. More...
 
struct  OnePVolumeVariablesTraits
 Traits class for the volume variables of the single-phase model. More...
 
struct  OptionalScalar
 A type for an optional scalar (contains either a valid number or NaN) More...
 
struct  OverlappingSolverTraits
 
class  ParallelISTLHelper
 A parallel helper class providing a nonoverlapping decomposition of all degrees of freedom. More...
 
class  ParallelMatrixHelper
 Helper class for adding up matrix entries for border entities. More...
 
class  ParallelMultiTypeScalarProduct
 A scalar product for multi-type vectors. More...
 
class  ParallelVectorHelper
 
class  ParameterCacheBase
 The base class of the parameter cache classes for fluid systems. More...
 
class  ParameterException
 Exception thrown if a run-time parameter is not specified correctly. More...
 
class  Parameters
 Parameter class managing runtime input parameters. More...
 
class  PartialReassembler
 detects which entries in the Jacobian have to be recomputed More...
 
class  PartialReassemblerEngine
 the partial reassembler engine specialized for discretization methods More...
 
class  PartialReassemblerEngine< Assembler, DiscretizationMethods::Box >
 The partial reassembler engine specialized for the box method. More...
 
class  PartialReassemblerEngine< Assembler, DiscretizationMethods::CCMpfa >
 The partial reassembler engine specialized for the cellcentered MPFA method. More...
 
class  PartialReassemblerEngine< Assembler, DiscretizationMethods::CCTpfa >
 The partial reassembler engine specialized for the cellcentered TPFA method. More...
 
class  PDESolver
 A high-level interface for a PDESolver. More...
 
class  PengRobinson
 Implements the Peng-Robinson equation of state for liquids and gases. More...
 
class  PengRobinsonMixture
 Implements the Peng-Robinson equation of state for a mixture. More...
 
class  PengRobinsonParams
 Stores and provides access to the Peng-Robinson parameters. More...
 
class  PengRobinsonParamsMixture
 The mixing rule for the oil and the gas phases of the SPE5 problem. More...
 
class  PermeabilityKozenyCarman
 The Kozeny-Carman relationship for the calculation of a porosity-dependent permeability. When the porosity is implemented as solution-independent, using this relationship for the permeability leads to unnecessary overhead. More...
 
class  PlotEffectiveDiffusivityModel
 Interface for plotting the multi-component-matrix-interaction laws. More...
 
class  PlotMaterialLaw
 Interface for plotting the three-phase fluid-matrix-interaction laws TODO: add theta head pressure plot (porosity and density is needed) More...
 
class  PlotThermalConductivityModel
 Interface for plotting the non-isothermal two-phase fluid-matrix-interaction laws. More...
 
class  PointCloudVtkWriter
 A VTK output module to simplify writing dumux simulation data to VTK format. More...
 
class  PointSource
 A point source base class. More...
 
class  PointSourceData
 A point source data class used for integration in multidimensional models. More...
 
class  PointSourceDataCircleAverage
 A point source data class used for integration in multidimensional models. More...
 
class  PoroElasticIOFields
 Adds I/O fields specific to the poro-elastic model. More...
 
class  PoroElasticLocalResidual
 Element-wise calculation of the local residual for problems using the poroelastic model. More...
 
struct  PoroElasticModelTraits
 Specifies a number properties of the poroelastic model. More...
 
class  PoroElasticVolumeVariables
 Contains the quantities which are constant within a finite volume in the poroelastic model. More...
 
class  PoroMechanicsCouplingManager
 Coupling manager for porous medium flow problems coupled to a poro-mechanical problem. More...
 
class  PorosityDeformation
 A relationship for the porosity of a porous medium under mechanical deformation. More...
 
class  PorosityPrecipitation
 Calculates the porosity depending on the volume fractions of precipitated minerals. More...
 
struct  PorousMediumFlowNIModelTraits
 Specifies a number properties of non-isothermal porous medium flow models based on the specifics of a given isothermal model. More...
 
class  PorousMediumFlowProblem
 Base class for all fully implicit porous media problems. More...
 
class  PorousMediumFlowVelocity
 Velocity computation for implicit (porous media) models. More...
 
class  PorousMediumFlowVelocityOutput
 Velocity output policy for implicit (porous media) models. More...
 
class  PorousMediumFlowVolumeVariables
 The isothermal base class. More...
 
class  PorousMediumFluxVariables
 The porous medium flux variables class that computes advective / convective, molecular diffusive and heat conduction fluxes. More...
 
class  PorousMediumFluxVariablesCacheFillerImplementation
 
class  PorousMediumFluxVariablesCacheFillerImplementation< TypeTag, DiscretizationMethods::CCMpfa >
 Specialization of the flux variables cache filler for the cell centered mpfa method. More...
 
class  PorousMediumFluxVariablesCacheFillerImplementation< TypeTag, DiscretizationMethods::CCTpfa >
 Specialization of the flux variables cache filler for the cell centered tpfa method. More...
 
class  PorousMediumFluxVariablesCacheImplementation
 
class  PorousMediumFluxVariablesCacheImplementation< TypeTag, DiscretizationMethods::CCMpfa >
 
class  PorousMediumFluxVariablesCacheImplementation< TypeTag, DiscretizationMethods::CCTpfa >
 
class  PorousMediumFluxVariablesCacheImplementation< TypeTag, DiscretizationMethods::CVFE< DM > >
 
struct  PQ1BubbleDefaultGridGeometryTraits
 The default traits for the pq1bubble finite volume grid geometry Defines the scv and scvf types and the mapper types. More...
 
struct  PQ1BubbleDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the cvfe scheme. More...
 
struct  PQ1BubbleDefaultScvGeometryTraits
 Default traits class to be used for the sub-control volumes for the pq1bubble scheme. More...
 
class  PQ1BubbleElementSolution
 The element solution vector. More...
 
class  PQ1BubbleFECache
 
class  PQ1BubbleFreeFlowCouplingManager
 The interface of the coupling manager for free flow systems. More...
 
class  PQ1BubbleFVElementGeometry
 Base class for the finite volume geometry vector for pq1bubble models This builds up the sub control volumes and sub control volume faces for each element. More...
 
class  PQ1BubbleFVElementGeometry< GG, true >
 specialization in case the FVElementGeometries are stored More...
 
class  PQ1BubbleFVGridGeometry
 Base class for the finite volume geometry vector for pq1bubble schemes This builds up the sub control volumes and sub control volume faces. More...
 
class  PQ1BubbleGeometryHelper
 A class to create sub control volume and sub control volume face geometries per element. More...
 
class  PQ1BubbleLocalAssembler
 An assembler for Jacobian and residual contribution per element (PQ1Bubble methods) More...
 
class  PQ1BubbleLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, false >
 TODO docme. More...
 
class  PQ1BubbleLocalAssembler< TypeTag, Assembler, DiffMethod::analytic, true >
 TODO docme. More...
 
class  PQ1BubbleLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, false >
 TODO docme. More...
 
class  PQ1BubbleLocalAssembler< TypeTag, Assembler, DiffMethod::numeric, true, Implementation >
 Face-centered scheme local assembler using numeric differentiation and implicit time discretization. More...
 
class  PQ1BubbleLocalAssemblerBase
 A base class for all local pq1bubble assemblers. More...
 
class  PQ1BubbleLocalFiniteElement
 P1/Q1 + Bubble finite element. More...
 
struct  PQ1BubbleMapperTraits
 
struct  PQ1BubbleMLGeometryTraits
 Traits for an efficient corner storage for the PQ1Bubble method. More...
 
class  PQ1BubbleSubControlVolume
 the sub control volume for the pq1bubble scheme More...
 
class  PQ1BubbleSubControlVolumeFace
 Class for a sub control volume face in the cvfe method, i.e a part of the boundary of a sub control volume we compute fluxes on. We simply use the base class here. More...
 
class  PressureOverlayFluidState
 This is a fluid state which allows to set the fluid pressures and takes all other quantities from an other fluid state. More...
 
class  PrimaryVariableSwitch
 The primary variable switch controlling the phase presence state variable. More...
 
class  PrimaryVariableSwitchAdapter
 An adapter for the Newton to manage models with primary variable switch. More...
 
class  PrimaryVariableSwitchAdapter< Variables, false >
 An empty adapter for the Newton for models without primary variable switch. More...
 
struct  ProblemTraits
 Type traits for problem classes. More...
 
class  Projector
 Does an L2-projection from one discrete function space into another. The convenience functions makeProjectorPair or makeProjector can be used to create such a projection. More...
 
class  ProjectorTraits
 Traits class stating the type of projector between to bases. More...
 
class  PseudoOnePTwoCFluidState
 Container for compositional variables in a 1p2c situation. More...
 
class  RANSBoundaryTypes
 Class to specify the type of a boundary condition for the RANS extension to the Navier-Stokes model. More...
 
struct  RANSIOFields
 Adds I/O fields for the Reynolds-Averaged Navier-Stokes model. More...
 
class  RANSProblemBase
 Reynolds-Averaged Navier-Stokes problem base class. More...
 
class  RANSProblemImpl
 forward declare More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::kepsilon >
 K-epsilon turbulence problem base class. More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::komega >
 K-Omega turbulence model problem base class. More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::lowrekepsilon >
 Low-Re k-epsilon turbulence problem base class. More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::oneeq >
 One-equation turbulence problem base class. More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::sst >
 SST turbulence model problem base class. More...
 
class  RANSProblemImpl< TypeTag, TurbulenceModel::zeroeq >
 Zero-equation turbulence problem base class. More...
 
struct  RANSTwoEqIndices
 The common indices for isothermal two-equation RANS models. More...
 
class  RANSVolumeVariables
 Volume variables for the isothermal single-phase Reynolds-Averaged Navier-Stokes models. More...
 
class  RefinementQuadratureRule
 A "quadrature" based on virtual refinement. More...
 
class  ReservedBlockVector
 A arithmetic block vector type based on DUNE's reserved vector. More...
 
class  Restart
 Load or save a state of a model to/from the harddisk. More...
 
struct  RichardsBalanceEquationOptions
 Traits class to set options used by the local residual when when evaluating the balance equations. More...
 
struct  RichardsIndices
 Index names for the Richards model. More...
 
class  RichardsIOFields
 Adds I/O fields specific to the Richards model. More...
 
class  RichardsLocalResidual
 Element-wise calculation of the Jacobian matrix for problems using the Richards fully implicit models. More...
 
struct  RichardsModelTraits
 Specifies a number properties of the Richards model. More...
 
struct  RichardsNCIndices
 The indices for the isothermal Richards, n-component model. More...
 
class  RichardsNCIOFields
 Adds I/O fields specific to the Richards model. More...
 
struct  RichardsNCModelTraits
 Specifies a number properties of the Richards n-components model. More...
 
class  RichardsNCVolumeVariables
 Contains the quantities which are constant within a finite volume in the Richards, n-component model. More...
 
class  RichardsNewtonSolver
 A Richards model specific Newton solver. More...
 
class  RichardsVelocityOutput
 Velocity output policy for the Richards model. More...
 
class  RichardsVolumeVariables
 Volume averaged quantities required by the Richards model. More...
 
struct  RichardsVolumeVariablesTraits
 Traits class for the Richards model. More...
 
struct  RotationalExtrusion
 Rotation symmetric extrusion policy for rotating about an external axis. More...
 
class  SaturationOverlayFluidState
 This is a fluid state which allows to set the fluid saturations and takes all other quantities from an other fluid state. More...
 
class  ScheideggersDispersionTensor
 Scheidegger's dispersion tensor. More...
 
class  ScotchBackend
 A reordering backend using the scotch library. More...
 
class  ScotchPartitioner
 A reordering backend using the scotch library. More...
 
class  ScvfIterator
 Iterators over sub control volume faces of an fv geometry. More...
 
class  ScvfToScvBoundaryTypes
 Convert intersection boundary types to vertex boundary types. More...
 
class  ScvIterator
 Iterators over sub control volumes. More...
 
struct  SequentialSolverTraits
 sequential solver traits More...
 
class  SeqUzawa
 A preconditioner based on the Uzawa algorithm for saddle-point problems of the form \( \begin{pmatrix} A & B \\ C & D \end{pmatrix} \begin{pmatrix} u\\ p \end{pmatrix} = \begin{pmatrix} f\\ g \end{pmatrix} \). More...
 
class  ShallowWaterFlux
 Prepare and compute the shallow water advective flux. More...
 
class  ShallowWaterFluxVariables
 The flux variables class for the shallow water model. More...
 
struct  ShallowWaterIndices
 The common indices for the shallow water equations model. More...
 
class  ShallowWaterIOFields
 Adds vtk output fields for the shallow water model. More...
 
struct  ShallowWaterModelTraits
 Specifies a number properties of shallow water models. More...
 
class  ShallowWaterProblem
 Shallow water problem base class. More...
 
class  ShallowWaterResidual
 Element-wise calculation of the residual for the shallow water equations. More...
 
class  ShallowWaterViscousFlux
 Compute the shallow water viscous momentum flux due to (turbulent) viscosity. More...
 
class  ShallowWaterVolumeVariables
 Volume variables for the shallow water equations model. More...
 
struct  ShallowWaterVolumeVariablesTraits
 Traits class for the volume variables of the shallow water model. More...
 
class  SimpleLogNormalDistribution
 A simple log-normal distribution. More...
 
class  SimpleNormalDistribution
 A simple normal distribution based on a biased uniform number generator and the Box-Mueller transform. More...
 
class  SimpleUniformDistribution
 A simple uniform distribution based on a biased uniform number generator. More...
 
class  SkippingScvfIterator
 Iterators over sub control volume faces of an fv geometry and a given sub control volume. More...
 
class  SolDependentPointSource
 A point source class for time dependent point sources. More...
 
struct  SolidEnergyIndices
 The indices. More...
 
class  SolidEnergyLocalResidual
 Element-wise calculation of the residual. More...
 
struct  SolidEnergyModelTraits
 The energy balance equation for a porous solid. More...
 
class  SolidEnergyVolumeVariables
 Class for computation of all volume averaged quantities. More...
 
struct  SolidEnergyVolumeVariablesTraits
 The volume variable traits. More...
 
class  SORBiCGSTABBackend
 Sequential SOR-preconditioned BiCSTAB solver. More...
 
class  SORCGBackend
 Sequential SOR-preconditioned CG solver. More...
 
class  Spe5ParameterCache
 Specifies the parameters required by the SPE5 problem which are despondent on the thermodynamic state. More...
 
class  Sphere
 A simple sphere type. More...
 
struct  SphericalExtrusion
 Rotation symmetric extrusion policy for spherical rotation. More...
 
class  Spline
 A 3rd order polynomial spline. More...
 
class  Spline< Scalar, -1 >
 Specialization of a spline with the number of sampling points only known at run time. More...
 
class  Spline< Scalar, 0 >
 Do not allow splines with zero sampling points. More...
 
class  Spline< Scalar, 1 >
 Do not allow splines with one sampling point. More...
 
class  Spline< Scalar, 2 >
 Spline for two sampling points. More...
 
class  SSORBiCGSTABBackend
 Sequential SSOR-preconditioned BiCGSTAB solver. More...
 
class  SSORCGBackend
 Sequential SSOR-preconditioned CG solver. More...
 
class  SSORRestartedGMResBackend
 Sequential SSOR-preconditioned GMRes solver. More...
 
class  SSTFluxVariablesImpl
 The flux variables class for the SST model using the staggered grid discretization. More...
 
class  SSTFluxVariablesImpl< TypeTag, BaseFluxVariables, DiscretizationMethods::Staggered >
 
struct  SSTIOFields
 Adds I/O fields for the Reynolds-Averaged Navier-Stokes model. More...
 
class  SSTResidualImpl
 Element-wise calculation of the residual for SST models using the staggered discretization. More...
 
class  SSTResidualImpl< TypeTag, BaseLocalResidual, DiscretizationMethods::Staggered >
 
class  SSTVolumeVariables
 Volume variables for the isothermal single-phase SST 2-Eq model. More...
 
class  StaggeredCouplingManager
 Base coupling manager for the staggered discretization. More...
 
struct  StaggeredDefaultGridFaceVariablesTraits
 Traits class to be used for the StaggeredGridFaceVariables. More...
 
struct  StaggeredDefaultGridFluxVariablesCacheTraits
 Traits class to be used for the StaggeredGridVFluxVariablesCache. More...
 
struct  StaggeredDefaultScvfGeometryTraits
 Default traits class to be used for the sub-control volume faces for the staggered finite volume scheme. More...
 
class  StaggeredElementFaceVariables
 Base class for the face variables vector. More...
 
class  StaggeredElementFaceVariables< GFV, false >
 Class for the face variables vector. Specialization for the case of not storing the face variables globally. More...
 
class  StaggeredElementFaceVariables< GFV, true >
 Class for the face variables vector. Specialization for the case of storing the face variables globally. More...
 
class  StaggeredElementFluxVariablesCache
 Base class for the stencil local flux variables cache for the staggered model. More...
 
class  StaggeredElementFluxVariablesCache< GFVC, false >
 Class for the stencil local flux variables cache for the staggered model. Specialization for the case of not storing the fluxvars cache globally. More...
 
class  StaggeredElementFluxVariablesCache< GFVC, true >
 Class for the stencil local flux variables cache for the staggered model. Specialization for the case of storing the fluxvars cache globally. More...
 
class  StaggeredElementVolumeVariables
 Base class for the element volume variables vector for the staggered model. More...
 
class  StaggeredElementVolumeVariables< GVV, false >
 Class for the element volume variables vector for the staggered model. Specialization in case the volume variables are not stored globally. More...
 
class  StaggeredElementVolumeVariables< GVV, true >
 Class for the element volume variables vector for the staggered model. Specialization in case the volume variables are stored globally. More...
 
class  StaggeredFaceSolution
 The global face variables class for staggered models. More...
 
class  StaggeredFaceVariables
 The face variables class for free flow staggered grid models. Contains all relevant velocities for the assembly of the momentum balance. When the upwindSchemeOrder is set to 2, additional velocities located at Dofs further from the central stencil will be added and used when calculating the advective term. When the order remains at 1, these velocities will not be provided. More...
 
class  StaggeredFreeFlowConnectivityMap
 Stores the dof indices corresponding to the neighboring cell centers and faces that contribute to the derivative calculation. Specialization for the staggered free flow model. More...
 
struct  StaggeredFreeFlowDefaultFVGridGeometryTraits
 Default traits for the finite volume grid geometry. More...
 
class  StaggeredFreeFlowPoreNetworkCouplingMapper
 Coupling mapper for staggered free-flow and pore-network models. More...
 
class  StaggeredFreeFlowVelocityOutput
 Velocity output for staggered free-flow models. More...
 
class  StaggeredFVAssembler
 A linear system assembler (residual and Jacobian) for staggered finite volume schemes. This is basically just a wrapper for the MultiDomainFVAssembler which simplifies the set-up of uncoupled problems using the staggered scheme. More...
 
class  StaggeredFVElementGeometry
 Stencil-local finite volume geometry (scvs and scvfs) for staggered models This builds up the sub control volumes and sub control volume faces for each element in the local scope we are restricting to, e.g. stencil or element. More...
 
class  StaggeredFVElementGeometry< GG, false >
 Base class for the finite volume geometry vector for staggered models This locally builds up the sub control volumes and sub control volume faces for each element. Specialization for grid caching disabled. More...
 
class  StaggeredFVElementGeometry< GG, true >
 Base class for the finite volume geometry vector for staggered models This locally builds up the sub control volumes and sub control volume faces for each element. Specialization for grid caching enabled. More...
 
class  StaggeredFVGridGeometry
 Base class for the finite volume geometry vector for staggered models This builds up the sub control volumes and sub control volume faces for each element. More...
 
class  StaggeredFVGridGeometry< GV, false, T >
 Base class for the finite volume geometry vector for staggered models This builds up the sub control volumes and sub control volume faces for each element. Specialization in case the FVElementGeometries are stored. More...
 
class  StaggeredFVGridGeometry< GV, true, T >
 Base class for the finite volume geometry vector for staggered models This builds up the sub control volumes and sub control volume faces for each element. Specialization in case the FVElementGeometries are stored. More...
 
class  StaggeredFVProblem
 Base class for all staggered finite-volume problems. More...
 
struct  StaggeredGridDefaultGridVolumeVariablesTraits
 
class  StaggeredGridFaceVariables
 Face variables cache class for staggered models. More...
 
class  StaggeredGridFaceVariables< P, FV, false, Traits >
 Face variables cache class for staggered models. Specialization in case of not storing the face variables. More...
 
class  StaggeredGridFaceVariables< P, FV, true, Traits >
 Face variables cache class for staggered models. Specialization in case of storing the face variables. More...
 
class  StaggeredGridFluxVariablesCache
 Flux variables cache class for staggered models. More...
 
class  StaggeredGridFluxVariablesCache< P, FVC, FVCF, false, upwindSchemeOrder, TheTraits >
 Flux variables cache class for staggered models. Specialization in case of not storing the flux cache. More...
 
class  StaggeredGridFluxVariablesCache< P, FVC, FVCF, true, upwindSchemeOrder, TheTraits >
 Flux variables cache class for staggered models. Specialization in case of storing the flux cache. More...
 
class  StaggeredGridVariables
 Class storing data associated to scvs and scvfs. More...
 
class  StaggeredGridVariablesView
 Base class for cell center of face specific auxiliary GridVariables classes. Provides a common interface and a pointer to the actual grid variables. More...
 
class  StaggeredGridVolumeVariables
 Grid volume variables class for staggered models. More...
 
class  StaggeredGridVolumeVariables< Traits, false >
 Grid volume variables class for staggered models. Specialization in case of not storing the volume variables. More...
 
class  StaggeredGridVolumeVariables< Traits, true >
 Grid volume variables class for staggered models. Specialization in case of storing the volume variables. More...
 
class  StaggeredLocalResidual
 Calculates the element-wise residual for the staggered FV scheme. More...
 
struct  StaggeredMultiDomainTraits
 
class  StaggeredNewtonConvergenceWriter
 Writes the intermediate solutions for every Newton iteration (for staggered grid scheme) More...
 
class  StaggeredSubControlVolumeFace
 Class for a sub control volume face in the staggered method, i.e a part of the boundary of a sub control volume we compute fluxes on. More...
 
class  StaggeredUpwindHelper
 The upwinding variables class for the Navier-Stokes model using the staggered grid discretization. More...
 
class  StaggeredUpwindMethods
 This file contains different higher order methods for approximating the velocity. More...
 
class  StaggeredVelocityGradients
 Helper class for calculating the velocity gradients for the Navier-Stokes model using the staggered grid discretization. More...
 
struct  StaggeredVelocityReconstruction
 Helper class for reconstructing the velocity. More...
 
class  StaggeredVtkOutputModule
 A VTK output module to simplify writing dumux simulation data to VTK format Specialization for staggered grids with dofs on faces. More...
 
class  StationaryVelocityField
 Evaluates a user given velocity field. More...
 
class  StokesDarcyCouplingDataImplementation
 
class  StokesDarcyCouplingDataImplementation< MDTraits, CouplingManager, enableEnergyBalance, false >
 Coupling data specialization for non-compositional models. More...
 
class  StokesDarcyCouplingDataImplementation< MDTraits, CouplingManager, enableEnergyBalance, true >
 Coupling data specialization for compositional models. More...
 
class  StokesDarcyCouplingDataImplementationBase
 A base class which provides some common methods used for Stokes-Darcy coupling. More...
 
class  StokesDarcyCouplingManager
 Coupling manager for Stokes and Darcy domains with equal dimension. More...
 
class  StokesDarcyCouplingMapper
 Coupling mapper for Stokes and Darcy domains with equal dimension. More...
 
struct  StokesDarcyCouplingOptions
 This structs holds a set of options which allow to modify the Stokes-Darcy coupling mechanism during runtime. More...
 
class  StressVariablesCache
 The stress variables cache classes for models involving geomechanics. Store data required for stress calculation. More...
 
class  StressVariablesCache< Scalar, GridGeometry, DiscretizationMethods::Box >
 We only store discretization-related quantities for the box method. More...
 
class  StressVariablesCache< Scalar, GridGeometry, DiscretizationMethods::CCMpfa >
 
class  StressVariablesCache< Scalar, GridGeometry, DiscretizationMethods::CCTpfa >
 
class  SubControlVolumeBase
 Base class for a sub control volume, i.e a part of the control volume we are making the balance for. Defines the general interface. More...
 
class  SubControlVolumeFaceBase
 Base class for a sub control volume face, i.e a part of the boundary of a sub control volume we computing a flux on. More...
 
class  SubDomainBoxLocalAssembler
 The box scheme multidomain local assembler. More...
 
class  SubDomainBoxLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, false >
 Box scheme multi domain local assembler using numeric differentiation and explicit time discretization. More...
 
class  SubDomainBoxLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Box scheme multi domain local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainBoxLocalAssemblerBase
 A base class for all box local assemblers. More...
 
class  SubDomainCCLocalAssembler
 The cell-centered scheme multidomain local assembler. More...
 
class  SubDomainCCLocalAssembler< id, TypeTag, Assembler, DiffMethod::analytic, true >
 Cell-centered scheme local assembler using analytic differentiation and implicit time discretization. More...
 
class  SubDomainCCLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, false >
 Cell-centered scheme multidomain local assembler using numeric differentiation and explicit time discretization. More...
 
class  SubDomainCCLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Cell-centered scheme multidomain local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainCCLocalAssemblerBase
 A base class for all multidomain local assemblers. More...
 
class  SubDomainFaceCenteredDiamondLocalAssembler
 The face-centered staggered scheme multidomain local assembler. More...
 
class  SubDomainFaceCenteredDiamondLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Face-centered staggered scheme multi domain local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainFaceCenteredDiamondLocalAssemblerBase
 A base class for all face-centered staggered local assemblers. More...
 
class  SubDomainFaceCenteredLocalAssembler
 The face-centered staggered scheme multidomain local assembler. More...
 
class  SubDomainFaceCenteredLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, false >
 Face-centered staggered scheme multi domain local assembler using numeric differentiation and explicit time discretization. More...
 
class  SubDomainFaceCenteredLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Face-centered staggered scheme multi domain local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainFaceCenteredLocalAssemblerBase
 A base class for all face-centered staggered local assemblers. More...
 
class  SubDomainPQ1BubbleLocalAssembler
 The PQ1Bubble scheme multidomain local assembler. More...
 
class  SubDomainPQ1BubbleLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Control-volume fe staggered scheme multi domain local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainPQ1BubbleLocalAssemblerBase
 A base class for PQ1Bubble local assemblers. More...
 
class  SubDomainStaggeredLocalAssembler
 The staggered multidomain local assembler. More...
 
class  SubDomainStaggeredLocalAssembler< id, TypeTag, Assembler, DiffMethod::numeric, true >
 Staggered scheme local assembler using numeric differentiation and implicit time discretization. More...
 
class  SubDomainStaggeredLocalAssemblerBase
 A base class for all multidomain local assemblers (staggered) More...
 
class  SubDomainStaggeredLocalAssemblerImplicitBase
 A base class for all implicit multidomain local assemblers (staggered) More...
 
struct  SupportsColoring
 Traits specifying if a given discretization tag supports coloring. More...
 
struct  SupportsColoring< DiscretizationMethods::Box >
 
struct  SupportsColoring< DiscretizationMethods::CCMpfa >
 
struct  SupportsColoring< DiscretizationMethods::CCTpfa >
 
struct  SupportsColoring< DiscretizationMethods::FCDiamond >
 
struct  SupportsColoring< DiscretizationMethods::FCStaggered >
 
struct  SupportsColoring< DiscretizationMethods::PQ1Bubble >
 
class  SwitchablePrimaryVariables
 A primary variable vector with a state to allow variable switches. More...
 
class  Tabulated2DFunction
 Implements tabulation for a two-dimensional function. More...
 
class  TemperatureOverlayFluidState
 This is a fluid state which allows to set the fluid temperatures and takes all other quantities from an other fluid state. More...
 
class  ThermalConductivityAverage
 Relation for a simple effective thermal conductivity. More...
 
class  ThermalConductivityJohansen
 Relation for the saturation-dependent effective thermal conductivity. More...
 
class  ThermalConductivitySimpleFluidLumping
 Relation for the saturation-dependent effective thermal conductivity. More...
 
struct  ThermalConductivitySolidEnergy
 
class  ThermalConductivitySomerton
 Relation for the saturation-dependent effective thermal conductivity. More...
 
class  ThreePIndices
 The common indices for the isothermal three-phase model. More...
 
class  ThreePIOFields
 Adds I/O fields specific to the three-phase model. More...
 
struct  ThreePModelTraits
 Specifies a number properties of three-phase models. More...
 
class  ThreePThreeCIndices
 The indices for the isothermal three-phase three-component model. More...
 
class  ThreePThreeCIOFields
 Adds I/O fields specific to the three-phase three-component model. More...
 
class  ThreePThreeCLocalResidual
 Element-wise calculation of the Jacobian matrix for problems using the three-phase three-component fully implicit model. More...
 
struct  ThreePThreeCModelTraits
 Specifies a number properties of two-phase models. More...
 
class  ThreePThreeCPrimaryVariableSwitch
 The primary variable switch controlling the phase presence state variable. More...
 
class  ThreePThreeCVolumeVariables
 Contains the quantities which are are constant within a finite volume in the three-phase three-component model. More...
 
class  ThreePVolumeVariables
 Contains the quantities which are constant within a finite volume in the three-phase model. More...
 
struct  ThreePVolumeVariablesTraits
 Traits class for the two-phase model. More...
 
class  ThreePWaterOilIndices
 The indices for the isothermal 3p2cni model. More...
 
class  ThreePWaterOilIOFields
 Adds I/O fields specific to the three-phase three-component model. More...
 
class  ThreePWaterOilLocalResidual
 Element-wise calculation of the local residual for problems using the ThreePWaterOil fully implicit model. More...
 
struct  ThreePWaterOilModelTraits
 Specifies a number properties of the three-phase two-component model. More...
 
class  ThreePWaterOilPrimaryVariableSwitch
 The primary variable switch controlling the phase presence state variable. More...
 
class  ThreePWaterOilVolumeVariables
 Contains the quantities which are are constant within a finite volume in the three-phase, two-component model. More...
 
class  TimeLoop
 The default time loop for instationary simulations. More...
 
class  TimeLoopBase
 Manages the handling of time dependent problems. More...
 
class  TpfaDarcysLawCache
 The cache corresponding to tpfa Darcy's Law. More...
 
class  TpfaDarcysLawCacheFiller
 Class that fills the cache corresponding to tpfa Darcy's Law. More...
 
class  TpfaForchheimersLawCache
 The cache corresponding to tpfa Forchheimer's Law. More...
 
class  TpfaForchheimersLawCacheFiller
 Class that fills the cache corresponding to tpfa Forchheimer's Law. More...
 
struct  TracerIndices
 Defines the primary variable and equation indices used by the isothermal tracer model. More...
 
class  TracerIOFields
 Adds I/O fields specific to the tracer model. More...
 
class  TracerLocalResidual
 Element-wise calculation of the local residual for problems using fully implicit tracer model. More...
 
struct  TracerModelTraits
 Specifies a number properties of the Richards n-components model. More...
 
class  TracerVolumeVariables
 Contains the quantities which are constant within a finite volume for the tracer model. More...
 
struct  TracerVolumeVariablesTraits
 Traits class for the volume variables of the single-phase model. More...
 
class  TurbulenceProperties
 This class contains different functions for estimating turbulence properties. More...
 
class  TwoPGridAdaptIndicator
 Class defining a standard, saturation dependent indicator for grid adaptation. More...
 
class  TwoPGridDataTransfer
 Class performing the transfer of data on a grid from before to after adaptation. More...
 
class  TwoPIncompressibleLocalResidual
 Element-wise calculation of the residual and its derivatives for a two-phase, incompressible test problem. More...
 
struct  TwoPIndices
 Defines the indices required for the two-phase fully implicit model. More...
 
class  TwoPIOFields
 Adds I/O fields specific to the two-phase model. More...
 
struct  TwoPModelTraits
 Specifies a number properties of two-phase models. More...
 
struct  TwoPNCIndices
 The indices for the isothermal two-phase n-component model. More...
 
class  TwoPNCIOFields
 Adds I/O fields specific to the TwoPNC model. More...
 
struct  TwoPNCModelTraits
 Specifies a number properties of two-phase n-component models. More...
 
class  TwoPNCPrimaryVariableSwitch
 The primary variable switch controlling the phase presence state variable. More...
 
class  TwoPNCVolumeVariables
 Contains the quantities which are are constant within a finite volume in the two-phase, n-component model. More...
 
class  TwoPOneCDarcysLaw
 Specialization of Darcy's Law for the two-phase one-component model, including a the possibility
to block spurious fluxes of cold water into the steam zone, which can improve the model's convergence behavior (Gudbjerg et al., 2005) [33]. More...
 
class  TwoPOneCIndices
 The indices for the two-phase one-component model. More...
 
class  TwoPOneCIOFields
 Adds I/O fields specific to two-phase one-component model. More...
 
class  TwoPOneCLocalResidual
 Element-wise calculation of the residual for the fully implicit two-phase one-component flow model. More...
 
struct  TwoPOneCNIModelTraits
 Specifies a number properties of models considering two phases with water as a single component. More...
 
class  TwoPOneCPrimaryVariableSwitch
 The primary variable switch for the two-phase one-component model. More...
 
class  TwoPOneCVolumeVariables
 The volume variables (i.e. secondary variables) for the two-phase one-component model. More...
 
struct  TwoPOneCVolumeVariablesTraits
 Traits class for the two-phase model. More...
 
class  TwoPScvSaturationReconstruction
 Class that computes the nonwetting saturation in an scv from the saturation at the global degree of freedom. More...
 
class  TwoPScvSaturationReconstruction< DiscretizationMethods::Box, true >
 Specialization for the box scheme with the interface solver enabled. More...
 
class  TwoPTwoCCO2PrimaryVariableSwitch
 The primary variable switch for the 2p2c-CO2 model controlling the phase presence state variable. More...
 
class  TwoPTwoCCO2VolumeVariables
 Contains the quantities which are are constant within a finite volume in the CO2 model. More...
 
struct  TwoPTwoCUnconstrainedModelTraits
 
class  TwoPTwoCVolumeVariablesBase
 Contains the quantities which are constant within a finite volume in the two-phase two-component model. This is the base class for a 2p2c model with and without chemical nonequilibrium. More...
 
class  TwoPTwoCVolumeVariablesImplementation
 
class  TwoPTwoCVolumeVariablesImplementation< Traits, false, useConstraintSolver >
 Contains the quantities which are constant within a finite volume in the two-phase two-component model. Specialization for chemical equilibrium. More...
 
class  TwoPTwoCVolumeVariablesImplementation< Traits, true, useConstraintSolver >
 Contains the quantities which are constant within a finite volume in the two-phase two-component model. Specialization for chemical non-equilibrium. The equilibrium mole fraction is calculated using Henry's and Raoult's law. More...
 
class  TwoPVolumeVariables
 Contains the quantities which are are constant within a finite volume in the two-phase model. More...
 
struct  TwoPVolumeVariablesTraits
 Traits class for the two-phase model. More...
 
class  UpwindSchemeImpl
 Forward declaration of the upwind scheme implementation. More...
 
class  UpwindSchemeImpl< GridGeometry, DiscretizationMethods::CCMpfa >
 Upwind scheme for cell-centered mpfa schemes. More...
 
class  UpwindSchemeImpl< GridGeometry, DiscretizationMethods::CCTpfa >
 Upwind scheme for the cell-centered tpfa scheme. More...
 
class  UpwindSchemeImpl< GridGeometry, DiscretizationMethods::CVFE< DM > >
 Upwind scheme for control-volume finite element methods (uses the standard scheme) More...
 
class  UzawaBiCGSTABBackend
 A Uzawa preconditioned BiCGSTAB solver for saddle-point problems. More...
 
class  VectorCommDataHandle
 A data handle class to exchange entries of a vector. More...
 
class  VectorConverter
 A helper class that converts a Dune::MultiTypeBlockVector into a plain Dune::BlockVector and transfers back values. More...
 
class  VelocityOutput
 Velocity output for implicit (porous media) models. More...
 
class  VertexEnrichmentHelper
 Specialization of the enrichment helper class for 2d grids. In this case, we look for two-dimensional bulk grid elements that are enclosed by (lie in between) two 1-dimensional facet grid elements. More...
 
class  VtkOutputModule
 A VTK output module to simplify writing dumux simulation data to VTK format. More...
 
class  VtkOutputModuleBase
 A VTK output module to simplify writing dumux simulation data to VTK format. More...
 
class  VTKReader
 A vtk file reader using tinyxml2 as xml backend. More...
 
class  VTKSequenceWriter
 Base class to write pvd-files which contains a list of all collected vtk-files. This is a modified version of DUNE's pvd writer which takes a VTKWriter as template argument making it more general. More...
 
class  WallDistance
 Class to calculate the wall distance at every element or vertex of a grid. More...
 
class  ZeroEqVolumeVariables
 Volume variables for the single-phase 0-Eq. model. More...
 

Typedefs

template<class TypeTag >
using BoxLocalResidual = CVFELocalResidual< TypeTag >
 The element-wise residual for the box scheme. More...
 
template<class GridView >
using ElementMap = EntityMap< GridView, 0 >
 
template<class PrimaryVariables >
using NumEqVector = typename NumEqVectorTraits< PrimaryVariables >::type
 A vector with the same size as numbers of equations This is the default implementation and has to be specialized for all custom primary variable vector types. More...
 
template<class TypeTag , template< class, class > class Property>
using GetProp = typename Properties::Detail::GetPropImpl< TypeTag, Property >::type
 get the type of a property More...
 
template<class TypeTag , template< class, class > class Property, class T >
using GetPropOr = typename Properties::Detail::GetPropOrImpl< TypeTag, Property, T >::type
 get the type of a property or the type T if the property is undefined More...
 
template<class TypeTag , template< class, class > class Property>
using GetPropType = typename GetProp< TypeTag, Property >::type
 get the type alias defined in the property More...
 
template<class TypeTag , template< class, class > class Property, class T >
using GetPropTypeOr = typename GetPropOr< TypeTag, Property, T >::type
 get the type alias defined in the property or the type T if the property is undefined More...
 
template<class GridView >
using ReorderingDofMapper = Dune::MultipleCodimMultipleGeomTypeMapper< GridView >
 
template<std::size_t n, std::size_t e>
using makeIncompleteIntegerSequence = typename Detail::ConcatSeq< decltype(std::make_index_sequence< e >{}), e+1, decltype(std::make_index_sequence<(n > e) ?(n - e - 1) :0 >{})>::type
 
template<class Vars >
using VariablesBackend = Detail::VariablesBackend< Vars, Dune::Std::is_detected_v< Detail::SolutionVectorType, Vars > >
 Class providing operations for generic variable classes that represent the state of a numerical solution, possibly consisting of primary/secondary variables and information on the time level. More...
 
template<class GV , class T >
using BasicGridGeometry_t = Dune::Std::detected_or_t< Dumux::BasicGridGeometry< GV, typename T::ElementMapper, typename T::VertexMapper >, Detail::SpecifiesBaseGridGeometry, T >
 Type of the basic grid geometry implementation used as backend. More...
 
template<class BTypes >
using BoxElementBoundaryTypes = CVFEElementBoundaryTypes< BTypes >
 This class stores an array of BoundaryTypes objects. More...
 
template<class GFVC , bool cachingEnabled>
using BoxElementFluxVariablesCache = CVFEElementFluxVariablesCache< GFVC, cachingEnabled >
 The flux variables caches for an element. More...
 
template<class GVV , bool cachingEnabled>
using BoxElementVolumeVariables = CVFEElementVolumeVariables< GVV, cachingEnabled >
 The local (stencil) volume variables class for box models. More...
 
template<class Scalar , class GridGeometry >
using BoxFluxVariablesCache = CVFEFluxVariablesCache< Scalar, GridGeometry >
 Flux variables cache class for the box scheme. For the box scheme, this class does not contain any physics-/process-dependent data. It solely stores disretization-/grid-related data. More...
 
template<class Problem , class FluxVariablesCache , bool cachingEnabled = false, class Traits = CVFEDefaultGridFVCTraits<Problem, FluxVariablesCache>>
using BoxGridFluxVariablesCache = CVFEGridFluxVariablesCache< Problem, FluxVariablesCache, cachingEnabled, Traits >
 Flux variable caches on a gridview. More...
 
template<class Problem , class VolumeVariables , bool enableGridVolVarsCache = false, class Traits = CVFEDefaultGridVolumeVariablesTraits<Problem, VolumeVariables>>
using BoxGridVolumeVariables = CVFEGridVolumeVariables< Traits, enableGridVolVarsCache >
 Base class for the grid volume variables. More...
 
template<class T >
using Extrusion_t = typename Extrusion< T >::type
 Convenience alias for obtaining the extrusion type. More...
 
template<class GridView >
using FaceCenteredStaggeredLocalIntersectionIndexMapper = Detail::FaceCenteredStaggeredLocalIntersectionIndexMapper< GridView, ConsistentlyOrientedGrid< typename GridView::Grid >{}>
 Provides a mapping of local intersection indices (indexInInside) such that the local indices always follow the order of a reference element, regardless of how the element is oriented. Does not do anything for grids not supporting rotated elements (such as Dune::YaspGrid). More...
 
template<class PrimaryVariables >
using StaggeredElementSolution = Dune::BlockVector< PrimaryVariables >
 
template<class TypeTag >
using DarcysLaw = DarcysLawImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Evaluates the normal component of the Darcy velocity on a (sub)control volume face. More...
 
template<class TypeTag , ReferenceSystemFormulation referenceSystem = ReferenceSystemFormulation::massAveraged>
using DiffusiveDispersionFlux = DispersionFluxImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod, referenceSystem >
 Evaluates the dispersive flux. More...
 
template<class TypeTag , ReferenceSystemFormulation referenceSystem = ReferenceSystemFormulation::massAveraged>
using FicksLaw = FicksLawImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod, referenceSystem >
 Evaluates the diffusive mass flux according to Fick's law. More...
 
template<class TypeTag >
using ForchheimersLaw = ForchheimersLawImplementation< TypeTag, ForchheimerVelocity< GetPropType< TypeTag, Properties::Scalar >, GetPropType< TypeTag, Properties::GridGeometry >, GetPropType< TypeTag, Properties::FluxVariables > >, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Evaluates the normal component of the Forchheimer velocity on a (sub)control volume face. More...
 
template<class TypeTag >
using FouriersLaw = FouriersLawImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Evaluates the heat conduction flux according to Fouriers's law. More...
 
template<class TypeTag >
using FouriersLawNonEquilibrium = FouriersLawNonEquilibriumImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Evaluates the heat conduction flux according to Fouriers's law. More...
 
template<class TypeTag , ReferenceSystemFormulation referenceSystem = ReferenceSystemFormulation::massAveraged>
using MaxwellStefansLaw = MaxwellStefansLawImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod, referenceSystem >
 Evaluates the diffusive mass flux according to Maxwell Stefan's law. More...
 
template<class GridGeometry >
using UpwindScheme = UpwindSchemeImpl< GridGeometry, typename GridGeometry::DiscretizationMethod >
 The upwind scheme used for the advective fluxes. This depends on the chosen discretization method. More...
 
template<class TypeTag >
using FreeflowNCFluxVariables = FreeflowNCFluxVariablesImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the multi-component free-flow model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag >
using FreeflowNCResidual = FreeflowNCResidualImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the multi-component free-flow model (balance equations). This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag >
using NavierStokesFluxVariables = NavierStokesFluxVariablesImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the Navier-Stokes model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag >
using NavierStokesResidual = NavierStokesResidualImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the Navier-Stokes model (balance equations). This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag >
using NavierStokesMassProblem = NavierStokesMassProblemImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Navier-Stokes mass problem class. More...
 
template<int dimension>
using NavierStokesMomentumPQ1BubbleIndices = NavierStokesMomentumDiamondIndices< dimension >
 The common indices for the isothermal Navier-Stokes model. More...
 
template<class Traits >
using NavierStokesMomentumPQ1BubbleVolumeVariables = NavierStokesMomentumDiamondVolumeVariables< Traits >
 Volume variables for the single-phase Navier-Stokes model. More...
 
template<class TypeTag >
using NavierStokesMomentumProblem = NavierStokesMomentumProblemImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Navier-Stokes momentum problem class. More...
 
template<class TypeTag >
using NavierStokesParentProblem = typename NavierStokesParentProblemImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >::type
 The actual NavierStokesParentProblem. More...
 
template<class TypeTag >
using NavierStokesProblem = NavierStokesProblemImpl< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 Navier-Stokes problem class. More...
 
template<class Problem , class ModelTraits , bool diffusionIsSolDependent, bool heatConductionIsSolDependent>
using FreeFlowScalarFluxVariablesCacheFiller = FreeFlowScalarFluxVariablesCacheFillerImplementation< Problem, ModelTraits, diffusionIsSolDependent, heatConductionIsSolDependent, typename ProblemTraits< Problem >::GridGeometry::DiscretizationMethod >
 The flux variables cache filler class for free flow. More...
 
template<class GridGeometry , class FluxVariables , bool enableEneryBalance, bool isCompositional>
using FreeFlowEnergyLocalResidual = FreeFlowEnergyLocalResidualImplementation< GridGeometry, FluxVariables, typename GridGeometry::DiscretizationMethod, enableEneryBalance, isCompositional >
 Element-wise calculation of the local residual for non-isothermal free-flow models. More...
 
template<class TypeTag , class BaseFluxVariables >
using OneEqFluxVariables = OneEqFluxVariablesImpl< TypeTag, BaseFluxVariables, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the one-equation turbulence model by Spalart-Allmaras. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag , class BaseLocalResidual >
using OneEqResidual = OneEqResidualImpl< TypeTag, BaseLocalResidual, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the one-equation turbulence model by Spalart-Allmaras This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag >
using RANSProblem = RANSProblemImpl< TypeTag, GetPropType< TypeTag, Properties::ModelTraits >::turbulenceModel()>
 the turbulence-model-specfic RANS problem More...
 
template<class TypeTag , class BaseFluxVariables >
using KEpsilonFluxVariables = KEpsilonFluxVariablesImpl< TypeTag, BaseFluxVariables, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the k-epsilon model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag , class BaseLocalResidual >
using KEpsilonResidual = KEpsilonResidualImpl< TypeTag, BaseLocalResidual, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the k-epsilon model. This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag , class BaseFluxVariables >
using KOmegaFluxVariables = KOmegaFluxVariablesImpl< TypeTag, BaseFluxVariables, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the k-omega model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag , class BaseLocalResidual >
using KOmegaResidual = KOmegaResidualImpl< TypeTag, BaseLocalResidual, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the k-omega model. This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag , class BaseFluxVariables >
using LowReKEpsilonFluxVariables = LowReKEpsilonFluxVariablesImpl< TypeTag, BaseFluxVariables, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the low-Reynolds k-epsilon model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag , class BaseLocalResidual >
using LowReKEpsilonResidual = LowReKEpsilonResidualImpl< TypeTag, BaseLocalResidual, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the low-Reynolds k-epsilon model. This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class TypeTag , class BaseFluxVariables >
using SSTFluxVariables = SSTFluxVariablesImpl< TypeTag, BaseFluxVariables, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables class for the SST model. This is a convenience alias for that actual, discretization-specific flux variables. More...
 
template<class TypeTag , class BaseLocalResidual >
using SSTResidual = SSTResidualImpl< TypeTag, BaseLocalResidual, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The local residual class for the SST model. This is a convenience alias for the actual, discretization-specific local residual. More...
 
template<class Traits , class Impl >
using FreeFlowVolumeVariables = FreeFlowVolumeVariablesImplementation< Traits, Impl, Traits::ModelTraits::enableEnergyBalance()>
 Volume variables for free-flow models. The class is specialized for isothermal and non-isothermal models. More...
 
template<class Geometry >
using DistanceField = AABBDistanceField< Geometry >
 Class to calculate the closest distance from a point to a given set of geometries describing the domain's boundaries. More...
 
template<int dim, int dimWorld, class ctype >
using Triangulation = std::vector< std::array< Dune::FieldVector< ctype, dimWorld >, dim+1 > >
 The default data type to store triangulations. More...
 
template<class GridGeometry >
using LinearSolverTraits = LinearSolverTraitsImpl< GridGeometry, typename GridGeometry::DiscretizationMethod >
 The type traits required for using the IstlFactoryBackend. More...
 
template<class MDTraits , class CouplingManager >
using FreeFlowPoreNetworkCouplingConditions = FreeFlowPoreNetworkCouplingConditionsImplementation< MDTraits, CouplingManager, GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::enableEnergyBalance(),(GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::numFluidComponents() > 1) >
 Coupling conditions for the coupling of a pore-network model with a (Navier-)Stokes model (staggerd grid). More...
 
template<class MDTraits , class CouplingManager >
using FreeFlowPorousMediumCouplingConditions = FreeFlowPorousMediumCouplingConditionsImplementation< MDTraits, CouplingManager, GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::enableEnergyBalance(),(GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::numFluidComponents() > 1) >
 Data for the coupling of a Darcy model (cell-centered finite volume) with a (Navier-)Stokes model (staggerd grid). More...
 
template<class MDTraits , class CouplingManager >
using StokesDarcyCouplingData = StokesDarcyCouplingDataImplementation< MDTraits, CouplingManager, GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::enableEnergyBalance(),(GetPropType< typename MDTraits::template SubDomain< 0 >::TypeTag, Properties::ModelTraits >::numFluidComponents() > 1)>
 Data for the coupling of a Darcy model (cell-centered finite volume) with a (Navier-)Stokes model (staggerd grid). More...
 
template<class ScalarType , class GridGeometry >
using CCTpfaFacetCouplingDarcysLaw = CCTpfaFacetCouplingDarcysLawImpl< ScalarType, GridGeometry,(int(GridGeometry::GridView::dimension)< int(GridGeometry::GridView::dimensionworld)) >
 Darcy's law for cell-centered finite volume schemes with two-point flux approximation in the context of coupled models where the coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain living on these facets. More...
 
template<class TypeTag , ReferenceSystemFormulation referenceSystem = ReferenceSystemFormulation::massAveraged>
using CCTpfaFacetCouplingFicksLaw = CCTpfaFacetCouplingFicksLawImpl< TypeTag, referenceSystem,(int(GetPropType< TypeTag, Properties::GridGeometry >::GridView::dimension)< int(GetPropType< TypeTag, Properties::GridGeometry >::GridView::dimensionworld)) >
 Fick's law for cell-centered finite volume schemes with two-point flux approximation in the context of coupled models where the coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain defined on these facets. More...
 
template<class TypeTag >
using CCTpfaFacetCouplingFouriersLaw = CCTpfaFacetCouplingFouriersLawImpl< TypeTag,(int(GetPropType< TypeTag, Properties::GridGeometry >::GridView::dimension)< int(GetPropType< TypeTag, Properties::GridGeometry >::GridView::dimensionworld)) >
 Fouriers's law for cell-centered finite volume schemes with two-point flux approximation in the context of coupled models where the coupling occurs across the facets of the bulk domain elements with a lower-dimensional domain defined on these facets. More...
 
template<class Traits >
using FreeFlowCouplingManager = typename Detail::FreeFlowCouplingManagerSelector< Traits >::type
 The interface of the coupling manager for free flow systems. More...
 
template<class DomainGridView , class TargetGridView , class DomainMapper , class TargetMapper >
using MultiDomainGlue = IntersectionEntitySet< GridViewGeometricEntitySet< DomainGridView, 0, DomainMapper >, GridViewGeometricEntitySet< TargetGridView, 0, TargetMapper > >
 A convenience alias for the IntersectionEntitySet of two GridViewGeometricEntitySets. More...
 
template<class Traits >
using StaggeredFreeFlowCouplingManager = FreeFlowCouplingManager< Traits >
 The interface of the coupling manager for free flow systems. More...
 
template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using VectorCommDataHandleEqual = VectorCommDataHandle< Mapper, Vector, codim, Detail::SetEqual, DataType >
 
template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using VectorCommDataHandleSum = VectorCommDataHandle< Mapper, Vector, codim, Detail::Sum, DataType >
 
template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using VectorCommDataHandleMin = VectorCommDataHandle< Mapper, Vector, codim, Detail::Min, DataType >
 
template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using VectorCommDataHandleMax = VectorCommDataHandle< Mapper, Vector, codim, Detail::Max, DataType >
 
template<class Traits , bool useConstraintSolver = true>
using TwoPTwoCVolumeVariables = TwoPTwoCVolumeVariablesImplementation< Traits, Traits::ModelTraits::enableChemicalNonEquilibrium(), useConstraintSolver >
 Contains the quantities which are constant within a finite volume in the two-phase two-component model. More...
 
template<class TypeTag >
using PorousMediumFluxVariablesCache = PorousMediumFluxVariablesCacheImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables cache classes for porous media. More...
 
template<class TypeTag >
using PorousMediumFluxVariablesCacheFiller = PorousMediumFluxVariablesCacheFillerImplementation< TypeTag, typename GetPropType< TypeTag, Properties::GridGeometry >::DiscretizationMethod >
 The flux variables cache filler class for porous media. More...
 
template<class Traits >
using MPNCVolumeVariables = MPNCVolumeVariablesImplementation< Traits, Traits::ModelTraits::enableChemicalNonEquilibrium()>
 Contains the quantities which are constant within a finite volume in the MpNc model. More...
 
template<class ModelTraits , class EquilibriumIOFields >
using NonEquilibriumIOFields = NonEquilibriumIOFieldsImplementation< ModelTraits, EquilibriumIOFields, ModelTraits::enableThermalNonEquilibrium()>
 
template<class TypeTag >
using NonEquilibriumLocalResidual = NonEquilibriumLocalResidualImplementation< TypeTag, GetPropType< TypeTag, Properties::ModelTraits >::enableChemicalNonEquilibrium()>
 
template<class Traits , class EquilibriumVolumeVariables >
using NonEquilibriumVolumeVariables = NonEquilibriumVolumeVariablesImplementation< Traits, EquilibriumVolumeVariables, Traits::ModelTraits::enableChemicalNonEquilibrium(), Traits::ModelTraits::enableThermalNonEquilibrium(), Traits::ModelTraits::numEnergyEqFluid()>
 
template<class TypeTag >
using EnergyLocalResidual = EnergyLocalResidualImplementation< TypeTag, GetPropType< TypeTag, Properties::ModelTraits >::enableEnergyBalance()>
 
template<class IsothermalTraits , class Impl >
using EnergyVolumeVariables = EnergyVolumeVariablesImplementation< IsothermalTraits, Impl, IsothermalTraits::ModelTraits::enableEnergyBalance()>
 Base class for the model specific class which provides access to all volume averaged quantities. More...
 

Enumerations

enum class  DiffMethod { DiffMethod::numeric , DiffMethod::analytic , DiffMethod::automatic }
 Differentiation methods in order to compute the derivatives of the residual i.e. the entries in the jacobian matrix. More...
 
enum class  EntityColor { EntityColor::red , EntityColor::yellow , EntityColor::orange , EntityColor::green }
 The colors of elements and vertices required for partial Jacobian reassembly. More...
 
enum class  NusseltFormulation { dittusBoelter , WakaoKaguei , VDI }
 A container for possible values of the property for selecting which Nusselt parametrization to choose. The actual value is set via the property NusseltFormulation. More...
 
enum class  SherwoodFormulation { WakaoKaguei }
 A container for possible values of the property for selecting which Sherwood parametrization to choose. The actual value is set via the property SherwoodFormulation. More...
 
enum class  MpfaMethods : unsigned int { MpfaMethods::oMethod }
 The available mpfa schemes in Dumux. More...
 
enum class  ReferenceSystemFormulation { ReferenceSystemFormulation::massAveraged , ReferenceSystemFormulation::molarAveraged }
 The formulations available for Fick's law related to the reference system. More...
 
enum class  TvdApproach { TvdApproach::none , TvdApproach::uniform , TvdApproach::li , TvdApproach::hou }
 Available Tvd approaches. More...
 
enum class  DifferencingScheme {
  DifferencingScheme::none , DifferencingScheme::vanleer , DifferencingScheme::vanalbada , DifferencingScheme::minmod ,
  DifferencingScheme::superbee , DifferencingScheme::umist , DifferencingScheme::mclimiter , DifferencingScheme::wahyd
}
 Available differencing schemes. More...
 
enum class  TurbulenceModel {
  TurbulenceModel::none , TurbulenceModel::zeroeq , TurbulenceModel::oneeq , TurbulenceModel::kepsilon ,
  TurbulenceModel::lowrekepsilon , TurbulenceModel::komega , TurbulenceModel::sst
}
 The available free flow turbulence models in Dumux. More...
 
enum class  SSTModel { SSTModel::BSL , SSTModel::SST }
 The available variations of the SST Turbulence Model. More...
 
enum  ElectroChemistryModel { Ochs , Acosta }
 The type of electrochemistry models implemented here (Ochs (2008) [50] or Acosta et al. (2006) [1] ) More...
 
enum class  TwoPFormulation { TwoPFormulation::p0s1 , TwoPFormulation::p1s0 }
 Enumerates the formulations which the two-phase model accepts. More...
 
enum class  MpNcPressureFormulation { MpNcPressureFormulation::mostWettingFirst , MpNcPressureFormulation::leastWettingFirst }
 Enumerates the formulations which the MpNc model accepts. More...
 

Functions

template<class Grid >
bool adapt (Grid &grid, GridDataTransfer< Grid > &dataTransfer)
 Adapt the grid and reconstruct the user data. More...
 
template<class Grid , class Indicator >
bool markElements (Grid &grid, const Indicator &indicator, bool verbose=true)
 A function to mark element for refinement or coarsening. More...
 
template<class GridGeometry >
auto computeColoring (const GridGeometry &gg, int verbosity=1)
 Compute iterable lists of element seeds partitioned by color. More...
 
template<class SolutionVector , class Problem >
void assembleInitialSolution (SolutionVector &sol, const Problem &problem)
 Set a solution vector to the initial solution provided by the problem. More...
 
template<class SolutionVector , class Problem >
SolutionVector makeInitialSolution (const Problem &problem)
 Create a solution vector filled with the initial solution provided by the problem. More...
 
template<bool isImplicit, class GridGeometry , typename std::enable_if_t<(GridGeometry::discMethod==DiscretizationMethods::box), int > = 0>
Dune::MatrixIndexSet getJacobianPattern (const GridGeometry &gridGeometry)
 Helper function to generate Jacobian pattern for the box method. More...
 
template<bool isImplicit, class GridGeometry , typename std::enable_if_t<((GridGeometry::discMethod==DiscretizationMethods::staggered)), int > = 0>
auto getJacobianPattern (const GridGeometry &gridGeometry)
 Helper function to generate Jacobian pattern for the staggered method. More...
 
template<class FEBasis >
Dune::MatrixIndexSet getFEJacobianPattern (const FEBasis &feBasis)
 Helper function to generate Jacobian pattern for finite element scheme. More...
 
std::string defaultUsageMessage (const std::string &programName)
 Provides a general text block, that is part of error/ help messages. More...
 
template<typename Range , typename RangeIterator = decltype(std::begin(std::declval<Range>())), typename = decltype(std::end(std::declval<Range>()))>
constexpr auto enumerate (Range &&iterable)
 A Python-like enumerate function. More...
 
void initialize (int &argc, char *argv[])
 
template<class GridGeometry , class SolutionVector , typename std::enable_if_t<!Detail::hasLocalFunction< SolutionVector >(), int > = 0>
auto integrateGridFunction (const GridGeometry &gg, const SolutionVector &sol, std::size_t order)
 Integrate a grid function over a grid view. More...
 
template<class GridGeometry , class Sol1 , class Sol2 , typename std::enable_if_t<!Detail::hasLocalFunction< Sol1 >(), int > = 0>
auto integrateL2Error (const GridGeometry &gg, const Sol1 &sol1, const Sol2 &sol2, std::size_t order)
 Integrate a function over a grid view. More...
 
template<class Scalar , class Function , typename std::enable_if_t< std::is_invocable_r_v< Scalar, Function, Scalar > > ...>
Scalar integrateScalarFunction (const Function &f, const Scalar lowerBound, const Scalar upperBound, const Scalar targetAbsoluteError=1e-13)
 Integrate a scalar function. More...
 
template<class Scalar >
constexpr Scalar arithmeticMean (Scalar x, Scalar y, Scalar wx=1.0, Scalar wy=1.0) noexcept
 Calculate the (weighted) arithmetic mean of two scalar values. More...
 
template<class Scalar >
constexpr Scalar harmonicMean (Scalar x, Scalar y, Scalar wx=1.0, Scalar wy=1.0) noexcept
 Calculate the (weighted) harmonic mean of two scalar values. More...
 
template<class Scalar >
Scalar geometricMean (Scalar x, Scalar y) noexcept
 Calculate the geometric mean of two scalar values. More...
 
template<class Scalar , int m, int n>
void harmonicMeanMatrix (Dune::FieldMatrix< Scalar, m, n > &K, const Dune::FieldMatrix< Scalar, m, n > &Ki, const Dune::FieldMatrix< Scalar, m, n > &Kj)
 Calculate the harmonic mean of a fixed-size matrix. More...
 
template<class Scalar , class SolContainer >
int invertLinearPolynomial (SolContainer &sol, Scalar a, Scalar b)
 Invert a linear polynomial analytically. More...
 
template<class Scalar , class SolContainer >
int invertQuadraticPolynomial (SolContainer &sol, Scalar a, Scalar b, Scalar c)
 Invert a quadratic polynomial analytically. More...
 
template<class Scalar , class SolContainer >
int invertCubicPolynomial (SolContainer *sol, Scalar a, Scalar b, Scalar c, Scalar d, std::size_t numPostProcessIterations=1)
 Invert a cubic polynomial analytically. More...
 
template<class Scalar , int dim>
bool isLarger (const Dune::FieldVector< Scalar, dim > &pos, const Dune::FieldVector< Scalar, dim > &smallerVec)
 Comparison of two position vectors. More...
 
template<class Scalar , int dim>
bool isSmaller (const Dune::FieldVector< Scalar, dim > &pos, const Dune::FieldVector< Scalar, dim > &largerVec)
 Comparison of two position vectors. More...
 
template<class Scalar , int dim>
bool isBetween (const Dune::FieldVector< Scalar, dim > &pos, const Dune::FieldVector< Scalar, dim > &smallerVec, const Dune::FieldVector< Scalar, dim > &largerVec)
 Comparison of three position vectors. More...
 
template<class Policy = InterpolationPolicy::Linear, class Scalar , class ... Parameter>
Scalar interpolate (Scalar ip, Parameter &&... params)
 a generic function to interpolate given a set of parameters and an interpolation point More...
 
template<class Scalar >
std::vector< Scalar > linspace (const Scalar begin, const Scalar end, std::size_t samples, bool endPoint=true)
 Generates linearly spaced vectors. More...
 
template<class Scalar >
Scalar antoine (Scalar temperature, Scalar A, Scalar B, Scalar C)
 Evaluates the Antoine equation used to calculate the vapour pressure of various liquids. More...
 
template<class ValueType >
constexpr int sign (const ValueType &value) noexcept
 Sign or signum function. More...
 
template<class Scalar >
Dune::FieldVector< Scalar, 3 > crossProduct (const Dune::FieldVector< Scalar, 3 > &vec1, const Dune::FieldVector< Scalar, 3 > &vec2)
 Cross product of two vectors in three-dimensional Euclidean space. More...
 
template<class Scalar >
Scalar crossProduct (const Dune::FieldVector< Scalar, 2 > &vec1, const Dune::FieldVector< Scalar, 2 > &vec2)
 Cross product of two vectors in two-dimensional Euclidean space retuning scalar. More...
 
template<class Scalar >
Scalar tripleProduct (const Dune::FieldVector< Scalar, 3 > &vec1, const Dune::FieldVector< Scalar, 3 > &vec2, const Dune::FieldVector< Scalar, 3 > &vec3)
 Triple product of three vectors in three-dimensional Euclidean space retuning scalar. More...
 
template<class Scalar , int m, int n>
Dune::FieldMatrix< Scalar, n, m > getTransposed (const Dune::FieldMatrix< Scalar, m, n > &M)
 Transpose a FieldMatrix. More...
 
template<class Scalar >
Dune::DynamicMatrix< Scalar > getTransposed (const Dune::DynamicMatrix< Scalar > &M)
 Transpose a DynamicMatrix. More...
 
template<class Scalar >
Dune::DynamicMatrix< Scalar > multiplyMatrices (const Dune::DynamicMatrix< Scalar > &M1, const Dune::DynamicMatrix< Scalar > &M2)
 Multiply two dynamic matrices. More...
 
template<class Scalar , int rows1, int cols1, int cols2>
Dune::FieldMatrix< Scalar, rows1, cols2 > multiplyMatrices (const Dune::FieldMatrix< Scalar, rows1, cols1 > &M1, const Dune::FieldMatrix< Scalar, cols1, cols2 > &M2)
 Multiply two field matrices. More...
 
template<class MatrixType >
Dune::DenseMatrix< MatrixType >::field_type trace (const Dune::DenseMatrix< MatrixType > &M)
 Trace of a dense matrix. More...
 
template<class MAT , class V >
Dune::DenseVector< V >::derived_type mv (const Dune::DenseMatrix< MAT > &M, const Dune::DenseVector< V > &v)
 Returns the result of the projection of a vector v with a Matrix M. More...
 
template<class FieldScalar , class V >
std::enable_if_t< Dune::IsNumber< FieldScalar >::value, typename Dune::DenseVector< V >::derived_type > mv (const FieldScalar m, const Dune::DenseVector< V > &v)
 Returns the result of a vector v multiplied by a scalar m. More...
 
template<class V1 , class MAT , class V2 >
Dune::DenseMatrix< MAT >::value_type vtmv (const Dune::DenseVector< V1 > &v1, const Dune::DenseMatrix< MAT > &M, const Dune::DenseVector< V2 > &v2)
 Evaluates the scalar product of a vector v2, projected by a matrix M, with a vector v1. More...
 
template<class V1 , class FieldScalar , class V2 >
std::enable_if_t< Dune::IsNumber< FieldScalar >::value, FieldScalar > vtmv (const Dune::DenseVector< V1 > &v1, const FieldScalar m, const Dune::DenseVector< V2 > &v2)
 Evaluates the scalar product of a vector v2, scaled by a scalar m, with a vector v1. More...
 
template<class Scalar >
std::array< Scalar, 2 > linearRegression (const std::vector< Scalar > &x, const std::vector< Scalar > &y)
 Returns the [intercept, slope] of the regression line fitted to a set of (x, y) data points. More...
 
template<typename T , typename... Args>
getParam (Args &&... args)
 A free function to get a parameter from the parameter tree singleton. More...
 
template<typename T , typename... Args>
getParamFromGroup (Args &&... args)
 A free function to get a parameter from the parameter tree singleton with a model group. More...
 
bool hasParam (const std::string &param)
 Check whether a key exists in the parameter tree. More...
 
bool hasParamInGroup (const std::string &paramGroup, const std::string &param)
 Check whether a key exists in the parameter tree with a model group prefix. More...
 
std::vector< std::string > getParamSubGroups (const std::string &subGroupName, const std::string &paramGroup)
 Get a list of sub groups from the parameter tree sorted by relevance. More...
 
template<class ... Args, std::size_t ... i>
auto partial (Dune::MultiTypeBlockVector< Args... > &v, Dune::index_constant< i >... indices)
 a function to get a MultiTypeBlockVector with references to some entries of another MultiTypeBlockVector More...
 
template<class ... Args, std::size_t ... i>
auto partial (const Dune::MultiTypeBlockVector< Args... > &v, Dune::index_constant< i >... indices)
 a function to get a MultiTypeBlockVector with const references to some entries of another MultiTypeBlockVector More...
 
template<class ... Args, std::size_t ... i>
auto partial (std::tuple< Args... > &v, Dune::index_constant< i >... indices)
 a function to get a tuple with references to some entries of another tuple More...
 
template<class ... Args, std::size_t ... i>
auto partial (const std::tuple< Args... > &v, Dune::index_constant< i >... indices)
 a function to get a tuple with const references to some entries of another tuple More...
 
template<class T , std::size_t ... i>
auto partial (T &t, std::tuple< Dune::index_constant< i >... > indices)
 a function to get a MultiTypeBlockVector with references to some entries of another MultiTypeBlockVector More...
 
template<class TypeTag , template< class, class > class Property>
constexpr auto getPropValue ()
 get the value data member of a property More...
 
std::vector< std::string_view > tokenize (std::string_view str, std::string_view delim)
 
std::vector< std::string_view > split (std::string_view str, std::string_view delim, bool removeEmpty=false)
 
template<typename Expression >
constexpr auto isValid (const Expression &t)
 A function that creates a test functor to do class member introspection at compile time. More...
 
template<std::size_t offset, std::size_t ... is>
constexpr std::index_sequence<(offset+is)... > addOffsetToIndexSequence (std::index_sequence< is... >)
 
template<std::size_t offset, std::size_t n>
constexpr auto makeIndexSequenceWithOffset ()
 
template<class Element , class SolutionVector , class GridGeometry >
auto elementSolution (const Element &element, const SolutionVector &sol, const GridGeometry &gg) -> std::enable_if_t< GridGeometry::discMethod==DiscretizationMethods::box, BoxElementSolution< typename GridGeometry::LocalView, std::decay_t< decltype(std::declval< SolutionVector >()[0])> > >
 Make an element solution for box schemes. More...
 
template<class Element , class ElementVolumeVariables , class FVElementGeometry >
auto elementSolution (const Element &element, const ElementVolumeVariables &elemVolVars, const FVElementGeometry &gg) -> std::enable_if_t< FVElementGeometry::GridGeometry::discMethod==DiscretizationMethods::box, BoxElementSolution< FVElementGeometry, typename ElementVolumeVariables::VolumeVariables::PrimaryVariables > >
 Make an element solution for box schemes. More...
 
template<class FVElementGeometry , class PrimaryVariables >
auto elementSolution (PrimaryVariables &&priVars) -> std::enable_if_t< FVElementGeometry::GridGeometry::discMethod==DiscretizationMethods::cctpfa||FVElementGeometry::GridGeometry::discMethod==DiscretizationMethods::ccmpfa, CCElementSolution< FVElementGeometry, PrimaryVariables > >
 Make an element solution for cell-centered schemes. More...
 
template<class FVElementGeometry , class PrimaryVariables >
auto elementSolution (const PrimaryVariables &priVars) -> std::enable_if_t< FVElementGeometry::GridGeometry::discMethod==DiscretizationMethods::cctpfa||FVElementGeometry::GridGeometry::discMethod==DiscretizationMethods::ccmpfa, CCElementSolution< FVElementGeometry, PrimaryVariables > >
 Make an element solution for cell-centered schemes. More...
 
template<class EG , class IVSubControlVolume , class Tensor >
Dune::FieldVector< typename Tensor::field_type, IVSubControlVolume::myDimension > computeMpfaTransmissibility (const IVSubControlVolume &scv, const typename EG::SubControlVolumeFace &scvf, const Tensor &t, typename IVSubControlVolume::ctype extrusionFactor)
 Free function to evaluate the Mpfa transmissibility associated with the flux (in the form of flux = t*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor t. More...
 
template<class EG , class IVSubControlVolume , class Tensor >
Dune::FieldVector< typename Tensor::field_type, IVSubControlVolume::myDimension > computeMpfaTransmissibility (const EG &fvGeometry, const IVSubControlVolume &scv, const typename EG::SubControlVolumeFace &scvf, const Tensor &t, typename IVSubControlVolume::ctype extrusionFactor)
 Free function to evaluate the Mpfa transmissibility associated with the flux (in the form of flux = t*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor t. More...
 
template<class EG , class IVSubControlVolume , class Tensor , std::enable_if_t< Dune::IsNumber< Tensor >::value, int > = 1>
Dune::FieldVector< Tensor, IVSubControlVolume::myDimension > computeMpfaTransmissibility (const IVSubControlVolume &scv, const typename EG::SubControlVolumeFace &scvf, const Tensor &t, typename IVSubControlVolume::ctype extrusionFactor)
 Free function to evaluate the Mpfa transmissibility associated with the flux (in the form of flux = t*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor t, where t is a scalar. More...
 
template<class EG , class IVSubControlVolume , class Tensor , std::enable_if_t< Dune::IsNumber< Tensor >::value, int > = 1>
Dune::FieldVector< Tensor, IVSubControlVolume::myDimension > computeMpfaTransmissibility (const EG &fvGeometry, const IVSubControlVolume &scv, const typename EG::SubControlVolumeFace &scvf, const Tensor &t, typename IVSubControlVolume::ctype extrusionFactor)
 Free function to evaluate the Mpfa transmissibility associated with the flux (in the form of flux = t*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor t, where t is a scalar. More...
 
template<class GridView >
void checkOverlapSizeCCMpfa (const GridView &gridView)
 check the overlap size for parallel computations More...
 
template<class SubControlVolumeFace , class SubControlVolume , class Tensor >
Tensor::field_type computeTpfaTransmissibility (const SubControlVolumeFace &scvf, const SubControlVolume &scv, const Tensor &T, typename SubControlVolume::Traits::Scalar extrusionFactor)
 Free function to evaluate the Tpfa transmissibility associated with the flux (in the form of flux = T*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor T. More...
 
template<class FVElementGeometry , class Tensor >
Tensor::field_type computeTpfaTransmissibility (const FVElementGeometry &fvGeometry, const typename FVElementGeometry::SubControlVolumeFace &scvf, const typename FVElementGeometry::SubControlVolume &scv, const Tensor &T, typename FVElementGeometry::SubControlVolume::Traits::Scalar extrusionFactor)
 Free function to evaluate the Tpfa transmissibility associated with the flux (in the form of flux = T*gradU) across a sub-control volume face stemming from a given sub-control volume with corresponding tensor T. More...
 
template<class SubControlVolumeFace , class SubControlVolume , class Tensor , typename std::enable_if_t< Dune::IsNumber< Tensor >::value, int > = 0>
Tensor computeTpfaTransmissibility (const SubControlVolumeFace &scvf, const SubControlVolume &scv, Tensor t, typename SubControlVolumeFace::Traits::Scalar extrusionFactor)
 Free function to evaluate the Tpfa transmissibility associated with the flux (in the form of flux = T*gradU) across a sub-control volume face stemming from a given sub-control volume for the case where T is just a scalar. More...
 
template<class FVElementGeometry , class Tensor , typename std::enable_if_t< Dune::IsNumber< Tensor >::value, int > = 0>
Tensor computeTpfaTransmissibility (const FVElementGeometry &fvGeometry, const typename FVElementGeometry::SubControlVolumeFace &scvf, const typename FVElementGeometry::SubControlVolume &scv, Tensor t, typename FVElementGeometry::SubControlVolumeFace::Traits::Scalar extrusionFactor)
 Free function to evaluate the Tpfa transmissibility associated with the flux (in the form of flux = T*gradU) across a sub-control volume face stemming from a given sub-control volume for the case where T is just a scalar. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
auto evalGradients (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const BoxElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Evaluates the gradient of a given box element solution to a given global position. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
auto evalGradients (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const FaceCenteredDiamondElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Evaluates the gradient of a given diamond scheme element solution to a given global position. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
auto evalGradients (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const PQ1BubbleElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Evaluates the gradient of a given pq1bubble scheme element solution to a given global position. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
Dune::FieldVector< typename Element::Geometry::GlobalCoordinate, PrimaryVariables::dimension > evalGradients (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const CCElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos)
 Evaluates the gradient of a given CCElementSolution to a given global position. This function is only here for (compilation) compatibility reasons with the box scheme. The solution within the control volumes is constant and thus gradients are zero. One can compute gradients towards the sub-control volume faces after reconstructing the solution on the faces. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const BoxElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given box element solution at a given global position. Uses the finite element cache of the grid geometry. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const BoxElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given box element solution at a given global position. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const CCElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given cell-centered element solution at a given global position. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const CCElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given cell-centered element solution at a given global position. Overload of the above evalSolution() function without a given gridGeometry. For compatibility reasons with the box scheme. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const FaceCenteredDiamondElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given diamond scheme element solution at a given global position. Uses the finite element cache of the grid geometry. More...
 
template<class Element , class FVElementGeometry , class PrimaryVariables >
PrimaryVariables evalSolution (const Element &element, const typename Element::Geometry &geometry, const typename FVElementGeometry::GridGeometry &gridGeometry, const PQ1BubbleElementSolution< FVElementGeometry, PrimaryVariables > &elemSol, const typename Element::Geometry::GlobalCoordinate &globalPos, bool ignoreState=false)
 Interpolates a given pq1bubble scheme element solution at a given global position. Uses the finite element cache of the grid geometry. More...
 
template<class Vector >
static std::size_t normalAxis (const Vector &v)
 Returns the normal axis index of a unit vector (0 = x, 1 = y, 2 = z) More...
 
template<class GridCache >
GridCache::LocalView localView (const GridCache &gridCache)
 Free function to get the local view of a grid cache object. More...
 
template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto makeProjectorPair (const FEBasisDomain &feBasisDomain, const FEBasisTarget &feBasisTarget, GlueType glue)
 Creates a pair of projectors between the space with basis feBasisDomain to the space with basis feBasisTarget. More...
 
template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto makeProjector (const FEBasisDomain &feBasisDomain, const FEBasisTarget &feBasisTarget, GlueType glue)
 Creates a forward projector from the space feBasisDomain to the space with basis feBasisTarget. More...
 
template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto makeProjectionMatricesPair (const FEBasisDomain &feBasisDomain, const FEBasisTarget &feBasisTarget, GlueType glue)
 Creates the matrices underlying l2-projections. More...
 
template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto makeProjectionMatrices (const FEBasisDomain &feBasisDomain, const FEBasisTarget &feBasisTarget, GlueType glue)
 Creates the matrices underlying l2-projections. More...
 
template<class PrimaryVariables , class CellCenterPrimaryVariables >
PrimaryVariables makePriVarsFromCellCenterPriVars (const CellCenterPrimaryVariables &cellCenterPriVars)
 Helper function to create a PrimaryVariables object from CellCenterPrimaryVariables. More...
 
template<class PrimaryVariables , class CellCenterPrimaryVariables >
StaggeredElementSolution< PrimaryVariables > makeElementSolutionFromCellCenterPrivars (const CellCenterPrimaryVariables &cellCenterPriVars)
 Helper function to create an elementSolution from cell center primary variables. More...
 
template<class Vector >
static unsigned int directionIndex (Vector &&vector)
 Returns the direction index of the facet (0 = x, 1 = y, 2 = z) More...
 
template<class SubControlVolumeFace >
SubControlVolumeFace makeStaggeredBoundaryFace (const SubControlVolumeFace &scvf, const typename SubControlVolumeFace::GlobalPosition &newCenter)
 Helper function to turn a given cell scvface into a fake boundary face. More...
 
template<class Scalar , int dim>
Scalar faceTensorAverage (const Scalar T1, const Scalar T2, const Dune::FieldVector< Scalar, dim > &normal)
 Average of a discontinuous scalar field at discontinuity interface (for compatibility reasons with the function below) More...
 
template<class Scalar , int dim>
Dune::FieldMatrix< Scalar, dim > faceTensorAverage (const Dune::FieldMatrix< Scalar, dim > &T1, const Dune::FieldMatrix< Scalar, dim > &T2, const Dune::FieldVector< Scalar, dim > &normal)
 Average of a discontinuous tensorial field at discontinuity interface. More...
 
template<class VolumeVariables >
VolumeVariables::PrimaryVariables::value_type massOrMolarDensity (const VolumeVariables &volVars, ReferenceSystemFormulation referenceSys, const int phaseIdx)
 evaluates the density to be used in Fick's law based on the reference system More...
 
template<class VolumeVariables >
VolumeVariables::PrimaryVariables::value_type massOrMoleFraction (const VolumeVariables &volVars, ReferenceSystemFormulation referenceSys, const int phaseIdx, const int compIdx)
 returns the mass or mole fraction to be used in Fick's law based on the reference system More...
 
template<class IOFields , class PrimaryVariables , class ModelTraits , class FluidSystem >
std::function< std::string(int, int)> createCellCenterPVNameFunction (const std::string &paramGroup="")
 helper function to determine the names of cell-centered primary variables of a model with staggered grid discretization More...
 
template<class IOFields , class PrimaryVariables , class ModelTraits , class FluidSystem >
std::function< std::string(int, int)> createFacePVNameFunction (const std::string &paramGroup="")
 helper function to determine the names of primary variables on the cell faces of a model with staggered grid discretization More...
 
constexpr unsigned int numTurbulenceEq (TurbulenceModel model)
 
std::string turbulenceModelToString (TurbulenceModel turbulenceModel)
 return the name of the Turbulence Model More...
 
std::string sstModelToString (SSTModel sstModel)
 return the name of the sst Model as a string More...
 
SSTModel sstModelFromString (const std::string &sstModel)
 Convenience function to convert user input given as std::string to the corresponding enum class used for choosing the SST Model. More...
 
template<class ctype , int dimworld, typename std::enable_if_t< dimworld==3, int > = 0>
bool intersectsPointBoundingBox (const Dune::FieldVector< ctype, dimworld > &point, const ctype *b)
 Check whether a point is intersectin a bounding box (dimworld == 3) More...
 
template<class ctype , int dimworld>
bool intersectsPointBoundingBox (const Dune::FieldVector< ctype, dimworld > &point, const Dune::FieldVector< ctype, dimworld > &min, const Dune::FieldVector< ctype, dimworld > &max)
 Determine if a point intersects an axis-aligned bounding box The bounding box is given by the lower left corner (min) and the upper right corner (max) More...
 
template<int dimworld, class ctypea , class ctypeb , typename std::enable_if_t< dimworld==3, int > = 0>
bool intersectsBoundingBoxBoundingBox (const ctypea *a, const ctypeb *b)
 Check whether a bounding box is intersecting another bounding box (dimworld == 3) More...
 
template<int dimworld, class ctype >
ctype squaredDistancePointBoundingBox (const Dune::FieldVector< ctype, dimworld > &point, const ctype *b)
 Compute squared distance between point and bounding box. More...
 
template<class ConvexGeometry >
static Sphere< typename ConvexGeometry::ctype, ConvexGeometry::coorddimension > boundingSphere (const ConvexGeometry &geometry)
 Computes a bounding sphere of a convex polytope geometry (Dune::Geometry interface) More...
 
template<class Scalar , int dim>
static Sphere< Scalar, dim > boundingSphere (const std::vector< Dune::FieldVector< Scalar, dim > > &points)
 Computes a bounding sphere of points. More...
 
template<class Corners >
Corners::value_type center (const Corners &corners)
 The center of a given list of corners. More...
 
template<class Point >
static Sphere< typename Point::value_type, Point::dimension > circumSphereOfTriangle (const Point &a, const Point &b, const Point &c)
 Computes the circumsphere of a triangle. More...
 
template<class Geometry , typename std::enable_if_t< Geometry::mydimension==2, int > = 0>
static Sphere< typename Geometry::ctype, Geometry::coorddimension > circumSphereOfTriangle (const Geometry &triangle)
 Computes the circumsphere of a triangle. More...
 
template<class Geometry >
Geometry::ctype diameter (const Geometry &geo)
 Computes the longest distance between points of a geometry. More...
 
template<class Geometry >
static Geometry::ctype averageDistancePointGeometry (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry, std::size_t integrationOrder=2)
 Compute the average distance from a point to a geometry by integration. More...
 
template<class Point >
static Point::value_type squaredDistancePointLine (const Point &p, const Point &a, const Point &b)
 Compute the squared distance from a point to a line through the points a and b. More...
 
template<class Geometry >
static Geometry::ctype squaredDistancePointLine (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the squared distance from a point to a line given by a geometry with two corners. More...
 
template<class Point >
static Point::value_type distancePointLine (const Point &p, const Point &a, const Point &b)
 Compute the distance from a point to a line through the points a and b. More...
 
template<class Geometry >
static Geometry::ctype distancePointLine (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the distance from a point to a line given by a geometry with two corners. More...
 
template<class Point >
static Point::value_type squaredDistancePointSegment (const Point &p, const Point &a, const Point &b)
 Compute the squared distance from a point to the segment connecting the points a and b. More...
 
template<class Geometry >
static Geometry::ctype squaredDistancePointSegment (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the squared distance from a point to a given segment geometry. More...
 
template<class Point >
static Point::value_type distancePointSegment (const Point &p, const Point &a, const Point &b)
 Compute the distance from a point to the segment connecting the points a and b. More...
 
template<class Geometry >
static Geometry::ctype distancePointSegment (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the distance from a point to a given segment geometry. More...
 
template<class Point >
static Point::value_type squaredDistancePointTriangle (const Point &p, const Point &a, const Point &b, const Point &c)
 Compute the shortest squared distance from a point to the triangle connecting the points a, b and c See https://www.iquilezles.org/www/articles/triangledistance/triangledistance.htm. More...
 
template<class Geometry >
static Geometry::ctype squaredDistancePointTriangle (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the shortest squared distance from a point to a given triangle geometry. More...
 
template<class Point >
static Point::value_type distancePointTriangle (const Point &p, const Point &a, const Point &b, const Point &c)
 Compute the shortest distance from a point to the triangle connecting the points a, b and c. More...
 
template<class Geometry >
static Geometry::ctype distancePointTriangle (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the shortest distance from a point to a given triangle geometry. More...
 
template<class Geometry >
static Geometry::ctype squaredDistancePointPolygon (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the shortest squared distance from a point to a given polygon geometry. More...
 
template<class Geometry >
static Geometry::ctype distancePointPolygon (const typename Geometry::GlobalCoordinate &p, const Geometry &geometry)
 Compute the shortest distance from a point to a given polygon geometry. More...
 
template<class Geometry >
static Geometry::ctype averageDistanceSegmentGeometry (const typename Geometry::GlobalCoordinate &a, const typename Geometry::GlobalCoordinate &b, const Geometry &geometry, std::size_t integrationOrder=2)
 Compute the average distance from a segment to a geometry by integration. More...
 
template<class ctype , int dimWorld>
static ctype distance (const Dune::FieldVector< ctype, dimWorld > &a, const Dune::FieldVector< ctype, dimWorld > &b)
 Compute the shortest distance between two points. More...
 
template<class ctype , int dimWorld>
static ctype squaredDistance (const Dune::FieldVector< ctype, dimWorld > &a, const Dune::FieldVector< ctype, dimWorld > &b)
 Compute the shortest squared distance between two points. More...
 
template<class Geo1 , class Geo2 >
static auto squaredDistance (const Geo1 &geo1, const Geo2 &geo2)
 Compute the shortest distance between two geometries. More...
 
template<class Geo1 , class Geo2 >
static auto distance (const Geo1 &geo1, const Geo2 &geo2)
 Compute the shortest distance between two geometries. More...
 
template<class EntitySet , class ctype , int dimworld>
std::pair< ctype, std::size_t > closestEntity (const Dune::FieldVector< ctype, dimworld > &point, const BoundingBoxTree< EntitySet > &tree, ctype minSquaredDistance=std::numeric_limits< ctype >::max())
 Compute the closest entity in an AABB tree to a point (index and shortest squared distance) More...
 
template<class EntitySet , class ctype , int dimworld>
ctype squaredDistance (const Dune::FieldVector< ctype, dimworld > &point, const BoundingBoxTree< EntitySet > &tree, ctype minSquaredDistance=std::numeric_limits< ctype >::max())
 Compute the shortest squared distance to entities in an AABB tree. More...
 
template<class EntitySet , class ctype , int dimworld>
ctype distance (const Dune::FieldVector< ctype, dimworld > &point, const BoundingBoxTree< EntitySet > &tree, ctype minSquaredDistance=std::numeric_limits< ctype >::max())
 Compute the shortest distance to entities in an AABB tree. More...
 
template<class ctype >
int getOrientation (const Dune::FieldVector< ctype, 3 > &a, const Dune::FieldVector< ctype, 3 > &b, const Dune::FieldVector< ctype, 3 > &c, const Dune::FieldVector< ctype, 3 > &normal)
 Returns the orientation of a sequence a-->b-->c in one plane (defined by normal vector) More...
 
template<int dim, class ctype , std::enable_if_t<(dim==2), int > = 0>
std::vector< Dune::FieldVector< ctype, 3 > > grahamConvexHullImpl (std::vector< Dune::FieldVector< ctype, 3 > > &points)
 Compute the points making up the convex hull around the given set of unordered points. More...
 
template<int dim, class ctype , std::enable_if_t<(dim==2), int > = 0>
std::vector< Dune::FieldVector< ctype, 2 > > grahamConvexHullImpl (const std::vector< Dune::FieldVector< ctype, 2 > > &points)
 Compute the points making up the convex hull around the given set of unordered points. More...
 
template<int dim, class ctype , int dimWorld>
std::vector< Dune::FieldVector< ctype, dimWorld > > grahamConvexHull (std::vector< Dune::FieldVector< ctype, dimWorld > > &points)
 Compute the points making up the convex hull around the given set of unordered points. More...
 
template<int dim, class ctype , int dimWorld>
std::vector< Dune::FieldVector< ctype, dimWorld > > grahamConvexHull (const std::vector< Dune::FieldVector< ctype, dimWorld > > &points)
 Compute the points making up the convex hull around the given set of unordered points. More...
 
template<class EntitySet , class ctype , int dimworld>
std::vector< std::size_t > intersectingEntities (const Dune::FieldVector< ctype, dimworld > &point, const BoundingBoxTree< EntitySet > &tree, bool isCartesianGrid=false)
 Compute all intersections between entities and a point. More...
 
template<class EntitySet , class ctype , int dimworld>
void intersectingEntities (const Dune::FieldVector< ctype, dimworld > &point, const BoundingBoxTree< EntitySet > &tree, std::size_t node, std::vector< std::size_t > &entities, bool isCartesianGrid=false)
 Compute intersections with point for all nodes of the bounding box tree recursively. More...
 
template<class Geometry , class EntitySet >
std::vector< IntersectionInfo< Geometry::coorddimension, typename Geometry::ctype, typename EntitySet::ctype > > intersectingEntities (const Geometry &geometry, const BoundingBoxTree< EntitySet > &tree)
 Compute all intersections between a geometry and a bounding box tree. More...
 
template<class Geometry , class EntitySet >
void intersectingEntities (const Geometry &geometry, const BoundingBoxTree< EntitySet > &tree, const std::array< typename Geometry::ctype, 2 *Geometry::coorddimension > &bBox, std::size_t nodeIdx, std::vector< IntersectionInfo< Geometry::coorddimension, typename Geometry::ctype, typename EntitySet::ctype > > &intersections)
 Compute intersections with point for all nodes of the bounding box tree recursively. More...
 
template<class EntitySet0 , class EntitySet1 >
std::vector< IntersectionInfo< EntitySet0::dimensionworld, typename EntitySet0::ctype, typename EntitySet1::ctype > > intersectingEntities (const BoundingBoxTree< EntitySet0 > &treeA, const BoundingBoxTree< EntitySet1 > &treeB)
 Compute all intersections between two bounding box trees. More...
 
template<class EntitySet0 , class EntitySet1 >
void intersectingEntities (const BoundingBoxTree< EntitySet0 > &treeA, const BoundingBoxTree< EntitySet1 > &treeB, std::size_t nodeA, std::size_t nodeB, std::vector< IntersectionInfo< EntitySet0::dimensionworld, typename EntitySet0::ctype, typename EntitySet1::ctype > > &intersections)
 Compute all intersections between two all bounding box tree nodes recursively. More...
 
template<class ctype , int dimworld>
std::size_t intersectingEntityCartesianGrid (const Dune::FieldVector< ctype, dimworld > &point, const Dune::FieldVector< ctype, dimworld > &min, const Dune::FieldVector< ctype, dimworld > &max, const std::array< int, std::size_t(dimworld)> &cells)
 Compute the index of the intersecting element of a Cartesian grid with a point The grid is given by the lower left corner (min), the upper right corner (max) and the number of cells in each direction (cells). More...
 
template<class ctype , int dimworld, class Geometry , typename std::enable_if_t<(Geometry::mydimension==3), int > = 0>
bool intersectsPointGeometry (const Dune::FieldVector< ctype, dimworld > &point, const Geometry &g)
 Find out whether a point is inside a three-dimensional geometry. More...
 
template<class ctype , int dimworld, typename std::enable_if_t<(dimworld==3), int > = 0>
bool intersectsPointSimplex (const Dune::FieldVector< ctype, dimworld > &point, const Dune::FieldVector< ctype, dimworld > &p0, const Dune::FieldVector< ctype, dimworld > &p1, const Dune::FieldVector< ctype, dimworld > &p2, const Dune::FieldVector< ctype, dimworld > &p3)
 Find out whether a point is inside the tetrahedron (p0, p1, p2, p3) (dimworld is 3) More...
 
template<class ctype , int dimworld, typename std::enable_if_t<(dimworld==3), int > = 0>
bool intersectsPointSimplex (const Dune::FieldVector< ctype, dimworld > &point, const Dune::FieldVector< ctype, dimworld > &p0, const Dune::FieldVector< ctype, dimworld > &p1, const Dune::FieldVector< ctype, dimworld > &p2)
 Find out whether a point is inside the triangle (p0, p1, p2) (dimworld is 3) More...
 
template<class ctype , int dimworld, typename std::enable_if_t<(dimworld==3||dimworld==2), int > = 0>
bool intersectsPointSimplex (const Dune::FieldVector< ctype, dimworld > &point, const Dune::FieldVector< ctype, dimworld > &p0, const Dune::FieldVector< ctype, dimworld > &p1)
 Find out whether a point is inside the interval (p0, p1) (dimworld is 2 or 3) More...
 
template<class CoordScalar >
bool pointsAreCoplanar (const std::vector< Dune::FieldVector< CoordScalar, 3 > > &points, const CoordScalar scale)
 Checks if four points lie within the same plane. More...
 
template<class CoordScalar >
bool pointsAreCoplanar (const std::vector< Dune::FieldVector< CoordScalar, 3 > > &points)
 Checks if four points lie within the same plane. More...
 
template<class CoordScalar >
std::vector< Dune::FieldVector< CoordScalar, 3 > > getReorderedPoints (const std::vector< Dune::FieldVector< CoordScalar, 3 > > &points)
 Returns a vector of points following the dune ordering. Convenience method that creates a temporary object in case no array of orientations is desired. More...
 
template<class CoordScalar >
std::vector< Dune::FieldVector< CoordScalar, 3 > > getReorderedPoints (const std::vector< Dune::FieldVector< CoordScalar, 3 > > &points, std::array< int, 4 > &orientations)
 Returns a vector of points following the dune ordering. More...
 
template<class CoordScalar , bool enableSanityCheck = true>
auto makeDuneQuadrilaterial (const std::vector< Dune::FieldVector< CoordScalar, 3 > > &points)
 Creates a dune quadrilateral geometry given 4 corner points. More...
 
template<class Vector >
Vector normal (const Vector &v)
 Create a vector normal to the given one (v is expected to be non-zero) More...
 
template<class Vector >
Vector unitNormal (const Vector &v)
 Create a vector normal to the given one (v is expected to be non-zero) More...
 
template<int dim, int dimWorld, class Policy = TriangulationPolicy::DefaultPolicy<dim, dimWorld>, class RandomAccessContainer , std::enable_if_t< std::is_same_v< Policy, TriangulationPolicy::DelaunayPolicy > &&dim==1, int > = 0>
Triangulation< dim, dimWorld, typename RandomAccessContainer::value_type::value_type > triangulate (const RandomAccessContainer &points)
 Triangulate area given points of a convex hull (1d) More...
 
template<int dim, class CornerF >
auto convexPolytopeVolume (Dune::GeometryType type, const CornerF &c)
 Compute the volume of several common geometry types. More...
 
template<class Geometry >
auto convexPolytopeVolume (const Geometry &geo)
 The volume of a given geometry. More...
 
template<class Geometry >
auto volume (const Geometry &geo, unsigned int integrationOrder=4)
 The volume of a given geometry. More...
 
template<class Geometry , class Transformation >
auto volume (const Geometry &geo, Transformation transformation, unsigned int integrationOrder=4)
 The volume of a given geometry with an extrusion/transformation policy. More...
 
template<typename Container >
void writeContainerToFile (const Container &v, const std::string &filename, int floatPrecision=6)
 Writes a container to file. More...
 
template<typename Container >
Container readStreamToContainer (std::istream &stream)
 Read an input stream into a container. More...
 
template<typename Container >
Container readFileToContainer (const std::string &filename)
 Read a simple text file into a container. More...
 
template<class SolutionVector , class PvNameFunc , class GridGeometry >
auto loadSolutionFromVtkFile (SolutionVector &sol, const std::string fileName, PvNameFunc &&targetPvNameFunc, const GridGeometry &gridGeometry, const VTKReader::DataType &dataType) -> typename std::enable_if_t<!decltype(isValid(Detail::hasState())(sol[0]))::value, void >
 read from a vtk file into a solution vector with primary variables without state More...
 
template<class IOFields , class PrimaryVariables , class ModelTraits = void, class FluidSystem = void, class SolidSystem = void>
auto createPVNameFunction (const std::string &paramGroup="") -> typename std::enable_if_t< decltype(isValid(Detail::hasState())(PrimaryVariables(0)))::value, std::function< std::string(int, int)> >
 helper function to determine the primary variable names of a model with privar state More...
 
template<class SolutionVector , class PvNameFunc , class GridGeometry >
void loadSolution (SolutionVector &sol, const std::string &fileName, PvNameFunc &&targetPvNameFunc, const GridGeometry &gridGeometry)
 load a solution vector from file More...
 
template<class PcKrSw , class V >
auto samplePcSw (const PcKrSw &curve, const V &sw)
 sample the pc-sw curve More...
 
template<class PcKrSw , class V >
auto samplePcSwDerivative (const PcKrSw &curve, const V &sw)
 sample the pc-sw curve derivative wrt sw More...
 
template<class PcKrSw , class V >
auto samplePcSwInverseDerivative (const PcKrSw &curve, const V &pc)
 sample the sw-pc curve derivative wrt pc More...
 
template<class PcKrSw , class V >
auto sampleLog10PcSw (const PcKrSw &curve, const V &sw)
 sample sw-pc curve but return the log10 of the capillary pressure More...
 
template<class PcKrSw , class V >
auto sampleRelPerms (const PcKrSw &curve, const V &sw)
 sample krw-sw and krn-sw curves More...
 
template<class PcKrSw , class V >
auto sampleRelPermDerivatives (const PcKrSw &curve, const V &sw)
 sample the derivatives of the krw-sw and krn-sw curves More...
 
template<class Matrix , class LinearOperator >
void initSolverFactories ()
 Initialize the solver factories for regular matrices or MultiTypeBlockMatrices. More...
 
template<class LinearSolverTraits , class ParallelTraits , class Matrix , class Vector , class ParallelHelper >
void prepareLinearAlgebraParallel (Matrix &A, Vector &b, ParallelHelper &pHelper)
 Prepare linear algebra variables for parallel solvers. More...
 
template<class LinearSolverTraits , class ParallelTraits , class Matrix , class Vector , class ParallelHelper >
void prepareLinearAlgebraParallel (Matrix &A, Vector &b, std::shared_ptr< typename ParallelTraits::Comm > &comm, std::shared_ptr< typename ParallelTraits::LinearOperator > &fop, std::shared_ptr< typename ParallelTraits::ScalarProduct > &sp, ParallelHelper &pHelper)
 Prepare linear algebra variables for parallel solvers. More...
 
 DUMUX_REGISTER_PRECONDITIONER ("uzawa", Dumux::MultiTypeBlockMatrixPreconditionerTag, Dune::defaultPreconditionerBlockLevelCreator< Dumux::SeqUzawa, 1 >())
 
template<class M >
constexpr std::size_t preconditionerBlockLevel () noexcept
 Returns the block level for the preconditioner for a given matrix. More...
 
template<class Scalar >
Scalar henryIAPWS (Scalar E, Scalar F, Scalar G, Scalar H, Scalar temperature)
 The Henry constants in liquid water using the IAPWS 2004 formulation. More...
 
template<class... Laws>
auto makeFluidMatrixInteraction (Laws &&... laws)
 Helper function to create an FluidMatrixInteraction object containing an arbitrary number of fluid matrix interaction laws (e.g., pc-Sw curves and interfacial area laws). To be used in the spatial parameters. More...
 
template<class ElemSol , class Problem , class Element , class Scv , class SolidState >
void updateSolidVolumeFractions (const ElemSol &elemSol, const Problem &problem, const Element &element, const Scv &scv, SolidState &solidState, const int solidVolFracOffset)
 update the solid volume fractions (inert and reacitve) and set them in the solidstate More...
 
template<bool isImplicit, class CouplingManager , class GridGeometryI , class GridGeometryJ , std::size_t i, std::size_t j, typename std::enable_if_t<((GridGeometryI::discMethod==DiscretizationMethods::cctpfa)||(GridGeometryI::discMethod==DiscretizationMethods::ccmpfa)), int > = 0>
Dune::MatrixIndexSet getCouplingJacobianPattern (const CouplingManager &couplingManager, Dune::index_constant< i > domainI, const GridGeometryI &gridGeometryI, Dune::index_constant< j > domainJ, const GridGeometryJ &gridGeometryJ)
 Helper function to generate coupling Jacobian pattern (off-diagonal blocks) for cell-centered schemes. More...
 
template<class DomainGG , class TargetGG >
MultiDomainGlue< typename DomainGG::GridView, typename TargetGG::GridView, typename DomainGG::ElementMapper, typename TargetGG::ElementMapper > makeGlue (const DomainGG &domainGridGeometry, const TargetGG &targetGridGeometry)
 Creates the glue object containing the intersections between two grids obtained from given grid geometries. More...
 
template<class Scalar , class ResFunc , class DerivFunc , typename std::enable_if_t< std::is_invocable_r_v< Scalar, ResFunc, Scalar > &&std::is_invocable_r_v< Scalar, DerivFunc, Scalar > > ...>
Scalar findScalarRootNewton (Scalar xOld, const ResFunc &residual, const DerivFunc &derivative, const Scalar tol=1e-13, const int maxIter=200)
 Newton's root finding algorithm for scalar functions (secant method) More...
 
template<class Scalar , class ResFunc , typename std::enable_if_t< std::is_invocable_r_v< Scalar, ResFunc, Scalar > > ...>
Scalar findScalarRootNewton (Scalar xOld, const ResFunc &residual, const Scalar tol=1e-13, const int maxIter=200)
 Newton's root finding algorithm for scalar functions (secant method) More...
 
template<class Scalar , class ResFunc , typename std::enable_if_t< std::is_invocable_r_v< Scalar, ResFunc, Scalar > > ...>
Scalar findScalarRootBrent (Scalar a, Scalar b, const ResFunc &residual, const Scalar tol=1e-13, const int maxIter=200)
 Brent's root finding algorithm for scalar functions. More...
 
template<class FunctorType >
void parallelFor (const std::size_t count, const FunctorType &functor)
 A parallel for loop (multithreading) More...
 

Variables

constexpr double doubleExponentialIntegrationAbcissas []
 
constexpr double doubleExponentialIntegrationWeights []
 
template<class T >
constexpr bool isRotationalExtrusion = false
 Convenience trait to check whether the extrusion is rotational. More...
 
template<int radialAxis>
constexpr bool isRotationalExtrusion< RotationalExtrusion< radialAxis > > = true
 Convenience trait to check whether the extrusion is rotational. More...
 
template<class Variables >
constexpr bool hasPriVarsSwitch = typename Detail::GetPVSwitch<Variables>::value_t()
 Helper boolean to check if the given variables involve primary variable switching. More...
 

Typedef Documentation

◆ ElementMap

template<class GridView >
using Dumux::ElementMap = typedef EntityMap<GridView, 0>

◆ EnergyLocalResidual

template<class TypeTag >
using Dumux::EnergyLocalResidual = typedef EnergyLocalResidualImplementation<TypeTag, GetPropType<TypeTag, Properties::ModelTraits>::enableEnergyBalance()>

◆ Extrusion_t

template<class T >
using Dumux::Extrusion_t = typedef typename Extrusion<T>::type

Convenience alias for obtaining the extrusion type.

◆ GetProp

template<class TypeTag , template< class, class > class Property>
using Dumux::GetProp = typedef typename Properties::Detail::GetPropImpl<TypeTag, Property>::type

get the type of a property

◆ GetPropOr

template<class TypeTag , template< class, class > class Property, class T >
using Dumux::GetPropOr = typedef typename Properties::Detail::GetPropOrImpl<TypeTag, Property, T>::type

get the type of a property or the type T if the property is undefined

◆ GetPropType

template<class TypeTag , template< class, class > class Property>
using Dumux::GetPropType = typedef typename GetProp<TypeTag, Property>::type

get the type alias defined in the property

◆ GetPropTypeOr

template<class TypeTag , template< class, class > class Property, class T >
using Dumux::GetPropTypeOr = typedef typename GetPropOr<TypeTag, Property, T>::type

get the type alias defined in the property or the type T if the property is undefined

◆ LinearSolverTraits

template<class GridGeometry >
using Dumux::LinearSolverTraits = typedef LinearSolverTraitsImpl<GridGeometry, typename GridGeometry::DiscretizationMethod>

The type traits required for using the IstlFactoryBackend.

◆ makeIncompleteIntegerSequence

template<std::size_t n, std::size_t e>
using Dumux::makeIncompleteIntegerSequence = typedef typename Detail::ConcatSeq<decltype(std::make_index_sequence<e>{}), e + 1, decltype(std::make_index_sequence<(n > e) ? (n - e - 1) : 0>{})>::type

◆ NavierStokesParentProblem

template<class TypeTag >
using Dumux::NavierStokesParentProblem = typedef typename NavierStokesParentProblemImpl< TypeTag, typename GetPropType<TypeTag, Properties::GridGeometry>::DiscretizationMethod >::type

The actual NavierStokesParentProblem.

◆ NonEquilibriumIOFields

template<class ModelTraits , class EquilibriumIOFields >
using Dumux::NonEquilibriumIOFields = typedef NonEquilibriumIOFieldsImplementation<ModelTraits, EquilibriumIOFields, ModelTraits::enableThermalNonEquilibrium()>

◆ NonEquilibriumLocalResidual

template<class TypeTag >
using Dumux::NonEquilibriumLocalResidual = typedef NonEquilibriumLocalResidualImplementation<TypeTag, GetPropType<TypeTag, Properties::ModelTraits>::enableChemicalNonEquilibrium()>

◆ NonEquilibriumVolumeVariables

template<class Traits , class EquilibriumVolumeVariables >
using Dumux::NonEquilibriumVolumeVariables = typedef NonEquilibriumVolumeVariablesImplementation<Traits, EquilibriumVolumeVariables, Traits::ModelTraits::enableChemicalNonEquilibrium(), Traits::ModelTraits::enableThermalNonEquilibrium(), Traits::ModelTraits::numEnergyEqFluid()>

◆ RANSProblem

template<class TypeTag >
using Dumux::RANSProblem = typedef RANSProblemImpl<TypeTag, GetPropType<TypeTag, Properties::ModelTraits>::turbulenceModel()>

the turbulence-model-specfic RANS problem

◆ ReorderingDofMapper

template<class GridView >
using Dumux::ReorderingDofMapper = typedef Dune::MultipleCodimMultipleGeomTypeMapper<GridView>

◆ StaggeredElementSolution

template<class PrimaryVariables >
using Dumux::StaggeredElementSolution = typedef Dune::BlockVector<PrimaryVariables>

◆ VectorCommDataHandleEqual

template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using Dumux::VectorCommDataHandleEqual = typedef VectorCommDataHandle<Mapper, Vector, codim, Detail::SetEqual, DataType>

◆ VectorCommDataHandleMax

template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using Dumux::VectorCommDataHandleMax = typedef VectorCommDataHandle<Mapper, Vector, codim, Detail::Max, DataType>

◆ VectorCommDataHandleMin

template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using Dumux::VectorCommDataHandleMin = typedef VectorCommDataHandle<Mapper, Vector, codim, Detail::Min, DataType>

◆ VectorCommDataHandleSum

template<class Mapper , class Vector , int codim, class DataType = typename Vector::value_type>
using Dumux::VectorCommDataHandleSum = typedef VectorCommDataHandle<Mapper, Vector, codim, Detail::Sum, DataType>

Enumeration Type Documentation

◆ NusseltFormulation

enum class Dumux::NusseltFormulation
strong

A container for possible values of the property for selecting which Nusselt parametrization to choose. The actual value is set via the property NusseltFormulation.

Enumerator
dittusBoelter 
WakaoKaguei 
VDI 

◆ SherwoodFormulation

enum class Dumux::SherwoodFormulation
strong

A container for possible values of the property for selecting which Sherwood parametrization to choose. The actual value is set via the property SherwoodFormulation.

Enumerator
WakaoKaguei 

Function Documentation

◆ addOffsetToIndexSequence()

template<std::size_t offset, std::size_t ... is>
constexpr std::index_sequence<(offset+is)... > Dumux::addOffsetToIndexSequence ( std::index_sequence< is... >  )
constexpr

◆ checkOverlapSizeCCMpfa()

template<class GridView >
void Dumux::checkOverlapSizeCCMpfa ( const GridView &  gridView)

check the overlap size for parallel computations

◆ computeColoring()

template<class GridGeometry >
auto Dumux::computeColoring ( const GridGeometry &  gg,
int  verbosity = 1 
)

Compute iterable lists of element seeds partitioned by color.

Splits up the elements of a grid view into partitions such that all elements in one partition do not modify global data structures at the same place during assembly. This is used to allow for lock-free thread-parallel (shared memory) assembly routines.

Implements a simply greedy graph coloring algorithm: For each node (element), assign the smallest available color not used by any of the neighboring nodes (element with conflicting memory access) The greedy algorithm doesn't necessarily return the smallest possible number of colors (that's a hard problem) but is fast

Returns a struct with access to the colors of each element (member colors) and vector of element seed sets of the same color (member sets)

Parameters
ggthe grid geometry
verbositythe verbosity level

◆ DUMUX_REGISTER_PRECONDITIONER()

Dumux::DUMUX_REGISTER_PRECONDITIONER ( "uzawa"  ,
Dumux::MultiTypeBlockMatrixPreconditionerTag  ,
Dune::defaultPreconditionerBlockLevelCreator< Dumux::SeqUzawa, 1 >  () 
)

◆ enumerate()

template<typename Range , typename RangeIterator = decltype(std::begin(std::declval<Range>())), typename = decltype(std::end(std::declval<Range>()))>
constexpr auto Dumux::enumerate ( Range &&  iterable)
constexpr

A Python-like enumerate function.

Parameters
iterableSome iterable type with begin/end (e.g. std::vector)
Note
From Nathan Reed (CC BY 4.0): http://reedbeta.com/blog/python-like-enumerate-in-cpp17/

Usage example: for (const auto& [i, item] : enumerate(list))

◆ faceTensorAverage() [1/2]

template<class Scalar , int dim>
Dune::FieldMatrix< Scalar, dim > Dumux::faceTensorAverage ( const Dune::FieldMatrix< Scalar, dim > &  T1,
const Dune::FieldMatrix< Scalar, dim > &  T2,
const Dune::FieldVector< Scalar, dim > &  normal 
)

Average of a discontinuous tensorial field at discontinuity interface.

Note
We do a harmonic average of the part normal to the interface (alpha*I) and an arithmetic average of the tangential part (T - alpha*I).
Returns
the averaged tensor
Parameters
T1first tensor
T2second tensor
normalThe unit normal vector of the interface

◆ faceTensorAverage() [2/2]

template<class Scalar , int dim>
Scalar Dumux::faceTensorAverage ( const Scalar  T1,
const Scalar  T2,
const Dune::FieldVector< Scalar, dim > &  normal 
)

Average of a discontinuous scalar field at discontinuity interface (for compatibility reasons with the function below)

Returns
the harmonic average of the scalars
Parameters
T1first scalar parameter
T2second scalar parameter
normalThe unit normal vector of the interface

◆ getJacobianPattern()

template<bool isImplicit, class GridGeometry , typename std::enable_if_t<((GridGeometry::discMethod==DiscretizationMethods::staggered)), int > = 0>
auto Dumux::getJacobianPattern ( const GridGeometry &  gridGeometry)

Helper function to generate Jacobian pattern for the staggered method.

◆ getPropValue()

template<class TypeTag , template< class, class > class Property>
constexpr auto Dumux::getPropValue ( )
inlineconstexpr

get the value data member of a property

◆ initialize()

void Dumux::initialize ( int &  argc,
char *  argv[] 
)

◆ initSolverFactories()

template<class Matrix , class LinearOperator >
void Dumux::initSolverFactories ( )

Initialize the solver factories for regular matrices or MultiTypeBlockMatrices.

Template Parameters
Matrixthe matrix
LinearOperatorthe linear operator
Note
This function could be removed once Dune::initSolverFactories supports MultiTypeBlockMatrices.

◆ integrateGridFunction()

template<class GridGeometry , class SolutionVector , typename std::enable_if_t<!Detail::hasLocalFunction< SolutionVector >(), int > = 0>
auto Dumux::integrateGridFunction ( const GridGeometry &  gg,
const SolutionVector &  sol,
std::size_t  order 
)

Integrate a grid function over a grid view.

Parameters
ggthe grid geometry
solthe solution vector
orderthe order of the quadrature rule

◆ integrateL2Error()

template<class GridGeometry , class Sol1 , class Sol2 , typename std::enable_if_t<!Detail::hasLocalFunction< Sol1 >(), int > = 0>
auto Dumux::integrateL2Error ( const GridGeometry &  gg,
const Sol1 &  sol1,
const Sol2 &  sol2,
std::size_t  order 
)

Integrate a function over a grid view.

Parameters
ggthe grid geometry
sol1the first function
sol2the second function
orderthe order of the quadrature rule
Note
dune functions currently doesn't support composing two functions

◆ integrateScalarFunction()

template<class Scalar , class Function , typename std::enable_if_t< std::is_invocable_r_v< Scalar, Function, Scalar > > ...>
Scalar Dumux::integrateScalarFunction ( const Function &  f,
const Scalar  lowerBound,
const Scalar  upperBound,
const Scalar  targetAbsoluteError = 1e-13 
)

Integrate a scalar function.

Parameters
fthe integrand (invocable with a single scalar)
lowerBoundlower integral bound
upperBoundupper integral bound
targetAbsoluteErrordesired absolute error in the result
Returns
The value of the integral

◆ intersectsBoundingBoxBoundingBox()

template<int dimworld, class ctypea , class ctypeb , typename std::enable_if_t< dimworld==3, int > = 0>
bool Dumux::intersectsBoundingBoxBoundingBox ( const ctypea *  a,
const ctypeb *  b 
)
inline

Check whether a bounding box is intersecting another bounding box (dimworld == 3)

Check whether a bounding box is intersecting another bounding box (dimworld == 1)

Check whether a bounding box is intersecting another bounding box (dimworld == 2)

Parameters
aPointer to first bounding box coordinates
bPointer to second bounding box coordinates

◆ intersectsPointBoundingBox()

template<class ctype , int dimworld, typename std::enable_if_t< dimworld==3, int > = 0>
bool Dumux::intersectsPointBoundingBox ( const Dune::FieldVector< ctype, dimworld > &  point,
const ctype *  b 
)
inline

Check whether a point is intersectin a bounding box (dimworld == 3)

Check whether a point is intersectin a bounding box (dimworld == 1)

Check whether a point is intersectin a bounding box (dimworld == 2)

Parameters
pointThe point
bPointer to bounding box coordinates

◆ makeIndexSequenceWithOffset()

template<std::size_t offset, std::size_t n>
constexpr auto Dumux::makeIndexSequenceWithOffset ( )
constexpr

◆ makeProjectionMatrices()

template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto Dumux::makeProjectionMatrices ( const FEBasisDomain &  feBasisDomain,
const FEBasisTarget &  feBasisTarget,
GlueType  glue 
)

Creates the matrices underlying l2-projections.

Parameters
feBasisDomainThe basis to the domain finite element space
feBasisTargetThe basis to the target finite element space
glueThe glue object containing the intersections between the two grids
Returns
An std::pair of matrices, which store the mass matrix in the first and the projection matrix in the second entry.

◆ makeProjectionMatricesPair()

template<class FEBasisDomain , class FEBasisTarget , class GlueType >
auto Dumux::makeProjectionMatricesPair ( const FEBasisDomain &  feBasisDomain,
const FEBasisTarget &  feBasisTarget,
GlueType  glue 
)

Creates the matrices underlying l2-projections.

Parameters
feBasisDomainThe basis to the domain finite element space
feBasisTargetThe basis to the target finite element space
glueThe glue object containing the intersections between the two grids
Returns
An std::pair of projection matrices, where the first entry stores the matrices of the forward projection and the second entry stores those of the backward projection. The entries of the returned pair are itself std::pairs which store the mass matrix in the first and the projection matrix in the second entry.

◆ numTurbulenceEq()

constexpr unsigned int Dumux::numTurbulenceEq ( TurbulenceModel  model)
constexpr

◆ partial() [1/5]

template<class ... Args, std::size_t ... i>
auto Dumux::partial ( const Dune::MultiTypeBlockVector< Args... > &  v,
Dune::index_constant< i >...  indices 
)

a function to get a MultiTypeBlockVector with const references to some entries of another MultiTypeBlockVector

Parameters
va MultiTypeBlockVector
indicesthe indices of the entries that should be referenced

◆ partial() [2/5]

template<class ... Args, std::size_t ... i>
auto Dumux::partial ( const std::tuple< Args... > &  v,
Dune::index_constant< i >...  indices 
)

a function to get a tuple with const references to some entries of another tuple

Parameters
va tuple
indicesa tuple of indices of the entries that should be referenced

◆ partial() [3/5]

template<class ... Args, std::size_t ... i>
auto Dumux::partial ( Dune::MultiTypeBlockVector< Args... > &  v,
Dune::index_constant< i >...  indices 
)

a function to get a MultiTypeBlockVector with references to some entries of another MultiTypeBlockVector

Parameters
va MultiTypeBlockVector
indicesthe indices of the entries that should be referenced

◆ partial() [4/5]

template<class ... Args, std::size_t ... i>
auto Dumux::partial ( std::tuple< Args... > &  v,
Dune::index_constant< i >...  indices 
)

a function to get a tuple with references to some entries of another tuple

Parameters
va tuple
indicesa tuple of indices of the entries that should be referenced

◆ partial() [5/5]

template<class T , std::size_t ... i>
auto Dumux::partial ( T &  t,
std::tuple< Dune::index_constant< i >... >  indices 
)

a function to get a MultiTypeBlockVector with references to some entries of another MultiTypeBlockVector

Parameters
tan std::tuple or Dune::MultiTypeBlockVector
indicesa tuple of indices of the entries that should be referenced

◆ prepareLinearAlgebraParallel() [1/2]

template<class LinearSolverTraits , class ParallelTraits , class Matrix , class Vector , class ParallelHelper >
void Dumux::prepareLinearAlgebraParallel ( Matrix &  A,
Vector &  b,
ParallelHelper &  pHelper 
)

Prepare linear algebra variables for parallel solvers.

◆ prepareLinearAlgebraParallel() [2/2]

template<class LinearSolverTraits , class ParallelTraits , class Matrix , class Vector , class ParallelHelper >
void Dumux::prepareLinearAlgebraParallel ( Matrix &  A,
Vector &  b,
std::shared_ptr< typename ParallelTraits::Comm > &  comm,
std::shared_ptr< typename ParallelTraits::LinearOperator > &  fop,
std::shared_ptr< typename ParallelTraits::ScalarProduct > &  sp,
ParallelHelper &  pHelper 
)

Prepare linear algebra variables for parallel solvers.

◆ readFileToContainer()

template<typename Container >
Container Dumux::readFileToContainer ( const std::string &  filename)

Read a simple text file into a container.

Parameters
filenameThe filename to write to
Template Parameters
ContainerThe container type requires begin(), end(), push_back() functions and Container::value_type requires operator>>.

usage: auto v = readFileToContainer<std::vector<double>>("myvector.txt");

◆ readStreamToContainer()

template<typename Container >
Container Dumux::readStreamToContainer ( std::istream &  stream)

Read an input stream into a container.

Parameters
streamA standard input stream
Template Parameters
ContainerThe container type requires begin(), end(), push_back() functions and Container::value_type requires operator>>.

◆ split()

std::vector< std::string_view > Dumux::split ( std::string_view  str,
std::string_view  delim,
bool  removeEmpty = false 
)

◆ squaredDistancePointBoundingBox()

template<int dimworld, class ctype >
ctype Dumux::squaredDistancePointBoundingBox ( const Dune::FieldVector< ctype, dimworld > &  point,
const ctype *  b 
)
inline

Compute squared distance between point and bounding box.

Parameters
pointThe point
bPointer to bounding box coordinates

◆ sstModelFromString()

SSTModel Dumux::sstModelFromString ( const std::string &  sstModel)

Convenience function to convert user input given as std::string to the corresponding enum class used for choosing the SST Model.

◆ sstModelToString()

std::string Dumux::sstModelToString ( SSTModel  sstModel)

return the name of the sst Model as a string

◆ tokenize()

std::vector< std::string_view > Dumux::tokenize ( std::string_view  str,
std::string_view  delim 
)

◆ turbulenceModelToString()

std::string Dumux::turbulenceModelToString ( TurbulenceModel  turbulenceModel)

return the name of the Turbulence Model

Variable Documentation

◆ doubleExponentialIntegrationAbcissas

constexpr double Dumux::doubleExponentialIntegrationAbcissas[]
constexpr

◆ doubleExponentialIntegrationWeights

constexpr double Dumux::doubleExponentialIntegrationWeights[]
constexpr

◆ isRotationalExtrusion

template<class T >
constexpr bool Dumux::isRotationalExtrusion = false
inlineconstexpr

Convenience trait to check whether the extrusion is rotational.

◆ isRotationalExtrusion< RotationalExtrusion< radialAxis > >

template<int radialAxis>
constexpr bool Dumux::isRotationalExtrusion< RotationalExtrusion< radialAxis > > = true
inlineconstexpr

Convenience trait to check whether the extrusion is rotational.