WOLFRAM SYSTEM MODELER

Function

Icon for functions

Wolfram Language

In[1]:=
SystemModel["Modelica.Icons.Function"]
Out[1]:=

Information

This information is part of the Modelica Standard Library maintained by the Modelica Association.

This icon indicates Modelica functions.

Extended by (1231)

getNumberOfFiles

Modelica.Utilities.Internal.FileSystem

Get number of files and directories in a directory (POSIX functions opendir, readdir, closedir)

readDirectory

Modelica.Utilities.Internal.FileSystem

Read names of a directory (POSIX functions opendir, readdir, closedir)

copyFile

Modelica.Utilities.Internal.FileSystem

Copy existing file (C functions 'fopen', 'fread', 'fwrite', 'fclose')

removeFile

Modelica.Utilities.Internal.FileSystem

Remove existing file (C function 'remove')

rename

Modelica.Utilities.Internal.FileSystem

Rename existing file or directory (C function 'rename')

stat

Modelica.Utilities.Internal.FileSystem

Inquire file information (POSIX function 'stat')

rmdir

Modelica.Utilities.Internal.FileSystem

Remove empty directory (POSIX function 'rmdir')

mkdir

Modelica.Utilities.Internal.FileSystem

Make directory (POSIX: 'mkdir')

exitBase

Modelica.Utilities.Internal.PartialModelicaServices.System

Interface for tool specific function to terminate the execution of the Modelica environment

PartialLoadResource

Modelica.Utilities.Internal.PartialModelicaServices.ExternalReferences

Interface for tool specific function to return the absolute path name of a URI or local file name

command

Modelica.Utilities.System

Execute command in default shell

getPid

Modelica.Utilities.System

Retrieve the current process id

getTime

Modelica.Utilities.System

Retrieve the local time (in the local time zone)

setEnvironmentVariable

Modelica.Utilities.System

Set content of local environment variable

getEnvironmentVariable

Modelica.Utilities.System

Get content of environment variable

setWorkDirectory

Modelica.Utilities.System

Set work directory

getWorkDirectory

Modelica.Utilities.System

Get full path name of work directory

skipLineComments

Modelica.Utilities.Strings.Advanced

Scan comments and white space

skipWhiteSpace

Modelica.Utilities.Strings.Advanced

Scan white space

scanIdentifier

Modelica.Utilities.Strings.Advanced

Scan simple identifiers

scanString

Modelica.Utilities.Strings.Advanced

Scan string

scanInteger

Modelica.Utilities.Strings.Advanced

Scan signed integer number

scanReal

Modelica.Utilities.Strings.Advanced

Scan a signed real number

syntaxError

Modelica.Utilities.Strings

Print an error message, a string and the index at which scanning detected an error

scanNoToken

Modelica.Utilities.Strings

Scan string and check that it contains no more token

scanDelimiter

Modelica.Utilities.Strings

Scan for the next delimiter and trigger an assert if not present

scanIdentifier

Modelica.Utilities.Strings

Scan for the next Identifier and trigger an assert if not present

scanString

Modelica.Utilities.Strings

Scan for the next Modelica string and trigger an assert if not present

scanBoolean

Modelica.Utilities.Strings

Scan for the next Boolean number and trigger an assert if not present

scanInteger

Modelica.Utilities.Strings

Scan for the next Integer number and trigger an assert if not present

scanReal

Modelica.Utilities.Strings

Scan for the next Real number and trigger an assert if not present

scanToken

Modelica.Utilities.Strings

Scan for the next token and return it

hashString

Modelica.Utilities.Strings

Create a hash value of a string

sort

Modelica.Utilities.Strings

Sort vector of strings in alphabetic order

replace

Modelica.Utilities.Strings

Replace non-overlapping occurrences of a string from left to right

findLast

Modelica.Utilities.Strings

Find last occurrence of a string within another string

find

Modelica.Utilities.Strings

Find first occurrence of a string within another string

count

Modelica.Utilities.Strings

Count the number of non-overlapping occurrences of a string

isEmpty

Modelica.Utilities.Strings

Return true if a string is empty (has only white space characters)

isEqual

Modelica.Utilities.Strings

Determine whether two strings are identical

compare

Modelica.Utilities.Strings

Compare two strings lexicographically

repeat

Modelica.Utilities.Strings

Repeat a string n times

substring

Modelica.Utilities.Strings

Return a substring defined by start and end index

length

Modelica.Utilities.Strings

Return length of string

writeRealMatrix

Modelica.Utilities.Streams

Write Real matrix to a MATLAB MAT file

readRealMatrix

Modelica.Utilities.Streams

Read Real matrix from MATLAB MAT file

readMatrixSize

Modelica.Utilities.Streams

Read dimensions of a Real matrix from a MATLAB MAT file

close

Modelica.Utilities.Streams

Close file

error

Modelica.Utilities.Streams

Print error message and cancel all actions - in case of an unrecoverable error

countLines

Modelica.Utilities.Streams

Return the number of lines in a file

readLine

Modelica.Utilities.Streams

Read a line of text from a file and return it in a string

readFile

Modelica.Utilities.Streams

Read content of a file and return it in a vector of strings

print

Modelica.Utilities.Streams

Print string to terminal or file

temporaryFileName

Modelica.Utilities.Files

Return arbitrary name of a file that does not exist and is in a directory where access rights allow to write to this file (useful for temporary output of files)

splitPathName

Modelica.Utilities.Files

Split path name in directory, file name kernel, file name extension

fullPathName

Modelica.Utilities.Files

Get full path name of file or directory name

assertNew

Modelica.Utilities.Files

Trigger an assert, if a file or directory exists

exist

Modelica.Utilities.Files

Inquire whether file or directory exists

createDirectory

Modelica.Utilities.Files

Create directory (if directory already exists, ignore call)

removeFile

Modelica.Utilities.Files

Remove file (ignore call, if it does not exist)

remove

Modelica.Utilities.Files

Remove file or directory (ignore call, if it does not exist)

move

Modelica.Utilities.Files

Move a file or a directory to another place

copy

Modelica.Utilities.Files

Generate a copy of a file or of a directory

list

Modelica.Utilities.Files

List content of file or directory

readRealParameter

Modelica.Utilities.Examples

Read the value of a Real parameter from file

expression

Modelica.Utilities.Examples

Expression interpreter that returns with the position after the expression (expression may consist of +, -, *, /, (), sin(), cos(), tan(), sqrt(), asin(), acos(), atan(), exp(), log(), pi)

calculator

Modelica.Utilities.Examples

Interpreter to evaluate simple expressions consisting of +, -, *, /, (), sin(), cos(), tan(), sqrt(), asin(), acos(), atan(), exp(), log(), pi

product

Modelica.ComplexMath

Return product of complex vector

sum

Modelica.ComplexMath

Return sum of complex vector

min

Modelica.ComplexMath

Return minimum element of complex vector

max

Modelica.ComplexMath

Return maximum element of complex vector

sqrt

Modelica.ComplexMath

Square root of complex number

fromPolar

Modelica.ComplexMath

Complex from polar representation

imag

Modelica.ComplexMath

Imaginary part of complex number

real

Modelica.ComplexMath

Real part of complex number

conj

Modelica.ComplexMath

Conjugate of complex number

arg

Modelica.ComplexMath

Phase angle of complex number

abs

Modelica.ComplexMath

Absolute value of complex number

log

Modelica.ComplexMath

Logarithm of complex number

exp

Modelica.ComplexMath

Exponential of complex number

atanh

Modelica.ComplexMath

Area-hyperbolic-tangent of complex number

acosh

Modelica.ComplexMath

Area-hyperbolic-cosine of complex number

asinh

Modelica.ComplexMath

Area-hyperbolic-sine of complex number

tanh

Modelica.ComplexMath

Hyperbolic-tangent of complex number

cosh

Modelica.ComplexMath

Hyperbolic-cosine of complex number

sinh

Modelica.ComplexMath

Hyperbolic-sine of complex number

atan

Modelica.ComplexMath

Arc-tangent of complex number

acos

Modelica.ComplexMath

Arc-cosine of complex number

asin

Modelica.ComplexMath

Arc-sine of complex number

tan

Modelica.ComplexMath

Tangent of complex number

cos

Modelica.ComplexMath

Cosine of complex number

sin

Modelica.ComplexMath

Sine of complex number

sort

Modelica.ComplexMath.Vectors

Sort elements of complex vector

reverse

Modelica.ComplexMath.Vectors

Reverse vector elements (e.g., v[1] becomes last element)

normalize

Modelica.ComplexMath.Vectors

Return normalized complex vector such that length = 1 and prevent zero-division for zero vector

length

Modelica.ComplexMath.Vectors

Return length of a complex vector

norm

Modelica.ComplexMath.Vectors

Returns the p-norm of a complex vector

isPowerOf2

Modelica.Math

Determine if the integer input is a power of 2

isEqual

Modelica.Math

Determine if two Real scalars are numerically identical

prime235Factorization

Modelica.Math.FastFourierTransform.Internal

Factorization of an integer in prime numbers 2,3,5

rawRealFFT

Modelica.Math.FastFourierTransform.Internal

Compute raw Fast Fourier Transform for real signal vector

realFFTwriteToFile

Modelica.Math.FastFourierTransform

Write real FFT computation to file

realFFT

Modelica.Math.FastFourierTransform

Return amplitude and phase vectors for a real FFT

realFFTsamplePoints

Modelica.Math.FastFourierTransform

Return number of sample points for a real FFT

realFFTinfo

Modelica.Math.FastFourierTransform

Print information about real FFT for given f_max and f_resolution

erfInvUtil

Modelica.Math.Special.Internal

Utility function for erfInv(u) and erfcInv(u)

erfcUtil

Modelica.Math.Special.Internal

Evaluate erfc(z) for 0.5 <= z

polyEval

Modelica.Math.Special.Internal

Evaluate a polynomial c[1] + c[2]*u + c[3]*u^2 + ....

sinc

Modelica.Math.Special

Unnormalized sinc function: sinc(u) = sin(u)/u

erfcInv

Modelica.Math.Special

Inverse complementary error function: u = erfc(erfcInv(u))

erfInv

Modelica.Math.Special

Inverse error function: u = erf(erfInv(u))

erfc

Modelica.Math.Special

Complementary error function erfc(u) = 1 - erf(u)

erf

Modelica.Math.Special

Error function erf(u) = 2/sqrt(pi)*Integral_0_u exp(-t^2)*d

partialQuantile

Modelica.Math.Distributions.Interfaces

Common interface of quantile functions (= inverse cumulative distribution functions)

partialCumulative

Modelica.Math.Distributions.Interfaces

Common interface of cumulative distribution functions

partialDensity

Modelica.Math.Distributions.Interfaces

Common interface of probability density functions

impureRandomInteger

Modelica.Math.Random.Utilities

Impure random number generator for integer values (with hidden state vector)

impureRandom

Modelica.Math.Random.Utilities

Impure random number generator (with hidden state vector)

initializeImpureRandom

Modelica.Math.Random.Utilities

Initializes the internal state of the impure random number generator

automaticLocalSeed

Modelica.Math.Random.Utilities

Creates an automatic local seed from the instance name

automaticGlobalSeed

Modelica.Math.Random.Utilities

Creates an automatic integer seed (typically from the current time and process id; this is an impure function)

initialStateWithXorshift64star

Modelica.Math.Random.Utilities

Return an initial state vector for a random number generator (based on xorshift64star algorithm)

random

Modelica.Math.Random.Generators.Xorshift1024star

Returns a uniform random number with the xorshift1024* algorithm

initialState

Modelica.Math.Random.Generators.Xorshift1024star

Returns an initial state for the xorshift1024* algorithm

random

Modelica.Math.Random.Generators.Xorshift128plus

Returns a uniform random number with the xorshift128+ algorithm

initialState

Modelica.Math.Random.Generators.Xorshift128plus

Returns an initial state for the xorshift128+ algorithm

random

Modelica.Math.Random.Generators.Xorshift64star

Returns a uniform random number with the xorshift64* algorithm

initialState

Modelica.Math.Random.Generators.Xorshift64star

Returns an initial state for the xorshift64* algorithm

roots

Modelica.Math.Polynomials

Compute zeros of a polynomial where the highest coefficient is assumed as not to be zero

derivativeValue_der

Modelica.Math.Polynomials

Time derivative of derivative of polynomial

integralValue_der

Modelica.Math.Polynomials

Time derivative of integral of polynomial p(u) from u_low to u_high, assuming only u_high as time-dependent (Leibniz rule)

evaluateWithRange_der

Modelica.Math.Polynomials

Evaluate derivative of polynomial at a given abscissa value with extrapolation outside of the defined range

evaluate_der

Modelica.Math.Polynomials

Evaluate derivative of polynomial at a given abscissa value

fitting

Modelica.Math.Polynomials

Computes the coefficients of a polynomial that fits a set of data points in a least-squares sense

integralValue

Modelica.Math.Polynomials

Integral of polynomial p(u) from u_low to u_high

integral

Modelica.Math.Polynomials

Indefinite integral of polynomial p(u)

secondDerivativeValue

Modelica.Math.Polynomials

Value of 2nd derivative of polynomial at abscissa value u

derivativeValue

Modelica.Math.Polynomials

Value of derivative of polynomial at abscissa value u

derivative

Modelica.Math.Polynomials

Derivative of polynomial

evaluateWithRange

Modelica.Math.Polynomials

Evaluate polynomial at a given abscissa value with linear extrapolation outside of the defined range

evaluate

Modelica.Math.Polynomials

Evaluate polynomial at a given abscissa value

solveOneNonlinearEquation

Modelica.Math.Nonlinear

Solve f(u) = 0 in a very reliable and efficient way (f(u_min) and f(u_max) must have different signs)

quadratureLobatto

Modelica.Math.Nonlinear

Return the integral of an integrand function using an adaptive Lobatto rule

partialScalarFunction

Modelica.Math.Nonlinear.Interfaces

Interface for a function with one input and one output Real signal

solveNonlinearEquations2

Modelica.Math.Nonlinear.Examples

Solve nonlinear equations with user dependent inputs

solveNonlinearEquations1

Modelica.Math.Nonlinear.Examples

Solve nonlinear equations with fixed inputs

quadratureLobatto2

Modelica.Math.Nonlinear.Examples

Integrate integral with user dependent inputs

quadratureLobatto1

Modelica.Math.Nonlinear.Examples

Integrate integral with fixed inputs

findLocal_tk

Modelica.Math.Matrices.Utilities

Find a local minimizer tk to define the length of the step tk*Nk in continuousRiccatiIterative and discreteRiccatiIterative

reorderRSF

Modelica.Math.Matrices.Utilities

Reorders a real Schur form to clusters of stable and unstable eigenvalues

eigenvaluesHessenberg

Modelica.Math.Matrices.Utilities

Compute eigenvalues of an upper Hessenberg form matrix

toUpperHessenberg

Modelica.Math.Matrices.Utilities

Transform a real square matrix A to upper Hessenberg form H by orthogonal similarity transformation: Q' * A * Q = H

discreteRiccatiIterative

Modelica.Math.Matrices.Utilities

Newton's method with exact line search for solving discrete algebraic Riccati equation

continuousRiccatiIterative

Modelica.Math.Matrices.Utilities

Newton's method with exact line search for iterative solving continuous algebraic Riccati equation

dorghr

Modelica.Math.Matrices.LAPACK

Generate a real orthogonal matrix Q which is defined as the product of IHI-ILO elementary reflectors of order N, as returned by DGEHRD

dtrsm

Modelica.Math.Matrices.LAPACK

Solve one of the matrix equations op( A )*X = alpha*B, or X*op( A ) = alpha*B, where A is triangular matrix. BLAS routine

dpotrf

Modelica.Math.Matrices.LAPACK

Compute the Cholesky factorization of a real symmetric positive definite matrix A

dtrevc

Modelica.Math.Matrices.LAPACK

Compute the right and/or left eigenvectors of a real upper quasi-triangular matrix T

dormqr

Modelica.Math.Matrices.LAPACK

Overwrite the general real M-by-N matrix C with Q * C or C * Q or Q' * C or C * Q', where Q is an orthogonal matrix of a QR factorization as returned by dgeqrf

dormhr

Modelica.Math.Matrices.LAPACK

Overwrite the general real M-by-N matrix C with Q * C or C * Q or Q' * C or C * Q', where Q is an orthogonal matrix as returned by dgehrd

dhgeqz

Modelica.Math.Matrices.LAPACK

Compute generalized eigenvalues for a (A,B) system

dggevx

Modelica.Math.Matrices.LAPACK

Compute generalized eigenvalues for a (A,B) system, using lapack routine dggevx

dggev

Modelica.Math.Matrices.LAPACK

Compute generalized eigenvalues, as well as the left and right eigenvectors for a (A,B) system

dgesdd

Modelica.Math.Matrices.LAPACK

Determine singular value decomposition

dgeevx

Modelica.Math.Matrices.LAPACK

Compute the eigenvalues and the (real) left and right eigenvectors of matrix A, using lapack routine dgeevx

dgeqrf

Modelica.Math.Matrices.LAPACK

Compute a QR factorization without pivoting

dgehrd

Modelica.Math.Matrices.LAPACK

Reduce a real general matrix A to upper Hessenberg form H by an orthogonal similarity transformation: Q' * A * Q = H

dgecon

Modelica.Math.Matrices.LAPACK

Estimate the reciprocal of the condition number of a general real matrix A

dlange

Modelica.Math.Matrices.LAPACK

Norm of a matrix

dhseqr

Modelica.Math.Matrices.LAPACK

Compute eigenvalues of a matrix H using lapack routine DHSEQR for Hessenberg form matrix

dtrsyl

Modelica.Math.Matrices.LAPACK

Solve the real Sylvester matrix equation op(A)*X + X*op(B) = scale*C or op(A)*X - X*op(B) = scale*C

dgesvx

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations op(A)*X=B, op(A) is A or A' according to the Boolean input transposed

dtrsen

Modelica.Math.Matrices.LAPACK

Reorder the real Schur factorization of a real matrix

dgees

Modelica.Math.Matrices.LAPACK

Compute real Schur form T of real nonsymmetric matrix A, and, optionally, the matrix of Schur vectors Z as well as the eigenvalues

dorgqr

Modelica.Math.Matrices.LAPACK

Generate a Real orthogonal matrix Q which is defined as the product of elementary reflectors as returned from dgeqrf

dgeqp3

Modelica.Math.Matrices.LAPACK

Compute QR factorization with column pivoting of square or rectangular matrix A

dgetri

Modelica.Math.Matrices.LAPACK

Compute the inverse of a matrix using the LU factorization from dgetrf

dgetrs_vec

Modelica.Math.Matrices.LAPACK

Solve a system of linear equations with the LU decomposition from dgetrf

dgetrs

Modelica.Math.Matrices.LAPACK

Solve a system of linear equations with the LU decomposition from dgetrf

dgetrf

Modelica.Math.Matrices.LAPACK

Compute LU factorization of square or rectangular matrix A (A = P*L*U)

dgesvd_sigma

Modelica.Math.Matrices.LAPACK

Determine singular values

dgesvd

Modelica.Math.Matrices.LAPACK

Determine singular value decomposition

dgbsv_vec

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*x=b with a b vector

dgbsv

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*X=B with a B matrix

dgtsv_vec

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*x=b with b vector and tridiagonal A

dgtsv

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*X=B with B matrix and tridiagonal A

dgglse_vec

Modelica.Math.Matrices.LAPACK

Solve a linear equality constrained least squares problem

dgesv_vec

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*x=b with a b vector

dgesv

Modelica.Math.Matrices.LAPACK

Solve real system of linear equations A*X=B with a B matrix

dgels_vec

Modelica.Math.Matrices.LAPACK

Solve overdetermined or underdetermined real linear equations A*x=b with a b vector

dgelsy_vec

Modelica.Math.Matrices.LAPACK

Compute the minimum-norm solution to a real linear least squares problem with rank deficient A

dgelsy

Modelica.Math.Matrices.LAPACK

Compute the minimum-norm solution to a real linear least squares problem with rank deficient A

dgeev_eigenValues

Modelica.Math.Matrices.LAPACK

Compute eigenvalues for real nonsymmetric matrix A

dgeev

Modelica.Math.Matrices.LAPACK

Compute eigenvalues and (right) eigenvectors for real nonsymmetric matrix A

flipUpDown

Modelica.Math.Matrices

Flip the rows of a matrix in up/down direction

flipLeftRight

Modelica.Math.Matrices

Flip the columns of a matrix in left/right direction

sort

Modelica.Math.Matrices

Sort the rows or columns of a matrix in ascending or descending order

discreteRiccati

Modelica.Math.Matrices

Return solution of discrete-time algebraic Riccati equation A'*X*A - X - A'*X*B*inv(R + B'*X*B)*B'*X*A + Q = 0 (dare)

discreteSylvester

Modelica.Math.Matrices

Return solution of the discrete-time Sylvester equation A*X*B + sgn*X = C

discreteLyapunov

Modelica.Math.Matrices

Return solution X of the discrete-time Lyapunov equation A'*X*A + sgn*X = C

continuousRiccati

Modelica.Math.Matrices

Return solution X of the continuous-time algebraic Riccati equation A'*X + X*A - X*B*inv(R)*B'*X + Q = 0 (care)

continuousSylvester

Modelica.Math.Matrices

Return solution X of the continuous-time Sylvester equation A*X + X*B = C

continuousLyapunov

Modelica.Math.Matrices

Return solution X of the continuous-time Lyapunov equation X*A + A'*X = C

integralExpT

Modelica.Math.Matrices

Return the exponential, the integral of the exponential, and time-weighted integral of the exponential of a matrix

integralExp

Modelica.Math.Matrices

Return the exponential and the integral of the exponential of a matrix

exp

Modelica.Math.Matrices

Return the exponential of a matrix by adaptive Taylor series expansion with scaling and balancing

nullSpace

Modelica.Math.Matrices

Return the orthonormal nullspace of a matrix

frobeniusNorm

Modelica.Math.Matrices

Return the Frobenius norm of a matrix

norm

Modelica.Math.Matrices

Return the p-norm of a matrix

rcond

Modelica.Math.Matrices

Return the reciprocal condition number of a matrix

conditionNumber

Modelica.Math.Matrices

Return the condition number norm(A)*norm(inv(A)) of a matrix A

rank

Modelica.Math.Matrices

Return rank of a rectangular matrix (computed with singular values)

inv

Modelica.Math.Matrices

Return inverse of a matrix (try to avoid inv(..))

det

Modelica.Math.Matrices

Return determinant of a matrix (computed by LU decomposition; try to avoid det(..))

trace

Modelica.Math.Matrices

Return the trace of matrix A, i.e., the sum of the diagonal elements

balanceABC

Modelica.Math.Matrices

Return a balanced form of a system [A,B;C,0] to improve its condition by a state transformation

balance

Modelica.Math.Matrices

Return a balanced form of matrix A to improve the condition of A

cholesky

Modelica.Math.Matrices

Return the Cholesky factorization of a symmetric positive definite matrix

realSchur

Modelica.Math.Matrices

Return the real Schur form (rsf) S of a square matrix A, A=QZ*S*QZ'

hessenberg

Modelica.Math.Matrices

Return upper Hessenberg form of a matrix

QR

Modelica.Math.Matrices

Return the QR decomposition of a square matrix with optional column pivoting (A(:,p) = Q*R)

singularValues

Modelica.Math.Matrices

Return singular values and left and right singular vectors

eigenValueMatrix

Modelica.Math.Matrices

Return real valued block diagonal matrix J of eigenvalues of matrix A (A=V*J*Vinv)

eigenValues

Modelica.Math.Matrices

Return eigenvalues and eigenvectors for a real, nonsymmetric matrix in a Real representation

LU_solve2

Modelica.Math.Matrices

Solve real system of linear equations P*L*U*X=B with a B matrix and an LU decomposition (from LU(..))

LU_solve

Modelica.Math.Matrices

Solve real system of linear equations P*L*U*x=b with a b vector and an LU decomposition (from LU(..))

LU

Modelica.Math.Matrices

LU decomposition of square or rectangular matrix

equalityLeastSquares

Modelica.Math.Matrices

Solve a linear equality constrained least squares problem

leastSquares2

Modelica.Math.Matrices

Solve linear equation A*X = B (exactly if possible, or otherwise in a least square sense; A may be non-square and may be rank deficient)

leastSquares

Modelica.Math.Matrices

Solve linear equation A*x = b (exactly if possible, or otherwise in a least square sense; A may be non-square and may be rank deficient)

solve2

Modelica.Math.Matrices

Solve real system of linear equations A*X=B with a B matrix (Gaussian elimination with partial pivoting)

solve

Modelica.Math.Matrices

Solve real system of linear equations A*x=b with a b vector (Gaussian elimination with partial pivoting)

isEqual

Modelica.Math.Matrices

Compare whether two Real matrices are identical

toString

Modelica.Math.Matrices

Convert a matrix into its string representation

solveLinearEquations

Modelica.Math.Matrices.Examples

Demonstrate the solution of linear equation systems

oneTrue

Modelica.Math.BooleanVectors

Returns true, if exactly one element of the Boolean input vector is true ("xor")

index

Modelica.Math.BooleanVectors

Returns the indices of the true elements of a Boolean vector

firstTrueIndex

Modelica.Math.BooleanVectors

Returns the index of the first true element of a Boolean vector

enumerate

Modelica.Math.BooleanVectors

Enumerates the true elements in a Boolean vector (0 for false elements)

countTrue

Modelica.Math.BooleanVectors

Returns the number of true elements in a Boolean vector

anyTrue

Modelica.Math.BooleanVectors

Returns true, if at least one element of the Boolean input vector is true ('or')

andTrue

Modelica.Math.BooleanVectors

Returns true, if all elements of the Boolean input vector are true ('and')

allTrue

Modelica.Math.BooleanVectors

Returns true, if all elements of the Boolean input vector are true ('and')

relNodePositions

Modelica.Math.Vectors

Return vector of relative node positions (0..1)

interpolate

Modelica.Math.Vectors

Interpolate linearly in a vector

find

Modelica.Math.Vectors

Find element in a vector

sort

Modelica.Math.Vectors

Sort elements of vector in ascending or descending order

reverse

Modelica.Math.Vectors

Reverse vector elements (e.g., v[1] becomes last element)

normalizeWithAssert

Modelica.Math.Vectors

Return normalized vector such that length = 1 (trigger an assert for zero vector)

normalize

Modelica.Math.Vectors

Return normalized vector such that length = 1 and prevent zero-division for zero vector

length

Modelica.Math.Vectors

Return length of a vector (better as norm(), if further symbolic processing is performed)

norm

Modelica.Math.Vectors

Return the p-norm of a vector

isEqual

Modelica.Math.Vectors

Determine if two Real vectors are numerically identical

toString

Modelica.Math.Vectors

Convert a real vector in to a string representation

dynamicIsentropicEnthalpy

Modelica.Media.Water.IF97_Utilities

Isentropic specific enthalpy from p,s and good guesses of d and T

isentropicEnthalpy_der

Modelica.Media.Water.IF97_Utilities

Derivative of isentropic specific enthalpy from p,s

isentropicEnthalpy_props

Modelica.Media.Water.IF97_Utilities

isentropicEnthalpy

Modelica.Media.Water.IF97_Utilities

Isentropic specific enthalpy from p,s (preferably use dynamicIsentropicEnthalpy in dynamic simulation!)

water_pT

Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial

Calculate property record for dynamic simulation properties using p and T as dynamic states

water_dT

Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial

Calculate property record for dynamic simulation properties using d and T as dynamic states

water_ph

Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial

Calculate the property record for dynamic simulation properties using p,h as states

isentropicExponent_dT

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of density and temperature

isentropicExponent_props_dT

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of density and temperature

velocityOfSound_dT

Modelica.Media.Water.IF97_Utilities

Speed of sound as function of density and temperature

velocityOfSound_props_dT

Modelica.Media.Water.IF97_Utilities

Speed of sound as function of density and temperature

kappa_dT

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of density and temperature

kappa_props_dT

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of density and temperature

beta_dT

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of density and temperature

beta_props_dT

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of density and temperature

cp_dT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of density and temperature

cp_props_dT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of density and temperature

cv_dT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of density and temperature

cv_props_dT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of density and temperature

s_dT

Modelica.Media.Water.IF97_Utilities

Temperature as function of density and temperature

s_props_dT

Modelica.Media.Water.IF97_Utilities

Specific entropy as function of density and temperature

p_dT_der

Modelica.Media.Water.IF97_Utilities

Derivative function of p_dT

p_dT

Modelica.Media.Water.IF97_Utilities

Pressure as function of density and temperature

p_props_dT

Modelica.Media.Water.IF97_Utilities

Pressure as function of density and temperature

h_dT_der

Modelica.Media.Water.IF97_Utilities

Derivative function of h_dT

h_dT

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function of density and temperature

h_props_dT

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function of density and temperature

waterBaseProp_dT

Modelica.Media.Water.IF97_Utilities

Intermediate property record for water (d and T preferred states)

isentropicExponent_pT

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of pressure and temperature

isentropicExponent_props_pT

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of pressure and temperature

velocityOfSound_pT

Modelica.Media.Water.IF97_Utilities

Speed of sound as function of pressure and temperature

velocityOfSound_props_pT

Modelica.Media.Water.IF97_Utilities

Speed of sound as function of pressure and temperature

kappa_pT

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of pressure and temperature

kappa_props_pT

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of pressure and temperature

beta_pT

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of pressure and temperature

beta_props_pT

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of pressure and temperature

cp_pT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of pressure and temperature

cp_props_pT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of pressure and temperature

cv_pT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of pressure and temperature

cv_props_pT

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of pressure and temperature

s_pT

Modelica.Media.Water.IF97_Utilities

Temperature as function of pressure and temperature

s_props_pT

Modelica.Media.Water.IF97_Utilities

Specific entropy as function of pressure and temperature

rho_pT_der

Modelica.Media.Water.IF97_Utilities

Derivative function of rho_pT

h_pT_der

Modelica.Media.Water.IF97_Utilities

Derivative function of h_pT

h_pT

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function or pressure and temperature

h_props_pT

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function or pressure and temperature

rho_pT

Modelica.Media.Water.IF97_Utilities

Density as function or pressure and temperature

rho_props_pT

Modelica.Media.Water.IF97_Utilities

Density as function or pressure and temperature

waterBaseProp_pT

Modelica.Media.Water.IF97_Utilities

Intermediate property record for water (p and T preferred states)

ddhp

Modelica.Media.Water.IF97_Utilities

Density derivative by specific enthalpy

ddhp_props

Modelica.Media.Water.IF97_Utilities

Density derivative by specific enthalpy

ddph

Modelica.Media.Water.IF97_Utilities

Density derivative by pressure

ddph_props

Modelica.Media.Water.IF97_Utilities

Density derivative by pressure

isentropicExponent_ph

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of pressure and specific enthalpy

isentropicExponent_props_ph

Modelica.Media.Water.IF97_Utilities

Isentropic exponent as function of pressure and specific enthalpy

velocityOfSound_ph

Modelica.Media.Water.IF97_Utilities

velocityOfSound_props_ph

Modelica.Media.Water.IF97_Utilities

Speed of sound as function of pressure and specific enthalpy

kappa_ph

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of pressure and specific enthalpy

kappa_props_ph

Modelica.Media.Water.IF97_Utilities

Isothermal compressibility factor as function of pressure and specific enthalpy

beta_ph

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of pressure and specific enthalpy

beta_props_ph

Modelica.Media.Water.IF97_Utilities

Isobaric expansion coefficient as function of pressure and specific enthalpy

cp_ph

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of pressure and specific enthalpy

cp_props_ph

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant pressure as function of pressure and specific enthalpy

regionAssertReal

Modelica.Media.Water.IF97_Utilities

Assert function for inlining

cv_ph

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of pressure and specific enthalpy

cv_props_ph

Modelica.Media.Water.IF97_Utilities

Specific heat capacity at constant volume as function of pressure and specific enthalpy

s_ph_der

Modelica.Media.Water.IF97_Utilities

Specific entropy as function of pressure and specific enthalpy

s_ph

Modelica.Media.Water.IF97_Utilities

Specific entropy as function of pressure and specific enthalpy

s_props_ph

Modelica.Media.Water.IF97_Utilities

Specific entropy as function of pressure and specific enthalpy

T_ph_der

Modelica.Media.Water.IF97_Utilities

Derivative function of T_ph

T_ph

Modelica.Media.Water.IF97_Utilities

Temperature as function of pressure and specific enthalpy

T_props_ph

Modelica.Media.Water.IF97_Utilities

Temperature as function of pressure and specific enthalpy

rho_ph_der

Modelica.Media.Water.IF97_Utilities

Derivative function of rho_ph

rho_ph

Modelica.Media.Water.IF97_Utilities

Density as function of pressure and specific enthalpy

rho_props_ph

Modelica.Media.Water.IF97_Utilities

Density as function of pressure and specific enthalpy

phase_dT

Modelica.Media.Water.IF97_Utilities

Phase as a function of pressure and temperature

phase_ph

Modelica.Media.Water.IF97_Utilities

Phase as a function of pressure and specific enthalpy

phase_ps

Modelica.Media.Water.IF97_Utilities

Phase as a function of pressure and specific entropy

h_ps

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function or pressure and temperature

h_props_ps

Modelica.Media.Water.IF97_Utilities

Specific enthalpy as function or pressure and temperature

T_ps

Modelica.Media.Water.IF97_Utilities

Temperature as function of pressure and specific entropy

T_props_ps

Modelica.Media.Water.IF97_Utilities

Temperature as function of pressure and specific entropy

rho_ps

Modelica.Media.Water.IF97_Utilities

Density as function of pressure and specific entropy

rho_props_ps

Modelica.Media.Water.IF97_Utilities

Density as function of pressure and specific entropy

waterBaseProp_ps

Modelica.Media.Water.IF97_Utilities

Intermediate property record for water

waterBaseProp_ph

Modelica.Media.Water.IF97_Utilities

Intermediate property record for water

extraDerivs_pT

Modelica.Media.Water.IF97_Utilities.BaseIF97

Function to calculate some extra thermophysical properties in regions 1, 2, 3 and 5 as f(p,T)

extraDerivs_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97

Function to calculate some extra thermophysical properties in regions 1, 2, 3 and 5 as f(p,h)

waterR4_dT

Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase

Water properties in region 4 as function of d and T

waterR4_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase

Water/Steam properties in region 4 of IAPWS/IF97 (two-phase)

waterSat_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase

Water saturation properties in the 2-phase region (4) as f(p,h)

waterVap_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase

Properties on the vapour phase boundary of region 4

waterLiq_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase

Properties on the liquid phase boundary of region 4

waterR5_pT

Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion

Standard properties for region 5, (p,T) as inputs

waterR3_dT

Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion

Standard properties for region 3, (d,T) as inputs

waterR2_pT

Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion

Standard properties for region 2, (p,T) as inputs

waterR1_pT

Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion

Standard properties for region 1, (p,T) as inputs

tofpst5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 5: (p,T) = f(p,s)

tofps5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 5: (p,T) = f(p,s)

tofph5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 5: (p,T) = f(p,h)

pofdt125

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 1,2 and 5: p = g(d,T)

dtofpsdt3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 3: (d,T) = f(p,s)

dtofps3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 3: (d,T) = f(p,s)

dtofph3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 3: (d,T) = f(p,h)

dofpt3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Inverse iteration in region 3: (d) = f(p,T)

dofp23

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Density at the boundary between regions 2 and 3

dofp13

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Density at the boundary between regions 1 and 3

fixdT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses

Region limits for inverse iteration in region 3

water_hisentropic_dyn

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Isentropic specific enthalpy from p,s and good guesses of d and T

water_hisentropic

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Isentropic specific enthalpy from p,s (preferably use water_hisentropic_dyn in dynamic simulation!)

hofpT5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Specific enthalpy in region 5 h(p,T)

hofps4

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Isentropic specific enthalpy in region 4 h(p,s)

hofpsdt3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Isentropic specific enthalpy in region 3 h(p,s) with given good guess in d and T

hofps3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Isentropic specific enthalpy in region 3 h(p,s)

hofdT3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Function for isentropic specific enthalpy in region 3

hofps2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Function for isentropic specific enthalpy in region 2

handsofpT2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Function for isentropic specific enthalpy and specific entropy in region 2

hofpT2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Intermediate function for isentropic specific enthalpy in region 2

hofps1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Function for isentropic specific enthalpy in region 1

handsofpT1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Special function for specific enthalpy and specific entropy in region 1

hofpT1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic

Intermediate function for isentropic specific enthalpy in region 1

surfaceTension

Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport

Surface tension in region 4 between steam and water

cond_dTp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport

Thermal conductivity lam(d,T,p) (industrial use version) only in one-phase region

visc_dTp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport

Dynamic viscosity eta(d,T,p), industrial formulation

sublimationPressure_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries

Sublimation pressure, valid from 190 to 273.16 K

pmIceV_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries

Melting pressure of ice V (temperature range from 256.164 to 273.31 K)

pmIceIII_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries

Melting pressure of ice III (temperature range from 251.165 to 256.164 K)

pmIceI_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries

Melting pressure of ice I (temperature range from 273.16 to 251.165 K)

v3b_ps

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 b: inverse function v(p,s)

v3a_ps

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 a: inverse function v(p,s)

T3b_ps

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 b: inverse function T(p,s)

T3a_ps

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 a: inverse function T(p,s)

v3b_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 b: inverse function v(p,h)

v3a_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 a: inverse function v(p,h)

T3b_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 b: inverse function T(p,h)

T3a_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 a: inverse function T(p,h)

h3ab_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 3 a b boundary for pressure/enthalpy

p2c_hs

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Pressure as a function of enthalpy and entropy in subregion 2c

p2b_hs

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Pressure as a function of enthalpy and entropy in subregion 2a

p2a_hs

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Pressure as a function of enthalpy and entropy in subregion 2a

h2ab_s

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Boundary between regions 2a and 2b

p1_hs

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Pressure as a function of enthalpy and entropy in region 1

psat_der

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative function for psat

dptofT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative of pressure w.r.t. temperature along the saturation pressure curve

psat

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 4 saturation pressure as a function of temperature

tsat_der

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative function for tsat

dtsatofp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative of saturation temperature w.r.t. pressure

tsat

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Region 4 saturation temperature as a function of pressure

tps2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Reverse function for region 2: T(p,s)

tps2c

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Reverse function for region 2c: T(p,s)

tps2b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Reverse function for region 2b: T(p,s)

tps2a

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Reverse function for region 2a: T(p,s)

tph2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Reverse function for region 2: T(p,h)

tps1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Inverse function for region 1: T(p,s)

tph1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Inverse function for region 1: T(p,h)

f3deltatau

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

1st derivatives of f w.r.t. delta and tau

g5pitau

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative of g w.r.t. pi and tau

g2pitau

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative of g w.r.t. pi and tau

g1pitau

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Derivative of g w.r.t. pi and tau

gibbs

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Gibbs function for region 1, 2 or 5: g(p,T,region)

g5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Base function for region 5: g(p,T)

f3

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Helmholtz function for region 3: f(d,T)

g2metastable

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Gibbs function for metastable part of region 2: g(p,T)

g2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Gibbs function for region 2: g(p,T)

g1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic

Gibbs function for region 1: g(p,T)

drhov_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative of density of saturated steam w.r.t. pressure

drhol_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative of density of saturated water w.r.t. pressure

drhovl_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

dhv_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative of vapour specific enthalpy on the boundary between regions 4 and 3 or 1 w.r.t. pressure

dhl_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative of liquid specific enthalpy on the boundary between regions 4 and 3 or 1 w.r.t. pressure

hvl_dp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative function for the specific enthalpy along the phase boundary

region_dT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Return the current region (valid values: 1,2,3,4,5) in IF97, given density and temperature

region_pT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Return the current region (valid values: 1,2,3,5) in IF97, given pressure and temperature

region_ps

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Return the current region (valid values: 1,2,3,4,5) in IF97 for given pressure and specific entropy

region_ph

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Return the current region (valid values: 1,2,3,4,5) in IF97 for given pressure and specific enthalpy

rhov_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density of saturated vapour

rhol_T

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density of saturated water

sv_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Vapour specific entropy on the boundary between regions 4 and 3 or 2

sl_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Liquid specific entropy on the boundary between regions 4 and 3 or 1

rhovl_p_der

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

rhov_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density of saturated vapour

rhol_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density of saturated water

rhovl_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

hvl_p_der

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Derivative function for the specific enthalpy along the phase boundary

hv_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Vapour specific enthalpy on the boundary between regions 4 and 3 or 2

hl_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Liquid specific enthalpy on the boundary between regions 4 and 3 or 1

hvl_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

dewcurve_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Properties on the dew curve

boilingcurve_p

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Properties on the boiling curve

rhov_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of vapour density on the boundary between regions 4 and 2

rhol_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of liquid density on the boundary between regions 4 and 3

sv_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of vapour specific entropy on the boundary between regions 4 and 3

sl_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of liquid specific entropy on the boundary between regions 4 and 3

hv_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of vapour specific enthalpy on the boundary between regions 4 and 3

hl_p_R4b

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit approximation of liquid specific enthalpy on the boundary between regions 4 and 3

dupper1ofT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density at upper pressure limit of region 1

dhot1ofp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density at upper temperature limit of region 1

d2n

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density in region 2 as function of p and T

d1n

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Density in region 1 as function of p and T

supperofp2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific entropy limit of region 2 as function of pressure

slowerofp2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific entropy limit of region 2 as function of pressure (meets region 4 saturation pressure curve at 623.15 K)

hupperofp2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific enthalpy limit of region 2 as function of pressure

hlowerofp2

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific enthalpy limit of region 2 as function of pressure (meets region 4 saturation pressure curve at 623.15 K)

supperofp1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific entropy limit of region 1 as function of pressure (meets region 4 saturation pressure curve at 623.15 K)

slowerofp1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific entropy limit of region 1 as function of pressure

hupperofp1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific enthalpy limit of region 1 as function of pressure (meets region 4 saturation pressure curve at 623.15 K)

hlowerofp1

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific enthalpy limit of region 1 as function of pressure

supperofp5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific entropy limit of region 5 as function of pressure

slowerofp5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific entropy limit of region 5 as function of pressure

hupperofp5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit upper specific enthalpy limit of region 5 as function of pressure

hlowerofp5

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Explicit lower specific enthalpy limit of region 5 as function of pressure

boundary23ofp

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Boundary function for region boundary between regions 2 and 3 (input pressure)

boundary23ofT

Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions

Boundary function for region boundary between regions 2 and 3 (input temperature)

getpstar

Modelica.Media.Water.IF97_Utilities.BaseIF97

Get normalization pressure for region 1, 2 or 5

getTstar

Modelica.Media.Water.IF97_Utilities.BaseIF97

Get normalization temperature for region 1, 2 or 5

density_pT

Modelica.Media.Water.WaterIF97_base

Computes density as a function of pressure and temperature

specificEnthalpy_ps

Modelica.Media.Water.WaterIF97_base

Computes specific enthalpy as a function of pressure and temperature

specificEnthalpy_pT

Modelica.Media.Water.WaterIF97_base

Computes specific enthalpy as a function of pressure and temperature

specificEnthalpy_dT

Modelica.Media.Water.WaterIF97_base

Computes specific enthalpy as a function of density and temperature

pressure_dT

Modelica.Media.Water.WaterIF97_base

Computes pressure as a function of density and temperature

density_ps

Modelica.Media.Water.WaterIF97_base

Computes density as a function of pressure and specific enthalpy

temperature_ps

Modelica.Media.Water.WaterIF97_base

Compute temperature from pressure and specific enthalpy

temperature_ph

Modelica.Media.Water.WaterIF97_base

Computes temperature as a function of pressure and specific enthalpy

density_ph

Modelica.Media.Water.WaterIF97_base

Computes density as a function of pressure and specific enthalpy

phaseBoundaryAssert

Modelica.Media.R134a.R134a_ph

Assert function for checking threshold to phase boundary

hofpT

Modelica.Media.R134a.R134a_ph

Compute h for given p and T

dofpT

Modelica.Media.R134a.R134a_ph

Compute d for given p and T

T_props_ph

Modelica.Media.R134a.R134a_ph

Temperature as function of pressure and specific enthalpy

T_ph_der

Modelica.Media.R134a.R134a_ph

Time derivative function of T_ph

rho_props_ph

Modelica.Media.R134a.R134a_ph

Density as function of pressure and specific enthalpy

rho_ph_der

Modelica.Media.R134a.R134a_ph

Time derivative function of density_ph

R134a_vapofdT

Modelica.Media.R134a.R134a_ph

Properties on vapor boundary phase

R134a_liqofdT

Modelica.Media.R134a.R134a_ph

Properties on liquid boundary phase

hofpsTwoPhase

Modelica.Media.R134a.R134a_ph

Isentropic specific enthalpy in two phase region h(p,s)

getPhase_ps

Modelica.Media.R134a.R134a_ph

Number of phases by pressure and entropy

getPhase_ph

Modelica.Media.R134a.R134a_ph

Number of phases by pressure and specific enthalpy

fres_R134a

Modelica.Media.R134a.R134a_ph

Calculation of helmholtz derivatives

fid_R134a

Modelica.Media.R134a.R134a_ph

Helmholtz coefficients of ideal part

f_R134a

Modelica.Media.R134a.R134a_ph

Calculation of helmholtz derivatives by density and temperature

dtofpsOnePhase

Modelica.Media.R134a.R134a_ph

Inverse iteration in one phase region (d,T) = f(p,s)

dtofphOnePhase

Modelica.Media.R134a.R134a_ph

Density and temperature w.r.t. pressure and specific enthalpy in one-phase region

dt_ph

Modelica.Media.R134a.R134a_ph

Density and temperature w.r.t. pressure and specific enthalpy

derivsOf_ph

Modelica.Media.R134a.R134a_ph

Derivatives required for inversion of temperature and density functions

dBubbleEntropy_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of liquid specific entropy in two-phase region w.r.t. pressure | use setState_phX function for input

dBubbleEntropy_dPressure

Modelica.Media.R134a.R134a_ph

Derivative of liquid specific entropy in two-phase region w.r.t. pressure | use setState_phX function for input

dDewEntropy_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of vapor specific entropy in two-phase region w.r.t. pressure | use setState_phX function for input

dDewEntropy_dPressure

Modelica.Media.R134a.R134a_ph

Derivative of vapor specific entropy in two-phase region w.r.t. pressure | use setState_phX function for input

dDewEnthalpy_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of vapor specific enthalpy in two-phase region w.r.t. pressure

dBubbleEnthalpy_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of liquid specific enthalpy in two-phase region w.r.t. pressure

dDewDensity_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of vapor density in two-phase region w.r.t. pressure

dBubbleDensity_dPressure_der_sat

Modelica.Media.R134a.R134a_ph

Time derivative of liquid density in two-phase region w.r.t. pressure

saturationTemperature_der_p

Modelica.Media.R134a.R134a_ph

Time derivative of saturation temperature in two-phase region

temperature_ph

Modelica.Media.R134a.R134a_ph

Temperature as function of pressure and specific enthalpy

density_ph

Modelica.Media.R134a.R134a_ph

Density as function of pressure and specific enthalpy

helmholtzToBoundaryProps

Modelica.Media.R134a.Common

Calculate phase boundary property record from dimensionless Helmholtz function

FindInterval

Modelica.Media.R134a.Common

Half-interval search algorithm

cv2Phase

Modelica.Media.R134a.Common

Compute isochoric specific heat capacity inside the two-phase region

CubicSplineEval

Modelica.Media.R134a.Common

Cubic spline

CubicSplineDerEval

Modelica.Media.R134a.Common

Derivative of cubic spline

T_ps

Modelica.Media.Incompressible.TableBased

Compute temperature from pressure and specific enthalpy

T_ph

Modelica.Media.Incompressible.TableBased

Compute temperature from pressure and specific enthalpy

density_T

Modelica.Media.Incompressible.TableBased

Return density as function of temperature

h_pT

Modelica.Media.Incompressible.TableBased

Compute specific enthalpy from pressure and temperature

h_T_der

Modelica.Media.Incompressible.TableBased

Compute specific enthalpy from temperature

h_T

Modelica.Media.Incompressible.TableBased

Compute specific enthalpy from temperature

s_T

Modelica.Media.Incompressible.TableBased

Compute specific entropy

setState_ps

Modelica.Media.Incompressible.TableBased

Returns state record as function of p and s

setState_ph

Modelica.Media.Incompressible.TableBased

Returns state record as function of p and h

setState_pT

Modelica.Media.Incompressible.TableBased

Returns state record as function of p and T

invertTemp

Modelica.Media.Incompressible.TableBased

Function to invert temperatures

T_psX

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return temperature from pressure, specific entropy and mass fraction

T_hX

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return temperature from specific enthalpy and mass fraction

density_derX

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return density derivative by mass fraction

lowPressureThermalConductivity

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return thermal conductivities of low-pressure gas mixtures (Mason and Saxena Modification)

mixtureViscosityChung

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return the viscosity of gas mixtures without access to component viscosities (Chung, et. al. rules)

gasMixtureViscosity

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return viscosities of gas mixtures at low pressures (Wilke method)

isentropicEnthalpyApproximation

Modelica.Media.IdealGases.Common.MixtureGasNasa

Approximate method of calculating h_is from upstream properties and downstream pressure

s_TX

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return temperature dependent part of the entropy, expects full entropy vector

MixEntropy

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return mixing entropy of ideal gases / R

h_TX_der

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return specific enthalpy derivative

h_TX

Modelica.Media.IdealGases.Common.MixtureGasNasa

Return specific enthalpy

setState_dTX

Modelica.Media.IdealGases.Common.MixtureGasNasa

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

setState_psX

Modelica.Media.IdealGases.Common.MixtureGasNasa

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

setState_phX

Modelica.Media.IdealGases.Common.MixtureGasNasa

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

setState_pTX

Modelica.Media.IdealGases.Common.MixtureGasNasa

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

thermalConductivityEstimate

Modelica.Media.IdealGases.Common.SingleGasNasa

Thermal conductivity of polyatomic gases(Eucken and Modified Eucken correlation)

dynamicViscosityLowPressure

Modelica.Media.IdealGases.Common.SingleGasNasa

Dynamic viscosity of low pressure gases

T_ps

Modelica.Media.IdealGases.Common.SingleGasNasa

Compute temperature from pressure and specific entropy

T_h

Modelica.Media.IdealGases.Common.SingleGasNasa

Compute temperature from specific enthalpy

isentropicEnthalpyApproximation

Modelica.Media.IdealGases.Common.SingleGasNasa

Approximate method of calculating h_is from upstream properties and downstream pressure

setState_dTX

Modelica.Media.IdealGases.Common.SingleGasNasa

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

setState_psX

Modelica.Media.IdealGases.Common.SingleGasNasa

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

setState_phX

Modelica.Media.IdealGases.Common.SingleGasNasa

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

setState_pTX

Modelica.Media.IdealGases.Common.SingleGasNasa

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

thermalConductivityEstimate

Modelica.Media.IdealGases.Common.Functions

Thermal conductivity of polyatomic gases (Eucken and Modified Eucken correlation)

dynamicViscosityLowPressure

Modelica.Media.IdealGases.Common.Functions

Dynamic viscosity of low pressure gases

s0_Tlow_der

Modelica.Media.IdealGases.Common.Functions

Compute derivative of specific entropy, low T region

s0_Tlow

Modelica.Media.IdealGases.Common.Functions

Compute specific entropy, low T region

s0_T

Modelica.Media.IdealGases.Common.Functions

Compute specific entropy from temperature and gas data

h_Tlow_der

Modelica.Media.IdealGases.Common.Functions

Compute derivative of specific enthalpy, low T region; reference is decided by the refChoice input, or by the referenceChoice package constant by default

h_Tlow

Modelica.Media.IdealGases.Common.Functions

Compute specific enthalpy, low T region; reference is decided by the refChoice input, or by the referenceChoice package constant by default

h_T_der

Modelica.Media.IdealGases.Common.Functions

Derivative function for h_T

h_T

Modelica.Media.IdealGases.Common.Functions

Compute specific enthalpy from temperature and gas data; reference is decided by the refChoice input, or by the referenceChoice package constant by default

cp_Tlow_der

Modelica.Media.IdealGases.Common.Functions

Compute derivative of specific heat capacity at constant pressure, low T region

cp_Tlow

Modelica.Media.IdealGases.Common.Functions

Compute specific heat capacity at constant pressure, low T region

cp_T

Modelica.Media.IdealGases.Common.Functions

Compute specific heat capacity at constant pressure from temperature and gas data

u_pTX_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of internal energy

h_pTX_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of specific enthalpy of moist air

h_dis_pTX_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

rho_pTX_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of density as a function of pressure p, temperature T and composition X

pds_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of saturation partial pressure of steam

xws_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of humidity ration (absolute) of saturated humid air

pd_pTX_der

Modelica.Media.Air.ReferenceMoistAir.Utilities

Derivative of partial pressure of steam

s_dis_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

cp_dis_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

u_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Internal energy

s_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Specific entropy of moist air

h_dis_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

h_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Specific enthalpy of moist air

cv_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Specific isochoric heat capacity

cp_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Specific isobaric heat capacity

phi_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Relative humidity

xws_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities

Humidity ratio (absolute) of saturated humid air

pd_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Partial pressure of steam

pds_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities

Saturation partial pressure of steam

rho_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities

Return density as a function of pressure p, temperature T and composition X

f_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities

Enhancement factor as function of pressure and temperature

beta_H

Modelica.Media.Air.ReferenceMoistAir.Utilities

Henry's law constant

kappa_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Isothermal compressibility factor as function of pressure and temperature

kappa_props_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Isothermal compressibility factor as function of pressure and temperature

s_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Temperature as function of pressure and temperature

s_props_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Specific entropy as function of pressure and temperature

h_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Derivative function of h_pT

h_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Specific enthalpy as function or pressure and temperature

h_props_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Specific enthalpy as function or pressure and temperature

rho_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Derivative function of rho_pT

rho_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Density as function or pressure and temperature

rho_props_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Density as function or pressure and temperature

ice09BaseProp_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities

Intermediate property record for water (p and T preferred states)

psub_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic

Derivative of sublimation pressure

Tsub

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic

Sublimation temperature

psub

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic

Sublimation pressure

Gibbs

Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic

Gibbs equation of state

Tsat_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities

Derivative of saturation temperature

psat_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities

Saturation pressure

Tsat

Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities

Saturation temperature

psat

Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities

Saturation pressure

h_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Derivative function of h_pT for region 2

rho_pT_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Derivative function of rho_pT for region 2

rho_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Density as function or pressure and temperature for region 2

cv_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Specific heat capacity at constant volume as function of pressure and temperature for region 2

cp_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Specific heat capacity at constant pressure as function of pressure and temperature for region 2

s_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Temperature as function of pressure and temperature for region 2

h_pT

Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new

Specific enthalpy as function or pressure and temperature

V6_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of energy index for formation of NO

V5_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of energy index for formation of O

V4_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of energy index for formation of H

V3_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative energy index for formation of OH

V2_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of energy index for formation of H2

U6_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of reaction index for formation of NO

U5_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of reaction index for formation of O

U4_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of reaction index for formation of H

U3_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative of reaction index for formation of OH

U2_der

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Derivative reaction index for formation of H2

V6

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Energy index for formation of NO

V5

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Energy index for formation of O

V4

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Energy index for formation of H

V3

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Energy index for formation of OH

V2

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Energy index for formation of H2

U6

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Reaction index for formation of NO

U5

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Reaction index for formation of O

U4

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Reaction index for formation of H

U3

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Reaction index for formation of OH

U2

Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices

Reaction index for formation of H2

Cwww_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Third molar virial coefficient of water

Caww_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Third molar cross-virial coefficient

Caaw_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Third molar cross-virial coefficient

Caaa_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Third molar virial coefficient of dry air

Bww_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Second molar virial coefficient of water

Baw_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Second molar cross-virial coefficient

Baa_dT

Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients

Second molar virial coefficient of dry air

lambda_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities.Transport

Thermal conductivity

eta_pTX

Modelica.Media.Air.ReferenceMoistAir.Utilities.Transport

Dynamic viscosity

p_dTX

Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses

Return pressure as function of density, temperature and mass fractions

T_psX

Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses

Return temperature as function of pressure, specific entropy and mass fractions

T_phX

Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses

Return temperature as a function of pressure, specific enthalpy and mass fractions

enthalpyOfWaterNonVapor

Modelica.Media.Air.ReferenceMoistAir

Return enthalpy of liquid and solid water

enthalpyOfWater

Modelica.Media.Air.ReferenceMoistAir

Return specific enthalpy of water (solid + liquid + steam)

sublimationPressureIce

Modelica.Media.Air.ReferenceMoistAir

Return sublimation pressure of water as a function of temperature T between 223.16 and 273.16 K

saturationPressureLiquid

Modelica.Media.Air.ReferenceMoistAir

Return saturation pressure of water as a function of temperature T

waterContent_X

Modelica.Media.Air.ReferenceMoistAir

Return water content in kg(water)/kg(dry air) given mass fractions

massFraction_waterContent

Modelica.Media.Air.ReferenceMoistAir

Return mass fractions as a function of pressure, temperature and absolute humidity in kg(water)/kg(dry air)

massFractionSaturation_ppsat

Modelica.Media.Air.ReferenceMoistAir

Return mass fvraction at saturation boundary given pressure and saturation pressure

massFractionWaterNonVapor

Modelica.Media.Air.ReferenceMoistAir

Return mass fraction of liquid and solid water

massFractionWaterVapor

Modelica.Media.Air.ReferenceMoistAir

Return mass fraction of water vapor

xsaturation

Modelica.Media.Air.ReferenceMoistAir

Return absolute humidity per unit mass of dry air at saturation as a function of the thermodynamic state record

Xsaturation

Modelica.Media.Air.ReferenceMoistAir

Return absolute humidity per unit mass of moist air at saturation as a function of the thermodynamic state record

smoothMax_der

Modelica.Media.Air.MoistAir.Utilities

smoothMax

Modelica.Media.Air.MoistAir.Utilities

spliceFunction_der

Modelica.Media.Air.MoistAir.Utilities

Derivative of spliceFunction

spliceFunction

Modelica.Media.Air.MoistAir.Utilities

Spline interpolation of two functions

s_pTX_der

Modelica.Media.Air.MoistAir

Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1)

s_pTX

Modelica.Media.Air.MoistAir

Return specific entropy of moist air as a function of pressure p, temperature T and composition X (only valid for phi<1)

T_psX

Modelica.Media.Air.MoistAir

Return temperature as a function of pressure p, specific entropy s and composition X

specificInternalEnergy_pTX_der

Modelica.Media.Air.MoistAir

Derivative function for specificInternalEnergy_pTX

specificInternalEnergy_pTX

Modelica.Media.Air.MoistAir

Return specific internal energy of moist air as a function of pressure p, temperature T and composition X

isentropicEnthalpyApproximation

Modelica.Media.Air.MoistAir

Approximate calculation of h_is from upstream properties, downstream pressure, gas part only

h_pTX_der

Modelica.Media.Air.MoistAir

Derivative function of h_pTX

h_pTX

Modelica.Media.Air.MoistAir

Return specific enthalpy of moist air as a function of pressure p, temperature T and composition X

T_phX

Modelica.Media.Air.MoistAir

Return temperature as a function of pressure p, specific enthalpy h and composition X

enthalpyOfWater_der

Modelica.Media.Air.MoistAir

Derivative function of enthalpyOfWater

enthalpyOfWater

Modelica.Media.Air.MoistAir

Computes specific enthalpy of water (solid/liquid) near atmospheric pressure from temperature T

HeatCapacityOfWater

Modelica.Media.Air.MoistAir

Return specific heat capacity of water (liquid only) as a function of temperature T

saturationTemperature

Modelica.Media.Air.MoistAir

Return saturation temperature of water as a function of (partial) pressure p

saturationPressure_der

Modelica.Media.Air.MoistAir

Derivative function for 'saturationPressure'

sublimationPressureIce_der

Modelica.Media.Air.MoistAir

Derivative function for 'sublimationPressureIce'

sublimationPressureIce

Modelica.Media.Air.MoistAir

Return sublimation pressure of water as a function of temperature T between 190 and 273.16 K

saturationPressureLiquid_der

Modelica.Media.Air.MoistAir

Derivative function for 'saturationPressureLiquid'

saturationPressureLiquid

Modelica.Media.Air.MoistAir

Return saturation pressure of water as a function of temperature T in the range of 273.16 to 647.096 K

gasConstant_X

Modelica.Media.Air.MoistAir

Return ideal gas constant as a function from composition X

relativeHumidity

Modelica.Media.Air.MoistAir

Return relative humidity as a function of the thermodynamic state record

relativeHumidity_pTX

Modelica.Media.Air.MoistAir

Return relative humidity as a function of pressure p, temperature T and composition X

massFraction_pTphi

Modelica.Media.Air.MoistAir

Return steam mass fraction as a function of relative humidity phi and temperature T

xsaturation_pT

Modelica.Media.Air.MoistAir

Return absolute humidity per unit mass of dry air at saturation as a function of pressure p and temperature T

xsaturation

Modelica.Media.Air.MoistAir

Return absolute humidity per unit mass of dry air at saturation as a function of the thermodynamic state record

Xsaturation

Modelica.Media.Air.MoistAir

Return absolute humidity per unit mass of moist air at saturation as a function of the thermodynamic state record

setState_dTX

Modelica.Media.Air.MoistAir

Return thermodynamic state as function of density d, temperature T and composition X

setState_phX

Modelica.Media.Air.MoistAir

Return thermodynamic state as function of pressure p, specific enthalpy h and composition X

setState_pTX

Modelica.Media.Air.MoistAir

Return thermodynamic state as function of pressure p, temperature T and composition X

air_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial

Calculate property record for dynamic simulation properties using p and T as dynamic states

air_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial

Calculate property record for dynamic simulation properties using d and T as dynamic states

air_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial

Calculate the property record for dynamic simulation properties using p,h as states

isentropicExponent_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of density and temperature

isentropicExponent_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of density and temperature

velocityOfSound_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Speed of sound as function of density and temperature

velocityOfSound_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Speed of sound as function of density and temperature

kappa_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of density and temperature

kappa_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of density and temperature

beta_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of density and temperature

beta_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of density and temperature

cp_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of density and temperature

cp_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of density and temperature

cv_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of density and temperature

cv_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of density and temperature

s_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of density and temperature

s_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific entropy as function of density and temperature

p_dT_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of p_dT

p_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Pressure as function of density and temperature

p_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Pressure as function of density and temperature

h_dT_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of h_dT

h_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function of density and temperature

h_props_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function of density and temperature

airBaseProp_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Intermediate property record for air (d and T preferred states)

isentropicExponent_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of pressure and temperature

isentropicExponent_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of pressure and temperature

velocityOfSound_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Speed of sound as function of pressure and temperature

velocityOfSound_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Speed of sound as function of pressure and temperature

kappa_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of pressure and temperature

kappa_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of pressure and temperature

beta_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of pressure and temperature

beta_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of pressure and temperature

cp_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of pressure and temperature

cp_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of pressure and temperature

cv_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of pressure and temperature

cv_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of pressure and temperature

s_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of pressure and temperature

s_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific entropy as function of pressure and temperature

h_pT_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of h_pT

h_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function or pressure and temperature

h_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function or pressure and temperature

rho_pT_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of rho_pT

rho_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function or pressure and temperature

rho_props_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function or pressure and temperature

airBaseProp_pT

Modelica.Media.Air.ReferenceAir.Air_Utilities

Intermediate property record for air (p and T preferred states)

ddhp

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density derivative by specific enthalpy

ddhp_props

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density derivative by specific enthalpy

ddph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density derivative by pressure

ddph_props

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density derivative by pressure

isentropicExponent_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of pressure and specific enthalpy

isentropicExponent_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isentropic exponent as function of pressure and specific enthalpy

velocityOfSound_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

velocityOfSound_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Speed of sound as function of pressure and specific enthalpy

kappa_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of pressure and specific enthalpy

kappa_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isothermal compressibility factor as function of pressure and specific enthalpy

beta_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of pressure and specific enthalpy

beta_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Isobaric expansion coefficient as function of pressure and specific enthalpy

cp_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of pressure and specific enthalpy

cp_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant pressure as function of pressure and specific enthalpy

cv_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of pressure and specific enthalpy

cv_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific heat capacity at constant volume as function of pressure and specific enthalpy

s_ph_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific entropy as function of pressure and specific enthalpy

s_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific entropy as function of pressure and specific enthalpy

s_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific entropy as function of pressure and specific enthalpy

T_ph_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of T_ph

T_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of pressure and specific enthalpy

T_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of pressure and specific enthalpy

rho_ph_der

Modelica.Media.Air.ReferenceAir.Air_Utilities

Derivative function of rho_ph

rho_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function of pressure and specific enthalpy

rho_props_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function of pressure and specific enthalpy

airBaseProp_ph

Modelica.Media.Air.ReferenceAir.Air_Utilities

Intermediate property record for air

h_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function or pressure and temperature

h_props_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Specific enthalpy as function or pressure and temperature

T_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of pressure and specific entropy

T_props_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Temperature as function of pressure and specific entropy

rho_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function of pressure and specific entropy

rho_props_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Density as function of pressure and specific entropy

airBaseProp_ps

Modelica.Media.Air.ReferenceAir.Air_Utilities

Intermediate property record for air

lambda_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities.Transport

Return thermal conductivity as a function of d and T

eta_dT

Modelica.Media.Air.ReferenceAir.Air_Utilities.Transport

Return dynamic viscosity as a function of d and T

dTofps

Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses

Return d and T as a function of p and s

dTofph

Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses

Return d and T as a function of p and h

dofpT

Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses

Compute d for given p and T

Helmholtz

Modelica.Media.Air.ReferenceAir.Air_Utilities.Basic

Helmholtz equation of state

density_pT

Modelica.Media.Air.ReferenceAir.Air_Base

Computes density as a function of pressure and temperature

specificEnthalpy_ps

Modelica.Media.Air.ReferenceAir.Air_Base

Computes specific enthalpy as a function of pressure and temperature

specificEnthalpy_pT

Modelica.Media.Air.ReferenceAir.Air_Base

Computes specific enthalpy as a function of pressure and temperature

specificEnthalpy_dT

Modelica.Media.Air.ReferenceAir.Air_Base

Computes specific enthalpy as a function of density and temperature

pressure_dT

Modelica.Media.Air.ReferenceAir.Air_Base

Computes pressure as a function of density and temperature

density_ps

Modelica.Media.Air.ReferenceAir.Air_Base

Computes density as a function of pressure and specific enthalpy

temperature_ps

Modelica.Media.Air.ReferenceAir.Air_Base

Compute temperature from pressure and specific enthalpy

temperature_ph

Modelica.Media.Air.ReferenceAir.Air_Base

Computes temperature as a function of pressure and specific enthalpy

density_ph

Modelica.Media.Air.ReferenceAir.Air_Base

Computes density as a function of pressure and specific enthalpy

thermalConductivity

Modelica.Media.Air.DryAirNasa

Return thermal conductivity of dry air (simple polynomial, moisture influence small, valid from 123.15 K to 1273.15 K, outside of this range linear extrapolation is used)

dynamicViscosity

Modelica.Media.Air.DryAirNasa

Return dynamic viscosity of dry air (simple polynomial, moisture influence small, valid from 123.15 K to 1273.15 K, outside of this range linear extrapolation is used)

Gibbs2_ps

Modelica.Media.Common

Function to calculate analytic derivatives for computing d and t given p and s

Gibbs2_dT

Modelica.Media.Common

Function to calculate analytic derivatives for computing p given d and T

Gibbs2_ph

Modelica.Media.Common

Function to calculate analytic derivatives for computing T given p and h

smoothStep

Modelica.Media.Common

Approximation of a general step, such that the characteristic is continuous and differentiable

Helmholtz_ps

Modelica.Media.Common

Function to calculate analytic derivatives for computing d and t given p and s

Helmholtz_pT

Modelica.Media.Common

Function to calculate analytic derivatives for computing d and t given p and t

Helmholtz_ph

Modelica.Media.Common

Function to calculate analytic derivatives for computing d and t given p and h

helmholtzToExtraDerivs

Modelica.Media.Common

Compute additional thermodynamic derivatives from dimensionless Helmholtz function

gibbsToExtraDerivs

Modelica.Media.Common

Compute additional thermodynamic derivatives from dimensionless Gibbs function

cvdpT2Phase

Modelica.Media.Common

Compute isochoric specific heat capacity inside the two-phase region and derivative of pressure w.r.t. temperature

cv2Phase

Modelica.Media.Common

Compute isochoric specific heat capacity inside the two-phase region

helmholtzToBoundaryProps

Modelica.Media.Common

Calculate phase boundary property record from dimensionless Helmholtz function

gibbsToBoundaryProps

Modelica.Media.Common

Calculate phase boundary property record from dimensionless Gibbs function

helmholtzToBridgmansTables

Modelica.Media.Common

Calculates base coefficients for Bridgmans tables from Helmholtz energy

gibbsToBridgmansTables

Modelica.Media.Common

Calculates base coefficients for Bridgman's tables from gibbs enthalpy

TwoPhaseToProps_dT

Modelica.Media.Common.ThermoFluidSpecial

Compute property record for density and temperature as states from saturation properties

TwoPhaseToProps_ph

Modelica.Media.Common.ThermoFluidSpecial

Compute property record for pressure and specific enthalpy as states from saturation properties

helmholtzToProps_dT

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for density and temperature as states from dimensionless Helmholtz function

helmholtzToProps_pT

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for pressure and temperature as states from dimensionless Helmholtz function

helmholtzToProps_ph

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for pressure and specific enthalpy as states from dimensionless Helmholtz function

gibbsToProps_pT

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for pressure and temperature as states from dimensionless Gibbs function

gibbsToProps_dT

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for density and temperature as states from dimensionless Gibbs function

gibbsToBoundaryProps

Modelica.Media.Common.ThermoFluidSpecial

Calculate phase boundary property record from dimensionless Gibbs function

gibbsToProps_ph

Modelica.Media.Common.ThermoFluidSpecial

Calculate property record for pressure and specific enthalpy as states from dimensionless Gibbs function

density_phX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return density from p, h, and X or Xi

temperature_phX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return temperature from p, h, and X or Xi

specificEnthalpy_pTX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

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

setState_dTX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return thermodynamic state from d, T, and X or Xi

setState_psX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return thermodynamic state from p, s, and X or Xi

setState_phX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return thermodynamic state from p, h, and X or Xi

setState_pTX

Modelica.Media.Interfaces.PartialSimpleIdealGasMedium

Return thermodynamic state from p, T, and X or Xi

density_phX

Modelica.Media.Interfaces.PartialSimpleMedium

Return density from p, h, and X or Xi

temperature_phX

Modelica.Media.Interfaces.PartialSimpleMedium

Return temperature from p, h, and X or Xi

specificEnthalpy_pTX

Modelica.Media.Interfaces.PartialSimpleMedium

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

setState_dTX

Modelica.Media.Interfaces.PartialSimpleMedium

Return thermodynamic state from d, T, and X or Xi

setState_psX

Modelica.Media.Interfaces.PartialSimpleMedium

Return thermodynamic state from p, s, and X or Xi

setState_phX

Modelica.Media.Interfaces.PartialSimpleMedium

Return thermodynamic state from p, h, and X or Xi

setState_pTX

Modelica.Media.Interfaces.PartialSimpleMedium

Return thermodynamic state from p, T, and X or Xi

density_pT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return density from p and T

specificEnthalpy_pT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return specific enthalpy from p and T

density_ps

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return density from p and s

temperature_ps

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return temperature from p and s

specificEnthalpy_ps

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return specific enthalpy from p and s

specificEnthalpy_dT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return specific enthalpy from d and T

pressure_dT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return pressure from d and T

temperature_ph

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return temperature from p and h

density_ph

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return density from p and h

vapourQuality

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return vapour quality

setState_Tx

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from temperature and vapour quality

setState_px

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from pressure and vapour quality

setState_dT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from d and T

setState_ps

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from p and s

setState_ph

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from p and h

setState_pT

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return thermodynamic state from p and T

specificEnthalpy_psX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

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

density_psX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return density from p, s, and X or Xi

temperature_psX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return temperature from p, s, and X or Xi

density_phX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return density from p, h, and X or Xi

temperature_phX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return temperature from p, h, and X or Xi

specificEnthalpy_pTX

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return specific enthalpy from pressure, temperature and mass fraction

dDewEnthalpy_dPressure

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return dew point specific enthalpy derivative

dBubbleEnthalpy_dPressure

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return bubble point specific enthalpy derivative

dDewDensity_dPressure

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return dew point density derivative

dBubbleDensity_dPressure

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return bubble point density derivative

surfaceTension

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return surface tension sigma in the two phase region

saturationTemperature_derp_sat

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return derivative of saturation temperature w.r.t. pressure

saturationTemperature_derp

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return derivative of saturation temperature w.r.t. pressure

saturationTemperature_sat

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation temperature

saturationPressure_sat

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation pressure

saturationTemperature

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation temperature

saturationPressure

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation pressure

dewDensity

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return dew point density

bubbleDensity

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return bubble point density

dewEntropy

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return dew point specific entropy

bubbleEntropy

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return bubble point specific entropy

dewEnthalpy

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return dew point specific enthalpy

bubbleEnthalpy

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return bubble point specific enthalpy

setSat_p

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation property record from pressure

setSat_T

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return saturation property record from temperature

setBubbleState

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return the thermodynamic state on the bubble line

setDewState

Modelica.Media.Interfaces.PartialTwoPhaseMedium

Return the thermodynamic state on the dew line

specificEntropy_phX

Modelica.Media.Interfaces.PartialRealCondensingGases

Return specific entropy as a function of pressure, specific enthalpy and mass fractions

enthalpyOfNonCondensingGas

Modelica.Media.Interfaces.PartialRealCondensingGases

Return enthalpy of the non-condensing species

enthalpyOfCondensingGas

Modelica.Media.Interfaces.PartialRealCondensingGases

Return enthalpy of condensing gas (most often steam)

enthalpyOfGas

Modelica.Media.Interfaces.PartialRealCondensingGases

Return enthalpy of non-condensing gas mixture

enthalpyOfLiquid

Modelica.Media.Interfaces.PartialRealCondensingGases

Return liquid enthalpy of condensing fluid

enthalpyOfVaporization

Modelica.Media.Interfaces.PartialRealCondensingGases

Return vaporization enthalpy of condensing fluid

relativeHumidity

Modelica.Media.Interfaces.PartialRealCondensingGases

Return relative humidity

massFraction_pTphi

Modelica.Media.Interfaces.PartialRealCondensingGases

Return mass fractions as a function of pressure, temperature and relative humidity

massFractionSaturation

Modelica.Media.Interfaces.PartialRealCondensingGases

Return saturation mass fractions

saturationTemperature

Modelica.Media.Interfaces.PartialRealCondensingGases

Return saturation temperature of condensing fluid

saturationPressure

Modelica.Media.Interfaces.PartialRealCondensingGases

Return saturation pressure of condensing fluid

enthalpyOfNonCondensingGas

Modelica.Media.Interfaces.PartialCondensingGases

Return enthalpy of the non-condensing species

enthalpyOfCondensingGas

Modelica.Media.Interfaces.PartialCondensingGases

Return enthalpy of condensing gas (most often steam)

enthalpyOfGas

Modelica.Media.Interfaces.PartialCondensingGases

Return enthalpy of non-condensing gas mixture

enthalpyOfLiquid

Modelica.Media.Interfaces.PartialCondensingGases

Return liquid enthalpy of condensing fluid

enthalpyOfVaporization

Modelica.Media.Interfaces.PartialCondensingGases

Return vaporization enthalpy of condensing fluid

saturationPressure

Modelica.Media.Interfaces.PartialCondensingGases

Return saturation pressure of condensing fluid

massToMoleFractions

Modelica.Media.Interfaces.PartialMixtureMedium

Return mole fractions from mass fractions X

moleToMassFractions

Modelica.Media.Interfaces.PartialMixtureMedium

Return mass fractions X from mole fractions

gasConstant

Modelica.Media.Interfaces.PartialMixtureMedium

Return the gas constant of the mixture (also for liquids)

T_ps

Modelica.Media.Interfaces.PartialLinearFluid

Return temperature from pressure and specific entropy

T_ph

Modelica.Media.Interfaces.PartialLinearFluid

Return temperature from pressure and specific enthalpy

density_pT

Modelica.Media.Interfaces.PartialPureSubstance

Return density from p and T

specificEnthalpy_pT

Modelica.Media.Interfaces.PartialPureSubstance

Return specific enthalpy from p and T

density_ps

Modelica.Media.Interfaces.PartialPureSubstance

Return density from p and s

temperature_ps

Modelica.Media.Interfaces.PartialPureSubstance

Return temperature from p and s

specificEnthalpy_ps

Modelica.Media.Interfaces.PartialPureSubstance

Return specific enthalpy from p and s

specificEnthalpy_dT

Modelica.Media.Interfaces.PartialPureSubstance

Return specific enthalpy from d and T

pressure_dT

Modelica.Media.Interfaces.PartialPureSubstance

Return pressure from d and T

temperature_ph

Modelica.Media.Interfaces.PartialPureSubstance

Return temperature from p and h

density_ph

Modelica.Media.Interfaces.PartialPureSubstance

Return density from p and h

setState_dT

Modelica.Media.Interfaces.PartialPureSubstance

Return thermodynamic state from d and T

setState_ps

Modelica.Media.Interfaces.PartialPureSubstance

Return thermodynamic state from p and s

setState_ph

Modelica.Media.Interfaces.PartialPureSubstance

Return thermodynamic state from p and h

setState_pT

Modelica.Media.Interfaces.PartialPureSubstance

Return thermodynamic state from p and T

specificEnthalpy_psX

Modelica.Media.Interfaces.PartialMedium

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

density_psX

Modelica.Media.Interfaces.PartialMedium

Return density from p, s, and X or Xi

temperature_psX

Modelica.Media.Interfaces.PartialMedium

Return temperature from p,s, and X or Xi

density_phX

Modelica.Media.Interfaces.PartialMedium

Return density from p, h, and X or Xi

temperature_phX

Modelica.Media.Interfaces.PartialMedium

Return temperature from p, h, and X or Xi

density_pTX

Modelica.Media.Interfaces.PartialMedium

Return density from p, T, and X or Xi

specificEntropy_pTX

Modelica.Media.Interfaces.PartialMedium

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

specificEnthalpy_pTX

Modelica.Media.Interfaces.PartialMedium

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

molarMass

Modelica.Media.Interfaces.PartialMedium

Return the molar mass of the medium

density_derX

Modelica.Media.Interfaces.PartialMedium

Return density derivative w.r.t. mass fraction

density_derT_p

Modelica.Media.Interfaces.PartialMedium

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

density_derp_T

Modelica.Media.Interfaces.PartialMedium

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

density_derh_p

Modelica.Media.Interfaces.PartialMedium

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

density_derp_h

Modelica.Media.Interfaces.PartialMedium

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

isothermalCompressibility

Modelica.Media.Interfaces.PartialMedium

Return overall the isothermal compressibility factor

isobaricExpansionCoefficient

Modelica.Media.Interfaces.PartialMedium

Return overall the isobaric expansion coefficient beta

velocityOfSound

Modelica.Media.Interfaces.PartialMedium

Return velocity of sound

isentropicEnthalpy

Modelica.Media.Interfaces.PartialMedium

Return isentropic enthalpy

isentropicExponent

Modelica.Media.Interfaces.PartialMedium

Return isentropic exponent

specificHeatCapacityCv

Modelica.Media.Interfaces.PartialMedium

Return specific heat capacity at constant volume

specificHeatCapacityCp

Modelica.Media.Interfaces.PartialMedium

Return specific heat capacity at constant pressure

specificHelmholtzEnergy

Modelica.Media.Interfaces.PartialMedium

Return specific Helmholtz energy

specificGibbsEnergy

Modelica.Media.Interfaces.PartialMedium

Return specific Gibbs energy

specificEntropy

Modelica.Media.Interfaces.PartialMedium

Return specific entropy

specificInternalEnergy

Modelica.Media.Interfaces.PartialMedium

Return specific internal energy

specificEnthalpy

Modelica.Media.Interfaces.PartialMedium

Return specific enthalpy

density

Modelica.Media.Interfaces.PartialMedium

Return density

temperature

Modelica.Media.Interfaces.PartialMedium

Return temperature

pressure

Modelica.Media.Interfaces.PartialMedium

Return pressure

prandtlNumber

Modelica.Media.Interfaces.PartialMedium

Return the Prandtl number

thermalConductivity

Modelica.Media.Interfaces.PartialMedium

Return thermal conductivity

dynamicViscosity

Modelica.Media.Interfaces.PartialMedium

Return dynamic viscosity

setSmoothState

Modelica.Media.Interfaces.PartialMedium

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

setState_dTX

Modelica.Media.Interfaces.PartialMedium

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

setState_psX

Modelica.Media.Interfaces.PartialMedium

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

setState_phX

Modelica.Media.Interfaces.PartialMedium

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

setState_pTX

Modelica.Media.Interfaces.PartialMedium

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

cubicHermite_withDerivative

Modelica.Fluid.Utilities

Evaluate a cubic Hermite spline, return value and derivative

cubicHermite

Modelica.Fluid.Utilities

Evaluate a cubic Hermite spline

regFun3

Modelica.Fluid.Utilities

Co-monotonic and C1 smooth regularization function

evaluatePoly3_derivativeAtZero

Modelica.Fluid.Utilities

Evaluate polynomial of order 3 that passes the origin with a predefined derivative

regStep

Modelica.Fluid.Utilities

Approximation of a general step, such that the characteristic is continuous and differentiable

regSquare2

Modelica.Fluid.Utilities

Anti-symmetric approximation of square with discontinuous factor so that the first derivative is non-zero and is continuous

regRoot2

Modelica.Fluid.Utilities

Anti-symmetric approximation of square root with discontinuous factor so that the first derivative is finite and continuous

regPow

Modelica.Fluid.Utilities

Anti-symmetric power approximation with non-zero derivative in the origin

regSquare

Modelica.Fluid.Utilities

Anti-symmetric square approximation with non-zero derivative in the origin

regRoot_der

Modelica.Fluid.Utilities

Derivative of regRoot

regRoot

Modelica.Fluid.Utilities

Anti-symmetric square root approximation with finite derivative in the origin

checkBoundary

Modelica.Fluid.Utilities

Check whether boundary definition is correct

Stepsmoother_der

Modelica.Fluid.Dissipation.Utilities.Functions.General

Derivative of function Stepsmoother

Stepsmoother

Modelica.Fluid.Dissipation.Utilities.Functions.General

Continuous interpolation for x

SmoothPower_der

Modelica.Fluid.Dissipation.Utilities.Functions.General

The derivative of function SmoothPower

SmoothPower

Modelica.Fluid.Dissipation.Utilities.Functions.General

Limiting the derivative of function y = if x>=0 then x^pow else -(-x)^pow

ReynoldsNumber

Modelica.Fluid.Dissipation.Utilities.Functions.General

Calculation of Reynolds number

PrandtlNumber

Modelica.Fluid.Dissipation.Utilities.Functions.General

Calculation of Prandtl number

LambertWIter

Modelica.Fluid.Dissipation.Utilities.Functions.General

Iterative form of Lambert's w function for solving f(x) = x exp(x) for x

LambertW

Modelica.Fluid.Dissipation.Utilities.Functions.General

Closed approximation of Lambert's w function for solving f(x) = x exp(x) for x

CubicInterpolation_lambda

Modelica.Fluid.Dissipation.Utilities.Functions.General

Cubic Hermite spline interpolation of the modified friction coefficient in transition regime of the Moody diagram (direct formulation)

CubicInterpolation_Re

Modelica.Fluid.Dissipation.Utilities.Functions.General

Cubic Hermite spline interpolation of the Reynolds number in transition regime of the Moody diagram (inverse formulation)

kc_twoPhase_boilingHorizontal_KC

Modelica.Fluid.Dissipation.Utilities.Functions.HeatTransfer.TwoPhase

Local two phase heat transfer coefficient of straight pipe | horizontal boiling

kc_twoPhase_boilingVertical_KC

Modelica.Fluid.Dissipation.Utilities.Functions.HeatTransfer.TwoPhase

Local two phase heat transfer coefficient of straight pipe | vertical boiling

kc_twoPhase_condensationHorizontal_KC

Modelica.Fluid.Dissipation.Utilities.Functions.HeatTransfer.TwoPhase

Local two phase heat transfer coefficient of straight pipe | horizontal condensation

SlipRatio

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Calculation of (analytical/empirical) slip ratio

VoidFraction

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Calculation of (cross sectional) void fraction for two phase flow

TwoPhaseDensity

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Calculation of mean density for two phase flow

TwoPhaseMultiplierChisholm

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Calculation of two phase multiplier according to Chisholm | constant mass flow rate quality

TwoPhaseMultiplierFriedel

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Calculation of two phase multiplier according to Friedel | constant mass flow rate quality | horizontal flow | vertical upflow and downflow

dp_twoPhaseMomentum_DP

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Momentum pressure loss of straight pipe for two phase flow | calculate pressure loss

dp_twoPhaseGeodetic_DP

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Geodetic pressure loss of straight pipe for two phase flow | calculate pressure loss

dp_twoPhaseFriedel_DP

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Frictional pressure loss of straight pipe for two phase flow according to Friedel correlation | calculate pressure loss| overall flow regime

dp_twoPhaseChisholm_DP

Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase

Frictional pressure loss of straight pipe for two phase flow according to Chisholm correlation | calculate pressure loss | overall flow regime

dp_severalGeometryOverall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Valve

Pressure loss of valve | calculate mass flow rate | several geometries | overall flow regime

dp_severalGeometryOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.Valve

Pressure loss of valve | calculate pressure loss | several geometries | overall flow regime

dp_twoPhaseOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe for two phase flow | calculate (frictional, momentum, geodetic) pressure loss

dp_turbulent_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate mass flow rate | turbulent flow regime | surface roughness

dp_turbulent_DP

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate pressure loss | turbulent flow regime | surface roughness

dp_overall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate mass flow rate | overall flow regime | surface roughness

dp_overall_DP

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate pressure loss | overall flow regime | surface roughness

dp_laminar_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate mass flow rate | laminar flow regime (Hagen-Poiseuille)

dp_laminar_DP

Modelica.Fluid.Dissipation.PressureLoss.StraightPipe

Pressure loss of straight pipe | calculate pressure loss| laminar flow regime (Hagen-Poiseuille)

dp_thickEdgedOverall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Orifice

Pressure loss of thick and sharp edged orifice | calculate mass flow rate | overall flow regime | constant influence of friction | arbitrary cross sectional area

dp_thickEdgedOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.Orifice

Pressure loss of thick and sharp edged orifice | calculate pressure loss | overall flow regime | constant influence of friction | arbitrary cross sectional area

dp_suddenChange_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Orifice

Pressure loss of orifice with sudden change in cross sectional area | calculate mass flow rate | turbulent flow regime | smooth surface | arbitrary cross sectional area | without baffles | sharp edge

dp_suddenChange_DP

Modelica.Fluid.Dissipation.PressureLoss.Orifice

Pressure loss of orifice with sudden change in cross sectional area | calculate pressure loss | turbulent flow regime | smooth surface | arbitrary cross sectional area | without baffles | sharp edge

dp_volumeFlowRate_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate mass flow rate | quadratic function (dp=a*V_flow^2 + b*V_flow)

dp_volumeFlowRate_DP

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate pressure loss | quadratic function (dp=a*V_flow^2 + b*V_flow)

dp_pressureLossCoefficient_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate mass flow rate | pressure loss coefficient (zeta_TOT)

dp_pressureLossCoefficient_DP

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate pressure loss | pressure loss coefficient (zeta_TOT)

dp_nominalPressureLossLawDensity_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate mass flow rate | nominal operation point | pressure loss law (coefficient and exponent) | density dependence

dp_nominalPressureLossLawDensity_DP

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate pressure loss | nominal operation point | pressure loss law (coefficient and exponent) | density dependence

dp_nominalDensityViscosity_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate M_FLOW (compressible) | nominal operation point | pressure loss law (exponent) | density and dynamic viscosity dependence

dp_nominalDensityViscosity_DP

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate mass flow rate | nominal operation point | pressure loss law (exponent) | density and dynamic viscosity dependence

dp_idealGas_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate mass flow rate | ideal gas | mean density

dp_idealGas_DP

Modelica.Fluid.Dissipation.PressureLoss.General

Generic pressure loss | calculate pressure loss | ideal gas | mean density

dp_internalFlowOverall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Channel

Pressure loss of internal flow | calculate mass flow rate | overall flow regime | surface roughness | several geometries

dp_internalFlowOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.Channel

Pressure loss of internal flow | calculate pressure loss | overall flow regime | surface roughness | several geometries

dp_edgedOverall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Bend

Pressure loss of edged bend | calculate mass flow rate | overall flow regime | surface roughness

dp_edgedOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.Bend

Pressure loss of edged bend | calculate pressure loss | overall flow regime | surface roughness

dp_curvedOverall_MFLOW

Modelica.Fluid.Dissipation.PressureLoss.Bend

Pressure loss of curved bend | calculate mass flow rate | overall flow regime | surface roughness

dp_curvedOverall_DP

Modelica.Fluid.Dissipation.PressureLoss.Bend

Pressure loss of curved bend | calculate pressure loss | overall flow regime | surface roughness

kc_twoPhaseOverall_KC

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Local two phase heat transfer coefficient of straight pipe | horizontal or vertical boiling | horizontal condensation

kc_turbulent_KC

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | hydrodynamically developed turbulent flow regime | pressure loss dependence

kc_turbulent

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | hydrodynamically developed turbulent flow regime | pressure loss dependence

kc_overall_KC

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | uniform wall temperature or uniform heat flux | hydrodynamically developed or undeveloped overall flow regime| pressure loss dependence

kc_overall

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | uniform wall temperature or uniform heat flux | hydrodynamically developed or undeveloped overall flow regime| pressure loss dependence

kc_laminar_KC

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | uniform wall temperature or uniform heat flux | hydrodynamically developed or undeveloped laminar flow regime

kc_laminar

Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe

Mean heat transfer coefficient of straight pipe | uniform wall temperature or uniform heat flux | hydrodynamically developed or undeveloped laminar flow regime

kc_turbulent_KC

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of even plate | turbulent regime | constant wall temperature

kc_turbulent

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of even plate | turbulent regime | constant wall temperature

kc_overall_KC

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of even plate | overall regime | constant wall temperature

kc_overall

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of even plate | overall regime | constant wall temperature

kc_laminar_KC

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of plate | laminar regime

kc_laminar

Modelica.Fluid.Dissipation.HeatTransfer.Plate

Mean heat transfer coefficient of plate | laminar regime

kc_turbulent_KC

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | hydrodynamically developed turbulent flow regime

kc_turbulent

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | hydrodynamically developed turbulent flow regime

kc_overall_KC

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | overall flow regime

kc_overall

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | overall flow regime

kc_laminar_KC

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | hydrodynamically developed laminar flow regime

kc_laminar

Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe

Mean heat transfer coefficient of helical pipe | laminar flow regime

kc_roundTube_KC

Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger

kc_roundTube

Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger

kc_flatTube_KC

Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger

kc_flatTube

Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger

kc_approxForcedConvection_KC

Modelica.Fluid.Dissipation.HeatTransfer.General

Mean convective heat transfer coefficient for forced convection | approximation | turbulent regime | hydrodynamically developed fluid flow

kc_approxForcedConvection

Modelica.Fluid.Dissipation.HeatTransfer.General

Mean convective heat transfer coefficient for forced convection | approximation | turbulent regime | hydrodynamically developed fluid flow

kc_evenGapTurbulent_KC

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | turbulent flow regime | developed fluid flow | heat transfer at BOTH sides | identical and constant wall temperatures

kc_evenGapTurbulent

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | turbulent flow regime | developed fluid flow | heat transfer at BOTH sides | identical and constant wall temperatures

kc_evenGapOverall_KC

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | overall flow regime | considering boundary layer development | heat transfer at ONE or BOTH sides | identical and constant wall temperatures | surface roughness

kc_evenGapOverall

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | overall flow regime | considering boundary layer development | heat transfer at ONE or BOTH sides | identical and constant wall temperatures | surface roughness

kc_evenGapLaminar_KC

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | laminar flow regime | considering boundary layer development | heat transfer at ONE or BOTH sides | identical and constant wall temperatures

kc_evenGapLaminar

Modelica.Fluid.Dissipation.HeatTransfer.Channel

Mean heat transfer coefficient of even gap | laminar flow regime | considering boundary layer development | heat transfer at ONE or BOTH sides | identical and constant wall temperatures

pressureLoss

Modelica.Fluid.Fittings.BaseClasses.GenericResistances.VolumeFlowRate

Return pressure loss dp as function of mass flow rate m_flow for a curved bend

massFlowRate

Modelica.Fluid.Fittings.BaseClasses.GenericResistances.VolumeFlowRate

Return mass flow rate m_flow as function of pressure loss dp for a curved bend

pressureLoss

Modelica.Fluid.Fittings.BaseClasses.Orifices.ThickEdgedOrifice

Return pressure loss dp as function of mass flow rate m_flow for a thick edged orifice

massFlowRate

Modelica.Fluid.Fittings.BaseClasses.Orifices.ThickEdgedOrifice

Return mass flow rate m_flow as function of pressure loss dp for a thick edged orifice

pressureLoss

Modelica.Fluid.Fittings.BaseClasses.Bends.EdgedBend

Return pressure loss dp as function of mass flow rate m_flow for a curved bend

massFlowRate

Modelica.Fluid.Fittings.BaseClasses.Bends.EdgedBend

Return mass flow rate m_flow as function of pressure loss dp for a curved bend

pressureLoss

Modelica.Fluid.Fittings.BaseClasses.Bends.CurvedBend

Return pressure loss dp as function of mass flow rate m_flow for a curved bend

massFlowRate

Modelica.Fluid.Fittings.BaseClasses.Bends.CurvedBend

Return mass flow rate m_flow as function of pressure loss dp for a curved bend

pressureLoss_m_flow_totalPressure

Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent

Return pressure drop from constant loss factor and mass flow rate (dp = f(m_flow))

pressureLoss_m_flow_and_Re

Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent

Return pressure drop from constant loss factor, mass flow rate and Re (dp = f(m_flow))

pressureLoss_m_flow

Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent

Return pressure drop from constant loss factor and mass flow rate (dp = f(m_flow))

massFlowRate_dp_and_Re

Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent

Return mass flow rate from constant loss factor data, pressure drop and Re (m_flow = f(dp))

massFlowRate_dp

Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent

Return mass flow rate from constant loss factor data and pressure drop (m_flow = f(dp))

lossConstant_D_zeta

Modelica.Fluid.Fittings.BaseClasses

Return the loss constant 8*zeta/(pi^2*D^4)

positiveMax

Modelica.Fluid.Fittings.MultiPort

baseFun

Modelica.Fluid.Valves.BaseClasses.ValveCharacteristics

Base class for valve characteristics

assertPositiveDifference

Modelica.Fluid.Machines.BaseClasses.PumpMonitoring

baseEfficiency

Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics

Base class for efficiency characteristics

basePower

Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics

Base class for pump power consumption characteristics

baseFlow

Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics

Base class for pump flow characteristics

dp_fric_of_m_flow

Modelica.Fluid.Pipes.BaseClasses.WallFriction.Detailed.Internal

Calculate pressure drop due to friction as function of mass flow rate

m_flow_of_dp_fric

Modelica.Fluid.Pipes.BaseClasses.WallFriction.Detailed.Internal

Calculate mass flow rate as function of pressure drop due to friction

dp_fric_of_m_flow

Modelica.Fluid.Pipes.BaseClasses.WallFriction.LaminarAndQuadraticTurbulent.Internal

Calculate pressure drop due to friction as function of mass flow rate

m_flow_of_dp_fric

Modelica.Fluid.Pipes.BaseClasses.WallFriction.LaminarAndQuadraticTurbulent.Internal

Calculate mass flow rate as function of pressure drop due to friction

pressureLoss_m_flow_staticHead

Modelica.Fluid.Pipes.BaseClasses.WallFriction.PartialWallFriction

Return pressure loss dp as function of mass flow rate m_flow, i.e., dp = f(m_flow), due to wall friction and static head

pressureLoss_m_flow

Modelica.Fluid.Pipes.BaseClasses.WallFriction.PartialWallFriction

Return pressure loss dp as function of mass flow rate m_flow, i.e., dp = f(m_flow), due to wall friction

massFlowRate_dp_staticHead

Modelica.Fluid.Pipes.BaseClasses.WallFriction.PartialWallFriction

Return mass flow rate m_flow as function of pressure loss dp, i.e., m_flow = f(dp), due to wall friction and static head

massFlowRate_dp

Modelica.Fluid.Pipes.BaseClasses.WallFriction.PartialWallFriction

Return mass flow rate m_flow as function of pressure loss dp, i.e., m_flow = f(dp), due to wall friction

NusseltNumber

Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers

Return Nusselt number

ReynoldsNumber_m_flow

Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers

Return Reynolds number from m_flow, mu, D, A

ReynoldsNumber

Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers

Return Reynolds number from v, rho, mu, D

GenerateStribeckFrictionTable

Modelica.Mechanics.Translational.Examples.Utilities

Generate Stribeck friction table for example Friction for the SupportFriction

scalarToColor

Modelica.Mechanics.MultiBody.Visualizers.Colors

Map a scalar to a color using a color map

colorMapToSvg

Modelica.Mechanics.MultiBody.Visualizers.Colors

Save a color map on file in svg (scalable vector graphics) format

partialColorMap

Modelica.Mechanics.MultiBody.Interfaces

Interface for a function returning a color map

partialSurfaceCharacteristic

Modelica.Mechanics.MultiBody.Interfaces

Interface for a function returning surface characteristics

partialGravityAcceleration

Modelica.Mechanics.MultiBody.Interfaces

Interface for the gravity function used in the World object

resolveRelative_der

Modelica.Mechanics.MultiBody.Frames.Internal

Derivative of function Frames.resolveRelative(..)

resolve2_der

Modelica.Mechanics.MultiBody.Frames.Internal

Derivative of function Frames.resolve2(..)

resolve1_der

Modelica.Mechanics.MultiBody.Frames.Internal

Derivative of function Frames.resolve1(..)

maxWithoutEvent_dd

Modelica.Mechanics.MultiBody.Frames.Internal

First derivative of function maxWithoutEvent_d(..)

maxWithoutEvent_d

Modelica.Mechanics.MultiBody.Frames.Internal

First derivative of function maxWithoutEvent(..)

maxWithoutEvent

Modelica.Mechanics.MultiBody.Frames.Internal

Maximum of the input arguments, without event and function can be differentiated

to_exy

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Map rotation object into e_x and e_y vectors of frame 2, resolved in frame 1

to_vector

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Map rotation object into vector

to_Q

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return quaternion orientation object Q from orientation object T

to_T_inv

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return inverse transformation matrix T_inv from orientation object R

to_T

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return transformation matrix T from orientation object R

from_Q

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object T from quaternion orientation object Q

from_T_inv

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object R from inverse transformation matrix T_inv

from_T

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object R from transformation matrix T

from_nxz

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object from n_x and n_z vectors

from_nxy

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object from n_x and n_y vectors

smallRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return rotation angles valid for a small rotation and optionally residues that should be zero

axesRotationsAngles

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return the 3 angles to rotate in sequence around 3 axes to construct the given orientation object

axesRotations

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return rotation object to rotate in sequence around 3 axes

axisRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return rotation object to rotate around one frame axis

planarRotationAngle

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return angle of a planar rotation, given the rotation axis and the representations of a vector in frame 1 and frame 2

planarRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object of a planar rotation

absoluteRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return absolute orientation object from another absolute and a relative orientation object

relativeRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return relative orientation object

inverseRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return inverse orientation object

nullRotation

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return orientation object that does not rotate a frame

resolveDyade2

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform second order tensor from frame 1 to frame 2

resolveDyade1

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform second order tensor from frame 2 to frame 1

multipleResolve2

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform several vectors from frame 1 to frame 2

multipleResolve1

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform several vectors from frame 2 to frame 1

resolve2

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform vector from frame 1 to frame 2

resolve1

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Transform vector from frame 2 to frame 1

angularVelocity2

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return angular velocity resolved in frame 2 from orientation object and its derivative

angularVelocity1

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return angular velocity resolved in frame 1 from orientation object and its derivative

orientationConstraint

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices

Return residues of orientation constraints (shall be zero)

equalityConstraint

Modelica.Mechanics.MultiBody.Frames.TransformationMatrices.Orientation

Return the constraint residues to express that two frames have the same orientation

to_T_inv

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return inverse transformation matrix T_inv from quaternion orientation object Q

to_T

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return transformation matrix T from quaternion orientation object Q

from_T_inv

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return quaternion orientation object Q from inverse transformation matrix T_inv

from_T

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return quaternion orientation object Q from transformation matrix T

smallRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return rotation angles valid for a small rotation

planarRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return quaternion orientation object of a planar rotation

absoluteRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return absolute quaternions orientation object from another absolute and a relative quaternions orientation object

relativeRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return relative quaternions orientation object

inverseRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return inverse quaternions orientation object

nullRotation

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return quaternion orientation object that does not rotate a frame

multipleResolve2

Modelica.Mechanics.MultiBody.Frames.Quaternions

Transform several vectors from frame 1 to frame 2

multipleResolve1

Modelica.Mechanics.MultiBody.Frames.Quaternions

Transform several vectors from frame 2 to frame 1

resolve2

Modelica.Mechanics.MultiBody.Frames.Quaternions

Transform vector from frame 1 to frame 2

resolve1

Modelica.Mechanics.MultiBody.Frames.Quaternions

Transform vector from frame 2 to frame 1

angularVelocity2

Modelica.Mechanics.MultiBody.Frames.Quaternions

Compute angular velocity resolved in frame 2 from quaternions orientation object and its derivative

angularVelocity1

Modelica.Mechanics.MultiBody.Frames.Quaternions

Compute angular velocity resolved in frame 1 from quaternions orientation object and its derivative

orientationConstraint

Modelica.Mechanics.MultiBody.Frames.Quaternions

Return residues of orientation constraints (shall be zero)

equalityConstraint

Modelica.Mechanics.MultiBody.Frames.Quaternions.Orientation

Return the constraint residues to express that two frames have the same quaternion orientation

axis

Modelica.Mechanics.MultiBody.Frames

Return unit vector for x-, y-, or z-axis

to_exy

Modelica.Mechanics.MultiBody.Frames

Map rotation object into e_x and e_y vectors of frame 2, resolved in frame 1

to_vector

Modelica.Mechanics.MultiBody.Frames

Map rotation object into vector

to_Q

Modelica.Mechanics.MultiBody.Frames

Return quaternion orientation object Q from orientation object R

to_T_inv

Modelica.Mechanics.MultiBody.Frames

Return inverse transformation matrix T_inv from orientation object R

to_T

Modelica.Mechanics.MultiBody.Frames

Return transformation matrix T from orientation object R

from_Q

Modelica.Mechanics.MultiBody.Frames

Return orientation object R from quaternion orientation object Q

from_T_inv

Modelica.Mechanics.MultiBody.Frames

Return orientation object R from inverse transformation matrix T_inv

from_T2

Modelica.Mechanics.MultiBody.Frames

Return orientation object R from transformation matrix T and its derivative der(T)

from_T

Modelica.Mechanics.MultiBody.Frames

Return orientation object R from transformation matrix T

from_nxz

Modelica.Mechanics.MultiBody.Frames

Return fixed orientation object from n_x and n_z vectors

from_nxy

Modelica.Mechanics.MultiBody.Frames

Return fixed orientation object from n_x and n_y vectors

smallRotation

Modelica.Mechanics.MultiBody.Frames

Return rotation angles valid for a small rotation and optionally residues that should be zero

axesRotationsAngles

Modelica.Mechanics.MultiBody.Frames

Return the 3 angles to rotate in sequence around 3 axes to construct the given orientation object

axesRotations

Modelica.Mechanics.MultiBody.Frames

Return fixed rotation object to rotate in sequence around fixed angles along 3 axes

axisRotation

Modelica.Mechanics.MultiBody.Frames

Return rotation object to rotate around an angle along one frame axis

planarRotationAngle

Modelica.Mechanics.MultiBody.Frames

Return angle of a planar rotation, given the rotation axis and the representations of a vector in frame 1 and frame 2

planarRotation

Modelica.Mechanics.MultiBody.Frames

Return orientation object of a planar rotation

absoluteRotation

Modelica.Mechanics.MultiBody.Frames

Return absolute orientation object from another absolute and a relative orientation object

relativeRotation

Modelica.Mechanics.MultiBody.Frames

Return relative orientation object

inverseRotation

Modelica.Mechanics.MultiBody.Frames

Return inverse orientation object

nullRotation

Modelica.Mechanics.MultiBody.Frames

Return orientation object that does not rotate a frame

resolveDyade2

Modelica.Mechanics.MultiBody.Frames

Transform second order tensor from frame 1 to frame 2

resolveDyade1

Modelica.Mechanics.MultiBody.Frames

Transform second order tensor from frame 2 to frame 1

resolveRelative

Modelica.Mechanics.MultiBody.Frames

Transform vector from frame 1 to frame 2 using absolute orientation objects of frame 1 and of frame 2

resolve2

Modelica.Mechanics.MultiBody.Frames

Transform vector from frame 1 to frame 2

resolve1

Modelica.Mechanics.MultiBody.Frames

Transform vector from frame 2 to frame 1

angularVelocity2

Modelica.Mechanics.MultiBody.Frames

Return angular velocity resolved in frame 2 from orientation object

angularVelocity1

Modelica.Mechanics.MultiBody.Frames

Return angular velocity resolved in frame 1 from orientation object

orientationConstraint

Modelica.Mechanics.MultiBody.Frames

Return residues of orientation constraints (shall be zero)

equalityConstraint

Modelica.Mechanics.MultiBody.Frames.Orientation

Return the constraint residues to express that two frames have the same orientation

standardGravityAcceleration

Modelica.Mechanics.MultiBody.Forces.Internal

Standard gravity fields (no/parallel/point field)

initPreisach

Modelica.Magnetic.FluxTubes.Utilities

Function used for the initialization of the Preisach hysteresis model GenericHystPreisachEverett

everett

Modelica.Magnetic.FluxTubes.Utilities

Everett function, see [YUY89]

mu_rApprox

Modelica.Magnetic.FluxTubes.Material.SoftMagnetic

Approximation of relative permeability mu_r as a function of flux density B for soft magnetic materials

activePower

Modelica.Electrical.QuasiStatic.Polyphase.Functions

Calculate active power of complex input voltage and current

quasiRMS

Modelica.Electrical.QuasiStatic.Polyphase.Functions

Overall quasi-RMS value of complex input (current or voltage)

indexNonPositiveSequence

Modelica.Electrical.Polyphase.Functions

Determines the indices of all non positive sequences

indexPositiveSequence

Modelica.Electrical.Polyphase.Functions

Determines the indices of all positive sequences

factorY2DC

Modelica.Electrical.Polyphase.Functions

Calculates factor of DC-voltage from RMS Y-voltage

factorY2D

Modelica.Electrical.Polyphase.Functions

Calculates factor Y voltage to polygon (delta) voltage

numberOfSymmetricBaseSystems

Modelica.Electrical.Polyphase.Functions

Determines the number of symmetric base systems of m phase symmetric system

symmetricBackTransformationMatrix

Modelica.Electrical.Polyphase.Functions

Back transformation matrix for symmetrical components

symmetricTransformationMatrix

Modelica.Electrical.Polyphase.Functions

Transformation matrix for symmetrical components

symmetricOrientationMatrix

Modelica.Electrical.Polyphase.Functions

Matrix symmetric orientation angles for creating the symmetric transformation matrix

symmetricOrientation

Modelica.Electrical.Polyphase.Functions

Orientations of the resulting fundamental wave field phasors

activePower

Modelica.Electrical.Polyphase.Functions

Calculate active power of voltage and current input

quasiRMS

Modelica.Electrical.Polyphase.Functions

Calculate continuous quasi RMS value of input

linearTemperatureDependency

Modelica.Electrical.Machines.Thermal

Converts a value (e.g. resistance) from reference temperature to an actual temperature

convertResistance

Modelica.Electrical.Machines.Thermal

Converts resistance from reference temperature to an actual temperature

convertAlpha

Modelica.Electrical.Machines.Thermal

Converts alpha from temperature 1 (default 20 degC) to temperature 2

brushVoltageDrop

Modelica.Electrical.Machines.Losses.DCMachines

Voltage drop of carbon brushes

activePower

Modelica.Electrical.Machines.SpacePhasors.Functions

Calculate active power of voltage and current input

quasiRMS

Modelica.Electrical.Machines.SpacePhasors.Functions

Calculate quasi-RMS value of input

FromPolar

Modelica.Electrical.Machines.SpacePhasors.Functions

Converts a space phasor from polar coordinates

ToPolar

Modelica.Electrical.Machines.SpacePhasors.Functions

Converts a space phasor to polar coordinates

Rotator

Modelica.Electrical.Machines.SpacePhasors.Functions

Rotates space phasor

FromSpacePhasor

Modelica.Electrical.Machines.SpacePhasors.Functions

Conversion from space phasor and zero sequence component to polyphase

ToSpacePhasor

Modelica.Electrical.Machines.SpacePhasors.Functions

Conversion from polyphase input to space phasor and zero sequence component

getMemory

Modelica.Electrical.Digital.Interfaces.MemoryBase

Get Memory

FCNq_sum_limit

Modelica.Electrical.Analog.Basic.OpAmpDetailed

Internal limitation function

FCNiout_limit

Modelica.Electrical.Analog.Basic.OpAmpDetailed

Internal limitation function

random

Modelica.Clocked.RealSignals.Sampler.Utilities.Internal

Pseudo random number generator

destructor

Modelica.Blocks.Types.ExternalCombiTable2D

Terminate 2-dim. table defined by matrix

constructor

Modelica.Blocks.Types.ExternalCombiTable2D

Initialize 2-dim. table defined by matrix

destructor

Modelica.Blocks.Types.ExternalCombiTable1D

Terminate 1-dim. table defined by matrix

constructor

Modelica.Blocks.Types.ExternalCombiTable1D

Initialize 1-dim. table defined by matrix

destructor

Modelica.Blocks.Types.ExternalCombiTimeTable

Terminate 1-dim. table where first column is time

constructor

Modelica.Blocks.Types.ExternalCombiTimeTable

Initialize 1-dim. table where first column is time

getTable2DAbscissaUmax

Modelica.Blocks.Tables.Internal

Return maximum abscissa value of 2-dim. table defined by matrix

getTable2DAbscissaUmin

Modelica.Blocks.Tables.Internal

Return minimum abscissa value of 2-dim. table defined by matrix

getDer2Table2DValue

Modelica.Blocks.Tables.Internal

Second derivative of interpolated 2-dim. table defined by matrix

getDerTable2DValueNoDer

Modelica.Blocks.Tables.Internal

Derivative of interpolated 2-dim. table defined by matrix (but do not provide a second derivative function)

getDerTable2DValue

Modelica.Blocks.Tables.Internal

Derivative of interpolated 2-dim. table defined by matrix

getTable2DValueNoDer2

Modelica.Blocks.Tables.Internal

Interpolate 2-dim. table defined by matrix (but do not provide a second derivative function)

getTable2DValueNoDer

Modelica.Blocks.Tables.Internal

Interpolate 2-dim. table defined by matrix (but do not provide a derivative function)

getTable2DValue

Modelica.Blocks.Tables.Internal

Interpolate 2-dim. table defined by matrix

getTable1DAbscissaUmax

Modelica.Blocks.Tables.Internal

Return maximum abscissa value of 1-dim. table defined by matrix

getTable1DAbscissaUmin

Modelica.Blocks.Tables.Internal

Return minimum abscissa value of 1-dim. table defined by matrix

getDer2Table1DValue

Modelica.Blocks.Tables.Internal

Second derivative of interpolated 1-dim. table defined by matrix

getDerTable1DValueNoDer

Modelica.Blocks.Tables.Internal

Derivative of interpolated 1-dim. table defined by matrix (but do not provide a second derivative function)

getDerTable1DValue

Modelica.Blocks.Tables.Internal

Derivative of interpolated 1-dim. table defined by matrix

getTable1DValueNoDer2

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table defined by matrix (but do not provide a second derivative function)

getTable1DValueNoDer

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table defined by matrix (but do not provide a derivative function)

getTable1DValue

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table defined by matrix

getNextTimeEvent

Modelica.Blocks.Tables.Internal

Return next time event value of 1-dim. table where first column is time

getTimeTableTmax

Modelica.Blocks.Tables.Internal

Return maximum abscissa value of 1-dim. table where first column is time

getTimeTableTmin

Modelica.Blocks.Tables.Internal

Return minimum abscissa value of 1-dim. table where first column is time

getDer2TimeTableValue

Modelica.Blocks.Tables.Internal

Second derivative of interpolated 1-dim. table where first column is time

getDerTimeTableValueNoDer

Modelica.Blocks.Tables.Internal

Derivative of interpolated 1-dim. table where first column is time (but do not provide a derivative function)

getDerTimeTableValue

Modelica.Blocks.Tables.Internal

Derivative of interpolated 1-dim. table where first column is time

getTimeTableValueNoDer2

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table where first column is time (but do not provide a second derivative function)

getTimeTableValueNoDer

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table where first column is time (but do not provide a derivative function)

getTimeTableValue

Modelica.Blocks.Tables.Internal

Interpolate 1-dim. table where first column is time

state2der2

Modelica.Blocks.Interfaces.Adaptors.Functions

Return 2nd derivative (der of state2der1)

state2der1

Modelica.Blocks.Interfaces.Adaptors.Functions

Return 1st derivative (der of state2)

state2

Modelica.Blocks.Interfaces.Adaptors.Functions

Return state (with two derivatives)

state1der1

Modelica.Blocks.Interfaces.Adaptors.Functions

Return 1st derivative (der of state1)

state1

Modelica.Blocks.Interfaces.Adaptors.Functions

Return state (with one derivative)

bandPassAlpha

Modelica.Blocks.Continuous.Internal.Filter.Utilities

Return alpha for band pass

normalizationFactor

Modelica.Blocks.Continuous.Internal.Filter.Utilities

Compute correction factor of low pass filter such that amplitude at cut-off frequency is -3db (=10^(-3/20) = 0.70794...)

toHighestPowerOne

Modelica.Blocks.Continuous.Internal.Filter.Utilities

Transform filter to form with highest power of s equal 1

BesselBaseCoefficients

Modelica.Blocks.Continuous.Internal.Filter.Utilities

Return coefficients of normalized low pass Bessel filter (= gain at cut-off frequency 1 rad/s is decreased 3dB)

bandStop

Modelica.Blocks.Continuous.Internal.Filter.roots

Return band stop filter roots as needed for block for given cut-off frequency

bandPass

Modelica.Blocks.Continuous.Internal.Filter.roots

Return band pass filter roots as needed for block for given cut-off frequency

highPass

Modelica.Blocks.Continuous.Internal.Filter.roots

Return high pass filter roots as needed for block for given cut-off frequency

lowPass

Modelica.Blocks.Continuous.Internal.Filter.roots

Return low pass filter roots as needed for block for given cut-off frequency

bandStop

Modelica.Blocks.Continuous.Internal.Filter.coefficients

Return band stop filter coefficients at given cut-off frequency

bandPass

Modelica.Blocks.Continuous.Internal.Filter.coefficients

Return band pass filter coefficients at given cut-off frequency

highPass

Modelica.Blocks.Continuous.Internal.Filter.coefficients

Return high pass filter coefficients at given cut-off frequency

lowPass

Modelica.Blocks.Continuous.Internal.Filter.coefficients

Return low pass filter coefficients at given cut-off frequency

ChebyshevI

Modelica.Blocks.Continuous.Internal.Filter.base

Return base filter coefficients of Chebyshev I filter (= low pass filter with w_cut = 1 rad/s)

Butterworth

Modelica.Blocks.Continuous.Internal.Filter.base

Return base filter coefficients of Butterworth filter (= low pass filter with w_cut = 1 rad/s)

Bessel

Modelica.Blocks.Continuous.Internal.Filter.base

Return base filter coefficients of Bessel filter (= low pass filter with w_cut = 1 rad/s)

CriticalDamping

Modelica.Blocks.Continuous.Internal.Filter.base

Return base filter coefficients of CriticalDamping filter (= low pass filter with w_cut = 1 rad/s)