Unstruct2D  1.0
Solution of 2-D Euler- and Navier-Stokes Equations on Unstructured Triangular Grids
 All Classes Files Functions Variables Typedefs Enumerations Macros
Precond Class Reference

#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
 

Detailed Description

Encompasses variables and functions related to low Mach-number preconditioning.

Constructor & Destructor Documentation

Precond::Precond ( )
inline

Initializes data of low Mach-number preconditioning.

Member Function Documentation

REAL Precond::ComputeTheta ( REAL  gam,
REAL  c,
REAL  q2 
) const
inline

Computes the preconditioning parameter.

Parameters
gamratio of specific heats
cspeed of sound
q2total velocity squared
static void Precond::Cons2Prim ( REAL  wvec[],
REAL  wpvec[],
REAL  H,
REAL  q2,
REAL  theta,
REAL  rhoT,
REAL  hp,
REAL  hT,
REAL  pmat[5][5] 
)
inlinestatic

Computes transformation matrix from conservative to primitive variables P^-1 (equivalent to the inverse of the preconditioning matrix G^-1).

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
Htotal enthalpy
q2total velocity squared
thetapreconditioning parameter
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
pmatinverse of matrix P
static void Precond::Eigenvalues ( REAL  wvec[],
REAL  wpvec[],
REAL  V,
REAL  theta,
REAL  rhop,
REAL  rhoT,
REAL  hp,
REAL  hT,
REAL  lam[5][5] 
)
inlinestatic

Computes matrix of eigenvalues of the preconditioned system.

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
Vcontravariant velocity
thetapreconditioning parameter
rhopderivative of density wrp. to pressure
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
lammatrix of eigenvalues
static void Precond::LeftEigenvec ( REAL  wvec[],
REAL  wpvec[],
REAL  nvec[],
REAL  V,
REAL  theta,
REAL  rhop,
REAL  rhoT,
REAL  hp,
REAL  hT,
REAL  evl[5][5] 
)
inlinestatic

Computes matrix of left eigenvectors of G^-1*A_c,p (i.e., (T_p)^-1).

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
nveccomponents of the unit normal vector
Vcontravariant velocity
thetapreconditioning parameter
rhopderivative of density wrp. to pressure
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
evlmatrix of left eigenvectors (T_p)^-1
static void Precond::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] 
)
inlinestatic

Computes matrix product (T_p^-1) * (P^-1).

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
nveccomponents of the unit normal vector
Vcontravariant velocity
Htotal enthalpy
thetapreconditioning parameter
rhopderivative of density wrp. to pressure
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
q2total velocity squared
matresulting matrix
static void Precond::MatrixTimesInverse ( REAL  wpvec[],
REAL  q2,
REAL  amat[5][5],
REAL  bmat[5][5],
REAL  cmat[5][5] 
)
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.

Parameters
wpvecvector of primitive variables
q2total velocity squared
amatmatrix A
bmatmatrix B
cmatresulting matrix C, i.e., C=A*B
static void Precond::MatVecProd5 ( REAL  a[5][5],
REAL  v[],
REAL  c[] 
)
inlinestatic

Computes matrix times vector (n=5).

Parameters
a5x5 matrix A
vvector v (length 5)
cresulting vector c, i.e., c=A*v
static void Precond::Prim2Cons ( REAL  wvec[],
REAL  wpvec[],
REAL  H,
REAL  theta,
REAL  rhoT,
REAL  hp,
REAL  hT,
REAL  pmat[5][5] 
)
inlinestatic

Computes transformation matrix from primitive to conservative variables P (equivalent to the preconditioning matrix G).

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
Htotal enthalpy
thetapreconditioning parameter
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
pmatmatrix P
static void Precond::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] 
)
inlinestatic

Computes matrix of right eigenvectors of G^-1*A_c,p multiplied by the preconditioning matrix G (i.e., G*T_p).

Parameters
wvecvector of conservative variables
wpvecvector of primitive variables
nveccomponents of the unit normal vector
Vcontravariant velocity
Htotal enthalpy
thetapreconditioning parameter
rhopderivative of density wrp. to pressure
rhoTderivative of density wrp. to temperature
hpderivative of enthalpy wrp. to pressure
hTderivative of enthalpy wrp. to temperature
evrmatrix of right eigenvectors multiplied by G (G*T_p)

Member Data Documentation

REAL Precond::machRef2

reference Mach number squared

REAL Precond::preCoeff

parameter K

bool Precond::switchedOn

on/off switch (true, false)


The documentation for this class was generated from the following file: