36 int ghosts = solver->
ghosts;
37 int ndims = solver->
ndims;
38 int index[ndims], bounds[ndims], offset[ndims];
42 for (i=0; i<ndims; i++) bounds[i] += 2*ghosts;
50 double rho, vx, vy, vz, e, P;
81 int ghosts = solver->
ghosts;
83 static int index[
_MODEL_NDIMS_], bounds[_MODEL_NDIMS_], offset[_MODEL_NDIMS_];
93 double *Af = param->
fast_jac+(_MODEL_NDIMS_*p+dir)*JacSize;
122 int ghosts = solver->
ghosts;
124 static int index[
_MODEL_NDIMS_], bounds[_MODEL_NDIMS_], offset[_MODEL_NDIMS_];
136 double rho, vx, vy, vz, e, P;
140 double *Af = param->
fast_jac+(_MODEL_NDIMS_*p+dir)*JacSize;
141 MatVecMult5(_MODEL_NVARS_,fstiff,Af,(u+_MODEL_NVARS_*p));
#define _NavierStokes3DGetFlowVar_(u, stride, rho, vx, vy, vz, e, P, gamma)
#define _ArraySetValue_(x, size, value)
3D Navier Stokes equations (compressible flows)
#define _ArrayIncrementIndex_(N, imax, i, done)
int NavierStokes3DNonStiffFlux(double *f, double *u, int dir, void *s, double t)
#define _NavierStokes3DSetFlux_(f, stride, rho, vx, vy, vz, e, P, dir)
#define _ArraySubtract1D_(x, a, b, size)
#define MatVecMult5(N, y, A, x)
int NavierStokes3DFlux(double *f, double *u, int dir, void *s, double t)
Contains function definitions for common mathematical functions.
#define _ArrayIndex1DWO_(N, imax, i, offset, ghost, index)
#define _ArrayCopy1D_(x, y, size)
Contains structure definition for hypar.
Structure containing variables and parameters specific to the 3D Navier Stokes equations. This structure contains the physical parameters, variables, and function pointers specific to the 3D Navier-Stokes equations.
Some basic definitions and macros.
Contains macros and function definitions for common array operations.
#define _ArrayAddCopy1D_(x, a, y, size)
int NavierStokes3DStiffFlux(double *f, double *u, int dir, void *s, double t)
Structure containing all solver-specific variables and functions.
Contains macros and function definitions for common matrix multiplication.
static const int _NavierStokes3D_stride_