FunctionIcon for functions |
This information is part of the Modelica Standard Library maintained by the Modelica Association.
This icon indicates Modelica functions.
Modelica.Utilities.Internal.FileSystem Get number of files and directories in a directory (POSIX functions opendir, readdir, closedir) |
|
Modelica.Utilities.Internal.FileSystem Read names of a directory (POSIX functions opendir, readdir, closedir) |
|
Modelica.Utilities.Internal.FileSystem Copy existing file (C functions 'fopen', 'fread', 'fwrite', 'fclose') |
|
Modelica.Utilities.Internal.FileSystem Remove existing file (C function 'remove') |
|
Modelica.Utilities.Internal.FileSystem Rename existing file or directory (C function 'rename') |
|
Modelica.Utilities.Internal.FileSystem Inquire file information (POSIX function 'stat') |
|
Modelica.Utilities.Internal.FileSystem Remove empty directory (POSIX function 'rmdir') |
|
Modelica.Utilities.Internal.FileSystem Make directory (POSIX: 'mkdir') |
|
Modelica.Utilities.Internal.PartialModelicaServices.System Interface for tool specific function to terminate the execution of the Modelica environment |
|
Modelica.Utilities.Internal.PartialModelicaServices.ExternalReferences Interface for tool specific function to return the absolute path name of a URI or local file name |
|
Modelica.Utilities.System Execute command in default shell |
|
Modelica.Utilities.System Retrieve the current process id |
|
Modelica.Utilities.System Retrieve the local time (in the local time zone) |
|
Modelica.Utilities.System Set content of local environment variable |
|
Modelica.Utilities.System Get content of environment variable |
|
Modelica.Utilities.System Set work directory |
|
Modelica.Utilities.System Get full path name of work directory |
|
Modelica.Utilities.Strings.Advanced Scan comments and white space |
|
Modelica.Utilities.Strings.Advanced Scan white space |
|
Modelica.Utilities.Strings.Advanced Scan simple identifiers |
|
Modelica.Utilities.Strings.Advanced Scan string |
|
Modelica.Utilities.Strings.Advanced Scan signed integer number |
|
Modelica.Utilities.Strings.Advanced Scan a signed real number |
|
Modelica.Utilities.Strings Print an error message, a string and the index at which scanning detected an error |
|
Modelica.Utilities.Strings Scan string and check that it contains no more token |
|
Modelica.Utilities.Strings Scan for the next delimiter and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next Identifier and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next Modelica string and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next Boolean number and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next Integer number and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next Real number and trigger an assert if not present |
|
Modelica.Utilities.Strings Scan for the next token and return it |
|
Modelica.Utilities.Strings Create a hash value of a string |
|
Modelica.Utilities.Strings Sort vector of strings in alphabetic order |
|
Modelica.Utilities.Strings Replace non-overlapping occurrences of a string from left to right |
|
Modelica.Utilities.Strings Find last occurrence of a string within another string |
|
Modelica.Utilities.Strings Find first occurrence of a string within another string |
|
Modelica.Utilities.Strings Count the number of non-overlapping occurrences of a string |
|
Modelica.Utilities.Strings Return true if a string is empty (has only white space characters) |
|
Modelica.Utilities.Strings Determine whether two strings are identical |
|
Modelica.Utilities.Strings Compare two strings lexicographically |
|
Modelica.Utilities.Strings Repeat a string n times |
|
Modelica.Utilities.Strings Return a substring defined by start and end index |
|
Modelica.Utilities.Strings Return length of string |
|
Modelica.Utilities.Streams Write Real matrix to a MATLAB MAT file |
|
Modelica.Utilities.Streams Read Real matrix from MATLAB MAT file |
|
Modelica.Utilities.Streams Read dimensions of a Real matrix from a MATLAB MAT file |
|
Modelica.Utilities.Streams Close file |
|
Modelica.Utilities.Streams Print error message and cancel all actions - in case of an unrecoverable error |
|
Modelica.Utilities.Streams Return the number of lines in a file |
|
Modelica.Utilities.Streams Read a line of text from a file and return it in a string |
|
Modelica.Utilities.Streams Read content of a file and return it in a vector of strings |
|
Modelica.Utilities.Streams Print string to terminal or file |
|
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) |
|
Modelica.Utilities.Files Split path name in directory, file name kernel, file name extension |
|
Modelica.Utilities.Files Get full path name of file or directory name |
|
Modelica.Utilities.Files Trigger an assert, if a file or directory exists |
|
Modelica.Utilities.Files Inquire whether file or directory exists |
|
Modelica.Utilities.Files Create directory (if directory already exists, ignore call) |
|
Modelica.Utilities.Files Remove file (ignore call, if it does not exist) |
|
Modelica.Utilities.Files Remove file or directory (ignore call, if it does not exist) |
|
Modelica.Utilities.Files Move a file or a directory to another place |
|
Modelica.Utilities.Files Generate a copy of a file or of a directory |
|
Modelica.Utilities.Files List content of file or directory |
|
Modelica.Utilities.Examples Read the value of a Real parameter from file |
|
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) |
|
Modelica.Utilities.Examples Interpreter to evaluate simple expressions consisting of +, -, *, /, (), sin(), cos(), tan(), sqrt(), asin(), acos(), atan(), exp(), log(), pi |
|
Modelica.ComplexMath Return product of complex vector |
|
Modelica.ComplexMath Return sum of complex vector |
|
Modelica.ComplexMath Return minimum element of complex vector |
|
Modelica.ComplexMath Return maximum element of complex vector |
|
Modelica.ComplexMath Square root of complex number |
|
Modelica.ComplexMath Complex from polar representation |
|
Modelica.ComplexMath Imaginary part of complex number |
|
Modelica.ComplexMath Real part of complex number |
|
Modelica.ComplexMath Conjugate of complex number |
|
Modelica.ComplexMath Phase angle of complex number |
|
Modelica.ComplexMath Absolute value of complex number |
|
Modelica.ComplexMath Logarithm of complex number |
|
Modelica.ComplexMath Exponential of complex number |
|
Modelica.ComplexMath Area-hyperbolic-tangent of complex number |
|
Modelica.ComplexMath Area-hyperbolic-cosine of complex number |
|
Modelica.ComplexMath Area-hyperbolic-sine of complex number |
|
Modelica.ComplexMath Hyperbolic-tangent of complex number |
|
Modelica.ComplexMath Hyperbolic-cosine of complex number |
|
Modelica.ComplexMath Hyperbolic-sine of complex number |
|
Modelica.ComplexMath Arc-tangent of complex number |
|
Modelica.ComplexMath Arc-cosine of complex number |
|
Modelica.ComplexMath Arc-sine of complex number |
|
Modelica.ComplexMath Tangent of complex number |
|
Modelica.ComplexMath Cosine of complex number |
|
Modelica.ComplexMath Sine of complex number |
|
Modelica.ComplexMath.Vectors Sort elements of complex vector |
|
Modelica.ComplexMath.Vectors Reverse vector elements (e.g., v[1] becomes last element) |
|
Modelica.ComplexMath.Vectors Return normalized complex vector such that length = 1 and prevent zero-division for zero vector |
|
Modelica.ComplexMath.Vectors Return length of a complex vector |
|
Modelica.ComplexMath.Vectors Returns the p-norm of a complex vector |
|
Modelica.Math Determine if the integer input is a power of 2 |
|
Modelica.Math Determine if two Real scalars are numerically identical |
|
Modelica.Math.FastFourierTransform.Internal Factorization of an integer in prime numbers 2,3,5 |
|
Modelica.Math.FastFourierTransform.Internal Compute raw Fast Fourier Transform for real signal vector |
|
Modelica.Math.FastFourierTransform Write real FFT computation to file |
|
Modelica.Math.FastFourierTransform Return amplitude and phase vectors for a real FFT |
|
Modelica.Math.FastFourierTransform Return number of sample points for a real FFT |
|
Modelica.Math.FastFourierTransform Print information about real FFT for given f_max and f_resolution |
|
Modelica.Math.Special.Internal Utility function for erfInv(u) and erfcInv(u) |
|
Modelica.Math.Special.Internal Evaluate erfc(z) for 0.5 <= z |
|
Modelica.Math.Special.Internal Evaluate a polynomial c[1] + c[2]*u + c[3]*u^2 + .... |
|
Modelica.Math.Special Unnormalized sinc function: sinc(u) = sin(u)/u |
|
Modelica.Math.Special Inverse complementary error function: u = erfc(erfcInv(u)) |
|
Modelica.Math.Special Inverse error function: u = erf(erfInv(u)) |
|
Modelica.Math.Special Complementary error function erfc(u) = 1 - erf(u) |
|
Modelica.Math.Special Error function erf(u) = 2/sqrt(pi)*Integral_0_u exp(-t^2)*d |
|
Modelica.Math.Distributions.Interfaces Common interface of quantile functions (= inverse cumulative distribution functions) |
|
Modelica.Math.Distributions.Interfaces Common interface of cumulative distribution functions |
|
Modelica.Math.Distributions.Interfaces Common interface of probability density functions |
|
Modelica.Math.Random.Utilities Impure random number generator for integer values (with hidden state vector) |
|
Modelica.Math.Random.Utilities Impure random number generator (with hidden state vector) |
|
Modelica.Math.Random.Utilities Initializes the internal state of the impure random number generator |
|
Modelica.Math.Random.Utilities Creates an automatic local seed from the instance name |
|
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) |
|
Modelica.Math.Random.Generators.Xorshift1024star Returns a uniform random number with the xorshift1024* algorithm |
|
Modelica.Math.Random.Generators.Xorshift1024star Returns an initial state for the xorshift1024* algorithm |
|
Modelica.Math.Random.Generators.Xorshift128plus Returns a uniform random number with the xorshift128+ algorithm |
|
Modelica.Math.Random.Generators.Xorshift128plus Returns an initial state for the xorshift128+ algorithm |
|
Modelica.Math.Random.Generators.Xorshift64star Returns a uniform random number with the xorshift64* algorithm |
|
Modelica.Math.Random.Generators.Xorshift64star Returns an initial state for the xorshift64* algorithm |
|
Modelica.Math.Polynomials Compute zeros of a polynomial where the highest coefficient is assumed as not to be zero |
|
Modelica.Math.Polynomials Time derivative of derivative of polynomial |
|
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) |
|
Modelica.Math.Polynomials Evaluate derivative of polynomial at a given abscissa value with extrapolation outside of the defined range |
|
Modelica.Math.Polynomials Evaluate derivative of polynomial at a given abscissa value |
|
Modelica.Math.Polynomials Computes the coefficients of a polynomial that fits a set of data points in a least-squares sense |
|
Modelica.Math.Polynomials Integral of polynomial p(u) from u_low to u_high |
|
Modelica.Math.Polynomials Indefinite integral of polynomial p(u) |
|
Modelica.Math.Polynomials Value of 2nd derivative of polynomial at abscissa value u |
|
Modelica.Math.Polynomials Value of derivative of polynomial at abscissa value u |
|
Modelica.Math.Polynomials Derivative of polynomial |
|
Modelica.Math.Polynomials Evaluate polynomial at a given abscissa value with linear extrapolation outside of the defined range |
|
Modelica.Math.Polynomials Evaluate polynomial at a given abscissa value |
|
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) |
|
Modelica.Math.Nonlinear Return the integral of an integrand function using an adaptive Lobatto rule |
|
Modelica.Math.Nonlinear.Interfaces Interface for a function with one input and one output Real signal |
|
Modelica.Math.Nonlinear.Examples Solve nonlinear equations with user dependent inputs |
|
Modelica.Math.Nonlinear.Examples Solve nonlinear equations with fixed inputs |
|
Modelica.Math.Nonlinear.Examples Integrate integral with user dependent inputs |
|
Modelica.Math.Nonlinear.Examples Integrate integral with fixed inputs |
|
Modelica.Math.Matrices.Utilities Find a local minimizer tk to define the length of the step tk*Nk in continuousRiccatiIterative and discreteRiccatiIterative |
|
Modelica.Math.Matrices.Utilities Reorders a real Schur form to clusters of stable and unstable eigenvalues |
|
Modelica.Math.Matrices.Utilities Compute eigenvalues of an upper Hessenberg form matrix |
|
Modelica.Math.Matrices.Utilities Transform a real square matrix A to upper Hessenberg form H by orthogonal similarity transformation: Q' * A * Q = H |
|
Modelica.Math.Matrices.Utilities Newton's method with exact line search for solving discrete algebraic Riccati equation |
|
Modelica.Math.Matrices.Utilities Newton's method with exact line search for iterative solving continuous algebraic Riccati equation |
|
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 |
|
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 |
|
Modelica.Math.Matrices.LAPACK Compute the Cholesky factorization of a real symmetric positive definite matrix A |
|
Modelica.Math.Matrices.LAPACK Compute the right and/or left eigenvectors of a real upper quasi-triangular matrix T |
|
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 |
|
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 |
|
Modelica.Math.Matrices.LAPACK Compute generalized eigenvalues for a (A,B) system |
|
Modelica.Math.Matrices.LAPACK Compute generalized eigenvalues for a (A,B) system, using lapack routine dggevx |
|
Modelica.Math.Matrices.LAPACK Compute generalized eigenvalues, as well as the left and right eigenvectors for a (A,B) system |
|
Modelica.Math.Matrices.LAPACK Determine singular value decomposition |
|
Modelica.Math.Matrices.LAPACK Compute the eigenvalues and the (real) left and right eigenvectors of matrix A, using lapack routine dgeevx |
|
Modelica.Math.Matrices.LAPACK Compute a QR factorization without pivoting |
|
Modelica.Math.Matrices.LAPACK Reduce a real general matrix A to upper Hessenberg form H by an orthogonal similarity transformation: Q' * A * Q = H |
|
Modelica.Math.Matrices.LAPACK Estimate the reciprocal of the condition number of a general real matrix A |
|
Modelica.Math.Matrices.LAPACK Norm of a matrix |
|
Modelica.Math.Matrices.LAPACK Compute eigenvalues of a matrix H using lapack routine DHSEQR for Hessenberg form matrix |
|
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 |
|
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 |
|
Modelica.Math.Matrices.LAPACK Reorder the real Schur factorization of a real matrix |
|
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 |
|
Modelica.Math.Matrices.LAPACK Generate a Real orthogonal matrix Q which is defined as the product of elementary reflectors as returned from dgeqrf |
|
Modelica.Math.Matrices.LAPACK Compute QR factorization with column pivoting of square or rectangular matrix A |
|
Modelica.Math.Matrices.LAPACK Compute the inverse of a matrix using the LU factorization from dgetrf |
|
Modelica.Math.Matrices.LAPACK Solve a system of linear equations with the LU decomposition from dgetrf |
|
Modelica.Math.Matrices.LAPACK Solve a system of linear equations with the LU decomposition from dgetrf |
|
Modelica.Math.Matrices.LAPACK Compute LU factorization of square or rectangular matrix A (A = P*L*U) |
|
Modelica.Math.Matrices.LAPACK Determine singular values |
|
Modelica.Math.Matrices.LAPACK Determine singular value decomposition |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*x=b with a b vector |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*X=B with a B matrix |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*x=b with b vector and tridiagonal A |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*X=B with B matrix and tridiagonal A |
|
Modelica.Math.Matrices.LAPACK Solve a linear equality constrained least squares problem |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*x=b with a b vector |
|
Modelica.Math.Matrices.LAPACK Solve real system of linear equations A*X=B with a B matrix |
|
Modelica.Math.Matrices.LAPACK Solve overdetermined or underdetermined real linear equations A*x=b with a b vector |
|
Modelica.Math.Matrices.LAPACK Compute the minimum-norm solution to a real linear least squares problem with rank deficient A |
|
Modelica.Math.Matrices.LAPACK Compute the minimum-norm solution to a real linear least squares problem with rank deficient A |
|
Modelica.Math.Matrices.LAPACK Compute eigenvalues for real nonsymmetric matrix A |
|
Modelica.Math.Matrices.LAPACK Compute eigenvalues and (right) eigenvectors for real nonsymmetric matrix A |
|
Modelica.Math.Matrices Flip the rows of a matrix in up/down direction |
|
Modelica.Math.Matrices Flip the columns of a matrix in left/right direction |
|
Modelica.Math.Matrices Sort the rows or columns of a matrix in ascending or descending order |
|
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) |
|
Modelica.Math.Matrices Return solution of the discrete-time Sylvester equation A*X*B + sgn*X = C |
|
Modelica.Math.Matrices Return solution X of the discrete-time Lyapunov equation A'*X*A + sgn*X = C |
|
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) |
|
Modelica.Math.Matrices Return solution X of the continuous-time Sylvester equation A*X + X*B = C |
|
Modelica.Math.Matrices Return solution X of the continuous-time Lyapunov equation X*A + A'*X = C |
|
Modelica.Math.Matrices Return the exponential, the integral of the exponential, and time-weighted integral of the exponential of a matrix |
|
Modelica.Math.Matrices Return the exponential and the integral of the exponential of a matrix |
|
Modelica.Math.Matrices Return the exponential of a matrix by adaptive Taylor series expansion with scaling and balancing |
|
Modelica.Math.Matrices Return the orthonormal nullspace of a matrix |
|
Modelica.Math.Matrices Return the Frobenius norm of a matrix |
|
Modelica.Math.Matrices Return the p-norm of a matrix |
|
Modelica.Math.Matrices Return the reciprocal condition number of a matrix |
|
Modelica.Math.Matrices Return the condition number norm(A)*norm(inv(A)) of a matrix A |
|
Modelica.Math.Matrices Return rank of a rectangular matrix (computed with singular values) |
|
Modelica.Math.Matrices Return inverse of a matrix (try to avoid inv(..)) |
|
Modelica.Math.Matrices Return determinant of a matrix (computed by LU decomposition; try to avoid det(..)) |
|
Modelica.Math.Matrices Return the trace of matrix A, i.e., the sum of the diagonal elements |
|
Modelica.Math.Matrices Return a balanced form of a system [A,B;C,0] to improve its condition by a state transformation |
|
Modelica.Math.Matrices Return a balanced form of matrix A to improve the condition of A |
|
Modelica.Math.Matrices Return the Cholesky factorization of a symmetric positive definite matrix |
|
Modelica.Math.Matrices Return the real Schur form (rsf) S of a square matrix A, A=QZ*S*QZ' |
|
Modelica.Math.Matrices Return upper Hessenberg form of a matrix |
|
Modelica.Math.Matrices Return the QR decomposition of a square matrix with optional column pivoting (A(:,p) = Q*R) |
|
Modelica.Math.Matrices Return singular values and left and right singular vectors |
|
Modelica.Math.Matrices Return real valued block diagonal matrix J of eigenvalues of matrix A (A=V*J*Vinv) |
|
Modelica.Math.Matrices Return eigenvalues and eigenvectors for a real, nonsymmetric matrix in a Real representation |
|
Modelica.Math.Matrices Solve real system of linear equations P*L*U*X=B with a B matrix and an LU decomposition (from LU(..)) |
|
Modelica.Math.Matrices Solve real system of linear equations P*L*U*x=b with a b vector and an LU decomposition (from LU(..)) |
|
Modelica.Math.Matrices LU decomposition of square or rectangular matrix |
|
Modelica.Math.Matrices Solve a linear equality constrained least squares problem |
|
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) |
|
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) |
|
Modelica.Math.Matrices Solve real system of linear equations A*X=B with a B matrix (Gaussian elimination with partial pivoting) |
|
Modelica.Math.Matrices Solve real system of linear equations A*x=b with a b vector (Gaussian elimination with partial pivoting) |
|
Modelica.Math.Matrices Compare whether two Real matrices are identical |
|
Modelica.Math.Matrices Convert a matrix into its string representation |
|
Modelica.Math.Matrices.Examples Demonstrate the solution of linear equation systems |
|
Modelica.Math.BooleanVectors Returns true, if exactly one element of the Boolean input vector is true ("xor") |
|
Modelica.Math.BooleanVectors Returns the indices of the true elements of a Boolean vector |
|
Modelica.Math.BooleanVectors Returns the index of the first true element of a Boolean vector |
|
Modelica.Math.BooleanVectors Enumerates the true elements in a Boolean vector (0 for false elements) |
|
Modelica.Math.BooleanVectors Returns the number of true elements in a Boolean vector |
|
Modelica.Math.BooleanVectors Returns true, if at least one element of the Boolean input vector is true ('or') |
|
Modelica.Math.BooleanVectors Returns true, if all elements of the Boolean input vector are true ('and') |
|
Modelica.Math.BooleanVectors Returns true, if all elements of the Boolean input vector are true ('and') |
|
Modelica.Math.Vectors Return vector of relative node positions (0..1) |
|
Modelica.Math.Vectors Interpolate linearly in a vector |
|
Modelica.Math.Vectors Find element in a vector |
|
Modelica.Math.Vectors Sort elements of vector in ascending or descending order |
|
Modelica.Math.Vectors Reverse vector elements (e.g., v[1] becomes last element) |
|
Modelica.Math.Vectors Return normalized vector such that length = 1 (trigger an assert for zero vector) |
|
Modelica.Math.Vectors Return normalized vector such that length = 1 and prevent zero-division for zero vector |
|
Modelica.Math.Vectors Return length of a vector (better as norm(), if further symbolic processing is performed) |
|
Modelica.Math.Vectors Return the p-norm of a vector |
|
Modelica.Math.Vectors Determine if two Real vectors are numerically identical |
|
Modelica.Math.Vectors Convert a real vector in to a string representation |
|
Modelica.Media.Water.IF97_Utilities Isentropic specific enthalpy from p,s and good guesses of d and T |
|
Modelica.Media.Water.IF97_Utilities Derivative of isentropic specific enthalpy from p,s |
|
Modelica.Media.Water.IF97_Utilities |
|
Modelica.Media.Water.IF97_Utilities Isentropic specific enthalpy from p,s (preferably use dynamicIsentropicEnthalpy in dynamic simulation!) |
|
Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial Calculate property record for dynamic simulation properties using p and T as dynamic states |
|
Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial Calculate property record for dynamic simulation properties using d and T as dynamic states |
|
Modelica.Media.Water.IF97_Utilities.ThermoFluidSpecial Calculate the property record for dynamic simulation properties using p,h as states |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Speed of sound as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Speed of sound as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific entropy as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Derivative function of p_dT |
|
Modelica.Media.Water.IF97_Utilities Pressure as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Pressure as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Derivative function of h_dT |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function of density and temperature |
|
Modelica.Media.Water.IF97_Utilities Intermediate property record for water (d and T preferred states) |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Speed of sound as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Speed of sound as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific entropy as function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Derivative function of rho_pT |
|
Modelica.Media.Water.IF97_Utilities Derivative function of h_pT |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Intermediate property record for water (p and T preferred states) |
|
Modelica.Media.Water.IF97_Utilities Density derivative by specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Density derivative by specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Density derivative by pressure |
|
Modelica.Media.Water.IF97_Utilities Density derivative by pressure |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Isentropic exponent as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities |
|
Modelica.Media.Water.IF97_Utilities Speed of sound as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Isothermal compressibility factor as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Isobaric expansion coefficient as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant pressure as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Assert function for inlining |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific heat capacity at constant volume as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Derivative function of T_ph |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Derivative function of rho_ph |
|
Modelica.Media.Water.IF97_Utilities Density as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Density as function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Phase as a function of pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Phase as a function of pressure and specific enthalpy |
|
Modelica.Media.Water.IF97_Utilities Phase as a function of pressure and specific entropy |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of pressure and specific entropy |
|
Modelica.Media.Water.IF97_Utilities Temperature as function of pressure and specific entropy |
|
Modelica.Media.Water.IF97_Utilities Density as function of pressure and specific entropy |
|
Modelica.Media.Water.IF97_Utilities Density as function of pressure and specific entropy |
|
Modelica.Media.Water.IF97_Utilities Intermediate property record for water |
|
Modelica.Media.Water.IF97_Utilities Intermediate property record for water |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97 Function to calculate some extra thermophysical properties in regions 1, 2, 3 and 5 as f(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97 Function to calculate some extra thermophysical properties in regions 1, 2, 3 and 5 as f(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase Water properties in region 4 as function of d and T |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase Water/Steam properties in region 4 of IAPWS/IF97 (two-phase) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase Water saturation properties in the 2-phase region (4) as f(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase Properties on the vapour phase boundary of region 4 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.TwoPhase Properties on the liquid phase boundary of region 4 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion Standard properties for region 5, (p,T) as inputs |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion Standard properties for region 3, (d,T) as inputs |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion Standard properties for region 2, (p,T) as inputs |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.ByRegion Standard properties for region 1, (p,T) as inputs |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 5: (p,T) = f(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 5: (p,T) = f(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 5: (p,T) = f(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 1,2 and 5: p = g(d,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 3: (d,T) = f(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 3: (d,T) = f(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 3: (d,T) = f(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Inverse iteration in region 3: (d) = f(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Density at the boundary between regions 2 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Density at the boundary between regions 1 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Inverses Region limits for inverse iteration in region 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Isentropic specific enthalpy from p,s and good guesses of d and T |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Isentropic specific enthalpy from p,s (preferably use water_hisentropic_dyn in dynamic simulation!) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Specific enthalpy in region 5 h(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Isentropic specific enthalpy in region 4 h(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Isentropic specific enthalpy in region 3 h(p,s) with given good guess in d and T |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Isentropic specific enthalpy in region 3 h(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Function for isentropic specific enthalpy in region 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Function for isentropic specific enthalpy in region 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Function for isentropic specific enthalpy and specific entropy in region 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Intermediate function for isentropic specific enthalpy in region 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Function for isentropic specific enthalpy in region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Special function for specific enthalpy and specific entropy in region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Isentropic Intermediate function for isentropic specific enthalpy in region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport Surface tension in region 4 between steam and water |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport Thermal conductivity lam(d,T,p) (industrial use version) only in one-phase region |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Transport Dynamic viscosity eta(d,T,p), industrial formulation |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries Sublimation pressure, valid from 190 to 273.16 K |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries Melting pressure of ice V (temperature range from 256.164 to 273.31 K) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries Melting pressure of ice III (temperature range from 251.165 to 256.164 K) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.IceBoundaries Melting pressure of ice I (temperature range from 273.16 to 251.165 K) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 b: inverse function v(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 a: inverse function v(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 b: inverse function T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 a: inverse function T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 b: inverse function v(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 a: inverse function v(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 b: inverse function T(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 a: inverse function T(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 3 a b boundary for pressure/enthalpy |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Pressure as a function of enthalpy and entropy in subregion 2c |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Pressure as a function of enthalpy and entropy in subregion 2a |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Pressure as a function of enthalpy and entropy in subregion 2a |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Boundary between regions 2a and 2b |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Pressure as a function of enthalpy and entropy in region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative function for psat |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative of pressure w.r.t. temperature along the saturation pressure curve |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 4 saturation pressure as a function of temperature |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative function for tsat |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative of saturation temperature w.r.t. pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Region 4 saturation temperature as a function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Reverse function for region 2: T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Reverse function for region 2c: T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Reverse function for region 2b: T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Reverse function for region 2a: T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Reverse function for region 2: T(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Inverse function for region 1: T(p,s) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Inverse function for region 1: T(p,h) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic 1st derivatives of f w.r.t. delta and tau |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative of g w.r.t. pi and tau |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative of g w.r.t. pi and tau |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Derivative of g w.r.t. pi and tau |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Gibbs function for region 1, 2 or 5: g(p,T,region) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Base function for region 5: g(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Helmholtz function for region 3: f(d,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Gibbs function for metastable part of region 2: g(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Gibbs function for region 2: g(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Basic Gibbs function for region 1: g(p,T) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Derivative of density of saturated steam w.r.t. pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Derivative of density of saturated water w.r.t. pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions |
|
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 |
|
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 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Derivative function for the specific enthalpy along the phase boundary |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Return the current region (valid values: 1,2,3,4,5) in IF97, given density and temperature |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Return the current region (valid values: 1,2,3,5) in IF97, given pressure and temperature |
|
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 |
|
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 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density of saturated vapour |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density of saturated water |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Vapour specific entropy on the boundary between regions 4 and 3 or 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Liquid specific entropy on the boundary between regions 4 and 3 or 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density of saturated vapour |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density of saturated water |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Derivative function for the specific enthalpy along the phase boundary |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Vapour specific enthalpy on the boundary between regions 4 and 3 or 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Liquid specific enthalpy on the boundary between regions 4 and 3 or 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Properties on the dew curve |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Properties on the boiling curve |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of vapour density on the boundary between regions 4 and 2 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of liquid density on the boundary between regions 4 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of vapour specific entropy on the boundary between regions 4 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of liquid specific entropy on the boundary between regions 4 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of vapour specific enthalpy on the boundary between regions 4 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit approximation of liquid specific enthalpy on the boundary between regions 4 and 3 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density at upper pressure limit of region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density at upper temperature limit of region 1 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density in region 2 as function of p and T |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Density in region 1 as function of p and T |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit upper specific entropy limit of region 2 as function of pressure |
|
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) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit upper specific enthalpy limit of region 2 as function of pressure |
|
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) |
|
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) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit lower specific entropy limit of region 1 as function of pressure |
|
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) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit lower specific enthalpy limit of region 1 as function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit upper specific entropy limit of region 5 as function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit lower specific entropy limit of region 5 as function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit upper specific enthalpy limit of region 5 as function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Explicit lower specific enthalpy limit of region 5 as function of pressure |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Boundary function for region boundary between regions 2 and 3 (input pressure) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97.Regions Boundary function for region boundary between regions 2 and 3 (input temperature) |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97 Get normalization pressure for region 1, 2 or 5 |
|
Modelica.Media.Water.IF97_Utilities.BaseIF97 Get normalization temperature for region 1, 2 or 5 |
|
Modelica.Media.Water.WaterIF97_base Computes density as a function of pressure and temperature |
|
Modelica.Media.Water.WaterIF97_base Computes specific enthalpy as a function of pressure and temperature |
|
Modelica.Media.Water.WaterIF97_base Computes specific enthalpy as a function of pressure and temperature |
|
Modelica.Media.Water.WaterIF97_base Computes specific enthalpy as a function of density and temperature |
|
Modelica.Media.Water.WaterIF97_base Computes pressure as a function of density and temperature |
|
Modelica.Media.Water.WaterIF97_base Computes density as a function of pressure and specific enthalpy |
|
Modelica.Media.Water.WaterIF97_base Compute temperature from pressure and specific enthalpy |
|
Modelica.Media.Water.WaterIF97_base Computes temperature as a function of pressure and specific enthalpy |
|
Modelica.Media.Water.WaterIF97_base Computes density as a function of pressure and specific enthalpy |
|
Modelica.Media.R134a.R134a_ph Assert function for checking threshold to phase boundary |
|
Modelica.Media.R134a.R134a_ph Compute h for given p and T |
|
Modelica.Media.R134a.R134a_ph Compute d for given p and T |
|
Modelica.Media.R134a.R134a_ph Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.R134a.R134a_ph Time derivative function of T_ph |
|
Modelica.Media.R134a.R134a_ph Density as function of pressure and specific enthalpy |
|
Modelica.Media.R134a.R134a_ph Time derivative function of density_ph |
|
Modelica.Media.R134a.R134a_ph Properties on vapor boundary phase |
|
Modelica.Media.R134a.R134a_ph Properties on liquid boundary phase |
|
Modelica.Media.R134a.R134a_ph Isentropic specific enthalpy in two phase region h(p,s) |
|
Modelica.Media.R134a.R134a_ph Number of phases by pressure and entropy |
|
Modelica.Media.R134a.R134a_ph Number of phases by pressure and specific enthalpy |
|
Modelica.Media.R134a.R134a_ph Calculation of helmholtz derivatives |
|
Modelica.Media.R134a.R134a_ph Helmholtz coefficients of ideal part |
|
Modelica.Media.R134a.R134a_ph Calculation of helmholtz derivatives by density and temperature |
|
Modelica.Media.R134a.R134a_ph Inverse iteration in one phase region (d,T) = f(p,s) |
|
Modelica.Media.R134a.R134a_ph Density and temperature w.r.t. pressure and specific enthalpy in one-phase region |
|
Modelica.Media.R134a.R134a_ph Density and temperature w.r.t. pressure and specific enthalpy |
|
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 |
|
Modelica.Media.R134a.R134a_ph Derivative of liquid specific entropy in two-phase region w.r.t. pressure | use setState_phX function for input |
|
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 |
|
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 |
|
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 |
|
Modelica.Media.R134a.R134a_ph Time derivative of saturation temperature in two-phase region |
|
Modelica.Media.R134a.R134a_ph Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.R134a.R134a_ph Density as function of pressure and specific enthalpy |
|
Modelica.Media.R134a.Common Calculate phase boundary property record from dimensionless Helmholtz function |
|
Modelica.Media.R134a.Common Half-interval search algorithm |
|
Modelica.Media.R134a.Common Compute isochoric specific heat capacity inside the two-phase region |
|
Modelica.Media.R134a.Common Cubic spline |
|
Modelica.Media.R134a.Common Derivative of cubic spline |
|
Modelica.Media.Incompressible.TableBased Compute temperature from pressure and specific enthalpy |
|
Modelica.Media.Incompressible.TableBased Compute temperature from pressure and specific enthalpy |
|
Modelica.Media.Incompressible.TableBased Return density as function of temperature |
|
Modelica.Media.Incompressible.TableBased Compute specific enthalpy from pressure and temperature |
|
Modelica.Media.Incompressible.TableBased Compute specific enthalpy from temperature |
|
Modelica.Media.Incompressible.TableBased Compute specific enthalpy from temperature |
|
Modelica.Media.Incompressible.TableBased Compute specific entropy |
|
Modelica.Media.Incompressible.TableBased Returns state record as function of p and s |
|
Modelica.Media.Incompressible.TableBased Returns state record as function of p and h |
|
Modelica.Media.Incompressible.TableBased Returns state record as function of p and T |
|
Modelica.Media.Incompressible.TableBased Function to invert temperatures |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return temperature from pressure, specific entropy and mass fraction |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return temperature from specific enthalpy and mass fraction |
|
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) |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return the viscosity of gas mixtures without access to component viscosities (Chung, et. al. rules) |
|
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 |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return temperature dependent part of the entropy, expects full entropy vector |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return mixing entropy of ideal gases / R |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return specific enthalpy derivative |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return specific enthalpy |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return thermodynamic state as function of d, T and composition X |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return thermodynamic state as function of p, s and composition X |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return thermodynamic state as function of p, h and composition X |
|
Modelica.Media.IdealGases.Common.MixtureGasNasa Return thermodynamic state as function of p, T and composition X |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Thermal conductivity of polyatomic gases(Eucken and Modified Eucken correlation) |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Dynamic viscosity of low pressure gases |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Compute temperature from pressure and specific entropy |
|
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 |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Return thermodynamic state as function of d, T and composition X |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Return thermodynamic state as function of p, s and composition X |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Return thermodynamic state as function of p, h and composition X |
|
Modelica.Media.IdealGases.Common.SingleGasNasa Return thermodynamic state as function of p, T and composition X |
|
Modelica.Media.IdealGases.Common.Functions Thermal conductivity of polyatomic gases (Eucken and Modified Eucken correlation) |
|
Modelica.Media.IdealGases.Common.Functions Dynamic viscosity of low pressure gases |
|
Modelica.Media.IdealGases.Common.Functions Compute derivative of specific entropy, low T region |
|
Modelica.Media.IdealGases.Common.Functions Compute specific entropy, low T region |
|
Modelica.Media.IdealGases.Common.Functions Compute specific entropy from temperature and gas data |
|
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 |
|
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 |
|
Modelica.Media.IdealGases.Common.Functions Derivative function for 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 |
|
Modelica.Media.IdealGases.Common.Functions Compute derivative of specific heat capacity at constant pressure, low T region |
|
Modelica.Media.IdealGases.Common.Functions Compute specific heat capacity at constant pressure, low T region |
|
Modelica.Media.IdealGases.Common.Functions Compute specific heat capacity at constant pressure from temperature and gas data |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of internal energy |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of specific enthalpy of moist air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of density as a function of pressure p, temperature T and composition X |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of saturation partial pressure of steam |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of humidity ration (absolute) of saturated humid air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Derivative of partial pressure of steam |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Internal energy |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Specific entropy of moist air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Specific enthalpy of moist air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Specific isochoric heat capacity |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Specific isobaric heat capacity |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Relative humidity |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Humidity ratio (absolute) of saturated humid air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Partial pressure of steam |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Saturation partial pressure of steam |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Return density as a function of pressure p, temperature T and composition X |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Enhancement factor as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities Henry's law constant |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Temperature as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Specific entropy as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Derivative function of h_pT |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Derivative function of rho_pT |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities Intermediate property record for water (p and T preferred states) |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic Derivative of sublimation pressure |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic Sublimation temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic Sublimation pressure |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Ice09_Utilities.Basic Gibbs equation of state |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities Derivative of saturation temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities Saturation pressure |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities Saturation temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Water95_Utilities Saturation pressure |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Derivative function of h_pT for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Derivative function of rho_pT for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Density as function or pressure and temperature for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Specific heat capacity at constant volume as function of pressure and temperature for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Specific heat capacity at constant pressure as function of pressure and temperature for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Temperature as function of pressure and temperature for region 2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.IF97_new Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of energy index for formation of NO |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of energy index for formation of O |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of energy index for formation of H |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative energy index for formation of OH |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of energy index for formation of H2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of reaction index for formation of NO |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of reaction index for formation of O |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of reaction index for formation of H |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative of reaction index for formation of OH |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Derivative reaction index for formation of H2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Energy index for formation of NO |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Energy index for formation of O |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Energy index for formation of H |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Energy index for formation of OH |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Energy index for formation of H2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Reaction index for formation of NO |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Reaction index for formation of O |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Reaction index for formation of H |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Reaction index for formation of OH |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.ReactionIndices Reaction index for formation of H2 |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Third molar virial coefficient of water |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Third molar cross-virial coefficient |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Third molar cross-virial coefficient |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Third molar virial coefficient of dry air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Second molar virial coefficient of water |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Second molar cross-virial coefficient |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.VirialCoefficients Second molar virial coefficient of dry air |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Transport Thermal conductivity |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Transport Dynamic viscosity |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses Return pressure as function of density, temperature and mass fractions |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses Return temperature as function of pressure, specific entropy and mass fractions |
|
Modelica.Media.Air.ReferenceMoistAir.Utilities.Inverses Return temperature as a function of pressure, specific enthalpy and mass fractions |
|
Modelica.Media.Air.ReferenceMoistAir Return enthalpy of liquid and solid water |
|
Modelica.Media.Air.ReferenceMoistAir Return specific enthalpy of water (solid + liquid + steam) |
|
Modelica.Media.Air.ReferenceMoistAir Return sublimation pressure of water as a function of temperature T between 223.16 and 273.16 K |
|
Modelica.Media.Air.ReferenceMoistAir Return saturation pressure of water as a function of temperature T |
|
Modelica.Media.Air.ReferenceMoistAir Return water content in kg(water)/kg(dry air) given mass fractions |
|
Modelica.Media.Air.ReferenceMoistAir Return mass fractions as a function of pressure, temperature and absolute humidity in kg(water)/kg(dry air) |
|
Modelica.Media.Air.ReferenceMoistAir Return mass fvraction at saturation boundary given pressure and saturation pressure |
|
Modelica.Media.Air.ReferenceMoistAir Return mass fraction of liquid and solid water |
|
Modelica.Media.Air.ReferenceMoistAir Return mass fraction of water vapor |
|
Modelica.Media.Air.ReferenceMoistAir Return absolute humidity per unit mass of dry air at saturation as a function of the thermodynamic state record |
|
Modelica.Media.Air.ReferenceMoistAir Return absolute humidity per unit mass of moist air at saturation as a function of the thermodynamic state record |
|
Modelica.Media.Air.MoistAir.Utilities |
|
Modelica.Media.Air.MoistAir.Utilities |
|
Modelica.Media.Air.MoistAir.Utilities Derivative of spliceFunction |
|
Modelica.Media.Air.MoistAir.Utilities Spline interpolation of two functions |
|
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) |
|
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) |
|
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 |
|
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 |
|
Modelica.Media.Air.MoistAir Derivative function of h_pTX |
|
Modelica.Media.Air.MoistAir Return specific enthalpy of moist air as a function of pressure p, temperature T and composition X |
|
Modelica.Media.Air.MoistAir Return temperature as a function of pressure p, specific enthalpy h and composition X |
|
Modelica.Media.Air.MoistAir Derivative function of enthalpyOfWater |
|
Modelica.Media.Air.MoistAir Computes specific enthalpy of water (solid/liquid) near atmospheric pressure from temperature T |
|
Modelica.Media.Air.MoistAir Return specific heat capacity of water (liquid only) as a function of temperature T |
|
Modelica.Media.Air.MoistAir Return saturation temperature of water as a function of (partial) pressure p |
|
Modelica.Media.Air.MoistAir Derivative function for 'saturationPressure' |
|
Modelica.Media.Air.MoistAir Derivative function for 'sublimationPressureIce' |
|
Modelica.Media.Air.MoistAir Return sublimation pressure of water as a function of temperature T between 190 and 273.16 K |
|
Modelica.Media.Air.MoistAir Derivative function for '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 |
|
Modelica.Media.Air.MoistAir Return ideal gas constant as a function from composition X |
|
Modelica.Media.Air.MoistAir Return relative humidity as a function of the thermodynamic state record |
|
Modelica.Media.Air.MoistAir Return relative humidity as a function of pressure p, temperature T and composition X |
|
Modelica.Media.Air.MoistAir Return steam mass fraction as a function of relative humidity phi and temperature T |
|
Modelica.Media.Air.MoistAir Return absolute humidity per unit mass of dry air at saturation as a function of pressure p and temperature T |
|
Modelica.Media.Air.MoistAir Return absolute humidity per unit mass of dry air at saturation as a function of the thermodynamic state record |
|
Modelica.Media.Air.MoistAir Return absolute humidity per unit mass of moist air at saturation as a function of the thermodynamic state record |
|
Modelica.Media.Air.MoistAir Return thermodynamic state as function of density d, temperature T and composition X |
|
Modelica.Media.Air.MoistAir Return thermodynamic state as function of pressure p, specific enthalpy h and composition X |
|
Modelica.Media.Air.MoistAir Return thermodynamic state as function of pressure p, temperature T and composition X |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial Calculate property record for dynamic simulation properties using p and T as dynamic states |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial Calculate property record for dynamic simulation properties using d and T as dynamic states |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.ThermoFluidSpecial Calculate the property record for dynamic simulation properties using p,h as states |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Speed of sound as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Speed of sound as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific entropy as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of p_dT |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Pressure as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Pressure as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of h_dT |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Intermediate property record for air (d and T preferred states) |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Speed of sound as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Speed of sound as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific entropy as function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of h_pT |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of rho_pT |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Intermediate property record for air (p and T preferred states) |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density derivative by specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density derivative by specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density derivative by pressure |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density derivative by pressure |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isentropic exponent as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Speed of sound as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isothermal compressibility factor as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Isobaric expansion coefficient as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant pressure as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific heat capacity at constant volume as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific entropy as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of T_ph |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Derivative function of rho_ph |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Intermediate property record for air |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Specific enthalpy as function or pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of pressure and specific entropy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Temperature as function of pressure and specific entropy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function of pressure and specific entropy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Density as function of pressure and specific entropy |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities Intermediate property record for air |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Transport Return thermal conductivity as a function of d and T |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Transport Return dynamic viscosity as a function of d and T |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses Return d and T as a function of p and s |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses Return d and T as a function of p and h |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Inverses Compute d for given p and T |
|
Modelica.Media.Air.ReferenceAir.Air_Utilities.Basic Helmholtz equation of state |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes density as a function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes specific enthalpy as a function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes specific enthalpy as a function of pressure and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes specific enthalpy as a function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes pressure as a function of density and temperature |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes density as a function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Base Compute temperature from pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes temperature as a function of pressure and specific enthalpy |
|
Modelica.Media.Air.ReferenceAir.Air_Base Computes density as a function of pressure and specific enthalpy |
|
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) |
|
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) |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing d and t given p and s |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing p given d and T |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing T given p and h |
|
Modelica.Media.Common Approximation of a general step, such that the characteristic is continuous and differentiable |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing d and t given p and s |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing d and t given p and t |
|
Modelica.Media.Common Function to calculate analytic derivatives for computing d and t given p and h |
|
Modelica.Media.Common Compute additional thermodynamic derivatives from dimensionless Helmholtz function |
|
Modelica.Media.Common Compute additional thermodynamic derivatives from dimensionless Gibbs function |
|
Modelica.Media.Common Compute isochoric specific heat capacity inside the two-phase region and derivative of pressure w.r.t. temperature |
|
Modelica.Media.Common Compute isochoric specific heat capacity inside the two-phase region |
|
Modelica.Media.Common Calculate phase boundary property record from dimensionless Helmholtz function |
|
Modelica.Media.Common Calculate phase boundary property record from dimensionless Gibbs function |
|
Modelica.Media.Common Calculates base coefficients for Bridgmans tables from Helmholtz energy |
|
Modelica.Media.Common Calculates base coefficients for Bridgman's tables from gibbs enthalpy |
|
Modelica.Media.Common.ThermoFluidSpecial Compute property record for density and temperature as states from saturation properties |
|
Modelica.Media.Common.ThermoFluidSpecial Compute property record for pressure and specific enthalpy as states from saturation properties |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for density and temperature as states from dimensionless Helmholtz function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for pressure and temperature as states from dimensionless Helmholtz function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for pressure and specific enthalpy as states from dimensionless Helmholtz function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for pressure and temperature as states from dimensionless Gibbs function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for density and temperature as states from dimensionless Gibbs function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate phase boundary property record from dimensionless Gibbs function |
|
Modelica.Media.Common.ThermoFluidSpecial Calculate property record for pressure and specific enthalpy as states from dimensionless Gibbs function |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return density from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return temperature from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return specific enthalpy from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return thermodynamic state from d, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return thermodynamic state from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return thermodynamic state from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleIdealGasMedium Return thermodynamic state from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return density from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return temperature from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return specific enthalpy from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return thermodynamic state from d, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return thermodynamic state from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return thermodynamic state from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialSimpleMedium Return thermodynamic state from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return density from p and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return specific enthalpy from p and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return density from p and s |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return temperature from p and s |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return specific enthalpy from p and s |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return specific enthalpy from d and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return pressure from d and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return temperature from p and h |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return density from p and h |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return vapour quality |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from temperature and vapour quality |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from pressure and vapour quality |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from d and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from p and s |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from p and h |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return thermodynamic state from p and T |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return specific enthalpy from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return density from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return temperature from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return density from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return temperature from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return specific enthalpy from pressure, temperature and mass fraction |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return dew point specific enthalpy derivative |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return bubble point specific enthalpy derivative |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return dew point density derivative |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return bubble point density derivative |
|
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 |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return derivative of saturation temperature w.r.t. pressure |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation temperature |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation pressure |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation temperature |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation pressure |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return dew point density |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return bubble point density |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return dew point specific entropy |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return bubble point specific entropy |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return dew point specific enthalpy |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return bubble point specific enthalpy |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation property record from pressure |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return saturation property record from temperature |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return the thermodynamic state on the bubble line |
|
Modelica.Media.Interfaces.PartialTwoPhaseMedium Return the thermodynamic state on the dew line |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return specific entropy as a function of pressure, specific enthalpy and mass fractions |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return enthalpy of the non-condensing species |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return enthalpy of condensing gas (most often steam) |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return enthalpy of non-condensing gas mixture |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return liquid enthalpy of condensing fluid |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return vaporization enthalpy of condensing fluid |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return relative humidity |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return mass fractions as a function of pressure, temperature and relative humidity |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return saturation mass fractions |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return saturation temperature of condensing fluid |
|
Modelica.Media.Interfaces.PartialRealCondensingGases Return saturation pressure of condensing fluid |
|
Modelica.Media.Interfaces.PartialCondensingGases Return enthalpy of the non-condensing species |
|
Modelica.Media.Interfaces.PartialCondensingGases Return enthalpy of condensing gas (most often steam) |
|
Modelica.Media.Interfaces.PartialCondensingGases Return enthalpy of non-condensing gas mixture |
|
Modelica.Media.Interfaces.PartialCondensingGases Return liquid enthalpy of condensing fluid |
|
Modelica.Media.Interfaces.PartialCondensingGases Return vaporization enthalpy of condensing fluid |
|
Modelica.Media.Interfaces.PartialCondensingGases Return saturation pressure of condensing fluid |
|
Modelica.Media.Interfaces.PartialMixtureMedium Return mole fractions from mass fractions X |
|
Modelica.Media.Interfaces.PartialMixtureMedium Return mass fractions X from mole fractions |
|
Modelica.Media.Interfaces.PartialMixtureMedium Return the gas constant of the mixture (also for liquids) |
|
Modelica.Media.Interfaces.PartialLinearFluid Return temperature from pressure and specific entropy |
|
Modelica.Media.Interfaces.PartialLinearFluid Return temperature from pressure and specific enthalpy |
|
Modelica.Media.Interfaces.PartialPureSubstance Return density from p and T |
|
Modelica.Media.Interfaces.PartialPureSubstance Return specific enthalpy from p and T |
|
Modelica.Media.Interfaces.PartialPureSubstance Return density from p and s |
|
Modelica.Media.Interfaces.PartialPureSubstance Return temperature from p and s |
|
Modelica.Media.Interfaces.PartialPureSubstance Return specific enthalpy from p and s |
|
Modelica.Media.Interfaces.PartialPureSubstance Return specific enthalpy from d and T |
|
Modelica.Media.Interfaces.PartialPureSubstance Return pressure from d and T |
|
Modelica.Media.Interfaces.PartialPureSubstance Return temperature from p and h |
|
Modelica.Media.Interfaces.PartialPureSubstance Return density from p and h |
|
Modelica.Media.Interfaces.PartialPureSubstance Return thermodynamic state from d and T |
|
Modelica.Media.Interfaces.PartialPureSubstance Return thermodynamic state from p and s |
|
Modelica.Media.Interfaces.PartialPureSubstance Return thermodynamic state from p and h |
|
Modelica.Media.Interfaces.PartialPureSubstance Return thermodynamic state from p and T |
|
Modelica.Media.Interfaces.PartialMedium Return specific enthalpy from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return density from p, s, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return temperature from p,s, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return density from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return temperature from p, h, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return density from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return specific enthalpy from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return specific enthalpy from p, T, and X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return the molar mass of the medium |
|
Modelica.Media.Interfaces.PartialMedium Return density derivative w.r.t. mass fraction |
|
Modelica.Media.Interfaces.PartialMedium Return density derivative w.r.t. temperature at constant pressure |
|
Modelica.Media.Interfaces.PartialMedium Return density derivative w.r.t. pressure at const temperature |
|
Modelica.Media.Interfaces.PartialMedium Return density derivative w.r.t. specific enthalpy at constant pressure |
|
Modelica.Media.Interfaces.PartialMedium Return density derivative w.r.t. pressure at const specific enthalpy |
|
Modelica.Media.Interfaces.PartialMedium Return overall the isothermal compressibility factor |
|
Modelica.Media.Interfaces.PartialMedium Return overall the isobaric expansion coefficient beta |
|
Modelica.Media.Interfaces.PartialMedium Return velocity of sound |
|
Modelica.Media.Interfaces.PartialMedium Return isentropic enthalpy |
|
Modelica.Media.Interfaces.PartialMedium Return isentropic exponent |
|
Modelica.Media.Interfaces.PartialMedium Return specific heat capacity at constant volume |
|
Modelica.Media.Interfaces.PartialMedium Return specific heat capacity at constant pressure |
|
Modelica.Media.Interfaces.PartialMedium Return specific Helmholtz energy |
|
Modelica.Media.Interfaces.PartialMedium Return specific Gibbs energy |
|
Modelica.Media.Interfaces.PartialMedium Return specific entropy |
|
Modelica.Media.Interfaces.PartialMedium Return specific internal energy |
|
Modelica.Media.Interfaces.PartialMedium Return specific enthalpy |
|
Modelica.Media.Interfaces.PartialMedium Return density |
|
Modelica.Media.Interfaces.PartialMedium Return temperature |
|
Modelica.Media.Interfaces.PartialMedium Return pressure |
|
Modelica.Media.Interfaces.PartialMedium Return the Prandtl number |
|
Modelica.Media.Interfaces.PartialMedium Return thermal conductivity |
|
Modelica.Media.Interfaces.PartialMedium Return dynamic viscosity |
|
Modelica.Media.Interfaces.PartialMedium Return thermodynamic state so that it smoothly approximates: if x > 0 then state_a else state_b |
|
Modelica.Media.Interfaces.PartialMedium Return thermodynamic state as function of d, T and composition X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return thermodynamic state as function of p, s and composition X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return thermodynamic state as function of p, h and composition X or Xi |
|
Modelica.Media.Interfaces.PartialMedium Return thermodynamic state as function of p, T and composition X or Xi |
|
Modelica.Fluid.Utilities Evaluate a cubic Hermite spline, return value and derivative |
|
Modelica.Fluid.Utilities Evaluate a cubic Hermite spline |
|
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 |
|
Modelica.Fluid.Utilities Approximation of a general step, such that the characteristic is continuous and differentiable |
|
Modelica.Fluid.Utilities Anti-symmetric approximation of square with discontinuous factor so that the first derivative is non-zero and is continuous |
|
Modelica.Fluid.Utilities Anti-symmetric approximation of square root with discontinuous factor so that the first derivative is finite and continuous |
|
Modelica.Fluid.Utilities Anti-symmetric power approximation with non-zero derivative in the origin |
|
Modelica.Fluid.Utilities Anti-symmetric square approximation with non-zero derivative in the origin |
|
Modelica.Fluid.Utilities Derivative of regRoot |
|
Modelica.Fluid.Utilities Anti-symmetric square root approximation with finite derivative in the origin |
|
Modelica.Fluid.Utilities Check whether boundary definition is correct |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Derivative of function Stepsmoother |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Continuous interpolation for x |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General The derivative of function SmoothPower |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Limiting the derivative of function y = if x>=0 then x^pow else -(-x)^pow |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Calculation of Reynolds number |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Calculation of Prandtl number |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Iterative form of Lambert's w function for solving f(x) = x exp(x) for x |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Closed approximation of Lambert's w function for solving f(x) = x exp(x) for x |
|
Modelica.Fluid.Dissipation.Utilities.Functions.General Cubic Hermite spline interpolation of the modified friction coefficient in transition regime of the Moody diagram (direct formulation) |
|
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 |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Calculation of (analytical/empirical) slip ratio |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Calculation of (cross sectional) void fraction for two phase flow |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Calculation of mean density for two phase flow |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Calculation of two phase multiplier according to Chisholm | constant mass flow rate quality |
|
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 |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Momentum pressure loss of straight pipe for two phase flow | calculate pressure loss |
|
Modelica.Fluid.Dissipation.Utilities.Functions.PressureLoss.TwoPhase Geodetic pressure loss of straight pipe for two phase flow | calculate pressure loss |
|
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 |
|
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 |
|
Modelica.Fluid.Dissipation.PressureLoss.Valve Pressure loss of valve | calculate pressure loss | several geometries | overall flow regime |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe for two phase flow | calculate (frictional, momentum, geodetic) pressure loss |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate mass flow rate | turbulent flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate pressure loss | turbulent flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate mass flow rate | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate pressure loss | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate mass flow rate | laminar flow regime (Hagen-Poiseuille) |
|
Modelica.Fluid.Dissipation.PressureLoss.StraightPipe Pressure loss of straight pipe | calculate pressure loss| laminar flow regime (Hagen-Poiseuille) |
|
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 |
|
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 |
|
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 |
|
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 |
|
Modelica.Fluid.Dissipation.PressureLoss.General Generic pressure loss | calculate mass flow rate | quadratic function (dp=a*V_flow^2 + b*V_flow) |
|
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) |
|
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 |
|
Modelica.Fluid.Dissipation.PressureLoss.General Generic pressure loss | calculate mass flow rate | nominal operation point | pressure loss law (exponent) | density and dynamic viscosity dependence |
|
Modelica.Fluid.Dissipation.PressureLoss.General Generic pressure loss | calculate mass flow rate | ideal gas | mean density |
|
Modelica.Fluid.Dissipation.PressureLoss.General Generic pressure loss | calculate pressure loss | ideal gas | mean density |
|
Modelica.Fluid.Dissipation.PressureLoss.Channel Pressure loss of internal flow | calculate mass flow rate | overall flow regime | surface roughness | several geometries |
|
Modelica.Fluid.Dissipation.PressureLoss.Channel Pressure loss of internal flow | calculate pressure loss | overall flow regime | surface roughness | several geometries |
|
Modelica.Fluid.Dissipation.PressureLoss.Bend Pressure loss of edged bend | calculate mass flow rate | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.Bend Pressure loss of edged bend | calculate pressure loss | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.Bend Pressure loss of curved bend | calculate mass flow rate | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.PressureLoss.Bend Pressure loss of curved bend | calculate pressure loss | overall flow regime | surface roughness |
|
Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe Local two phase heat transfer coefficient of straight pipe | horizontal or vertical boiling | horizontal condensation |
|
Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe Mean heat transfer coefficient of straight pipe | hydrodynamically developed turbulent flow regime | pressure loss dependence |
|
Modelica.Fluid.Dissipation.HeatTransfer.StraightPipe Mean heat transfer coefficient of straight pipe | hydrodynamically developed turbulent flow regime | pressure loss dependence |
|
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 |
|
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 |
|
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 |
|
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 |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of even plate | turbulent regime | constant wall temperature |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of even plate | turbulent regime | constant wall temperature |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of even plate | overall regime | constant wall temperature |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of even plate | overall regime | constant wall temperature |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of plate | laminar regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.Plate Mean heat transfer coefficient of plate | laminar regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | hydrodynamically developed turbulent flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | hydrodynamically developed turbulent flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | overall flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | overall flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | hydrodynamically developed laminar flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HelicalPipe Mean heat transfer coefficient of helical pipe | laminar flow regime |
|
Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger |
|
Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger |
|
Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger |
|
Modelica.Fluid.Dissipation.HeatTransfer.HeatExchanger |
|
Modelica.Fluid.Dissipation.HeatTransfer.General Mean convective heat transfer coefficient for forced convection | approximation | turbulent regime | hydrodynamically developed fluid flow |
|
Modelica.Fluid.Dissipation.HeatTransfer.General Mean convective heat transfer coefficient for forced convection | approximation | turbulent regime | hydrodynamically developed fluid flow |
|
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 |
|
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 |
|
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 |
|
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 |
|
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 |
|
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 |
|
Modelica.Fluid.Fittings.BaseClasses.GenericResistances.VolumeFlowRate Return pressure loss dp as function of mass flow rate m_flow for a curved bend |
|
Modelica.Fluid.Fittings.BaseClasses.GenericResistances.VolumeFlowRate Return mass flow rate m_flow as function of pressure loss dp for a curved bend |
|
Modelica.Fluid.Fittings.BaseClasses.Orifices.ThickEdgedOrifice Return pressure loss dp as function of mass flow rate m_flow for a thick edged orifice |
|
Modelica.Fluid.Fittings.BaseClasses.Orifices.ThickEdgedOrifice Return mass flow rate m_flow as function of pressure loss dp for a thick edged orifice |
|
Modelica.Fluid.Fittings.BaseClasses.Bends.EdgedBend Return pressure loss dp as function of mass flow rate m_flow for a curved bend |
|
Modelica.Fluid.Fittings.BaseClasses.Bends.EdgedBend Return mass flow rate m_flow as function of pressure loss dp for a curved bend |
|
Modelica.Fluid.Fittings.BaseClasses.Bends.CurvedBend Return pressure loss dp as function of mass flow rate m_flow for a curved bend |
|
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)) |
|
Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent Return pressure drop from constant loss factor, mass flow rate and Re (dp = f(m_flow)) |
|
Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent Return pressure drop from constant loss factor and mass flow rate (dp = f(m_flow)) |
|
Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent Return mass flow rate from constant loss factor data, pressure drop and Re (m_flow = f(dp)) |
|
Modelica.Fluid.Fittings.BaseClasses.QuadraticTurbulent Return mass flow rate from constant loss factor data and pressure drop (m_flow = f(dp)) |
|
Modelica.Fluid.Fittings.BaseClasses Return the loss constant 8*zeta/(pi^2*D^4) |
|
Modelica.Fluid.Fittings.MultiPort |
|
Modelica.Fluid.Valves.BaseClasses.ValveCharacteristics Base class for valve characteristics |
|
Modelica.Fluid.Machines.BaseClasses.PumpMonitoring |
|
Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics Base class for efficiency characteristics |
|
Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics Base class for pump power consumption characteristics |
|
Modelica.Fluid.Machines.BaseClasses.PumpCharacteristics Base class for pump flow characteristics |
|
Modelica.Fluid.Pipes.BaseClasses.WallFriction.Detailed.Internal Calculate pressure drop due to friction as function of mass flow rate |
|
Modelica.Fluid.Pipes.BaseClasses.WallFriction.Detailed.Internal Calculate mass flow rate as function of pressure drop due to friction |
|
Modelica.Fluid.Pipes.BaseClasses.WallFriction.LaminarAndQuadraticTurbulent.Internal Calculate pressure drop due to friction as function of mass flow rate |
|
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 |
|
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 |
|
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 |
|
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 |
|
Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers Return Nusselt number |
|
Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers Return Reynolds number from m_flow, mu, D, A |
|
Modelica.Fluid.Pipes.BaseClasses.CharacteristicNumbers Return Reynolds number from v, rho, mu, D |
|
Modelica.Mechanics.Translational.Examples.Utilities Generate Stribeck friction table for example Friction for the SupportFriction |
|
Modelica.Mechanics.MultiBody.Visualizers.Colors Map a scalar to a color using a color map |
|
Modelica.Mechanics.MultiBody.Visualizers.Colors Save a color map on file in svg (scalable vector graphics) format |
|
Modelica.Mechanics.MultiBody.Interfaces Interface for a function returning a color map |
|
Modelica.Mechanics.MultiBody.Interfaces Interface for a function returning surface characteristics |
|
Modelica.Mechanics.MultiBody.Interfaces Interface for the gravity function used in the World object |
|
Modelica.Mechanics.MultiBody.Frames.Internal Derivative of function Frames.resolveRelative(..) |
|
Modelica.Mechanics.MultiBody.Frames.Internal Derivative of function Frames.resolve2(..) |
|
Modelica.Mechanics.MultiBody.Frames.Internal Derivative of function Frames.resolve1(..) |
|
Modelica.Mechanics.MultiBody.Frames.Internal First derivative of function maxWithoutEvent_d(..) |
|
Modelica.Mechanics.MultiBody.Frames.Internal First derivative of function maxWithoutEvent(..) |
|
Modelica.Mechanics.MultiBody.Frames.Internal Maximum of the input arguments, without event and function can be differentiated |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Map rotation object into e_x and e_y vectors of frame 2, resolved in frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Map rotation object into vector |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return quaternion orientation object Q from orientation object T |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return inverse transformation matrix T_inv from orientation object R |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return transformation matrix T from orientation object R |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object T from quaternion orientation object Q |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object R from inverse transformation matrix T_inv |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object R from transformation matrix T |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object from n_x and n_z vectors |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object from n_x and n_y vectors |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return rotation angles valid for a small rotation and optionally residues that should be zero |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return the 3 angles to rotate in sequence around 3 axes to construct the given orientation object |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return rotation object to rotate in sequence around 3 axes |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return rotation object to rotate around one frame axis |
|
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 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object of a planar rotation |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return absolute orientation object from another absolute and a relative orientation object |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return relative orientation object |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return inverse orientation object |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return orientation object that does not rotate a frame |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform second order tensor from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform second order tensor from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform several vectors from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform several vectors from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform vector from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Transform vector from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return angular velocity resolved in frame 2 from orientation object and its derivative |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return angular velocity resolved in frame 1 from orientation object and its derivative |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices Return residues of orientation constraints (shall be zero) |
|
Modelica.Mechanics.MultiBody.Frames.TransformationMatrices.Orientation Return the constraint residues to express that two frames have the same orientation |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return inverse transformation matrix T_inv from quaternion orientation object Q |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return transformation matrix T from quaternion orientation object Q |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return quaternion orientation object Q from inverse transformation matrix T_inv |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return quaternion orientation object Q from transformation matrix T |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return rotation angles valid for a small rotation |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return quaternion orientation object of a planar rotation |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return absolute quaternions orientation object from another absolute and a relative quaternions orientation object |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return relative quaternions orientation object |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return inverse quaternions orientation object |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return quaternion orientation object that does not rotate a frame |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Transform several vectors from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Transform several vectors from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Transform vector from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Transform vector from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Compute angular velocity resolved in frame 2 from quaternions orientation object and its derivative |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Compute angular velocity resolved in frame 1 from quaternions orientation object and its derivative |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions Return residues of orientation constraints (shall be zero) |
|
Modelica.Mechanics.MultiBody.Frames.Quaternions.Orientation Return the constraint residues to express that two frames have the same quaternion orientation |
|
Modelica.Mechanics.MultiBody.Frames Return unit vector for x-, y-, or z-axis |
|
Modelica.Mechanics.MultiBody.Frames Map rotation object into e_x and e_y vectors of frame 2, resolved in frame 1 |
|
Modelica.Mechanics.MultiBody.Frames Map rotation object into vector |
|
Modelica.Mechanics.MultiBody.Frames Return quaternion orientation object Q from orientation object R |
|
Modelica.Mechanics.MultiBody.Frames Return inverse transformation matrix T_inv from orientation object R |
|
Modelica.Mechanics.MultiBody.Frames Return transformation matrix T from orientation object R |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object R from quaternion orientation object Q |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object R from inverse transformation matrix T_inv |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object R from transformation matrix T and its derivative der(T) |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object R from transformation matrix T |
|
Modelica.Mechanics.MultiBody.Frames Return fixed orientation object from n_x and n_z vectors |
|
Modelica.Mechanics.MultiBody.Frames Return fixed orientation object from n_x and n_y vectors |
|
Modelica.Mechanics.MultiBody.Frames Return rotation angles valid for a small rotation and optionally residues that should be zero |
|
Modelica.Mechanics.MultiBody.Frames Return the 3 angles to rotate in sequence around 3 axes to construct the given orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return fixed rotation object to rotate in sequence around fixed angles along 3 axes |
|
Modelica.Mechanics.MultiBody.Frames Return rotation object to rotate around an angle along one frame axis |
|
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 |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object of a planar rotation |
|
Modelica.Mechanics.MultiBody.Frames Return absolute orientation object from another absolute and a relative orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return relative orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return inverse orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return orientation object that does not rotate a frame |
|
Modelica.Mechanics.MultiBody.Frames Transform second order tensor from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames Transform second order tensor from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames Transform vector from frame 1 to frame 2 using absolute orientation objects of frame 1 and of frame 2 |
|
Modelica.Mechanics.MultiBody.Frames Transform vector from frame 1 to frame 2 |
|
Modelica.Mechanics.MultiBody.Frames Transform vector from frame 2 to frame 1 |
|
Modelica.Mechanics.MultiBody.Frames Return angular velocity resolved in frame 2 from orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return angular velocity resolved in frame 1 from orientation object |
|
Modelica.Mechanics.MultiBody.Frames Return residues of orientation constraints (shall be zero) |
|
Modelica.Mechanics.MultiBody.Frames.Orientation Return the constraint residues to express that two frames have the same orientation |
|
Modelica.Mechanics.MultiBody.Forces.Internal Standard gravity fields (no/parallel/point field) |
|
Modelica.Magnetic.FluxTubes.Utilities Function used for the initialization of the Preisach hysteresis model GenericHystPreisachEverett |
|
Modelica.Magnetic.FluxTubes.Utilities Everett function, see [YUY89] |
|
Modelica.Magnetic.FluxTubes.Material.SoftMagnetic Approximation of relative permeability mu_r as a function of flux density B for soft magnetic materials |
|
Modelica.Electrical.Spice3.Internal.Csemiconductor |
|
Modelica.Electrical.Spice3.Internal.Csemiconductor |
|
Modelica.Electrical.Spice3.Internal.Csemiconductor |
|
Modelica.Electrical.Spice3.Internal.Jfet Parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Jfet Calculations of currents and capacities |
|
Modelica.Electrical.Spice3.Internal.Jfet Precalculations relating to temperature |
|
Modelica.Electrical.Spice3.Internal.Jfet Gate capacitance calculation |
|
Modelica.Electrical.Spice3.Internal.Jfet Drain current calculation |
|
Modelica.Electrical.Spice3.Internal.Jfet Initial precalculation |
|
Modelica.Electrical.Spice3.Internal.Jfet FET initial precalculations |
|
Modelica.Electrical.Spice3.Internal.Fet Device Parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Bjt Temperature calculation |
|
Modelica.Electrical.Spice3.Internal.Bjt Technology parameter renaming |
|
Modelica.Electrical.Spice3.Internal.Bjt Calculation of currents |
|
Modelica.Electrical.Spice3.Internal.Bjt Temperature dependency calculation |
|
Modelica.Electrical.Spice3.Internal.Bjt Initial calculation |
|
Modelica.Electrical.Spice3.Internal.Bjt Initial calculation |
|
Modelica.Electrical.Spice3.Internal.Rsemiconductor Initial calculation |
|
Modelica.Electrical.Spice3.Internal.Rsemiconductor Device parameter renaming |
|
Modelica.Electrical.Spice3.Internal.Rsemiconductor Technology parameter renaming |
|
Modelica.Electrical.Spice3.Internal.Diode Temperature calculation |
|
Modelica.Electrical.Spice3.Internal.Diode Temperature calculation |
|
Modelica.Electrical.Spice3.Internal.Diode Technology parameter renaming |
|
Modelica.Electrical.Spice3.Internal.Diode Calculation of additional values |
|
Modelica.Electrical.Spice3.Internal.Diode Calculation of currents |
|
Modelica.Electrical.Spice3.Internal.Diode Temperature dependency calculation |
|
Modelica.Electrical.Spice3.Internal.Diode Initial calculation |
|
Modelica.Electrical.Spice3.Internal.Diode Initial precalculation of model line parameters |
|
Modelica.Electrical.Spice3.Internal.Mos2 Device parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Mos2 Parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Mos2 Drain current calculation |
|
mos2ModelLineParamsInitEquationsRevised Modelica.Electrical.Spice3.Internal.Mos2 Initial precalculation |
|
Modelica.Electrical.Spice3.Internal.Mos1 Device parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Mos1 Parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Mos1 Drain current calculation |
|
mos1ModelLineParamsInitEquations Modelica.Electrical.Spice3.Internal.Mos1 Initial precalculation |
|
Modelica.Electrical.Spice3.Internal.Mos Calculation of currents and capacities (level 2) |
|
mos2CalcCalcTempDependenciesRevised Modelica.Electrical.Spice3.Internal.Mos Precalculation relating to temperature |
|
Modelica.Electrical.Spice3.Internal.Mos Mosfet initial precalculations (level 2) |
|
Modelica.Electrical.Spice3.Internal.Mos Calculation of Meyer capacities |
|
Modelica.Electrical.Spice3.Internal.Mos Calculation of currents and capacities (level 1) |
|
Modelica.Electrical.Spice3.Internal.Mos Precalculation relating to temperature |
|
Modelica.Electrical.Spice3.Internal.Mos Mosfet initial precalculations (level 1) |
|
Modelica.Electrical.Spice3.Internal.Mosfet Device parameter renaming to internal names |
|
Modelica.Electrical.Spice3.Internal.Mosfet Number of Pins |
|
Modelica.Electrical.Spice3.Internal.Mosfet Type transcription |
|
Modelica.Electrical.Spice3.Internal.Mosfet MOSFET initial precalculations |
|
Modelica.Electrical.Spice3.Internal.SpiceRoot Choice of junction voltage handling |
|
Modelica.Electrical.Spice3.Internal.SpiceRoot Limitation of junction voltage |
|
Modelica.Electrical.Spice3.Internal.SpiceRoot Initial condition handling |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of energy gap |
|
Modelica.Electrical.Spice3.Internal.Functions Junction current and conductance calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of energy gap |
|
Modelica.Electrical.Spice3.Internal.Functions Capacitance dependent from width and narrow |
|
saturationCurDepTempSPICE3JFET Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of saturation current |
|
Modelica.Electrical.Spice3.Internal.Functions Resistance dependent from width and narrow |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependent conductance |
|
Modelica.Electrical.Spice3.Internal.Functions Junction current and conductance calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Junction capacitance transittime calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Junction current and conductance calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Junction Voltage |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of saturation current |
|
Modelica.Electrical.Spice3.Internal.Functions Junction capacity |
|
Modelica.Electrical.Spice3.Internal.Functions Junction current and conductance calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Coefficient calculation |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of junction parameters |
|
Modelica.Electrical.Spice3.Internal.Functions Voltage limitation |
|
saturationCurDepTempSPICE3MOSFET Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of saturation current |
|
Modelica.Electrical.Spice3.Internal.Functions Temperature dependency of junction potential |
|
Modelica.Electrical.Spice3.Additionals POLY function of SPICE2 |
|
Modelica.Electrical.QuasiStatic.Polyphase.Functions Calculate active power of complex input voltage and current |
|
Modelica.Electrical.QuasiStatic.Polyphase.Functions Overall quasi-RMS value of complex input (current or voltage) |
|
Modelica.Electrical.Polyphase.Functions Determines the indices of all non positive sequences |
|
Modelica.Electrical.Polyphase.Functions Determines the indices of all positive sequences |
|
Modelica.Electrical.Polyphase.Functions Calculates factor of DC-voltage from RMS Y-voltage |
|
Modelica.Electrical.Polyphase.Functions Calculates factor Y voltage to polygon (delta) voltage |
|
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 |
|
Modelica.Electrical.Polyphase.Functions Transformation matrix for symmetrical components |
|
Modelica.Electrical.Polyphase.Functions Matrix symmetric orientation angles for creating the symmetric transformation matrix |
|
Modelica.Electrical.Polyphase.Functions Orientations of the resulting fundamental wave field phasors |
|
Modelica.Electrical.Polyphase.Functions Calculate active power of voltage and current input |
|
Modelica.Electrical.Polyphase.Functions Calculate continuous quasi RMS value of input |
|
Modelica.Electrical.Machines.Thermal Converts a value (e.g. resistance) from reference temperature to an actual temperature |
|
Modelica.Electrical.Machines.Thermal Converts resistance from reference temperature to an actual temperature |
|
Modelica.Electrical.Machines.Thermal Converts alpha from temperature 1 (default 20 degC) to temperature 2 |
|
Modelica.Electrical.Machines.Losses.DCMachines Voltage drop of carbon brushes |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Calculate active power of voltage and current input |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Calculate quasi-RMS value of input |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Converts a space phasor from polar coordinates |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Converts a space phasor to polar coordinates |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Rotates space phasor |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Conversion from space phasor and zero sequence component to polyphase |
|
Modelica.Electrical.Machines.SpacePhasors.Functions Conversion from polyphase input to space phasor and zero sequence component |
|
Modelica.Electrical.Digital.Interfaces.MemoryBase Get Memory |
|
Modelica.Electrical.Analog.Basic.OpAmpDetailed Internal limitation function |
|
Modelica.Electrical.Analog.Basic.OpAmpDetailed Internal limitation function |
|
Modelica.Clocked.RealSignals.Sampler.Utilities.Internal Pseudo random number generator |
|
Modelica.Blocks.Types.ExternalCombiTable2D Terminate 2-dim. table defined by matrix |
|
Modelica.Blocks.Types.ExternalCombiTable2D Initialize 2-dim. table defined by matrix |
|
Modelica.Blocks.Types.ExternalCombiTable1D Terminate 1-dim. table defined by matrix |
|
Modelica.Blocks.Types.ExternalCombiTable1D Initialize 1-dim. table defined by matrix |
|
Modelica.Blocks.Types.ExternalCombiTimeTable Terminate 1-dim. table where first column is time |
|
Modelica.Blocks.Types.ExternalCombiTimeTable Initialize 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Return maximum abscissa value of 2-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Return minimum abscissa value of 2-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Second derivative of interpolated 2-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 2-dim. table defined by matrix (but do not provide a second derivative function) |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 2-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Interpolate 2-dim. table defined by matrix (but do not provide a second derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 2-dim. table defined by matrix (but do not provide a derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 2-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Return maximum abscissa value of 1-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Return minimum abscissa value of 1-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Second derivative of interpolated 1-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 1-dim. table defined by matrix (but do not provide a second derivative function) |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 1-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table defined by matrix (but do not provide a second derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table defined by matrix (but do not provide a derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table defined by matrix |
|
Modelica.Blocks.Tables.Internal Return next time event value of 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Return maximum abscissa value of 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Return minimum abscissa value of 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Second derivative of interpolated 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 1-dim. table where first column is time (but do not provide a derivative function) |
|
Modelica.Blocks.Tables.Internal Derivative of interpolated 1-dim. table where first column is time |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table where first column is time (but do not provide a second derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table where first column is time (but do not provide a derivative function) |
|
Modelica.Blocks.Tables.Internal Interpolate 1-dim. table where first column is time |
|
Modelica.Blocks.Interfaces.Adaptors.Functions Return 2nd derivative (der of state2der1) |
|
Modelica.Blocks.Interfaces.Adaptors.Functions Return 1st derivative (der of state2) |
|
Modelica.Blocks.Interfaces.Adaptors.Functions Return state (with two derivatives) |
|
Modelica.Blocks.Interfaces.Adaptors.Functions Return 1st derivative (der of state1) |
|
Modelica.Blocks.Interfaces.Adaptors.Functions Return state (with one derivative) |
|
Modelica.Blocks.Continuous.Internal.Filter.Utilities Return alpha for band pass |
|
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...) |
|
Modelica.Blocks.Continuous.Internal.Filter.Utilities Transform filter to form with highest power of s equal 1 |
|
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) |
|
Modelica.Blocks.Continuous.Internal.Filter.roots Return band stop filter roots as needed for block for given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.roots Return band pass filter roots as needed for block for given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.roots Return high pass filter roots as needed for block for given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.roots Return low pass filter roots as needed for block for given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.coefficients Return band stop filter coefficients at given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.coefficients Return band pass filter coefficients at given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.coefficients Return high pass filter coefficients at given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.coefficients Return low pass filter coefficients at given cut-off frequency |
|
Modelica.Blocks.Continuous.Internal.Filter.base Return base filter coefficients of Chebyshev I filter (= low pass filter with w_cut = 1 rad/s) |
|
Modelica.Blocks.Continuous.Internal.Filter.base Return base filter coefficients of Butterworth filter (= low pass filter with w_cut = 1 rad/s) |
|
Modelica.Blocks.Continuous.Internal.Filter.base Return base filter coefficients of Bessel filter (= low pass filter with w_cut = 1 rad/s) |
|
Modelica.Blocks.Continuous.Internal.Filter.base Return base filter coefficients of CriticalDamping filter (= low pass filter with w_cut = 1 rad/s) |