Volume variables for the single-phase Navier-Stokes model.
#include <dumux/freeflow/navierstokes/mass/1pnc/volumevariables.hh>
| Public Types | |
| using | FluidSystem = typename Traits::FluidSystem | 
| export the underlying fluid system | |
| using | FluidState = typename Traits::FluidState | 
| export the fluid state type | |
| using | MolecularDiffusionType = typename Traits::DiffusionType | 
| export the diffusion type | |
| using | Indices = typename Traits::ModelTraits::Indices | 
| export the indices type | |
| using | PrimaryVariables = typename Traits::PrimaryVariables | 
| export the type used for the primary variables | |
| using | HeatConductionType | 
| Public Member Functions | |
| template<class ElementSolution, class Problem, class Element, class SubControlVolume> | |
| void | update (const ElementSolution &elemSol, const Problem &problem, const Element &element, const SubControlVolume &scv) | 
| Update all quantities for a given control volume. | |
| template<class ElementSolution, class Problem, class Element, class SubControlVolume> | |
| void | completeFluidState (const ElementSolution &elemSol, const Problem &problem, const Element &element, const SubControlVolume &scv, FluidState &fluidState) const | 
| Update the fluid state. | |
| Scalar | pressure (int phaseIdx=0) const | 
| Return the effective pressure \(\mathrm{[Pa]}\) of a given phase within the control volume. | |
| Scalar | saturation (int phaseIdx=0) const | 
| Returns the saturation. | |
| Scalar | density (int phaseIdx=0) const | 
| Return the mass density \(\mathrm{[kg/m^3]}\) of a given phase within the control volume. | |
| Scalar | temperature () const | 
| Return temperature \(\mathrm{[K]}\) inside the sub-control volume. | |
| Scalar | effectiveViscosity () const | 
| Return the effective dynamic viscosity \(\mathrm{[Pa s]}\) of the fluid within the control volume. | |
| Scalar | viscosity (int phaseIdx=0) const | 
| Return the dynamic viscosity \(\mathrm{[Pa s]}\) of the fluid within the control volume. | |
| Scalar | massFraction (int phaseIdx, int compIdx) const | 
| Returns the mass fraction of a component in the phase \(\mathrm{[-]}\). | |
| Scalar | massFraction (int compIdx) const | 
| Returns the mass fraction of a component in the phase \(\mathrm{[-]}\). | |
| Scalar | moleFraction (int phaseIdx, int compIdx) const | 
| Returns the mole fraction of a component in the phase \(\mathrm{[-]}\). | |
| Scalar | moleFraction (int compIdx) const | 
| Returns the mole fraction of a component in the phase \(\mathrm{[-]}\). | |
| Scalar | molarDensity (int phaseIdx=0) const | 
| Returns the mass density of a given phase \(\mathrm{[kg/m^3]}\). | |
| Scalar | molarMass (int compIdx) const | 
| Returns the molar mass of a given component. | |
| Scalar | averageMolarMass (const int phaseIdx=0) const | 
| Returns the average molar mass \(\mathrm{[kg/mol]}\) of the fluid phase. | |
| Scalar | diffusionCoefficient (int phaseIdx, int compIIdx, int compJIdx) const | 
| Returns the binary diffusion coefficients for a phase in \([m^2/s]\). | |
| Scalar | effectiveDiffusionCoefficient (int phaseIdx, int compIIdx, int compJIdx) const | 
| Returns the effective diffusion coefficients for a phase in \([m^2/s]\). | |
| const FluidState & | fluidState () const | 
| Return the fluid state of the control volume. | |
| Scalar | extrusionFactor () const | 
| Return how much the sub-control volume is extruded. | |
| Scalar | priVar (const int pvIdx) const | 
| Return a component of primary variable vector. | |
| const PrimaryVariables & | priVars () const | 
| Return the primary variable vector. | |
| Scalar | getTemperature (const ElementSolution &elemSol, const Problem &problem, const Element &element, const SubControlVolume &scv) const | 
| Returns the temperature at a given sub-control volume. | |
| Scalar | getTemperature (const ElementSolution &elemSol, const Problem &problem, const Element &element, const SubControlVolume &scv) const | 
| Returns the temperature at a given sub-control volume. | |
| void | updateEffectiveThermalConductivity () | 
| The effective thermal conductivity is zero for isothermal models. | |
| void | updateEffectiveThermalConductivity () | 
| The effective thermal conductivity is zero for isothermal models. | |
| Scalar | internalEnergy (const int phaseIdx=0) const | 
| Returns the total internal energy of a phase in the sub-control volume. | |
| Scalar | internalEnergy (const int phaseIdx=0) const | 
| Returns the total internal energy of a phase in the sub-control volume. | |
| Scalar | enthalpy (const int phaseIdx=0) const | 
| Returns the total enthalpy of a phase in the sub-control volume. | |
| Scalar | enthalpy (const int phaseIdx=0) const | 
| Returns the total enthalpy of a phase in the sub-control volume. | |
| Scalar | temperatureFluid (const int phaseIdx=0) const | 
| Returns the temperature of a fluid phase assuming thermal nonequilibrium the sub-control volume. | |
| Scalar | temperatureFluid (const int phaseIdx=0) const | 
| Returns the temperature of a fluid phase assuming thermal nonequilibrium the sub-control volume. | |
| Scalar | fluidThermalConductivity (const int phaseIdx=0) const | 
| Returns the thermal conductivity \(\mathrm{[W/(m*K)]}\) of a fluid phase in the sub-control volume. | |
| Scalar | fluidThermalConductivity (const int phaseIdx=0) const | 
| Returns the thermal conductivity \(\mathrm{[W/(m*K)]}\) of a fluid phase in the sub-control volume. | |
| Scalar | effectiveThermalConductivity (const int phaseIdx=0) const | 
| Returns the effective thermal conductivity \(\mathrm{[W/(m*K)]}\) in the sub-control volume. Specific to equilibirum models (case fullThermalEquilibrium). | |
| Scalar | effectiveThermalConductivity (const int phaseIdx=0) const | 
| Returns the effective thermal conductivity \(\mathrm{[W/(m*K)]}\) in the sub-control volume. Specific to equilibirum models (case fullThermalEquilibrium). | |
| Static Public Member Functions | |
| static constexpr int | numFluidPhases () | 
| Return number of phases considered by the model. | |
| static constexpr int | numFluidComponents () | 
| Return number of components considered by the model. | |
| static Scalar | enthalpy (const FluidState &fluidState, const ParameterCache ¶mCache) | 
| static Scalar | enthalpy (const FluidState &fluidState, const ParameterCache ¶mCache) | 
| Protected Member Functions | |
| const NavierStokesMassOnePNCVolumeVariables< Traits > & | asImp_ () const | 
| NavierStokesMassOnePNCVolumeVariables< Traits > & | asImp_ () | 
| const NavierStokesMassOnePNCVolumeVariables< Traits > & | asImp_ () const | 
| NavierStokesMassOnePNCVolumeVariables< Traits > & | asImp_ () | 
| Protected Attributes | |
| FluidState | fluidState_ | 
| DiffusionCoefficients | diffCoefficient_ | 
| PrimaryVariables | priVars_ | 
| Scalar | extrusionFactor_ | 
| Scalar | lambdaEff_ | 
| Scalar | lambdaEff_ | 
| using Dumux::NavierStokesMassOnePNCVolumeVariables< Traits >::FluidState = typename Traits::FluidState | 
| using Dumux::NavierStokesMassOnePNCVolumeVariables< Traits >::FluidSystem = typename Traits::FluidSystem | 
| 
 | inherited | 
| using Dumux::NavierStokesMassOnePNCVolumeVariables< Traits >::Indices = typename Traits::ModelTraits::Indices | 
| using Dumux::NavierStokesMassOnePNCVolumeVariables< Traits >::MolecularDiffusionType = typename Traits::DiffusionType | 
| 
 | inherited | 
| 
 | inlineprotectedinherited | 
| 
 | inlineprotectedinherited | 
| 
 | inlineprotectedinherited | 
| 
 | inlineprotectedinherited | 
| 
 | inline | 
| phaseIdx | The phase index | 
| 
 | inline | 
| 
 | inline | 
| 
 | inline | 
| 
 | inline | 
| 
 | inlineinherited | 
| 
 | inlineinherited | 
| 
 | inline | 
| 
 | inlinestaticinherited | 
The phase enthalpy is zero for isothermal models This is needed for completing the fluid state
| 
 | inlinestaticinherited | 
The phase enthalpy is zero for isothermal models This is needed for completing the fluid state
| 
 | inlineinherited | 
| phaseIdx | The phase index | 
| 
 | inlineinherited | 
| phaseIdx | The phase index | 
| 
 | inlineinherited | 
This means the factor by which a lower-dimensional (1D or 2D) entity needs to be expanded to get a full dimensional cell. The default is 1.0 which means that 1D problems are actually thought as pipes with a cross section of 1 m^2 and 2D problems are assumed to extend 1 m to the back.
| 
 | inline | 
| 
 | inlineinherited | 
| 
 | inlineinherited | 
| 
 | inlineinherited | 
| elemSol | A vector containing all primary variables connected to the element | 
| problem | The object specifying the problem which ought to be simulated | 
| element | An element which contains part of the control volume | 
| scv | The sub-control volume | 
| 
 | inlineinherited | 
| elemSol | A vector containing all primary variables connected to the element | 
| problem | The object specifying the problem which ought to be simulated | 
| element | An element which contains part of the control volume | 
| scv | The sub-control volume | 
| 
 | inlineinherited | 
| phaseIdx | The phase index | 
| 
 | inlineinherited | 
| phaseIdx | The phase index | 
| 
 | inline | 
| compIdx | the index of the component | 
| 
 | inline | 
| phaseIdx | the index of the phase | 
| compIdx | the index of the component | 
| 
 | inline | 
| 
 | inline | 
| compIdx | the index of the component | 
| 
 | inline | 
| compIdx | the index of the component | 
| 
 | inline | 
| phaseIdx | the index of the phase | 
| compIdx | the index of the component | 
| 
 | inlinestaticconstexprinherited | 
| 
 | inlinestaticconstexprinherited | 
| 
 | inline | 
| 
 | inlineinherited | 
| pvIdx | The index of the primary variable of interest | 
| 
 | inlineinherited | 
| 
 | inline | 
| 
 | inline | 
| 
 | inlineinherited | 
| phaseIdx | The local index of the phases | 
| 
 | inlineinherited | 
| phaseIdx | The local index of the phases | 
| 
 | inline | 
| elemSol | A vector containing all primary variables connected to the element | 
| problem | The object specifying the problem which ought to be simulated | 
| element | An element which contains part of the control volume | 
| scv | The sub-control volume | 
| 
 | inlineinherited | 
| 
 | inlineinherited | 
| 
 | inline | 
| 
 | protected | 
| 
 | protectedinherited | 
| 
 | protected | 
| 
 | protectedinherited | 
| 
 | protectedinherited | 
| 
 | protectedinherited |