Opm::FluidSystems::BlackOil< Scalar > Class Template Reference

A fluid system which uses the black-oil parameters to calculate termodynamically meaningful quantities. More...

#include <BlackOilFluidSystem.hpp>

Inheritance diagram for Opm::FluidSystems::BlackOil< Scalar >:
Inheritance graph

Classes

class  ParameterCache
 The type of the fluid system's parameter cache. More...
 

Public Types

typedef NullParameterCache ParameterCache
 The type of the fluid system's parameter cache. More...
 

Static Public Member Functions

static void initBegin (size_t numPvtRegions)
 Begin the initialization of the black oil fluid system. More...
 
static void setEnableDissolvedGas (bool yesno)
 Specify whether the fluid system should consider that the gas component can dissolve in the oil phase. More...
 
static void setEnableVaporizedOil (bool yesno)
 Specify whether the fluid system should consider that the oil component can dissolve in the gas phase. More...
 
static void setGasPvt (std::shared_ptr< GasPvt > pvtObj)
 Set the pressure-volume-saturation (PVT) relations for the gas phase. More...
 
static void setOilPvt (std::shared_ptr< OilPvt > pvtObj)
 Set the pressure-volume-saturation (PVT) relations for the oil phase. More...
 
static void setWaterPvt (std::shared_ptr< WaterPvt > pvtObj)
 Set the pressure-volume-saturation (PVT) relations for the water phase. More...
 
static void setReferenceDensities (Scalar rhoOil, Scalar rhoWater, Scalar rhoGas, unsigned regionIdx)
 Initialize the values of the reference densities. More...
 
static void initEnd ()
 Finish initializing the black oil fluid system. More...
 
static const char * phaseName (const unsigned phaseIdx)
 Return the human readable name of a fluid phase. More...
 
static bool isLiquid (const unsigned phaseIdx)
 Return whether a phase is liquid. More...
 
static const char * componentName (unsigned compIdx)
 Return the human readable name of a component. More...
 
static Scalar molarMass (unsigned compIdx, unsigned regionIdx=0)
 Return the molar mass of a component in [kg/mol]. More...
 
static bool isIdealMixture (unsigned)
 Returns true if and only if a fluid phase is assumed to be an ideal mixture. More...
 
static bool isCompressible (unsigned)
 Returns true if and only if a fluid phase is assumed to be compressible. More...
 
static bool isIdealGas (unsigned)
 Returns true if and only if a fluid phase is assumed to be an ideal gas. More...
 
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval density (const FluidState &fluidState, ParameterCache &paramCache, const unsigned phaseIdx)
 Calculate the density [kg/m^3] of a fluid phase. More...
 
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval fugacityCoefficient (const FluidState &fluidState, const ParameterCache &paramCache, unsigned phaseIdx, unsigned compIdx)
 Calculate the fugacity coefficient [Pa] of an individual component in a fluid phase. More...
 
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval viscosity (const FluidState &fluidState, const ParameterCache &paramCache, unsigned phaseIdx)
 Calculate the dynamic viscosity of a fluid phase [Pa*s]. More...
 
static bool enableDissolvedGas ()
 Returns whether the fluid system should consider that the gas component can dissolve in the oil phase. More...
 
static bool enableVaporizedOil ()
 Returns whether the fluid system should consider that the oil component can dissolve in the gas phase. More...
 
static Scalar referenceDensity (unsigned phaseIdx, unsigned regionIdx)
 Returns the density of a fluid phase at surface pressure [kg/m^3]. More...
 
template<class LhsEval >
static LhsEval saturatedOilFormationVolumeFactor (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the oil formation volume factor $B_o$ of saturated oil for a given pressure. More...
 
template<class LhsEval >
static LhsEval waterFormationVolumeFactor (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Return the formation volume factor of water. More...
 
template<class LhsEval >
static LhsEval gasDissolutionFactor (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the gas dissolution factor $R_s$ for a given pressure. More...
 
template<class LhsEval >
static LhsEval oilVaporizationFactor (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the oil vaporization factor $R_v$ for a given pressure. More...
 
template<class LhsEval >
static LhsEval fugCoefficientInWater (unsigned compIdx, const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the fugacity coefficient of a given component in the water phase. More...
 
template<class LhsEval >
static LhsEval fugCoefficientInGas (unsigned compIdx, const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the fugacity coefficient of a given component in the gas phase. More...
 
template<class LhsEval >
static LhsEval fugCoefficientInOil (unsigned compIdx, const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Returns the fugacity coefficient of a given component in the oil phase. More...
 
template<class LhsEval >
static LhsEval oilSaturationPressure (const LhsEval &temperature, const LhsEval &XoG, unsigned regionIdx)
 Returns the saturation pressure of the oil phase [Pa] depending on its mass fraction of the gas component. More...
 
template<class LhsEval >
static LhsEval saturatedOilGasMassFraction (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 The maximum mass fraction of the gas component in the oil phase. More...
 
template<class LhsEval >
static LhsEval saturatedOilGasMoleFraction (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 The maximum mole fraction of the gas component in the oil phase. More...
 
template<class LhsEval >
static LhsEval saturatedGasOilMassFraction (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 The maximum mass fraction of the oil component in the gas phase. More...
 
template<class LhsEval >
static LhsEval saturatedGasOilMoleFraction (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 The maximum mole fraction of the oil component in the gas phase. More...
 
template<class LhsEval >
static LhsEval oilFormationVolumeFactor (const LhsEval &temperature, const LhsEval &pressure, const LhsEval &XoG, unsigned regionIdx)
 Return the normalized formation volume factor of (potentially) under-saturated oil. More...
 
template<class LhsEval >
static LhsEval oilDensity (const LhsEval &temperature, const LhsEval &pressure, const LhsEval &XoG, unsigned regionIdx)
 Return the density of (potentially) under-saturated oil. More...
 
template<class LhsEval >
static LhsEval saturatedOilDensity (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Return the density of gas-saturated oil. More...
 
template<class LhsEval >
static LhsEval gasFormationVolumeFactor (const LhsEval &temperature, const LhsEval &pressure, const LhsEval &XgO, unsigned regionIdx)
 Return the formation volume factor of gas. More...
 
template<class LhsEval >
static LhsEval gasDensity (const LhsEval &temperature, const LhsEval &pressure, const LhsEval &XgO, unsigned regionIdx)
 Return the density of dry gas. More...
 
template<class LhsEval >
static LhsEval waterDensity (const LhsEval &temperature, const LhsEval &pressure, unsigned regionIdx)
 Return the density of water. More...
 
static Scalar molarMass (unsigned)
 Return the molar mass of a component in [kg/mol]. More...
 
static void init ()
 Initialize the fluid system's static parameters. More...
 
static LhsEval density (const FluidState &, const ParameterCache &, unsigned)
 Calculate the density [kg/m^3] of a fluid phase. More...
 
static LhsEval fugacityCoefficient (const FluidState &, const ParameterCache &, unsigned, unsigned)
 Calculate the fugacity coefficient [Pa] of an individual component in a fluid phase. More...
 
static LhsEval viscosity (const FluidState &, const ParameterCache &, unsigned)
 Calculate the dynamic viscosity of a fluid phase [Pa*s]. More...
 
static LhsEval diffusionCoefficient (const FluidState &, const ParameterCache &, unsigned, unsigned)
 Calculate the binary molecular diffusion coefficient for a component in a fluid phase [mol^2 * s / (kg*m^3)]. More...
 
static LhsEval enthalpy (const FluidState &, const ParameterCache &, unsigned)
 Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy [J/kg]. More...
 
static LhsEval thermalConductivity (const FluidState &, const ParameterCache &, unsigned)
 Thermal conductivity of a fluid phase [W/(m K)]. More...
 
static LhsEval heatCapacity (const FluidState &, const ParameterCache &, unsigned)
 Specific isobaric heat capacity of a fluid phase [J/kg]. More...
 

Static Public Attributes

static const int numPhases = 3
 Number of fluid phases in the fluid system. More...
 
static const int waterPhaseIdx = 0
 Index of the water phase. More...
 
static const int oilPhaseIdx = 1
 Index of the oil phase. More...
 
static const int gasPhaseIdx = 2
 Index of the gas phase. More...
 
static const Scalar surfacePressure = 101325.0
 The pressure at the surface. More...
 
static const Scalar surfaceTemperature = 273.15 + 15.56
 The temperature at the surface. More...
 
static const int numComponents = 3
 Number of chemical species in the fluid system. More...
 
static const int oilCompIdx = 0
 Index of the oil component. More...
 
static const int waterCompIdx = 1
 Index of the water component. More...
 
static const int gasCompIdx = 2
 Index of the gas component. More...
 

Detailed Description

template<class Scalar>
class Opm::FluidSystems::BlackOil< Scalar >

A fluid system which uses the black-oil parameters to calculate termodynamically meaningful quantities.

Member Typedef Documentation

typedef NullParameterCache Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::ParameterCache
inherited

The type of the fluid system's parameter cache.

The parameter cache can be used to avoid re-calculating expensive parameters for multiple quantities. Be aware that what the parameter cache actually does is specific for each fluid system and that it is opaque outside the fluid system.

Member Function Documentation

template<class Scalar >
static const char* Opm::FluidSystems::BlackOil< Scalar >::componentName ( unsigned  compIdx)
inlinestatic

Return the human readable name of a component.

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::density ( const FluidState &  ,
const ParameterCache ,
unsigned   
)
inlinestaticinherited

Calculate the density [kg/m^3] of a fluid phase.

template<class Scalar >
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::density ( const FluidState &  fluidState,
ParameterCache paramCache,
const unsigned  phaseIdx 
)
inlinestatic

Calculate the density [kg/m^3] of a fluid phase.

References Opm::FluidSystems::BlackOil< Scalar >::ParameterCache::regionIndex().

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::diffusionCoefficient ( const FluidState &  ,
const ParameterCache ,
unsigned  ,
unsigned   
)
inlinestaticinherited

Calculate the binary molecular diffusion coefficient for a component in a fluid phase [mol^2 * s / (kg*m^3)].

Molecular diffusion of a compoent $\kappa$ is caused by a gradient of the mole fraction and follows the law

\[ J = - D \mathbf{grad} x^\kappa_\alpha \]

where $x_\alpha^\kappa$ is the component's mole fraction in phase $\alpha$, $D$ is the diffusion coefficient and $J$ is the diffusive flux.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::enableDissolvedGas ( )
inlinestatic

Returns whether the fluid system should consider that the gas component can dissolve in the oil phase.

By default, dissolved gas is considered.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::enableVaporizedOil ( )
inlinestatic

Returns whether the fluid system should consider that the oil component can dissolve in the gas phase.

By default, vaporized oil is not considered.

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::enthalpy ( const FluidState &  ,
const ParameterCache ,
unsigned   
)
inlinestaticinherited

Given a phase's composition, temperature, pressure and density, calculate its specific enthalpy [J/kg].

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::fugacityCoefficient ( const FluidState &  ,
const ParameterCache ,
unsigned  ,
unsigned   
)
inlinestaticinherited

Calculate the fugacity coefficient [Pa] of an individual component in a fluid phase.

The fugacity coefficient $\phi_\kappa$ is connected to the fugacity $f_\kappa$ and the component's molarity $x_\kappa$ by means of the relation

\[ f_\kappa = \phi_\kappa\,x_{\kappa} \]

template<class Scalar >
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::fugacityCoefficient ( const FluidState &  fluidState,
const ParameterCache paramCache,
unsigned  phaseIdx,
unsigned  compIdx 
)
inlinestatic

Calculate the fugacity coefficient [Pa] of an individual component in a fluid phase.

The fugacity coefficient $\phi_\kappa$ is connected to the fugacity $f_\kappa$ and the component's molarity $x_\kappa$ by means of the relation

\[ f_\kappa = \phi_\kappa\,x_{\kappa} \]

References Opm::FluidSystems::BlackOil< Scalar >::ParameterCache::regionIndex().

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::fugCoefficientInGas ( unsigned  compIdx,
const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the fugacity coefficient of a given component in the gas phase.

Parameters
compIdxThe index of the component of interest
pressureThe pressure of interest [Pa]
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::fugCoefficientInOil ( unsigned  compIdx,
const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the fugacity coefficient of a given component in the oil phase.

Parameters
compIdxThe index of the component of interest
pressureThe pressure of interest [Pa]
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::fugCoefficientInWater ( unsigned  compIdx,
const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the fugacity coefficient of a given component in the water phase.

Parameters
compIdxThe index of the component of interest
pressureThe pressure of interest [Pa]
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::gasDensity ( const LhsEval &  temperature,
const LhsEval &  pressure,
const LhsEval &  XgO,
unsigned  regionIdx 
)
inlinestatic

Return the density of dry gas.

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::gasDissolutionFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the gas dissolution factor $R_s$ for a given pressure.

Parameters
pressureThe pressure of interest [Pa]
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::gasFormationVolumeFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
const LhsEval &  XgO,
unsigned  regionIdx 
)
inlinestatic

Return the formation volume factor of gas.

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::heatCapacity ( const FluidState &  ,
const ParameterCache ,
unsigned   
)
inlinestaticinherited

Specific isobaric heat capacity of a fluid phase [J/kg].

static void Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::init ( )
inlinestaticinherited

Initialize the fluid system's static parameters.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::initBegin ( size_t  numPvtRegions)
inlinestatic

Begin the initialization of the black oil fluid system.

After calling this method the reference densities, all dissolution and formation volume factors, the oil bubble pressure, all viscosities and the water compressibility must be set. Before the fluid system can be used, initEnd() must be called to finalize the initialization.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::isCompressible ( unsigned  )
inlinestatic

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.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::isIdealGas ( unsigned  )
inlinestatic

Returns true if and only if a fluid phase is assumed to be an ideal gas.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::isIdealMixture ( unsigned  )
inlinestatic

Returns true if and only if a fluid phase is assumed to be an ideal mixture.

We define an ideal mixture as a fluid phase where the fugacity coefficients of all components times the pressure of the phase are independent on the fluid composition. This assumption is true if Henry's law and Rault's law apply. If you are unsure what this function should return, it is safe to return false. The only damage done will be (slightly) increased computation times in some cases.

template<class Scalar >
static bool Opm::FluidSystems::BlackOil< Scalar >::isLiquid ( const unsigned  phaseIdx)
inlinestatic

Return whether a phase is liquid.

References Opm::FluidSystems::BlackOil< Scalar >::gasPhaseIdx.

static Scalar Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::molarMass ( unsigned  )
inlinestaticinherited

Return the molar mass of a component in [kg/mol].

template<class Scalar >
static Scalar Opm::FluidSystems::BlackOil< Scalar >::molarMass ( unsigned  compIdx,
unsigned  regionIdx = 0 
)
inlinestatic

Return the molar mass of a component in [kg/mol].

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::oilDensity ( const LhsEval &  temperature,
const LhsEval &  pressure,
const LhsEval &  XoG,
unsigned  regionIdx 
)
inlinestatic

Return the density of (potentially) under-saturated oil.

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::oilFormationVolumeFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
const LhsEval &  XoG,
unsigned  regionIdx 
)
inlinestatic

Return the normalized formation volume factor of (potentially) under-saturated oil.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::saturatedOilFormationVolumeFactor().

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::oilSaturationPressure ( const LhsEval &  temperature,
const LhsEval &  XoG,
unsigned  regionIdx 
)
inlinestatic

Returns the saturation pressure of the oil phase [Pa] depending on its mass fraction of the gas component.

Parameters
XoGThe mass fraction of the gas component in the oil phase [-]
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::oilVaporizationFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the oil vaporization factor $R_v$ for a given pressure.

Parameters
pressureThe pressure of interest [Pa]
template<class Scalar >
static const char* Opm::FluidSystems::BlackOil< Scalar >::phaseName ( const unsigned  phaseIdx)
inlinestatic

Return the human readable name of a fluid phase.

template<class Scalar >
static Scalar Opm::FluidSystems::BlackOil< Scalar >::referenceDensity ( unsigned  phaseIdx,
unsigned  regionIdx 
)
inlinestatic

Returns the density of a fluid phase at surface pressure [kg/m^3].

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedGasOilMassFraction ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

The maximum mass fraction of the oil component in the gas phase.

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedGasOilMoleFraction ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

The maximum mole fraction of the oil component in the gas phase.

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedOilDensity ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Return the density of gas-saturated oil.

References Opm::FluidSystems::BlackOil< Scalar >::saturatedOilGasMassFraction().

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedOilFormationVolumeFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Returns the oil formation volume factor $B_o$ of saturated oil for a given pressure.

Parameters
pressureThe pressure of interest [Pa]

References Valgrind::CheckDefined(), Opm::FluidSystems::BlackOil< Scalar >::oilFormationVolumeFactor(), and Opm::FluidSystems::BlackOil< Scalar >::saturatedOilGasMassFraction().

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedOilGasMassFraction ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic
template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::saturatedOilGasMoleFraction ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

The maximum mole fraction of the gas component in the oil phase.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setEnableDissolvedGas ( bool  yesno)
inlinestatic

Specify whether the fluid system should consider that the gas component can dissolve in the oil phase.

By default, dissolved gas is considered.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setEnableVaporizedOil ( bool  yesno)
inlinestatic

Specify whether the fluid system should consider that the oil component can dissolve in the gas phase.

By default, vaporized oil is not considered.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setGasPvt ( std::shared_ptr< GasPvt pvtObj)
inlinestatic

Set the pressure-volume-saturation (PVT) relations for the gas phase.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setOilPvt ( std::shared_ptr< OilPvt pvtObj)
inlinestatic

Set the pressure-volume-saturation (PVT) relations for the oil phase.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setReferenceDensities ( Scalar  rhoOil,
Scalar  rhoWater,
Scalar  rhoGas,
unsigned  regionIdx 
)
inlinestatic

Initialize the values of the reference densities.

Parameters
rhoOilThe reference density of (gas saturated) oil phase.
rhoWaterThe reference density of the water phase.
rhoGasThe reference density of the gas phase.

References Opm::FluidSystems::BlackOil< Scalar >::gasPhaseIdx, Opm::FluidSystems::BlackOil< Scalar >::oilPhaseIdx, and Opm::FluidSystems::BlackOil< Scalar >::waterPhaseIdx.

template<class Scalar >
static void Opm::FluidSystems::BlackOil< Scalar >::setWaterPvt ( std::shared_ptr< WaterPvt pvtObj)
inlinestatic

Set the pressure-volume-saturation (PVT) relations for the water phase.

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::thermalConductivity ( const FluidState &  ,
const ParameterCache ,
unsigned   
)
inlinestaticinherited

Thermal conductivity of a fluid phase [W/(m K)].

static LhsEval Opm::BaseFluidSystem< Scalar, BlackOil< Scalar > >::viscosity ( const FluidState &  ,
const ParameterCache ,
unsigned   
)
inlinestaticinherited

Calculate the dynamic viscosity of a fluid phase [Pa*s].

template<class Scalar >
template<class FluidState , class LhsEval = typename FluidState::Scalar>
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::viscosity ( const FluidState &  fluidState,
const ParameterCache paramCache,
unsigned  phaseIdx 
)
inlinestatic

Calculate the dynamic viscosity of a fluid phase [Pa*s].

References Opm::FluidSystems::BlackOil< Scalar >::ParameterCache::regionIndex().

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::waterDensity ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Return the density of water.

template<class Scalar >
template<class LhsEval >
static LhsEval Opm::FluidSystems::BlackOil< Scalar >::waterFormationVolumeFactor ( const LhsEval &  temperature,
const LhsEval &  pressure,
unsigned  regionIdx 
)
inlinestatic

Return the formation volume factor of water.

Member Data Documentation

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::gasCompIdx = 2
static

Index of the gas component.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::initEnd().

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::numComponents = 3
static

Number of chemical species in the fluid system.

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::numPhases = 3
static

Number of fluid phases in the fluid system.

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::oilCompIdx = 0
static

Index of the oil component.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::initEnd().

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::oilPhaseIdx = 1
static
template<class Scalar >
const Scalar Opm::FluidSystems::BlackOil< Scalar >::surfacePressure = 101325.0
static

The pressure at the surface.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::initEnd().

template<class Scalar >
const Scalar Opm::FluidSystems::BlackOil< Scalar >::surfaceTemperature = 273.15 + 15.56
static

The temperature at the surface.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::initEnd().

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::waterCompIdx = 1
static

Index of the water component.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::initEnd().

template<class Scalar >
const int Opm::FluidSystems::BlackOil< Scalar >::waterPhaseIdx = 0
static

Index of the water phase.

Referenced by Opm::FluidSystems::BlackOil< Scalar >::setReferenceDensities().


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