Modelica.Media.Interfaces.PartialLinearFluid

Generic pure liquid model with constant cp, compressibility and thermal expansion coefficients

Information

Linear Compressibility Fluid Model

This linear compressibility fluid model is based on the assumptions that:

That means that the density is a linear function in temperature and in pressure. In order to define the complete model, a number of constant reference values are needed which are computed at the reference values of the states pressure p and temperature T. The model can be interpreted as a linearization of a full non-linear fluid model (but it is not linear in all thermodynamic coordinates). Reference values are needed for

  1. the density (reference_d),
  2. the specific enthalpy (reference_h),
  3. the specific entropy (reference_s).

Apart from that, a user needs to define the molar mass, MM_const. Note that it is possible to define a fluid by computing the reference values from a full non-linear fluid model by computing the package constants using the standard functions defined in a fluid package (see example in liquids package).

In order to avoid numerical inversion of the temperature in the T_ph and T_ps functions, the density is always taken to be the reference density in the computation of h, s, u and cv. For liquids (and this model is intended only for liquids) the relative error of doing so is 1e-3 to 1e-4 at most. The model would be more "correct" based on the other assumptions, if occurrences of reference_d in the computations of h,s,u and cv would be replaced by a call to density(state). That would require a numerical solution for T_ps, while T_ph can be solved symbolically from a quadratic function. Errors from this approximation are small because liquid density varies little.

Efficiency considerations

One of the main reasons to use a simple, linear fluid model is to achieve high performance in simulations. There are a number of possible compromises and possibilities to improve performance. Some of them can be influenced by a flag. The following rules where used in this model:

Authors:
Francesco Casella
Dipartimento di Elettronica e Informazione
Politecnico di Milano
Via Ponzio 34/5
I-20133 Milano, Italy
email: [email protected]
and
Hubertus Tummescheit
Modelon AB
Ideon Science Park
SE-22730 Lund, Sweden
email: [email protected]

Extends from Interfaces.PartialPureSubstance (Base class for pure substances of one chemical substance).

Package Content

Name Description
cp_const Specific heat capacity at constant pressure
beta_const Thermal expansion coefficient at constant pressure
kappa_const Isothermal compressibility
MM_const Molar mass
reference_d Density in reference conditions
reference_h Specific enthalpy in reference conditions
reference_s Specific entropy in reference conditions
constantJacobian If true, entries in thermodynamic Jacobian are constant, taken at reference conditions
Modelica.Media.Interfaces.PartialLinearFluid.ThermodynamicState ThermodynamicState A selection of variables that uniquely defines the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.BaseProperties BaseProperties Base properties of medium
Modelica.Media.Interfaces.PartialLinearFluid.setState_pTX setState_pTX Set the thermodynamic state record from p and T (X not needed)
Modelica.Media.Interfaces.PartialLinearFluid.setState_phX setState_phX Set the thermodynamic state record from p and h (X not needed)
Modelica.Media.Interfaces.PartialLinearFluid.setState_psX setState_psX Set the thermodynamic state record from p and s (X not needed)
Modelica.Media.Interfaces.PartialLinearFluid.setState_dTX setState_dTX Set the thermodynamic state record from d and T (X not needed)
Modelica.Media.Interfaces.PartialLinearFluid.setSmoothState setSmoothState Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b
Modelica.Media.Interfaces.PartialLinearFluid.pressure pressure Return the pressure from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.temperature temperature Return the temperature from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.density density Return the density from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.specificEnthalpy specificEnthalpy Return the specific enthalpy from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.specificEntropy specificEntropy Return the specific entropy from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.specificInternalEnergy specificInternalEnergy Return the specific internal energy from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.specificGibbsEnergy specificGibbsEnergy Return specific Gibbs energy from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.specificHelmholtzEnergy specificHelmholtzEnergy Return specific Helmholtz energy from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.velocityOfSound velocityOfSound Return velocity of sound from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.isentropicExponent isentropicExponent Return isentropic exponent from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.isentropicEnthalpy isentropicEnthalpy Return isentropic enthalpy
Modelica.Media.Interfaces.PartialLinearFluid.specificHeatCapacityCp specificHeatCapacityCp Return specific heat capacity at constant volume
Modelica.Media.Interfaces.PartialLinearFluid.specificHeatCapacityCv specificHeatCapacityCv Return specific heat capacity at constant volume from the thermodynamic state
Modelica.Media.Interfaces.PartialLinearFluid.isothermalCompressibility isothermalCompressibility Return the isothermal compressibility kappa
Modelica.Media.Interfaces.PartialLinearFluid.isobaricExpansionCoefficient isobaricExpansionCoefficient Return the isobaric expansion coefficient
Modelica.Media.Interfaces.PartialLinearFluid.density_derp_h density_derp_h Return density derivative w.r.t. pressure at const specific enthalpy
Modelica.Media.Interfaces.PartialLinearFluid.density_derh_p density_derh_p Return density derivative w.r.t. specific enthalpy at constant pressure
Modelica.Media.Interfaces.PartialLinearFluid.density_derp_T density_derp_T Return density derivative w.r.t. pressure at const temperature
Modelica.Media.Interfaces.PartialLinearFluid.density_derT_p density_derT_p Return density derivative w.r.t. temperature at constant pressure
Modelica.Media.Interfaces.PartialLinearFluid.density_derX density_derX Returns the partial derivative of density with respect to mass fractions at constant pressure and temperature
Modelica.Media.Interfaces.PartialLinearFluid.molarMass molarMass Return molar mass
Modelica.Media.Interfaces.PartialLinearFluid.T_ph T_ph Return temperature from pressure and specific enthalpy
Modelica.Media.Interfaces.PartialLinearFluid.T_ps T_ps Return temperature from pressure and specific entropy
Inherited
Modelica.Media.Interfaces.PartialPureSubstance.setState_pT setState_pT Return thermodynamic state from p and T
Modelica.Media.Interfaces.PartialPureSubstance.setState_ph setState_ph Return thermodynamic state from p and h
Modelica.Media.Interfaces.PartialPureSubstance.setState_ps setState_ps Return thermodynamic state from p and s
Modelica.Media.Interfaces.PartialPureSubstance.setState_dT setState_dT Return thermodynamic state from d and T
Modelica.Media.Interfaces.PartialPureSubstance.density_ph density_ph Return density from p and h
Modelica.Media.Interfaces.PartialPureSubstance.temperature_ph temperature_ph Return temperature from p and h
Modelica.Media.Interfaces.PartialPureSubstance.pressure_dT pressure_dT Return pressure from d and T
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_dT specificEnthalpy_dT Return specific enthalpy from d and T
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_ps specificEnthalpy_ps Return specific enthalpy from p and s
Modelica.Media.Interfaces.PartialPureSubstance.temperature_ps temperature_ps Return temperature from p and s
Modelica.Media.Interfaces.PartialPureSubstance.density_ps density_ps Return density from p and s
Modelica.Media.Interfaces.PartialPureSubstance.specificEnthalpy_pT specificEnthalpy_pT Return specific enthalpy from p and T
Modelica.Media.Interfaces.PartialPureSubstance.density_pT density_pT Return density from p and T
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.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.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.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
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.Interfaces.PartialLinearFluid.ThermodynamicState Modelica.Media.Interfaces.PartialLinearFluid.ThermodynamicState

A selection of variables that uniquely defines the thermodynamic state

Information

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

Modelica.Media.Interfaces.PartialLinearFluid.BaseProperties Modelica.Media.Interfaces.PartialLinearFluid.BaseProperties

Base properties of medium

Information

Extends from .

Parameters

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

Modelica.Media.Interfaces.PartialLinearFluid.setState_pTX Modelica.Media.Interfaces.PartialLinearFluid.setState_pTX

Set the thermodynamic state record from p and T (X not needed)

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]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialLinearFluid.setState_phX Modelica.Media.Interfaces.PartialLinearFluid.setState_phX

Set the thermodynamic state record from p and h (X not needed)

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]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialLinearFluid.setState_psX Modelica.Media.Interfaces.PartialLinearFluid.setState_psX

Set the thermodynamic state record from p and s (X not needed)

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]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialLinearFluid.setState_dTX Modelica.Media.Interfaces.PartialLinearFluid.setState_dTX

Set the thermodynamic state record from d and T (X not needed)

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]

Outputs

NameDescription
stateThermodynamic state record

Modelica.Media.Interfaces.PartialLinearFluid.setSmoothState Modelica.Media.Interfaces.PartialLinearFluid.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)

Modelica.Media.Interfaces.PartialLinearFluid.pressure Modelica.Media.Interfaces.PartialLinearFluid.pressure

Return the pressure from the thermodynamic state

Information

Extends from (Return pressure).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
pPressure [Pa]

Modelica.Media.Interfaces.PartialLinearFluid.temperature Modelica.Media.Interfaces.PartialLinearFluid.temperature

Return the temperature from the thermodynamic state

Information

Extends from (Return temperature).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialLinearFluid.density Modelica.Media.Interfaces.PartialLinearFluid.density

Return the density from the thermodynamic state

Information

Extends from (Return density).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
dDensity [kg/m3]

Modelica.Media.Interfaces.PartialLinearFluid.specificEnthalpy Modelica.Media.Interfaces.PartialLinearFluid.specificEnthalpy

Return the specific enthalpy from the thermodynamic state

Information

Extends from (Return specific enthalpy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
hSpecific enthalpy [J/kg]

Modelica.Media.Interfaces.PartialLinearFluid.specificEntropy Modelica.Media.Interfaces.PartialLinearFluid.specificEntropy

Return the specific entropy from the thermodynamic state

Information

Extends from (Return specific entropy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialLinearFluid.specificInternalEnergy Modelica.Media.Interfaces.PartialLinearFluid.specificInternalEnergy

Return the specific internal energy from the thermodynamic state

Information

Extends from (Return specific internal energy).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
uSpecific internal energy [J/kg]

Modelica.Media.Interfaces.PartialLinearFluid.specificGibbsEnergy Modelica.Media.Interfaces.PartialLinearFluid.specificGibbsEnergy

Return specific Gibbs energy from the thermodynamic state

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.Interfaces.PartialLinearFluid.specificHelmholtzEnergy Modelica.Media.Interfaces.PartialLinearFluid.specificHelmholtzEnergy

Return specific Helmholtz energy from the thermodynamic state

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.Interfaces.PartialLinearFluid.velocityOfSound Modelica.Media.Interfaces.PartialLinearFluid.velocityOfSound

Return velocity of sound from the thermodynamic state

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return velocity of sound).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
aVelocity of sound [m/s]

Modelica.Media.Interfaces.PartialLinearFluid.isentropicExponent Modelica.Media.Interfaces.PartialLinearFluid.isentropicExponent

Return isentropic exponent from the thermodynamic state

Information

Extends from Modelica.Icons.Function (Icon for functions), (Return isentropic exponent).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
gammaIsentropic exponent [1]

Modelica.Media.Interfaces.PartialLinearFluid.isentropicEnthalpy Modelica.Media.Interfaces.PartialLinearFluid.isentropicEnthalpy

Return isentropic enthalpy

Information

A minor approximation is used: the reference density is used instead of the real one, which would require a numeric solution.

Extends from (Return isentropic enthalpy).

Inputs

NameDescription
p_downstreamDownstream pressure [Pa]
refStateReference state for entropy

Outputs

NameDescription
h_isIsentropic enthalpy [J/kg]

Modelica.Media.Interfaces.PartialLinearFluid.specificHeatCapacityCp Modelica.Media.Interfaces.PartialLinearFluid.specificHeatCapacityCp

Return specific heat capacity at constant volume

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.Interfaces.PartialLinearFluid.specificHeatCapacityCv Modelica.Media.Interfaces.PartialLinearFluid.specificHeatCapacityCv

Return specific heat capacity at constant volume from the thermodynamic state

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.Interfaces.PartialLinearFluid.isothermalCompressibility Modelica.Media.Interfaces.PartialLinearFluid.isothermalCompressibility

Return the isothermal compressibility kappa

Information

Extends from (Return overall the isothermal compressibility factor).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
kappaIsothermal compressibility [1/Pa]

Modelica.Media.Interfaces.PartialLinearFluid.isobaricExpansionCoefficient Modelica.Media.Interfaces.PartialLinearFluid.isobaricExpansionCoefficient

Return the isobaric expansion coefficient

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
betaIsobaric expansion coefficient [1/K]

Modelica.Media.Interfaces.PartialLinearFluid.density_derp_h Modelica.Media.Interfaces.PartialLinearFluid.density_derp_h

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

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.Interfaces.PartialLinearFluid.density_derh_p Modelica.Media.Interfaces.PartialLinearFluid.density_derh_p

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

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.Interfaces.PartialLinearFluid.density_derp_T Modelica.Media.Interfaces.PartialLinearFluid.density_derp_T

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

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialLinearFluid.density_derT_p Modelica.Media.Interfaces.PartialLinearFluid.density_derT_p

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

Information

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

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialLinearFluid.density_derX Modelica.Media.Interfaces.PartialLinearFluid.density_derX

Returns the partial derivative of density with respect to mass fractions at constant pressure and temperature

Information

Extends from (Return density derivative w.r.t. mass fraction).

Inputs

NameDescription
stateThermodynamic state record

Outputs

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

Modelica.Media.Interfaces.PartialLinearFluid.molarMass Modelica.Media.Interfaces.PartialLinearFluid.molarMass

Return molar mass

Information

Extends from (Return the molar mass of the medium).

Inputs

NameDescription
stateThermodynamic state record

Outputs

NameDescription
MMMixture molar mass [kg/mol]

Modelica.Media.Interfaces.PartialLinearFluid.T_ph Modelica.Media.Interfaces.PartialLinearFluid.T_ph

Return temperature from pressure and specific enthalpy

Information

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

Inputs

NameDescription
hSpecific enthalpy [J/kg]
pPressure [Pa]

Outputs

NameDescription
TTemperature [K]

Modelica.Media.Interfaces.PartialLinearFluid.T_ps Modelica.Media.Interfaces.PartialLinearFluid.T_ps

Return temperature from pressure and specific entropy

Information

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

Inputs

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

Outputs

NameDescription
TTemperature [K]
Automatically generated Tue Apr 05 09:36:54 2016.