A simple fluid system with three components for testing the multi-component diffusion with the Maxwell-Stefan formulation. More...
#include <test/porousmediumflow/1pnc/implicit/1p3c/problem.hh>
A simple fluid system with three components for testing the multi-component diffusion with the Maxwell-Stefan formulation.
Public Types | |
using | ParameterCache = NullParameterCache |
The type of parameter cache objects. More... | |
Static Public Member Functions | |
static std::string | componentName (int compIdx) |
Human readable component name (index compIdx) (for vtk output) More... | |
static std::string | phaseName (int phaseIdx=0) |
Human readable phase name (index phaseIdx) (for velocity vtk output) More... | |
static Scalar | molarMass (unsigned int compIdx) |
Molar mass in kg/mol of the component with index compIdx. More... | |
template<class FluidState > | |
static Scalar | binaryDiffusionCoefficient (const FluidState &fluidState, int phaseIdx, int compIIdx, int compJIdx) |
Given a phase's composition, temperature and pressure, returns the binary diffusion coefficient \mathrm{[m^2/s]} for components i and j in this phase. More... | |
template<class FluidState > | |
static Scalar | density (const FluidState &fluidState, const int phaseIdx) |
Given a phase's composition, temperature, pressure, and the partial pressures of all components, returns its density \mathrm{[kg/m^3]}. More... | |
template<class FluidState > | |
static Scalar | viscosity (const FluidState &fluidState, int phaseIdx) |
Calculates the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}. More... | |
template<class FluidState > | |
static Scalar | molarDensity (const FluidState &fluidState, int phaseIdx) |
The molar density \rho_{mol,\alpha} of a fluid phase \alpha in \mathrm{[mol/m^3]}. More... | |
template<class FluidState > | |
static Scalar | binaryDiffusionCoefficient (const FluidState &fluidState, int phaseIdx, int compIIdx, int compJIdx) |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase. More... | |
template<class FluidState > | |
static Scalar | binaryDiffusionCoefficient (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx, int compIIdx, int compJIdx) |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase. More... | |
template<class FluidState > | |
static Scalar | density (const FluidState &fluidState, int phaseIdx) |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase. More... | |
template<class FluidState > | |
static Scalar | density (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase. More... | |
template<class FluidState > | |
static Scalar | viscosity (const FluidState &fluidState, int phaseIdx) |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}. More... | |
template<class FluidState > | |
static Scalar | viscosity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}. More... | |
template<class FluidState > | |
static Scalar | molarDensity (const FluidState &fluidState, int phaseIdx) |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase. More... | |
template<class FluidState > | |
static Scalar | molarDensity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase. More... | |
static constexpr bool | isTracerFluidSystem () |
Some properties of the fluid system. More... | |
static constexpr int | getMainComponent (int phaseIdx) |
Get the main component of a given phase if possible. More... | |
static constexpr bool | isCompressible (int phaseIdx) |
Returns true if and only if a fluid phase is assumed to be compressible. More... | |
static constexpr bool | isMiscible () |
Returns whether the fluids are miscible. More... | |
static constexpr bool | viscosityIsConstant (int phaseIdx) |
Returns true if and only if a fluid phase is assumed to have a constant viscosity. More... | |
static Scalar | density (const FluidState &fluidState, int phaseIdx) |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase. More... | |
static Scalar | density (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase. More... | |
static Scalar | molarDensity (const FluidState &fluidState, int phaseIdx) |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase. More... | |
static Scalar | molarDensity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase. More... | |
static Scalar | fugacityCoefficient (const FluidState &fluidState, int phaseIdx, int compIdx) |
Calculate the fugacity coefficient \mathrm{[Pa]} of an individual component in a fluid phase. More... | |
static Scalar | fugacityCoefficient (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx, int compIdx) |
Calculate the fugacity coefficient \mathrm{[Pa]} of an individual component in a fluid phase. More... | |
static Scalar | viscosity (const FluidState &fluidState, int phaseIdx) |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}. More... | |
static Scalar | viscosity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}. More... | |
static Scalar | diffusionCoefficient (const FluidState &fluidState, int phaseIdx, int compIdx) |
Calculate the binary molecular diffusion coefficient for a component in a fluid phase \mathrm{[mol^2 * s / (kg*m^3)]}. More... | |
static Scalar | diffusionCoefficient (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx, int compIdx) |
Calculate the binary molecular diffusion coefficient for a component in a fluid phase \mathrm{[mol^2 * s / (kg*m^3)]}. More... | |
static Scalar | binaryDiffusionCoefficient (const FluidState &fluidState, int phaseIdx, int compIIdx, int compJIdx) |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase. More... | |
static Scalar | binaryDiffusionCoefficient (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx, int compIIdx, int compJIdx) |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase. More... | |
static Scalar | enthalpy (const FluidState &fluidState, int phaseIdx) |
Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy \mathrm{[J/kg]}. More... | |
static Scalar | enthalpy (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy \mathrm{[J/kg]}. More... | |
static Scalar | thermalConductivity (const FluidState &fluidState, int phaseIdx) |
Thermal conductivity \lambda_\alpha of a fluid phase \mathrm{[W/(m K)]}. More... | |
static Scalar | thermalConductivity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Thermal conductivity \lambda_\alpha of a fluid phase \mathrm{[W/(m K)]}. More... | |
static Scalar | heatCapacity (const FluidState &fluidState, int phaseIdx) |
Specific isobaric heat capacity c_{p,\alpha} of a fluid phase \mathrm{[J/(kg*K)]}. More... | |
static Scalar | heatCapacity (const FluidState &fluidState, const ParameterCache ¶mCache, int phaseIdx) |
Specific isobaric heat capacity c_{p,\alpha} of a fluid phase \mathrm{[J/(kg*K)]}. More... | |
Static Public Attributes | |
static constexpr int | numPhases = 1 |
The number of phases. More... | |
static constexpr int | numComponents = 3 |
static constexpr int | H2Idx = 0 |
static constexpr int | N2Idx = 1 |
static constexpr int | CO2Idx = 2 |
|
inherited |
The type of parameter cache objects.
|
inlinestaticinherited |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
compIIdx | Index of the component i |
compJIdx | Index of the component j |
|
inlinestatic |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
compIIdx | Index of the component i |
compJIdx | Index of the component j |
|
inlinestaticinherited |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
compIIdx | Index of the component i |
compJIdx | Index of the component j |
|
inlinestatic |
Given a phase's composition, temperature and pressure, return the binary diffusion coefficient \mathrm{[m^2/s]} for components \mathrm{i} and \mathrm{j} in this phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
compIIdx | Index of the component i |
compJIdx | Index of the component j |
|
inlinestatic |
Given a phase's composition, temperature and pressure, returns the binary diffusion coefficient \mathrm{[m^2/s]} for components i and j in this phase.
fluidState | An arbitrary fluid state |
phaseIdx | The index of the fluid phase to consider |
compIIdx | The index of the first component to consider |
compJIdx | The index of the second component to consider |
|
inlinestatic |
Human readable component name (index compIdx) (for vtk output)
|
inlinestatic |
Given a phase's composition, temperature, pressure, and the partial pressures of all components, returns its density \mathrm{[kg/m^3]}.
phaseIdx | index of the phase |
fluidState | the fluid state |
|
inlinestaticinherited |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the density \mathrm{[kg/m^3]} of a fluid phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the binary molecular diffusion coefficient for a component in a fluid phase \mathrm{[mol^2 * s / (kg*m^3)]}.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
compIdx | Index of the component Molecular diffusion of a component \mathrm{\kappa} is caused by a gradient of the chemical potential and follows the law |
J = - D \mathbf{grad} \mu_\kappa
where \mathrm{\mu_\kappa} is the component's chemical potential, \mathrm{D} is the diffusion coefficient and \mathrm{J} is the diffusive flux. \mathrm{\mu_\kappa} is connected to the component's fugacity \mathrm{f_\kappa} by the relation
\mu_\kappa = R T_\alpha \mathrm{ln} \frac{f_\kappa}{p_\alpha}
where \mathrm{p_\alpha} and \mathrm{T_\alpha} are the fluid phase' pressure and temperature.
|
inlinestaticinherited |
Calculate the binary molecular diffusion coefficient for a component in a fluid phase \mathrm{[mol^2 * s / (kg*m^3)]}.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
compIdx | Index of the component Molecular diffusion of a component \mathrm{\kappa} is caused by a gradient of the chemical potential and follows the law |
J = - D \mathbf{grad} \mu_\kappa
where \mathrm{\mu_\kappa} is the component's chemical potential, \mathrm{D} is the diffusion coefficient and \mathrm{J} is the diffusive flux. \mathrm{\mu_\kappa} is connected to the component's fugacity \mathrm{f_\kappa} by the relation
\mu_\kappa = R T_\alpha \mathrm{ln} \frac{f_\kappa}{p_\alpha}
where \mathrm{p_\alpha} and \mathrm{T_\alpha} are the fluid phase' pressure and temperature.
|
inlinestaticinherited |
Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy \mathrm{[J/kg]}.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy \mathrm{[J/kg]}.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the fugacity coefficient \mathrm{[Pa]} of an individual component in a fluid phase.
The fugacity coefficient \mathrm{\phi^\kappa_\alpha} is connected to the fugacity \mathrm{f^\kappa_\alpha} and the component's mole fraction \mathrm{x^\kappa_\alpha} by means of the relation
f^\kappa_\alpha = \phi^\kappa_\alpha\;x^\kappa_\alpha\;p_\alpha
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
compIdx | Index of the component |
|
inlinestaticinherited |
Calculate the fugacity coefficient \mathrm{[Pa]} of an individual component in a fluid phase.
The fugacity coefficient \mathrm{\phi^\kappa_\alpha} is connected to the fugacity \mathrm{f^\kappa_\alpha} and the component's mole fraction \mathrm{x^\kappa_\alpha} by means of the relation
f^\kappa_\alpha = \phi^\kappa_\alpha\;x^\kappa_\alpha\;p_\alpha
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
compIdx | Index of the component |
|
inlinestaticconstexprinherited |
Get the main component of a given phase if possible.
phaseIdx | The index of the fluid phase to consider |
|
inlinestaticinherited |
Specific isobaric heat capacity c_{p,\alpha} of a fluid phase \mathrm{[J/(kg*K)]}.
fluidState | represents all relevant thermodynamic quantities of a fluid system |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
Given a fluid state, an up-to-date parameter cache and a phase index, this method computes the isobaric heat capacity c_{p,\alpha} of the fluid phase. The isobaric heat capacity is defined as the partial derivative of the specific enthalpy h_\alpha to the fluid pressure p_\alpha:
c_{p,\alpha} = \frac{\partial h_\alpha}{\partial p_\alpha}
|
inlinestaticinherited |
Specific isobaric heat capacity c_{p,\alpha} of a fluid phase \mathrm{[J/(kg*K)]}.
fluidState | represents all relevant thermodynamic quantities of a fluid system |
phaseIdx | Index of the fluid phase |
Given a fluid state, an up-to-date parameter cache and a phase index, this method computes the isobaric heat capacity c_{p,\alpha} of the fluid phase. The isobaric heat capacity is defined as the partial derivative of the specific enthalpy h_\alpha to the fluid pressure p_\alpha:
c_{p,\alpha} = \frac{\partial h_\alpha}{\partial p_\alpha}
|
inlinestaticconstexprinherited |
Returns true if and only if a fluid phase is assumed to be compressible.
Compressible means that the partial derivative of the density to the fluid pressure is always larger than zero.
phaseIdx | The index of the fluid phase to consider |
|
inlinestaticconstexprinherited |
Returns whether the fluids are miscible.
|
inlinestaticconstexprinherited |
Some properties of the fluid system.
If the fluid system only contains tracer components
|
inlinestaticinherited |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the molar density \mathrm{[mol/m^3]} of a fluid phase.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
The molar density \rho_{mol,\alpha} of a fluid phase \alpha in \mathrm{[mol/m^3]}.
The molar density for the simple relation is defined by the mass density \rho_\alpha and the molar mass of the main component M_\kappa:
\rho_{mol,\alpha} = \frac{\rho_\alpha}{M_\kappa} \;.
|
inlinestatic |
Molar mass in kg/mol of the component with index compIdx.
|
inlinestatic |
Human readable phase name (index phaseIdx) (for velocity vtk output)
|
inlinestaticinherited |
Thermal conductivity \lambda_\alpha of a fluid phase \mathrm{[W/(m K)]}.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Thermal conductivity \lambda_\alpha of a fluid phase \mathrm{[W/(m K)]}.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}.
fluidState | The fluid state |
paramCache | mutable parameters |
phaseIdx | Index of the fluid phase |
|
inlinestaticinherited |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculate the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}.
fluidState | The fluid state |
phaseIdx | Index of the fluid phase |
|
inlinestatic |
Calculates the dynamic viscosity of a fluid phase \mathrm{[Pa*s]}.
fluidState | An arbitrary fluid state |
phaseIdx | The index of the fluid phase to consider |
|
inlinestaticconstexprinherited |
Returns true if and only if a fluid phase is assumed to have a constant viscosity.
phaseIdx | The index of the fluid phase to consider |
|
staticconstexpr |
|
staticconstexpr |
|
staticconstexpr |
|
staticconstexpr |
|
staticconstexpr |
The number of phases.