Modelica.Media.Interfaces.PartialMedium

Partial medium properties (base package of all media packages)

Information

PartialMedium is a package and contains all declarations for a medium. This means that constants, models, and functions are defined that every medium is supposed to support (some of them are optional). A medium package inherits from PartialMedium and provides the equations for the medium. The details of this package are described in Modelica.Media.UsersGuide.

Extends from Modelica.Media.Interfaces.Types (Types to be used in fluid models), Modelica.Icons.MaterialPropertiesPackage (Icon for package containing property classes).

Package Content

Name Description
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.Units.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)
C_default=fill(0, nC) Default value for trace substances 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.ThermodynamicState ThermodynamicState Minimal variable set that is available as input argument to every medium function
Modelica.Media.Interfaces.PartialMedium.BaseProperties BaseProperties Base properties (p, d, T, h, u, R_s, MM and, if applicable, X and Xi) of a medium
Modelica.Media.Interfaces.PartialMedium.setState_pTX setState_pTX Return thermodynamic state as function of p, T and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_phX setState_phX Return thermodynamic state as function of p, h and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_psX setState_psX Return thermodynamic state as function of p, s and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setState_dTX setState_dTX Return thermodynamic state as function of d, T and composition X or Xi
Modelica.Media.Interfaces.PartialMedium.setSmoothState setSmoothState Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
Modelica.Media.Interfaces.PartialMedium.dynamicViscosity dynamicViscosity Return dynamic viscosity
Modelica.Media.Interfaces.PartialMedium.thermalConductivity thermalConductivity Return thermal conductivity
Modelica.Media.Interfaces.PartialMedium.prandtlNumber prandtlNumber Return the Prandtl number
Modelica.Media.Interfaces.PartialMedium.pressure pressure Return pressure
Modelica.Media.Interfaces.PartialMedium.temperature temperature Return temperature
Modelica.Media.Interfaces.PartialMedium.density density Return density
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy specificEnthalpy Return specific enthalpy
Modelica.Media.Interfaces.PartialMedium.specificInternalEnergy specificInternalEnergy Return specific internal energy
Modelica.Media.Interfaces.PartialMedium.specificEntropy specificEntropy Return specific entropy
Modelica.Media.Interfaces.PartialMedium.specificGibbsEnergy specificGibbsEnergy Return specific Gibbs energy
Modelica.Media.Interfaces.PartialMedium.specificHelmholtzEnergy specificHelmholtzEnergy Return specific Helmholtz energy
Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCp specificHeatCapacityCp Return specific heat capacity at constant pressure
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cp heatCapacity_cp Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCv specificHeatCapacityCv Return specific heat capacity at constant volume
Modelica.Media.Interfaces.PartialMedium.heatCapacity_cv heatCapacity_cv Alias for deprecated name
Modelica.Media.Interfaces.PartialMedium.isentropicExponent isentropicExponent Return isentropic exponent
Modelica.Media.Interfaces.PartialMedium.isentropicEnthalpy isentropicEnthalpy Return isentropic enthalpy
Modelica.Media.Interfaces.PartialMedium.velocityOfSound velocityOfSound Return velocity of sound
Modelica.Media.Interfaces.PartialMedium.isobaricExpansionCoefficient isobaricExpansionCoefficient Return overall the isobaric expansion coefficient beta
Modelica.Media.Interfaces.PartialMedium.beta beta Alias for isobaricExpansionCoefficient for user convenience
Modelica.Media.Interfaces.PartialMedium.isothermalCompressibility isothermalCompressibility Return overall the isothermal compressibility factor
Modelica.Media.Interfaces.PartialMedium.kappa kappa Alias of isothermalCompressibility for user convenience
Modelica.Media.Interfaces.PartialMedium.density_derp_h density_derp_h Return density derivative w.r.t. pressure at const specific enthalpy
Modelica.Media.Interfaces.PartialMedium.density_derh_p density_derh_p Return density derivative w.r.t. specific enthalpy at constant pressure
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.molarMass molarMass Return the molar mass of the medium
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_pTX specificEnthalpy_pTX Return specific enthalpy from p, T, and X or Xi
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
Modelica.Media.Interfaces.PartialMedium.temperature_phX temperature_phX Return temperature from p, h, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_phX density_phX Return density from p, h, and X or Xi
Modelica.Media.Interfaces.PartialMedium.temperature_psX temperature_psX Return temperature from p,s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.density_psX density_psX Return density from p, s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_psX specificEnthalpy_psX Return specific enthalpy from p, s, and X or Xi
Modelica.Media.Interfaces.PartialMedium.MassFlowRate MassFlowRate Type for mass flow rate with medium specific attributes
Inherited
Modelica.Media.Interfaces.Types.AbsolutePressure AbsolutePressure Type for absolute pressure with medium specific attributes
Modelica.Media.Interfaces.Types.Density Density Type for density with medium specific attributes
Modelica.Media.Interfaces.Types.DynamicViscosity DynamicViscosity Type for dynamic viscosity with medium specific attributes
Modelica.Media.Interfaces.Types.EnthalpyFlowRate EnthalpyFlowRate Type for enthalpy flow rate with medium specific attributes
Modelica.Media.Interfaces.Types.MassFraction MassFraction Type for mass fraction with medium specific attributes
Modelica.Media.Interfaces.Types.MoleFraction MoleFraction Type for mole fraction with medium specific attributes
Modelica.Media.Interfaces.Types.MolarMass MolarMass Type for molar mass with medium specific attributes
Modelica.Media.Interfaces.Types.MolarVolume MolarVolume Type for molar volume with medium specific attributes
Modelica.Media.Interfaces.Types.IsentropicExponent IsentropicExponent Type for isentropic exponent with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEnergy SpecificEnergy Type for specific energy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificInternalEnergy SpecificInternalEnergy Type for specific internal energy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEnthalpy SpecificEnthalpy Type for specific enthalpy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificEntropy SpecificEntropy Type for specific entropy with medium specific attributes
Modelica.Media.Interfaces.Types.SpecificHeatCapacity SpecificHeatCapacity Type for specific heat capacity with medium specific attributes
Modelica.Media.Interfaces.Types.SurfaceTension SurfaceTension Type for surface tension with medium specific attributes
Modelica.Media.Interfaces.Types.Temperature Temperature Type for temperature with medium specific attributes
Modelica.Media.Interfaces.Types.ThermalConductivity ThermalConductivity Type for thermal conductivity with medium specific attributes
Modelica.Media.Interfaces.Types.PrandtlNumber PrandtlNumber Type for Prandtl number with medium specific attributes
Modelica.Media.Interfaces.Types.VelocityOfSound VelocityOfSound Type for velocity of sound with medium specific attributes
Modelica.Media.Interfaces.Types.ExtraProperty ExtraProperty Type for unspecified, mass-specific property transported by flow
Modelica.Media.Interfaces.Types.CumulativeExtraProperty CumulativeExtraProperty Type for conserved integral of unspecified, mass specific property
Modelica.Media.Interfaces.Types.ExtraPropertyFlowRate ExtraPropertyFlowRate Type for flow rate of unspecified, mass-specific property
Modelica.Media.Interfaces.Types.IsobaricExpansionCoefficient IsobaricExpansionCoefficient Type for isobaric expansion coefficient with medium specific attributes
Modelica.Media.Interfaces.Types.DipoleMoment DipoleMoment Type for dipole moment with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByPressure DerDensityByPressure Type for partial derivative of density with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByEnthalpy DerDensityByEnthalpy Type for partial derivative of density with respect to enthalpy with medium specific attributes
Modelica.Media.Interfaces.Types.DerEnthalpyByPressure DerEnthalpyByPressure Type for partial derivative of enthalpy with respect to pressure with medium specific attributes
Modelica.Media.Interfaces.Types.DerDensityByTemperature DerDensityByTemperature Type for partial derivative of density with respect to temperature with medium specific attributes
Modelica.Media.Interfaces.Types.DerTemperatureByPressure 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
Modelica.Media.Interfaces.Types.FixedPhase 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.Interfaces.PartialMedium.FluidConstants Modelica.Media.Interfaces.PartialMedium.FluidConstants

Critical, triple, molecular and other standard data of fluid

Modelica.Media.Interfaces.PartialMedium.ThermodynamicState Modelica.Media.Interfaces.PartialMedium.ThermodynamicState

Minimal variable set that is available as input argument to every medium function

Information

Extends from Modelica.Icons.Record (Icon for records).

Modelica.Media.Interfaces.PartialMedium.BaseProperties Modelica.Media.Interfaces.PartialMedium.BaseProperties

Base properties (p, d, T, h, u, R_s, MM and, if applicable, X and Xi) of a medium

Information

Model BaseProperties is a model within package PartialMedium and contains the declarations of the minimum number of variables that every medium model is supposed to support. A specific medium inherits from model BaseProperties and provides the equations for the basic properties.

The BaseProperties model contains the following 7+nXi variables (nXi is the number of independent mass fractions defined in package PartialMedium):

Variable Unit Description
T K Temperature
p Pa Absolute pressure
d kg/m3 Density
h J/kg Specific enthalpy
u J/kg Specific internal energy
Xi[nXi] kg/kg Structurally independent mass fractions
R_s J/(kg.K) Specific gas constant (of mixture if applicable)
MM kg/mol Molar mass

In order to implement an actual medium model, one can extend from this base model and add 5 equations that provide relations among these variables. Equations will also have to be added in order to set all the variables within the ThermodynamicState record state.

If standardOrderComponents=true, the full composition vector X[nX] is determined by the equations contained in this base class, depending on the independent mass fraction vector Xi[nXi].

Additional 2 + nXi equations will have to be provided when using the BaseProperties model, in order to fully specify the thermodynamic conditions. The input connector qualifier applied to p, h, and nXi indirectly declares the number of missing equations, permitting advanced equation balance checking by Modelica tools. Please note that this doesn't mean that the additional equations should be connection equations, nor that exactly those variables should be supplied, in order to complete the model. For further information, see the Modelica.Media User's guide, and Section 4.7 (Balanced Models) of the Modelica 3.4 specification.

Parameters

NameDescription
standardOrderComponentsIf true, and reducedX = true, the last element of X will be computed from the other ones
Advanced
preferredMediumStates= true if StateSelect.prefer shall be used for the independent property variables of the medium

Modelica.Media.Interfaces.PartialMedium.setState_pTX Modelica.Media.Interfaces.PartialMedium.setState_pTX

Return thermodynamic state as function of p, T and composition X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialMedium.setState_phX Modelica.Media.Interfaces.PartialMedium.setState_phX

Return thermodynamic state as function of p, h and composition X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialMedium.setState_psX Modelica.Media.Interfaces.PartialMedium.setState_psX

Return thermodynamic state as function of p, s and composition X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialMedium.setState_dTX Modelica.Media.Interfaces.PartialMedium.setState_dTX

Return thermodynamic state as function of d, T and composition X or Xi

Information

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

Inputs

NameDescription
dDensity [kg/m3]
TTemperature [K]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialMedium.setSmoothState Modelica.Media.Interfaces.PartialMedium.setSmoothState

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

Information

This function is used to approximate the equation

state = if x > 0 then state_a else state_b;

by a smooth characteristic, so that the expression is continuous and differentiable:

state := smooth(1, if x >  x_small then state_a else
                   if x < -x_small then state_b else f(state_a, state_b));

This is performed by applying function Media.Common.smoothStep(..) on every element of the thermodynamic state record.

If mass fractions X[:] are approximated with this function then this can be performed for all nX mass fractions, instead of applying it for nX-1 mass fractions and computing the last one by the mass fraction constraint sum(X)=1. The reason is that the approximating function has the property that sum(state.X) = 1, provided sum(state_a.X) = sum(state_b.X) = 1. This can be shown by evaluating the approximating function in the abs(x) < x_small region (otherwise state.X is either state_a.X or state_b.X):

X[1]  = smoothStep(x, X_a[1] , X_b[1] , x_small);
X[2]  = smoothStep(x, X_a[2] , X_b[2] , x_small);
   ...
X[nX] = smoothStep(x, X_a[nX], X_b[nX], x_small);

or

X[1]  = c*(X_a[1]  - X_b[1])  + (X_a[1]  + X_b[1])/2
X[2]  = c*(X_a[2]  - X_b[2])  + (X_a[2]  + X_b[2])/2;
   ...
X[nX] = c*(X_a[nX] - X_b[nX]) + (X_a[nX] + X_b[nX])/2;
c     = (x/x_small)*((x/x_small)^2 - 3)/4

Summing all mass fractions together results in

sum(X) = c*(sum(X_a) - sum(X_b)) + (sum(X_a) + sum(X_b))/2
       = c*(1 - 1) + (1 + 1)/2
       = 1

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

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)

Modelica.Media.Interfaces.PartialMedium.dynamicViscosity Modelica.Media.Interfaces.PartialMedium.dynamicViscosity

Return dynamic viscosity

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
etaDynamic viscosity [Pa.s]

Modelica.Media.Interfaces.PartialMedium.thermalConductivity Modelica.Media.Interfaces.PartialMedium.thermalConductivity

Return thermal conductivity

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.prandtlNumber Modelica.Media.Interfaces.PartialMedium.prandtlNumber

Return the Prandtl number

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
PrPrandtl number [1]

Modelica.Media.Interfaces.PartialMedium.pressure Modelica.Media.Interfaces.PartialMedium.pressure

Return pressure

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
pPressure [Pa]

Modelica.Media.Interfaces.PartialMedium.temperature Modelica.Media.Interfaces.PartialMedium.temperature

Return temperature

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialMedium.density Modelica.Media.Interfaces.PartialMedium.density

Return density

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialMedium.specificEnthalpy Modelica.Media.Interfaces.PartialMedium.specificEnthalpy

Return specific enthalpy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialMedium.specificInternalEnergy Modelica.Media.Interfaces.PartialMedium.specificInternalEnergy

Return specific internal energy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
uSpecific internal energy [J/kg]

Modelica.Media.Interfaces.PartialMedium.specificEntropy Modelica.Media.Interfaces.PartialMedium.specificEntropy

Return specific entropy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.specificGibbsEnergy Modelica.Media.Interfaces.PartialMedium.specificGibbsEnergy

Return specific Gibbs energy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
gSpecific Gibbs energy [J/kg]

Modelica.Media.Interfaces.PartialMedium.specificHelmholtzEnergy Modelica.Media.Interfaces.PartialMedium.specificHelmholtzEnergy

Return specific Helmholtz energy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
fSpecific Helmholtz energy [J/kg]

Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCp Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCp

Return specific heat capacity at constant pressure

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.heatCapacity_cp Modelica.Media.Interfaces.PartialMedium.heatCapacity_cp

Alias for deprecated name

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCv Modelica.Media.Interfaces.PartialMedium.specificHeatCapacityCv

Return specific heat capacity at constant volume

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.heatCapacity_cv Modelica.Media.Interfaces.PartialMedium.heatCapacity_cv

Alias for deprecated name

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.isentropicExponent Modelica.Media.Interfaces.PartialMedium.isentropicExponent

Return isentropic exponent

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
gammaIsentropic exponent [1]

Modelica.Media.Interfaces.PartialMedium.isentropicEnthalpy Modelica.Media.Interfaces.PartialMedium.isentropicEnthalpy

Return isentropic enthalpy

Information

This function computes an isentropic state transformation:

  1. A medium is in a particular state, refState.
  2. The enthalpy at another state (h_is) shall be computed under the assumption that the state transformation from refState to h_is is performed with a change of specific entropy ds = 0 and the pressure of state h_is is p_downstream and the composition X upstream and downstream is assumed to be the same.

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

Inputs

NameDescription
p_downstreamDownstream pressure [Pa]
refStateReference state for entropy

Outputs

NameDescription
h_isIsentropic enthalpy [J/kg]

Modelica.Media.Interfaces.PartialMedium.velocityOfSound Modelica.Media.Interfaces.PartialMedium.velocityOfSound

Return velocity of sound

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
aVelocity of sound [m/s]

Modelica.Media.Interfaces.PartialMedium.isobaricExpansionCoefficient Modelica.Media.Interfaces.PartialMedium.isobaricExpansionCoefficient

Return overall the isobaric expansion coefficient beta

Information

beta is defined as  1/v * der(v,T), with v = 1/d, at constant pressure p.

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
betaIsobaric expansion coefficient [1/K]

Modelica.Media.Interfaces.PartialMedium.beta Modelica.Media.Interfaces.PartialMedium.beta

Alias for isobaricExpansionCoefficient for user convenience

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
betaIsobaric expansion coefficient [1/K]

Modelica.Media.Interfaces.PartialMedium.isothermalCompressibility Modelica.Media.Interfaces.PartialMedium.isothermalCompressibility

Return overall the isothermal compressibility factor

Information


kappa is defined as - 1/v * der(v,p), with v = 1/d at constant temperature T.

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
kappaIsothermal compressibility [1/Pa]

Modelica.Media.Interfaces.PartialMedium.kappa Modelica.Media.Interfaces.PartialMedium.kappa

Alias of isothermalCompressibility for user convenience

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
kappaIsothermal compressibility [1/Pa]

Modelica.Media.Interfaces.PartialMedium.density_derp_h Modelica.Media.Interfaces.PartialMedium.density_derp_h

Return density derivative w.r.t. pressure at const specific enthalpy

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.density_derh_p Modelica.Media.Interfaces.PartialMedium.density_derh_p

Return density derivative w.r.t. specific enthalpy at constant pressure

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.density_derp_T Modelica.Media.Interfaces.PartialMedium.density_derp_T

Return density derivative w.r.t. pressure at const temperature

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialMedium.density_derT_p Modelica.Media.Interfaces.PartialMedium.density_derT_p

Return density derivative w.r.t. temperature at constant pressure

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
ddTpDensity derivative w.r.t. temperature [kg/(m3.K)]

Modelica.Media.Interfaces.PartialMedium.density_derX Modelica.Media.Interfaces.PartialMedium.density_derX

Return density derivative w.r.t. mass fraction

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
dddX[nX]Derivative of density w.r.t. mass fraction [kg/m3]

Modelica.Media.Interfaces.PartialMedium.molarMass Modelica.Media.Interfaces.PartialMedium.molarMass

Return the molar mass of the medium

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
MMMixture molar mass [kg/mol]

Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_pTX Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_pTX

Return specific enthalpy from p, T, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialMedium.specificEntropy_pTX Modelica.Media.Interfaces.PartialMedium.specificEntropy_pTX

Return specific enthalpy from p, T, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
X[:]Mass fractions [kg/kg]

Outputs

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

Modelica.Media.Interfaces.PartialMedium.density_pTX Modelica.Media.Interfaces.PartialMedium.density_pTX

Return density from p, T, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
TTemperature [K]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialMedium.temperature_phX Modelica.Media.Interfaces.PartialMedium.temperature_phX

Return temperature from p, h, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialMedium.density_phX Modelica.Media.Interfaces.PartialMedium.density_phX

Return density from p, h, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
hSpecific enthalpy [J/kg]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialMedium.temperature_psX Modelica.Media.Interfaces.PartialMedium.temperature_psX

Return temperature from p,s, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialMedium.density_psX Modelica.Media.Interfaces.PartialMedium.density_psX

Return density from p, s, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_psX Modelica.Media.Interfaces.PartialMedium.specificEnthalpy_psX

Return specific enthalpy from p, s, and X or Xi

Information

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

Inputs

NameDescription
pPressure [Pa]
sSpecific entropy [J/(kg.K)]
X[:]Mass fractions [kg/kg]

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialMedium.MassFlowRate

Type for mass flow rate with medium specific attributes

Parameters

NameValue
Custom Parameters
quantity"MassFlowRate." + mediumName
min-1.0e5
max1.e5
Automatically generated Thu Oct 1 16:08:01 2020.