Modelica.Media.Water.WaterIF97_base

Water: Steam properties as defined by IAPWS/IF97 standard

Information

This model calculates medium properties for water in the liquid, gas and two phase regions according to the IAPWS/IF97 standard, i.e., the accepted industrial standard and best compromise between accuracy and computation time. For more details see Modelica.Media.Water.IF97_Utilities. Three variable pairs can be the independent variables of the model:

  1. Pressure p and specific enthalpy h are the most natural choice for general applications. This is the recommended choice for most general purpose applications, in particular for power plants.
  2. Pressure p and temperature T are the most natural choice for applications where water is always in the same phase, both for liquid water and steam.
  3. Density d and temperature T are explicit variables of the Helmholtz function in the near-critical region and can be the best choice for applications with super-critical or near-critical states.

The following quantities are always computed:

Variable Unit Description
T K temperature
u J/kg specific internal energy
d kg/m^3 density
p Pa pressure
h J/kg specific enthalpy

In some cases additional medium properties are needed. A component that needs these optional properties has to call one of the functions listed in Modelica.Media.UsersGuide.MediumUsage.OptionalProperties and in Modelica.Media.UsersGuide.MediumUsage.TwoPhase.

Many further properties can be computed. Using the well-known Bridgman's Tables, all first partial derivatives of the standard thermodynamic variables can be computed easily.

Extends from Interfaces.PartialTwoPhaseMedium (Base class for two phase medium of one substance).

Package Content

Name Description
Modelica.Media.Water.WaterIF97_base.ThermodynamicState ThermodynamicState Thermodynamic state
Region=0 Region of IF97, if known, zero otherwise
ph_explicit True if explicit in pressure and specific enthalpy
dT_explicit True if explicit in density and temperature
pT_explicit True if explicit in pressure and temperature
Modelica.Media.Water.WaterIF97_base.BaseProperties BaseProperties Base properties of water
Modelica.Media.Water.WaterIF97_base.density_ph density_ph Computes density as a function of pressure and specific enthalpy
Modelica.Media.Water.WaterIF97_base.temperature_ph temperature_ph Computes temperature as a function of pressure and specific enthalpy
Modelica.Media.Water.WaterIF97_base.temperature_ps temperature_ps Compute temperature from pressure and specific enthalpy
Modelica.Media.Water.WaterIF97_base.density_ps density_ps Computes density as a function of pressure and specific enthalpy
Modelica.Media.Water.WaterIF97_base.pressure_dT pressure_dT Computes pressure as a function of density and temperature
Modelica.Media.Water.WaterIF97_base.specificEnthalpy_dT specificEnthalpy_dT Computes specific enthalpy as a function of density and temperature
Modelica.Media.Water.WaterIF97_base.specificEnthalpy_pT specificEnthalpy_pT Computes specific enthalpy as a function of pressure and temperature
Modelica.Media.Water.WaterIF97_base.specificEnthalpy_ps specificEnthalpy_ps Computes specific enthalpy as a function of pressure and temperature
Modelica.Media.Water.WaterIF97_base.density_pT density_pT Computes density as a function of pressure and temperature
Modelica.Media.Water.WaterIF97_base.setDewState setDewState Set the thermodynamic state on the dew line
Modelica.Media.Water.WaterIF97_base.setBubbleState setBubbleState Set the thermodynamic state on the bubble line
Modelica.Media.Water.WaterIF97_base.dynamicViscosity dynamicViscosity Dynamic viscosity of water
Modelica.Media.Water.WaterIF97_base.thermalConductivity thermalConductivity Thermal conductivity of water
Modelica.Media.Water.WaterIF97_base.surfaceTension surfaceTension Surface tension in two phase region of water
Modelica.Media.Water.WaterIF97_base.pressure pressure Return pressure of ideal gas
Modelica.Media.Water.WaterIF97_base.temperature temperature Return temperature of ideal gas
Modelica.Media.Water.WaterIF97_base.density density Return density of ideal gas
Modelica.Media.Water.WaterIF97_base.specificEnthalpy specificEnthalpy Return specific enthalpy
Modelica.Media.Water.WaterIF97_base.specificInternalEnergy specificInternalEnergy Return specific internal energy
Modelica.Media.Water.WaterIF97_base.specificGibbsEnergy specificGibbsEnergy Return specific Gibbs energy
Modelica.Media.Water.WaterIF97_base.specificHelmholtzEnergy specificHelmholtzEnergy Return specific Helmholtz energy
Modelica.Media.Water.WaterIF97_base.specificEntropy specificEntropy Specific entropy of water
Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCp specificHeatCapacityCp Specific heat capacity at constant pressure of water
Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCv specificHeatCapacityCv Specific heat capacity at constant volume of water
Modelica.Media.Water.WaterIF97_base.isentropicExponent isentropicExponent Return isentropic exponent
Modelica.Media.Water.WaterIF97_base.isothermalCompressibility isothermalCompressibility Isothermal compressibility of water
Modelica.Media.Water.WaterIF97_base.isobaricExpansionCoefficient isobaricExpansionCoefficient Isobaric expansion coefficient of water
Modelica.Media.Water.WaterIF97_base.velocityOfSound velocityOfSound Return velocity of sound as a function of the thermodynamic state record
Modelica.Media.Water.WaterIF97_base.isentropicEnthalpy isentropicEnthalpy Compute h(s,p)
Modelica.Media.Water.WaterIF97_base.density_derh_p density_derh_p Density derivative by specific enthalpy
Modelica.Media.Water.WaterIF97_base.density_derp_h density_derp_h Density derivative by pressure
Modelica.Media.Water.WaterIF97_base.bubbleEnthalpy bubbleEnthalpy Boiling curve specific enthalpy of water
Modelica.Media.Water.WaterIF97_base.dewEnthalpy dewEnthalpy Dew curve specific enthalpy of water
Modelica.Media.Water.WaterIF97_base.bubbleEntropy bubbleEntropy Boiling curve specific entropy of water
Modelica.Media.Water.WaterIF97_base.dewEntropy dewEntropy Dew curve specific entropy of water
Modelica.Media.Water.WaterIF97_base.bubbleDensity bubbleDensity Boiling curve specific density of water
Modelica.Media.Water.WaterIF97_base.dewDensity dewDensity Dew curve specific density of water
Modelica.Media.Water.WaterIF97_base.saturationTemperature saturationTemperature Saturation temperature of water
Modelica.Media.Water.WaterIF97_base.saturationTemperature_derp saturationTemperature_derp Derivative of saturation temperature w.r.t. pressure
Modelica.Media.Water.WaterIF97_base.saturationPressure saturationPressure Saturation pressure of water
Modelica.Media.Water.WaterIF97_base.dBubbleDensity_dPressure dBubbleDensity_dPressure Bubble point density derivative
Modelica.Media.Water.WaterIF97_base.dDewDensity_dPressure dDewDensity_dPressure Dew point density derivative
Modelica.Media.Water.WaterIF97_base.dBubbleEnthalpy_dPressure dBubbleEnthalpy_dPressure Bubble point specific enthalpy derivative
Modelica.Media.Water.WaterIF97_base.dDewEnthalpy_dPressure dDewEnthalpy_dPressure Dew point specific enthalpy derivative
Modelica.Media.Water.WaterIF97_base.setState_dTX setState_dTX Return thermodynamic state of water as function of d, T, and optional region
Modelica.Media.Water.WaterIF97_base.setState_phX setState_phX Return thermodynamic state of water as function of p, h, and optional region
Modelica.Media.Water.WaterIF97_base.setState_psX setState_psX Return thermodynamic state of water as function of p, s, and optional region
Modelica.Media.Water.WaterIF97_base.setState_pTX setState_pTX Return thermodynamic state of water as function of p, T, and optional region
Modelica.Media.Water.WaterIF97_base.setSmoothState setSmoothState Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
Inherited
smoothModel=false True if the (derived) model should not generate state events
onePhase=false True if the (derived) model should never be called with two-phase inputs
fluidConstants Constant data for the fluid
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setSat_T setSat_T Return saturation property record from temperature
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setSat_p setSat_p Return saturation property record from pressure
Modelica.Media.Interfaces.PartialTwoPhaseMedium.saturationPressure_sat saturationPressure_sat Return saturation temperature
Modelica.Media.Interfaces.PartialTwoPhaseMedium.saturationTemperature_sat saturationTemperature_sat Return saturation temperature
Modelica.Media.Interfaces.PartialTwoPhaseMedium.saturationTemperature_derp_sat saturationTemperature_derp_sat Return derivative of saturation temperature w.r.t. pressure
Modelica.Media.Interfaces.PartialTwoPhaseMedium.molarMass molarMass Return the molar mass of the medium
Modelica.Media.Interfaces.PartialTwoPhaseMedium.specificEnthalpy_pTX specificEnthalpy_pTX Return specific enthalpy from pressure, temperature and mass fraction
Modelica.Media.Interfaces.PartialTwoPhaseMedium.temperature_phX temperature_phX Return temperature from p, h, and X or Xi
Modelica.Media.Interfaces.PartialTwoPhaseMedium.density_phX density_phX Return density from p, h, and X or Xi
Modelica.Media.Interfaces.PartialTwoPhaseMedium.temperature_psX temperature_psX Return temperature from p, s, and X or Xi
Modelica.Media.Interfaces.PartialTwoPhaseMedium.density_psX density_psX Return density from p, s, and X or Xi
Modelica.Media.Interfaces.PartialTwoPhaseMedium.specificEnthalpy_psX specificEnthalpy_psX Return specific enthalpy from p, s, and X or Xi
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_pT setState_pT Return thermodynamic state from p and T
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_ph setState_ph Return thermodynamic state from p and h
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_ps setState_ps Return thermodynamic state from p and s
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_dT setState_dT Return thermodynamic state from d and T
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_px setState_px Return thermodynamic state from pressure and vapour quality
Modelica.Media.Interfaces.PartialTwoPhaseMedium.setState_Tx setState_Tx Return thermodynamic state from temperature and vapour quality
Modelica.Media.Interfaces.PartialTwoPhaseMedium.vapourQuality vapourQuality Return vapour quality
ThermoStates Enumeration type for independent variables
mediumName="unusablePartialMedium" Name of the medium
substanceNames={mediumName} Names of the mixture substances. Set substanceNames={mediumName} if only one substance.
extraPropertiesNames=fill("", 0) Names of the additional (extra) transported properties. Set extraPropertiesNames=fill("",0) if unused
singleState = true, if u and d are not a function of pressure
reducedX=true = true if medium contains the equation sum(X) = 1.0; set reducedX=true if only one substance (see docu for details)
fixedX=false = true if medium contains the equation X = reference_X
reference_p=101325 Reference pressure of Medium: default 1 atmosphere
reference_T=298.15 Reference temperature of Medium: default 25 deg Celsius
reference_X=fill(1/nX, nX) Default mass fractions of medium
p_default=101325 Default value for pressure of medium (for initialization)
T_default=Modelica.SIunits.Conversions.from_degC(20) Default value for temperature of medium (for initialization)
h_default=specificEnthalpy_pTX(p_default, T_default, X_default) Default value for specific enthalpy of medium (for initialization)
X_default=reference_X Default value for mass fractions of medium (for initialization)
nS=size(substanceNames, 1) Number of substances
nX=nS Number of mass fractions
nXi=if fixedX then 0 else if reducedX then nS - 1 else nS Number of structurally independent mass fractions (see docu for details)
nC=size(extraPropertiesNames, 1) Number of extra (outside of standard mass-balance) transported properties
C_nominal=1.0e-6*ones(nC) Default for the nominal values for the extra properties
Modelica.Media.Interfaces.PartialMedium.FluidConstants FluidConstants Critical, triple, molecular and other standard data of fluid
Modelica.Media.Interfaces.PartialMedium.prandtlNumber prandtlNumber Return the Prandtl number
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cp heatCapacity_cp Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cv heatCapacity_cv Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.beta beta Alias for isobaricExpansionCoefficient for user convenience
Modelica.Media.Interfaces.PartialMedium.kappa kappa Alias of isothermalCompressibility for user convenience
Modelica.Media.Interfaces.PartialMedium.density_derp_T density_derp_T Return density derivative w.r.t. pressure at const temperature
Modelica.Media.Interfaces.PartialMedium.density_derT_p density_derT_p Return density derivative w.r.t. temperature at constant pressure
Modelica.Media.Interfaces.PartialMedium.density_derX density_derX Return density derivative w.r.t. mass fraction
Modelica.Media.Interfaces.PartialMedium.specificEntropy_pTX specificEntropy_pTX Return specific enthalpy from p, T, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_pTX density_pTX Return density from p, T, and X or Xi
MassFlowRate Type for mass flow rate with medium specific attributes
AbsolutePressure Type for absolute pressure with medium specific attributes
Density Type for density with medium specific attributes
DynamicViscosity Type for dynamic viscosity with medium specific attributes
EnthalpyFlowRate Type for enthalpy flow rate with medium specific attributes
MassFraction Type for mass fraction with medium specific attributes
MoleFraction Type for mole fraction with medium specific attributes
MolarMass Type for molar mass with medium specific attributes
MolarVolume Type for molar volume with medium specific attributes
IsentropicExponent Type for isentropic exponent with medium specific attributes
SpecificEnergy Type for specific energy with medium specific attributes
SpecificInternalEnergy Type for specific internal energy with medium specific attributes
SpecificEnthalpy Type for specific enthalpy with medium specific attributes
SpecificEntropy Type for specific entropy with medium specific attributes
SpecificHeatCapacity Type for specific heat capacity with medium specific attributes
SurfaceTension Type for surface tension with medium specific attributes
Temperature Type for temperature with medium specific attributes
ThermalConductivity Type for thermal conductivity with medium specific attributes
PrandtlNumber Type for Prandtl number with medium specific attributes
VelocityOfSound Type for velocity of sound with medium specific attributes
ExtraProperty Type for unspecified, mass-specific property transported by flow
CumulativeExtraProperty Type for conserved integral of unspecified, mass specific property
ExtraPropertyFlowRate Type for flow rate of unspecified, mass-specific property
IsobaricExpansionCoefficient Type for isobaric expansion coefficient with medium specific attributes
DipoleMoment Type for dipole moment with medium specific attributes
DerDensityByPressure Type for partial derivative of density with respect to pressure with medium specific attributes
DerDensityByEnthalpy Type for partial derivative of density with respect to enthalpy with medium specific attributes
DerEnthalpyByPressure Type for partial derivative of enthalpy with respect to pressure with medium specific attributes
DerDensityByTemperature Type for partial derivative of density with respect to temperature with medium specific attributes
DerTemperatureByPressure Type for partial derivative of temperature with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.SaturationProperties SaturationProperties Saturation properties of two phase medium
Modelica.Media.Interfaces.Types.FluidLimits FluidLimits Validity limits for fluid model
FixedPhase Phase of the fluid: 1 for 1-phase, 2 for two-phase, 0 for not known, e.g., interactive use
Modelica.Media.Interfaces.Types.Basic Basic The most basic version of a record used in several degrees of detail
Modelica.Media.Interfaces.Types.IdealGas IdealGas The ideal gas version of a record used in several degrees of detail
Modelica.Media.Interfaces.Types.TwoPhase TwoPhase The two phase fluid version of a record used in several degrees of detail

Modelica.Media.Water.WaterIF97_base.ThermodynamicState Modelica.Media.Water.WaterIF97_base.ThermodynamicState

Thermodynamic state

Information

Extends from (Thermodynamic state of two phase medium).

Modelica.Media.Water.WaterIF97_base.BaseProperties Modelica.Media.Water.WaterIF97_base.BaseProperties

Base properties of water

Information

Extends from (Base properties (p, d, T, h, u, R, MM, sat) of two phase medium).

Parameters

NameDescription
Advanced
preferredMediumStates= true if StateSelect.prefer shall be used for the independent property variables of the medium

Modelica.Media.Water.WaterIF97_base.density_ph Modelica.Media.Water.WaterIF97_base.density_ph

Computes density as a function of pressure and specific enthalpy

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Water.WaterIF97_base.temperature_ph Modelica.Media.Water.WaterIF97_base.temperature_ph

Computes temperature as a function of pressure and specific enthalpy

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Water.WaterIF97_base.temperature_ps Modelica.Media.Water.WaterIF97_base.temperature_ps

Compute temperature from pressure and specific enthalpy

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Water.WaterIF97_base.density_ps Modelica.Media.Water.WaterIF97_base.density_ps

Computes density as a function of pressure and specific enthalpy

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Water.WaterIF97_base.pressure_dT Modelica.Media.Water.WaterIF97_base.pressure_dT

Computes pressure as a function of density and temperature

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
pPressure [Pa]

Modelica.Media.Water.WaterIF97_base.specificEnthalpy_dT Modelica.Media.Water.WaterIF97_base.specificEnthalpy_dT

Computes specific enthalpy as a function of density and temperature

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificEnthalpy_pT Modelica.Media.Water.WaterIF97_base.specificEnthalpy_pT

Computes specific enthalpy as a function of pressure and temperature

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificEnthalpy_ps Modelica.Media.Water.WaterIF97_base.specificEnthalpy_ps

Computes specific enthalpy as a function of pressure and temperature

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.density_pT Modelica.Media.Water.WaterIF97_base.density_pT

Computes density as a function of pressure and temperature

Information

Extends from Modelica.Icons.Function (Icon for functions).

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Water.WaterIF97_base.setDewState Modelica.Media.Water.WaterIF97_base.setDewState

Set the thermodynamic state on the dew line

Information

Extends from (Return the thermodynamic state on the dew line).

Inputs

NameDescription
satSaturation point
phasePhase: default is one phase

Outputs

NameDescription
stateComplete thermodynamic state info

Modelica.Media.Water.WaterIF97_base.setBubbleState Modelica.Media.Water.WaterIF97_base.setBubbleState

Set the thermodynamic state on the bubble line

Information

Extends from (Return the thermodynamic state on the bubble line).

Inputs

NameDescription
satSaturation point
phasePhase: default is one phase

Outputs

NameDescription
stateComplete thermodynamic state info

Modelica.Media.Water.WaterIF97_base.dynamicViscosity Modelica.Media.Water.WaterIF97_base.dynamicViscosity

Dynamic viscosity of water

Information

Extends from (Return dynamic viscosity).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
etaDynamic viscosity [Pa.s]

Modelica.Media.Water.WaterIF97_base.thermalConductivity Modelica.Media.Water.WaterIF97_base.thermalConductivity

Thermal conductivity of water

Information

Extends from (Return thermal conductivity).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
lambdaThermal conductivity [W/(m.K)]

Modelica.Media.Water.WaterIF97_base.surfaceTension Modelica.Media.Water.WaterIF97_base.surfaceTension

Surface tension in two phase region of water

Information

Extends from (Return surface tension sigma in the two phase region).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
sigmaSurface tension sigma in the two phase region [N/m]

Modelica.Media.Water.WaterIF97_base.pressure Modelica.Media.Water.WaterIF97_base.pressure

Return pressure of ideal gas

Information

Extends from (Return pressure).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
pPressure [Pa]

Modelica.Media.Water.WaterIF97_base.temperature Modelica.Media.Water.WaterIF97_base.temperature

Return temperature of ideal gas

Information

Extends from (Return temperature).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Water.WaterIF97_base.density Modelica.Media.Water.WaterIF97_base.density

Return density of ideal gas

Information

Extends from (Return density).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Water.WaterIF97_base.specificEnthalpy Modelica.Media.Water.WaterIF97_base.specificEnthalpy

Return specific enthalpy

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return specific enthalpy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificInternalEnergy Modelica.Media.Water.WaterIF97_base.specificInternalEnergy

Return specific internal energy

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return specific internal energy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
uSpecific internal energy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificGibbsEnergy Modelica.Media.Water.WaterIF97_base.specificGibbsEnergy

Return specific Gibbs energy

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return specific Gibbs energy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
gSpecific Gibbs energy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificHelmholtzEnergy Modelica.Media.Water.WaterIF97_base.specificHelmholtzEnergy

Return specific Helmholtz energy

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return specific Helmholtz energy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
fSpecific Helmholtz energy [J/kg]

Modelica.Media.Water.WaterIF97_base.specificEntropy Modelica.Media.Water.WaterIF97_base.specificEntropy

Specific entropy of water

Information

Extends from (Return specific entropy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
sSpecific entropy [J/(kg.K)]

Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCp Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCp

Specific heat capacity at constant pressure of water

Information

Extends from (Return specific heat capacity at constant pressure).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
cpSpecific heat capacity at constant pressure [J/(kg.K)]

Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCv Modelica.Media.Water.WaterIF97_base.specificHeatCapacityCv

Specific heat capacity at constant volume of water

Information

Extends from (Return specific heat capacity at constant volume).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
cvSpecific heat capacity at constant volume [J/(kg.K)]

Modelica.Media.Water.WaterIF97_base.isentropicExponent Modelica.Media.Water.WaterIF97_base.isentropicExponent

Return isentropic exponent

Information

Extends from (Return isentropic exponent).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
gammaIsentropic exponent [1]

Modelica.Media.Water.WaterIF97_base.isothermalCompressibility Modelica.Media.Water.WaterIF97_base.isothermalCompressibility

Isothermal compressibility of water

Information

Extends from (Return overall the isothermal compressibility factor).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
kappaIsothermal compressibility [1/Pa]

Modelica.Media.Water.WaterIF97_base.isobaricExpansionCoefficient Modelica.Media.Water.WaterIF97_base.isobaricExpansionCoefficient

Isobaric expansion coefficient of water

Information

Extends from (Return overall the isobaric expansion coefficient beta).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
betaIsobaric expansion coefficient [1/K]

Modelica.Media.Water.WaterIF97_base.velocityOfSound Modelica.Media.Water.WaterIF97_base.velocityOfSound

Return velocity of sound as a function of the thermodynamic state record

Information

Extends from (Return velocity of sound).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
aVelocity of sound [m/s]

Modelica.Media.Water.WaterIF97_base.isentropicEnthalpy Modelica.Media.Water.WaterIF97_base.isentropicEnthalpy

Compute h(s,p)

Information

Extends from (Return isentropic enthalpy).

Inputs

NameDescription
p_downstreamDownstream pressure [Pa]
refStateReference state for entropy

Outputs

NameDescription
h_isIsentropic enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.density_derh_p Modelica.Media.Water.WaterIF97_base.density_derh_p

Density derivative by specific enthalpy

Information

Extends from (Return density derivative w.r.t. specific enthalpy at constant pressure).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
ddhpDensity derivative w.r.t. specific enthalpy [kg.s2/m5]

Modelica.Media.Water.WaterIF97_base.density_derp_h Modelica.Media.Water.WaterIF97_base.density_derp_h

Density derivative by pressure

Information

Extends from (Return density derivative w.r.t. pressure at const specific enthalpy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
ddphDensity derivative w.r.t. pressure [s2/m2]

Modelica.Media.Water.WaterIF97_base.bubbleEnthalpy Modelica.Media.Water.WaterIF97_base.bubbleEnthalpy

Boiling curve specific enthalpy of water

Information

Extends from (Return bubble point specific enthalpy).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
hlBoiling curve specific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.dewEnthalpy Modelica.Media.Water.WaterIF97_base.dewEnthalpy

Dew curve specific enthalpy of water

Information

Extends from (Return dew point specific enthalpy).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
hvDew curve specific enthalpy [J/kg]

Modelica.Media.Water.WaterIF97_base.bubbleEntropy Modelica.Media.Water.WaterIF97_base.bubbleEntropy

Boiling curve specific entropy of water

Information

Extends from (Return bubble point specific entropy).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
slBoiling curve specific entropy [J/(kg.K)]

Modelica.Media.Water.WaterIF97_base.dewEntropy Modelica.Media.Water.WaterIF97_base.dewEntropy

Dew curve specific entropy of water

Information

Extends from (Return dew point specific entropy).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
svDew curve specific entropy [J/(kg.K)]

Modelica.Media.Water.WaterIF97_base.bubbleDensity Modelica.Media.Water.WaterIF97_base.bubbleDensity

Boiling curve specific density of water

Information

Extends from (Return bubble point density).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
dlBoiling curve density [kg/m3]

Modelica.Media.Water.WaterIF97_base.dewDensity Modelica.Media.Water.WaterIF97_base.dewDensity

Dew curve specific density of water

Information

Extends from (Return dew point density).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
dvDew curve density [kg/m3]

Modelica.Media.Water.WaterIF97_base.saturationTemperature Modelica.Media.Water.WaterIF97_base.saturationTemperature

Saturation temperature of water

Information

Extends from (Return saturation temperature).

Inputs

NameDescription
pPressure [Pa]

Outputs

NameDescription
TSaturation temperature [K]

Modelica.Media.Water.WaterIF97_base.saturationTemperature_derp Modelica.Media.Water.WaterIF97_base.saturationTemperature_derp

Derivative of saturation temperature w.r.t. pressure

Information

Extends from (Return derivative of saturation temperature w.r.t. pressure).

Inputs

NameDescription
pPressure [Pa]

Outputs

NameDescription
dTpDerivative of saturation temperature w.r.t. pressure [K/Pa]

Modelica.Media.Water.WaterIF97_base.saturationPressure Modelica.Media.Water.WaterIF97_base.saturationPressure

Saturation pressure of water

Information

Extends from (Return saturation pressure).

Inputs

NameDescription
TTemperature [K]

Outputs

NameDescription
pSaturation pressure [Pa]

Modelica.Media.Water.WaterIF97_base.dBubbleDensity_dPressure Modelica.Media.Water.WaterIF97_base.dBubbleDensity_dPressure

Bubble point density derivative

Information

Extends from (Return bubble point density derivative).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
ddldpBoiling curve density derivative [s2/m2]

Modelica.Media.Water.WaterIF97_base.dDewDensity_dPressure Modelica.Media.Water.WaterIF97_base.dDewDensity_dPressure

Dew point density derivative

Information

Extends from (Return dew point density derivative).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
ddvdpSaturated steam density derivative [s2/m2]

Modelica.Media.Water.WaterIF97_base.dBubbleEnthalpy_dPressure Modelica.Media.Water.WaterIF97_base.dBubbleEnthalpy_dPressure

Bubble point specific enthalpy derivative

Information

Extends from (Return bubble point specific enthalpy derivative).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
dhldpBoiling curve specific enthalpy derivative [J.m.s2/kg2]

Modelica.Media.Water.WaterIF97_base.dDewEnthalpy_dPressure Modelica.Media.Water.WaterIF97_base.dDewEnthalpy_dPressure

Dew point specific enthalpy derivative

Information

Extends from (Return dew point specific enthalpy derivative).

Inputs

NameDescription
satSaturation property record

Outputs

NameDescription
dhvdpSaturated steam specific enthalpy derivative [J.m.s2/kg2]

Modelica.Media.Water.WaterIF97_base.setState_dTX Modelica.Media.Water.WaterIF97_base.setState_dTX

Return thermodynamic state of water as function of d, T, and optional region

Information

Extends from (Return thermodynamic state as function of d, T and composition X or Xi).

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]
X[:]Mass fractions [kg/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Water.WaterIF97_base.setState_phX Modelica.Media.Water.WaterIF97_base.setState_phX

Return thermodynamic state of water as function of p, h, and optional region

Information

Extends from (Return thermodynamic state as function of p, h and composition X or Xi).

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
X[:]Mass fractions [kg/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Water.WaterIF97_base.setState_psX Modelica.Media.Water.WaterIF97_base.setState_psX

Return thermodynamic state of water as function of p, s, and optional region

Information

Extends from (Return thermodynamic state as function of p, s and composition X or Xi).

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
X[:]Mass fractions [kg/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Water.WaterIF97_base.setState_pTX Modelica.Media.Water.WaterIF97_base.setState_pTX

Return thermodynamic state of water as function of p, T, and optional region

Information

Extends from (Return thermodynamic state as function of p, T and composition X or Xi).

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
X[:]Mass fractions [kg/kg]
phase2 for two-phase, 1 for one-phase, 0 if not known
regionIf 0, region is unknown, otherwise known and this input

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Water.WaterIF97_base.setSmoothState Modelica.Media.Water.WaterIF97_base.setSmoothState

Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b

Information

Extends from (Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b).

Inputs

NameDescription
xm_flow or dp
state_aThermodynamic state if x > 0
state_bThermodynamic state if x < 0
x_smallSmooth transition in the region -x_small < x < x_small

Outputs

NameDescription
stateSmooth thermodynamic state for all x (continuous and differentiable)
Automatically generated Tue Apr 05 09:37:01 2016.