ThermophysicalData[CoolProp]
Property
access thermophysical fluid data
Calling Sequence
Parameters
Description
Examples
Compatibility
Property(output, fluid, inputopts, opts)
Property(output, inputopts, fluid, opts)
output
-
symbol or string for the desired output quantity
fluid
symbol or string representing the medium
inputopts
(optional) equations of the form quantity = value
opts
(optional) equation of the form useunits = true or useunits = false
The Property function interrogates the CoolProp library for thermophysical data.
Property provides a uniform interface to the PropsSI, Props1SI, PhaseSI, and HAPropsSI commands in the CoolProp subpackage of the ThermophysicalData package. Those commands adhere relatively closely to the commands of the same name in interfaces to CoolProp in other programming languages. This command, on the other hand, conforms more closely to typical Maple calling sequences.
Most uses of this command require the use of two or three input options (represented by the inputopts argument in the calling sequence above). These are equations of the form quantity = value, where quantity is a name or string from one of the tables below, and value is a real constant, possibly with a unit. If a unit is given for a value, it will be converted to the appropriate SI unit from the table below. If you supply a unit with any of the quantities you submit, the answer will have the appropriate unit as well. This behavior can be overridden by using the useunits option: if you supply useunits = true (which can be shortened to just useunits), then the result will always have the appropriate unit, and if you supply useunits = false, the result will never have a unit.
The Property command works as follows.
If the fluid given is HumidAir, then this command redirects to the HAPropsSI command. In this case, you need to supply three inputopts equations (just as you need to supply three inputs to the HAPropsSI command). In the following table, quantities that have Input or Both in the Input / Output column can be used for quantity in an inputopts equation; quantities that have Output or Both in the Input / Output column can be used for the output parameter.
Quantity
Maple-specific aliases
Unit
Input / Output
B, T_wb, Twb, WetBulb
temperature_wet_bulb, temperaturewetbulb
K
Both
Wet-Bulb Temperature
C, cp
specific_heat, specific_heat_per_dry_air, specificheat, specificheatperdryair
J/kg(dry_air)/K
Output
Mixture specific heat per unit dry air
Cha, cp_ha
specific_heat_per_humid_air, specificheatperhumidair
J/kg(humid_air)/K
Mixture specific heat per unit humid air
CV
ha_quantity, haquantity
Mixture specific heat at constant volume per unit dry air
CVha, cv_ha
Mixture specific heat at constant volume per unit humid air
D, DewPoint, T_dp, Tdp
temperature_dew_point, temperaturedewpoint
Dew-Point Temperature
Enthalpy, H, Hda
enthalpy, enthalpy_per_dry_air, enthalpyperdryair
J/kg(dry_air)
Mixture enthalpy per dry air
Hha
enthalpy_per_humid_air, enthalpyperhumidair
J/kg(humid_air)
Mixture enthalpy per humid air
Conductivity, K, k
thermal_conductivity, thermalconductivity
W/m/K
Mixture thermal conductivity
M, Visc, mu
viscosity
Pa*s
Mixture viscosity
Y, psi_w
water_fraction, water_mole_fraction, waterfraction, watermolefraction
mol(water)/mol(humid_air)
Water mole fraction
P
pressure
Pa
Input
Pressure
P_w
water_vapor_pressure, water_vapour_pressure, watervaporpressure, watervapourpressure
Partial pressure of water vapor
R, RH, RelHum
humidity, relative_humidity, relativehumidity
Relative humidity in [0, 1]
Entropy, S, Sda
entropy, entropy_per_dry_air, entropyperdryair
Mixture entropy per unit dry air
Sha
entropy_per_humid_air, entropyperhumidair
Mixture entropy per unit humid air
T, T_db, Tdb
temperature_dry_bulb, temperaturedrybulb
Dry-Bulb Temperature
V, Vda
volume, volume_per_dry_air, volumeperdryair
m^3/kg(dry_air)
Mixture volume per unit dry air
Vha
volume_per_humid_air, volumeperhumidair
m^3/kg(humid_air)
Mixture volume per unit humid air
HumRat, Omega, W
humidity_ratio, humidityratio
kg(water)/kg(dry_air)
Humidity Ratio
Z
compressibility_factor, compressibilityfactor
Compressibility factor (Z=p⁢vR⁢T)
If the output parameter is PhaseString, then this command redirects to the PhaseSI command. In this case, you need to supply two inputopts equations (just as you need to supply two inputs to the PhaseSI command). This uses the same quantity names as the PropsSI command (see the following table). Quantities that have Yes in the Can be input column can be used for the quantity in an inputopts equation.
If there are no inputopts given, this command redirects to the Props1SI command. This uses the same quantity names as the Props1SI command. In the following table, the quantities that have No in the Needs input opts column can be used for the output parameter.
Otherwise, this command redirects to the PropsSI command, and you need to supply two inputopts equations (just as you need to supply two inputs to the PropsSI command). The following table lists the quantities that can be used for output and for the quantity in an inputopts equation.
Can be input
Needs input opts
DELTA, Delta
reduced_density, reduceddensity
Yes
Reduced density (rho/rhoc)
DMOLAR, Dmolar
molar_density, molardensity
mol/m^3
Molar density
D, DMASS, Dmass
density, mass_density, massdensity
kg/m^3
Mass density
HMOLAR, Hmolar
molar_specific_enthalpy, molarspecificenthalpy
J/mol
Molar specific enthalpy
H, HMASS, Hmass
enthalpy, mass_specific_enthalpy, massspecificenthalpy
J/kg
Mass specific enthalpy
Q
mass_vapor_quality, mass_vapour_quality, massvaporquality, massvapourquality, vapor_quality, vaporquality, vapour_quality, vapourquality
Mass vapor quality
SMOLAR, Smolar
molar_specific_entropy, molarspecificentropy
J/mol/K
Molar specific entropy
S, SMASS, Smass
entropy, mass_specific_entropy, massspecificentropy
J/kg/K
Mass specific entropy
TAU, Tau
reciprocal_reduced_temperature, reciprocalreducedtemperature
Reciprocal reduced temperature (Tc/T)
T
temperature
Temperature
UMOLAR, Umolar
molar_specific_internal_energy, molarspecificinternalenergy
Molar specific internal energy
U, UMASS, Umass
internal_energy, internalenergy, mass_specific_internal_energy, massspecificinternalenergy
Mass specific internal energy
ACENTRIC, acentric
acentric_factor, acentricfactor
No
Acentric factor
ALPHA0, alpha0
ideal_helmholtz_energy, idealhelmholtzenergy
Ideal Helmholtz energy
ALPHAR, alphar
residual_helmholtz_energy, residualhelmholtzenergy
Residual Helmholtz energy
A, SPEED_OF_SOUND, speed_of_sound
speedofsound
m/s
Speed of sound
BVIRIAL, Bvirial
second_virial_coefficient, secondvirialcoefficient
Second virial coefficient
CONDUCTIVITY, L, conductivity
Thermal conductivity
CP0MASS, Cp0mass
ideal_gas_mass_specific_constant_pressure_specific_heat, idealgasmassspecificconstantpressurespecificheat
Ideal gas mass specific constant pressure specific heat
CP0MOLAR, Cp0molar
ideal_gas_molar_specific_constant_pressure_specific_heat, idealgasmolarspecificconstantpressurespecificheat
Ideal gas molar specific constant pressure specific heat
CPMOLAR, Cpmolar
molar_specific_constant_pressure_specific_heat, molarspecificconstantpressurespecificheat
Molar specific constant pressure specific heat
CVIRIAL, Cvirial
third_virial_coefficient, thirdvirialcoefficient
Third virial coefficient
CVMASS, Cvmass, O
mass_specific_constant_volume_specific_heat, massspecificconstantvolumespecificheat
Mass specific constant volume specific heat
CVMOLAR, Cvmolar
molar_specific_constant_volume_specific_heat, molarspecificconstantvolumespecificheat
Molar specific constant volume specific heat
C, CPMASS, Cpmass
mass_specific_constant_pressure_specific_heat, massspecificconstantpressurespecificheat
Mass specific constant pressure specific heat
DALPHA0_DDELTA_CONSTTAU, dalpha0_ddelta_consttau
d_ideal_helmholtz_energy_d_delta
Derivative of ideal Helmholtz energy with delta
DALPHA0_DTAU_CONSTDELTA, dalpha0_dtau_constdelta
d_ideal_helmholtz_energy_d_tau
Derivative of ideal Helmholtz energy with tau
DALPHAR_DDELTA_CONSTTAU, dalphar_ddelta_consttau
d_residual_helmholtz_energy_d_delta
Derivative of residual Helmholtz energy with delta
DALPHAR_DTAU_CONSTDELTA, dalphar_dtau_constdelta
d_residual_helmholtz_energy_d_tau
Derivative of residual Helmholtz energy with tau
DBVIRIAL_DT, dBvirial_dT
d_second_virial_coefficient_d_temperature
Derivative of second virial coefficient with respect to T
DCVIRIAL_DT, dCvirial_dT
d_third_virial_coefficient_d_temperature
Derivative of third virial coefficient with respect to T
DIPOLE_MOMENT, dipole_moment
dipole_moment, dipolemoment
C*m
Dipole moment
FH
flammability_hazard, flammabilityhazard
Flammability hazard
FRACTION_MAX, fraction_max
fractionmax
Fraction (mole, mass, volume) maximum value for incompressible solutions
FRACTION_MIN, fraction_min
fractionmin
Fraction (mole, mass, volume) minimum value for incompressible solutions
FUNDAMENTAL_DERIVATIVE_OF_GAS_DYNAMICS, fundamental_derivative_of_gas_dynamics
fundamentalderivativeofgasdynamics
Fundamental derivative of gas dynamics
GAS_CONSTANT, gas_constant
gasconstant
Molar gas constant
GMOLAR_RESIDUAL, Gmolar_residual
gmolar_residual
Residual molar Gibbs energy
GMOLAR, Gmolar
molar_specific_gibbs_energy, molarspecificgibbsenergy
Molar specific Gibbs energy
GWP100
global_warming_potential_100, globalwarmingpotential100
100-year global warming potential
GWP20
global_warming_potential_20, globalwarmingpotential20
20-year global warming potential
GWP500
global_warming_potential_500, globalwarmingpotential500
500-year global warming potential
G, GMASS, Gmass
gibbs_energy, gibbsenergy, mass_specific_gibbs_energy, massspecificgibbsenergy
Mass specific Gibbs energy
HELMHOLTZMASS, Helmholtzmass
helmholtz_mass, helmholtzmass
Mass specific Helmholtz energy
HELMHOLTZMOLAR, Helmholtzmolar
helmholtz_molar, helmholtzmolar
Molar specific Helmholtz energy
HH
health_hazard, healthhazard
Health hazard
HMOLAR_RESIDUAL, Hmolar_residual
hmolar_residual
Residual molar enthalpy
ISENTROPIC_EXPANSION_COEFFICIENT, isentropic_expansion_coefficient
isentropicexpansioncoefficient
Isentropic expansion coefficient
ISOBARIC_EXPANSION_COEFFICIENT, isobaric_expansion_coefficient
isobaricexpansioncoefficient
1/K
Isobaric expansion coefficient
ISOTHERMAL_COMPRESSIBILITY, isothermal_compressibility
isothermalcompressibility
1/Pa
Isothermal compressibility
I, SURFACE_TENSION, surface_tension
surfacetension
N/m
Surface tension
M, MOLARMASS, MOLAR_MASS, MOLEMASS, molar_mass, molarmass, molemass
kg/mol
Molar mass
ODP
ozone_depletion_potential, ozonedepletionpotential
Ozone depletion potential
PCRIT, P_CRITICAL, Pcrit, p_critical, pcrit
pcritical
Pressure at the critical point
PHASE, Phase
phase
Phase index as a float
PH
physical_hazard, physicalhazard
Physical hazard
PIP
phase_identification, phase_identification_parameter
Phase identification parameter
PMAX, P_MAX, P_max, pmax
p_max, pressure_max, pressuremax
Maximum pressure limit
PMIN, P_MIN, P_min, pmin
p_min, pressure_min, pressuremin
Minimum pressure limit
PRANDTL, Prandtl
prandtl
Prandtl number
PTRIPLE, P_TRIPLE, p_triple, ptriple
pressure_triple, pressuretriple
Pressure at the triple point (pure only)
P_REDUCING, p_reducing
preducing, pressure_reducing, pressurereducing
Pressure at the reducing point
RHOCRIT, RHOMASS_CRITICAL, rhocrit, rhomass_critical
density_critical, densitycritical
Mass density at critical point
RHOMASS_REDUCING, rhomass_reducing
density_reducing, densityreducing, mass_density_reducing, massdensityreducing
Mass density at reducing point
RHOMOLAR_CRITICAL, rhomolar_critical
molar_density_critical, molardensitycritical
Molar density at critical point
RHOMOLAR_REDUCING, rhomolar_reducing
molar_density_reducing, molardensityreducing
Molar density at reducing point
SMOLAR_RESIDUAL, Smolar_residual
residual_molar_entropy, smolar_residual, smolarresidual
Residual molar entropy (sr/R = s(T,rho) - s^0(T,rho))
TCRIT, T_CRITICAL, T_critical, Tcrit
temperature_critical, temperaturecritical
Temperature at the critical point
TMAX, T_MAX, T_max, Tmax
temperature_max, temperaturemax
Maximum temperature limit
TMIN, T_MIN, T_min, Tmin
temperature_min, temperaturemin
Minimum temperature limit
TTRIPLE, T_TRIPLE, T_triple, Ttriple
temperature_triple, temperaturetriple
Temperature at the triple point
T_FREEZE, T_freeze
temperature_freeze, temperature_freezing, temperaturefreeze, temperaturefreezing
Freezing temperature for incompressible solutions
T_REDUCING, T_reducing
temperature_reducing, temperaturereducing
Temperature at the reducing point
V, VISCOSITY, viscosity
Viscosity
Compressibility factor
Up to Maple 2017, this command was available as ThermophysicalData[Property]. With the introduction of the ThermophysicalData[Chemicals] package as a second data source for Maple 2018, that command was rewritten so that it can now redirect either to this command, i.e., ThermophysicalData[CoolProp][Property], or to ThermophysicalData[Chemicals][Property].
with⁡ThermophysicalDataCoolProp:
What is the density of water at 300 kelvin and a pressure of 1 atmosphere? (This example redirects to the PropsSI procedure.)
Property⁡density,temperature=300,pressure=1⁢Unit⁡atm,Water
996.5569353⁢kgm3
You can see the redirection (for the following commands) if you set the value of the variable infolevel[ThermophysicalData] to two (or more).
infolevelThermophysicalData≔2:
We can give the inputs before or after specifying the fluid.
Property⁡density,Water,temperature=300⁢Unit⁡kelvin,pressure=101325
Property: "using PropsSI backend"
The useunits = false option suppresses the unit in the answer.
Property⁡density,Water,temperature=300⁢Unit⁡kelvin,pressure=101325,useunits=false
996.556935265196785
Alternatively, we can suppress units by not submitting any units in the input options.
Property⁡density,Water,temperature=300,pressure=101325
This can be overridden by using the useunits = true option.
Property⁡density,Water,temperature=300,pressure=101325,useunits=true
We can use other name for the quantities. These can come from the Quantity or Maple-specific aliases columns in the preceding tables.
Property⁡D,Water,T=300⁢Unit⁡kelvin,P=101325
We can also use different units.
Property⁡density,Water,temperature=26.85⁢Unit⁡degC,pressure=760⁢Unit⁡mmHg
If we ask for properties of humid air, we need to supply three input equations.
Property⁡temperature_dew_point,HumidAir,temperature_dry_bulb=300,pressure=1⁢Unit⁡atm,humidity=12
Property: "using HAPropsSI backend"
288.7139414⁢K
Computing the PhaseString property results in a call to the PhaseSI procedure.
Property⁡PhaseString,temperature=300⁢Unit⁡kelvin,pressure=101325,Water
Property: "using PhaseSI backend"
liquid
Finally, if you request a property that does not require input options, such as the minimal temperature that CoolProp can deal with for a particular fluid, you can call it as follows.
Property⁡temperature_min,Water
Property: "using Props1SI backend"
273.160000000000025
By specifying the useunits option, you can instruct the Property command to return a quantity with the appropriate unit attached.
min_temp≔Property⁡temperature_min,Water,useunits
min_temp≔273.1600000⁢K
convert⁡min_temp,temperature,degC
0.0100000⁢°C
convert⁡min_temp,temperature,degF
32.0180000⁢°F
The ThermophysicalData[CoolProp][Property] command was introduced in Maple 2016.
For more information on Maple 2016 changes, see Updates in Maple 2016.
The ThermophysicalData[CoolProp][Property] command was updated in Maple 2018.
See Also
ThermophysicalData
ThermophysicalData/fluids
Download Help Document