Unstruct2D
1.0
Solution of 2-D Euler- and Navier-Stokes Equations on Unstructured Triangular Grids
|
#include <precond.h>
Public Member Functions | |
Precond () | |
REAL | ComputeTheta (REAL gam, REAL c, REAL q2) const |
Static Public Member Functions | |
static void | Prim2Cons (REAL wvec[], REAL wpvec[], REAL H, REAL theta, REAL rhoT, REAL hp, REAL hT, REAL pmat[5][5]) |
static void | Cons2Prim (REAL wvec[], REAL wpvec[], REAL H, REAL q2, REAL theta, REAL rhoT, REAL hp, REAL hT, REAL pmat[5][5]) |
static void | Eigenvalues (REAL wvec[], REAL wpvec[], REAL V, REAL theta, REAL rhop, REAL rhoT, REAL hp, REAL hT, REAL lam[5][5]) |
static void | LeftEigenvec (REAL wvec[], REAL wpvec[], REAL nvec[], REAL V, REAL theta, REAL rhop, REAL rhoT, REAL hp, REAL hT, REAL evl[5][5]) |
static void | RightEigenvec (REAL wvec[], REAL wpvec[], REAL nvec[], REAL V, REAL H, REAL theta, REAL rhop, REAL rhoT, REAL hp, REAL hT, REAL evr[5][5]) |
static void | MatprodTp1_P1 (REAL wvec[], REAL wpvec[], REAL nvec[], REAL V, REAL H, REAL theta, REAL rhop, REAL rhoT, REAL hp, REAL hT, REAL q2, REAL mat[5][5]) |
static void | MatrixTimesInverse (REAL wpvec[], REAL q2, REAL amat[5][5], REAL bmat[5][5], REAL cmat[5][5]) |
static void | MatVecProd5 (REAL a[5][5], REAL v[], REAL c[]) |
Public Attributes | |
bool | switchedOn |
REAL | preCoeff |
REAL | machRef2 |
Encompasses variables and functions related to low Mach-number preconditioning.
|
inline |
Initializes data of low Mach-number preconditioning.
Computes the preconditioning parameter.
gam | ratio of specific heats |
c | speed of sound |
q2 | total velocity squared |
|
inlinestatic |
Computes transformation matrix from conservative to primitive variables P^-1 (equivalent to the inverse of the preconditioning matrix G^-1).
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
H | total enthalpy |
q2 | total velocity squared |
theta | preconditioning parameter |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
pmat | inverse of matrix P |
|
inlinestatic |
Computes matrix of eigenvalues of the preconditioned system.
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
V | contravariant velocity |
theta | preconditioning parameter |
rhop | derivative of density wrp. to pressure |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
lam | matrix of eigenvalues |
|
inlinestatic |
Computes matrix of left eigenvectors of G^-1*A_c,p (i.e., (T_p)^-1).
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
nvec | components of the unit normal vector |
V | contravariant velocity |
theta | preconditioning parameter |
rhop | derivative of density wrp. to pressure |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
evl | matrix of left eigenvectors (T_p)^-1 |
|
inlinestatic |
Computes matrix product (T_p^-1) * (P^-1).
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
nvec | components of the unit normal vector |
V | contravariant velocity |
H | total enthalpy |
theta | preconditioning parameter |
rhop | derivative of density wrp. to pressure |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
q2 | total velocity squared |
mat | resulting matrix |
|
inlinestatic |
Computes matrix times the inverse of a similar matrix, where both matrices have the structure of the preconditioning (or the transformation) matrix. Thus, products like P*G^-1 or G*P^-1 can be evaluated efficiently.
wpvec | vector of primitive variables |
q2 | total velocity squared |
amat | matrix A |
bmat | matrix B |
cmat | resulting matrix C, i.e., C=A*B |
Computes matrix times vector (n=5).
a | 5x5 matrix A |
v | vector v (length 5) |
c | resulting vector c, i.e., c=A*v |
|
inlinestatic |
Computes transformation matrix from primitive to conservative variables P (equivalent to the preconditioning matrix G).
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
H | total enthalpy |
theta | preconditioning parameter |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
pmat | matrix P |
|
inlinestatic |
Computes matrix of right eigenvectors of G^-1*A_c,p multiplied by the preconditioning matrix G (i.e., G*T_p).
wvec | vector of conservative variables |
wpvec | vector of primitive variables |
nvec | components of the unit normal vector |
V | contravariant velocity |
H | total enthalpy |
theta | preconditioning parameter |
rhop | derivative of density wrp. to pressure |
rhoT | derivative of density wrp. to temperature |
hp | derivative of enthalpy wrp. to pressure |
hT | derivative of enthalpy wrp. to temperature |
evr | matrix of right eigenvectors multiplied by G (G*T_p) |
REAL Precond::machRef2 |
reference Mach number squared
REAL Precond::preCoeff |
parameter K
bool Precond::switchedOn |
on/off switch (true, false)