|  | 
| #define | SLOWFAC   1.0  /* reduce u_phi by this amount */ | 
|  | 
| #define | MAXPASSPARMS   10 | 
|  | 
| #define | USER_THETAROTMETRIC   (0.0) | 
|  | 
| #define | USER_THETAROTPRIMITIVES   (0.0) | 
|  | 
| #define | NOFIELD   -1 | 
|  | 
| #define | DISK1FIELD   0 | 
|  | 
| #define | DISK2FIELD   1 | 
|  | 
| #define | VERTFIELD   2 | 
|  | 
| #define | DISK1VERT   3 | 
|  | 
| #define | DISK2VERT   4 | 
|  | 
| #define | BLANDFORDQUAD   5 | 
|  | 
| #define | TOROIDALFIELD   6 | 
|  | 
| #define | OHSUGAFIELD   7 | 
|  | 
| #define | MONOPOLAR   8 | 
|  | 
| #define | OLEKFIELD   9 | 
|  | 
| #define | FIELDJONMAD   10 | 
|  | 
| #define | FIELDWALD   11 | 
|  | 
| #define | MONOPOLE   12 | 
|  | 
| #define | SPLITMONOPOLE   13 | 
|  | 
| #define | DIMVARLIST   GGG,CCCTRUE,MSUNCM,MPERSUN,LBAR,TBAR,VBAR,RHOBAR,MBAR,ENBAR,UBAR,TEMPBAR,ARAD_CODE_DEF,XFACT,YFACT,ZFACT,MUMEAN,MUMEAN,OPACITYBAR,MASSCM,KORAL2HARMRHO(1.0),TEMPMIN | 
|  | 
| #define | DIMTYPELIST   "%21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g %21.15g\n" | 
|  | 
| #define | NTUBE   31 | 
|  | 
| #define | WHICHRADATM   0 | 
|  | 
| #define | fsx(x)   ((x)>0 ? exp(-1.0/(x)) : 0.0) | 
|  | 
| #define | gsx(x)   (fsx(x)/(fsx(x) + fsx(1.0-(x)))) | 
|  | 
| #define | stepfunction(x)   (1.0 - gsx((x)-0.5)) | 
|  | 
| #define | stepfunctionab(x, a, b)   (((a)-(b))*stepfunction(x) + (b)) | 
|  | 
| #define | stepfunctionab2(x, a, b)   (((a)-(b))*stepfunction(x)*stepfunction(x) + (b)) | 
|  | 
| #define | NUMTgasITERS   4 | 
|  | 
| #define | JONMADHPOW   (4.0) | 
|  | 
| #define | JONMADR0   (0.0) | 
|  | 
| #define | JONMADROUT   (300.0) | 
|  | 
| #define | QPOWER   (1.0) | 
|  | 
| #define | POWERNU   (2.0) | 
|  | 
| #define | FCOVDERTYPE   DIFFGAMMIE | 
|  | 
| #define | FCOVDXDELTA   1E-5 | 
|  | 
| #define | TAUADJUSTATM   (10.0) | 
|  | 
| #define | KAPPA_ES_FERMICORR(rhocode, Tcode)   (1.0/(1.0+2.7E11*((rhocode)*RHOBAR)/prpow((Tcode)*TEMPBAR,2.0))) | 
|  | PURE ELASTIC SCATTERING.  More... 
 | 
|  | 
| #define | KAPPA_ES_KNCORR(rhocode, Tcode)   (1.0/(1.0+prpow((Tcode)*TEMPBAR/4.5E8,0.86))) | 
|  | 
| #define | KAPPA_ES_CODE(rhocode, Tcode)   (0.2*(1.0+XFACT)*KAPPA_ES_FERMICORR(rhocode,Tcode)*KAPPA_ES_KNCORR(rhocode,Tcode)/OPACITYBAR) | 
|  | kappaes = sigma_T n_e = sigma_T n_b (n_e/n_b) = sigma_T rho/mb (ne/nb)  More... 
 | 
|  | 
| #define | KAPPA_ES_BASIC_CODE(rhocode, Tcode)   (0.2*(1.0+XFACT)/OPACITYBAR) | 
|  | 
| #define | KAPPA_FORCOMPT_RELCORREP(ep)   ((1.0 + 3.683*(ep)+4.0*(ep)*(ep))/(1.0 + (ep))) | 
|  | 
| #define | KAPPA_FORCOMPT_RELCORR(rhocode, Tcode)   (KAPPA_FORCOMPT_RELCORREP(K_BOLTZ*(Tcode)*TEMPBAR/(MELE*CCCTRUE*CCCTRUE))) | 
|  | 
| #define | KAPPA_FORCOMPT_CODE(rhocode, Tcode)   (0.2*(1.0+XFACT)*KAPPA_ES_FERMICORR(rhocode,Tcode)*KAPPA_FORCOMPT_RELCORR(rhocode,Tcode)/OPACITYBAR) | 
|  | 
| #define | KAPPA_ZETA(Tgcode, Trcode)   ((TEMPMIN+Trcode)/(TEMPMIN+Tgcode)) | 
|  | EMISSION (Tr=Tg) or ABSORBPTION (Tr different from Tg)  More... 
 | 
|  | 
| #define | KAPPA_FF_CODE(rhocode, Tgcode, Trcode)   (4.0E22*(1.0+XFACT)*(1.0-ZFACT)*((rhocode)*RHOBAR)*prpow((Tgcode)*TEMPBAR,-0.5)*prpow((Trcode)*TEMPBAR,-3.0)*prlog(1.0+1.6*KAPPA_ZETA(Tgcode,Trcode))*(1.0+4.4E-10*(Tgcode*TEMPBAR))/OPACITYBAR) | 
|  | 
| #define | KAPPAN_FF_CODE(rhocode, Tgcode, Trcode)   KAPPA_FF_CODE(rhocode,Tgcode,Trcode) | 
|  | 
| #define | KAPPA_BF_CODE(rhocode, Tgcode, Trcode)   (3.0E25*(ZFACT)*(1.0+XFACT+0.75*YFACT)*((rhocode)*RHOBAR)*prpow((Tgcode)*TEMPBAR,-0.5)*prpow((Trcode)*TEMPBAR,-3.0)*prlog(1.0+1.6*KAPPA_ZETA(Tgcode,Trcode))/OPACITYBAR) | 
|  | 
| #define | KAPPA_CHIANTIBF_CODE(rhocode, Tgcode, Trcode)   (4.0E34*((rhocode*RHOBAR))*(ZFACT/ZSOLAR)*YELE*prpow((Tgcode)*TEMPBAR,-1.7)*prpow((Trcode)*TEMPBAR,-3.0)/OPACITYBAR) | 
|  | 
| #define | KAPPA_HN_CODE(rhocode, Tgcode, Trcode)   (1.1E-25*prpow(ZFACT,0.5)*prpow((rhocode)*RHOBAR,0.5)*prpow((Tgcode)*TEMPBAR,7.7)/OPACITYBAR) | 
|  | 
| #define | KAPPA_MOL_CODE(rhocode, Tgcode, Trcode)   (0.1*ZFACT/OPACITYBAR) | 
|  | 
| #define | KAPPA_GENFF_CODE(rhocode, Tgcode, Trcode)   (1.0/(1.0/(KAPPA_MOL_CODE(rhocode,Tgcode,Trcode)+KAPPA_HN_CODE(rhocode,Tgcode,Trcode)) + 1.0/(KAPPA_CHIANTIBF_CODE(rhocode,Tgcode,Trcode)+KAPPA_BF_CODE(rhocode,Tgcode,Trcode)+KAPPA_FF_CODE(rhocode,Tgcode,Trcode)))) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   (1E3) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (0.0) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (25*rho) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*1.0) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*0.0) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   1. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*RADWAVE_KAPPA) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*RADWAVE_KAPPAES) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (0.) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (0.) | 
|  | 
| #define | KAPPA   1.0 | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   1.0 | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPA   0. | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   0. | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*KAPPA_FF_CODE(rho,Tg,Tr)) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_BASIC_CODE(rho,T)) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA_ES_CODE(rho,Tg)/1E14*0.1) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (0.0) | 
|  | 
| #define | KAPPA   1.0 | 
|  | SYNCH STUFF.  More... 
 | 
|  | 
| #define | KAPPAES   1.0 | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA*(KAPPA_GENFF_CODE(SMALL+rho,Tg+TEMPMIN,Tr+TEMPMIN))) | 
|  | 
| #define | KAPPANUSER(rho, B, Tg, Tr)   (rho*KAPPA*(KAPPA_GENFF_CODE(SMALL+rho,Tg+TEMPMIN,Tr+TEMPMIN))) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (rho*KAPPAES*KAPPA_ES_CODE(rho,T)) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*KAPPA_ES_BASIC_CODE(rho,Tg)/1E14*0.0) | 
|  | 
| #define | KAPPAESUSER(rho, T)   (0.0) | 
|  | 
| #define | KAPPAUSER(rho, B, Tg, Tr)   (rho*(KAPPA_FF_CODE(SMALL+rho,Tg+TEMPMIN,Tr+TEMPMIN))) | 
|  | 
| #define | KAPPAESUSER(rho, Tg)   (rho*KAPPA_ES_BASIC_CODE(rho,Tg)/100.0) | 
|  | 
| #define | ISKAPPAEABS   0 | 
|  | 
| #define | ISKAPPANABS   1 | 
|  | 
| #define | ISKAPPAEEMIT   2 | 
|  | 
| #define | ISKAPPANEMIT   3 | 
|  | 
| #define | ISKAPPAES   4 | 
|  | 
| #define | E   2.718281828459045 | 
|  | 
| #define | JET6LIKEUSERCOORD   0 | 
|  | 
| #define | UNIHALFUSERCOORD   1 | 
|  | 
| #define | ORIGWALD   2 | 
|  | 
| #define | WHICHUSERCOORD   JET6LIKEUSERCOORD | 
|  | 
| #define | cr(x)   (exp(-1.0/(x))) | 
|  | 
| #define | tr(x)   (cr(x)/(cr(x) + cr(1.0-(x)))) | 
|  | 
| #define | trans(x, L, R)   ((x)<=(L) ? 0.0 : ((x)>=(R) ? 1.0 : tr(((x)-(L))/((R)-(L)))) ) | 
|  | 
| #define | transR(x, center, width)   ( 0.5*(1.0-tanh(+((x)-(center))/(width)))) | 
|  | 
| #define | transL(x, center, width)   ( 0.5*(1.0-tanh(-((x)-(center))/(width)))) | 
|  | 
| #define | transM(x, center, width)   ( exp(-pow(((x)-(center))/((width)*0.5),2.0) ) ) | 
|  | 
| #define | plateau(x, L, R, W)   (trans(x,(L)-0.5*(W),(L)+0.5*(W))*(1.0-trans(x,(R)-0.5*(W),(R)+0.5*(W)))) | 
|  | 
| #define | line1r(x, w)   (Rout) | 
|  | 
| #define | line2r(x, w)   (Routeq) | 
|  | 
| #define | line3r(x, w)   (Rout)) | 
|  | 
| #define | thetajon(x, w, xp1, xp2)   (line1r(x,w)*(1.0-trans(x,xp1,xp2)) + line2r(x,w)*trans(x,xp1,xp2)) | 
|  | 
| #define | lineeqr(x, w)   (R0 + exp(npow*(X[1]-mysx1)*0.70 + npow*mysx1  ) ) | 
|  | 
| #define | linepoler(x, w)   (R0 + exp(npow*X[1])) | 
|  | 
| #define | thetaLr(x, wp, weq, xp1, xp2)   ( linepoler(x,wp)*(1.0-trans(x,xp1,xp2)) + lineeqr(x,weq)*trans(x,xp1,xp2) ) | 
|  | 
| #define | thetajon2(x, wp, weq, xp1, xp2)   ( x<0.5 ? thetaLr(x,wp,weq,xp1,xp2) : thetaLr(1.0-x,wp,weq,xp1,xp2) ) | 
|  | 
| #define | line1(x, w)   ((x)*(w)) | 
|  | 
| #define | line2(x, w)   ((x)*(w)+M_PI-(w)) | 
|  | 
| #define | line3(x, w)   ((x)*(w)) | 
|  | 
| #define | wparsam(x, r)   (h0 + pow(0.15 + ((r)-0.0)/10.0 , -njet)) | 
|  | 
| #define | thetasam(x, r, w, xp1, xp2)   (line1(x,w)*(1.0-trans(x,xp1,xp2)) + line2(x,w)*trans(x,xp1,xp2)) | 
|  | 
| #define | lineeq(x, w)   ((x)*(w)+(0.5*M_PI)-(0.5*w)) | 
|  | 
| #define | linepole(x, w)   (line1(x,w)) | 
|  | 
| #define | thetaL(x, wp, weq, xp1, xp2)   ( linepole(x,wp)*(1.0-trans(x,xp1,xp2)) + lineeq(x,weq)*trans(x,xp1,xp2) ) | 
|  | 
| #define | thetasam2(x, wp, weq, xp1, xp2)   ( x<0.5 ? thetaL(x,wp,weq,xp1,xp2) : -thetaL(1.0-x,wp,weq,xp1,xp2)+M_PI ) | 
|  | 
| #define | MAXIHOR   10 | 
|  | 
| #define | FRACN1   (0.1) | 
|  | 
| #define | ADJUSTFRACT   (0.25) | 
|  | 
|  | 
| static FTYPE | nz_func (FTYPE R) | 
|  | 
| static FTYPE | taper_func2 (FTYPE R, FTYPE rin, FTYPE rpow) | 
|  | 
| static int | fieldprim (int whichmethod, int whichinversion, int *whichvel, int *whichcoord, int ii, int jj, int kk, FTYPE *pr) | 
|  | 
| static int | get_full_rtsolution (int *whichvel, int *whichcoord, int opticallythick, FTYPE *pp, FTYPE *X, FTYPE *V, struct of_geom **ptrptrgeom) | 
|  | 
| static int | make_nonrt2rt_solution (int *whichvel, int *whichcoord, int opticallythick, FTYPE *pp, FTYPE *X, FTYPE *V, struct of_geom **ptrptrgeom) | 
|  | 
| static int | donut_analytical_solution (int *whichvel, int *whichcoord, int opticallythick, FTYPE *pp, FTYPE *X, FTYPE *V, struct of_geom **ptrptrgeom, FTYPE *ptptr) | 
|  | 
| static int | process_solution (int *whichvel, int *whichcoord, int opticallythick, FTYPE *pp, FTYPE *X, FTYPE *V, struct of_geom **ptrptrgeom, FTYPE *ptptr) | 
|  | 
| int | prepre_init_specific_init (void) | 
|  | 
| int | pre_init_specific_init (void) | 
|  | 
| int | init_conservatives (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE(*pstag)[NSTORE2][NSTORE3][NPR], FTYPE(*Utemp)[NSTORE2][NSTORE3][NPR], FTYPE(*U)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| int | post_init_specific_init (void) | 
|  | 
| int | init_consts (void) | 
|  | 
| int | init_global (void) | 
|  | 
| int | init_defcoord (void) | 
|  | 
| int | init_grid (void) | 
|  | 
| int | init_grid_post_set_grid (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE(*pstag)[NSTORE2][NSTORE3][NPR], FTYPE(*ucons)[NSTORE2][NSTORE3][NPR], FTYPE(*vpot)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*Bhat)[NSTORE2][NSTORE3][NPR], FTYPE(*panalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*pstaganalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*vpotanalytic)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*Bhatanalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*F1)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*F2)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*F3)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*Atemp)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3]) | 
|  | 
| int | init_primitives (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE(*pstag)[NSTORE2][NSTORE3][NPR], FTYPE(*ucons)[NSTORE2][NSTORE3][NPR], FTYPE(*vpot)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*Bhat)[NSTORE2][NSTORE3][NPR], FTYPE(*panalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*pstaganalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*vpotanalytic)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*Bhatanalytic)[NSTORE2][NSTORE3][NPR], FTYPE(*F1)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*F2)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*F3)[NSTORE2][NSTORE3][NPR+NSPECIAL], FTYPE(*Atemp)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3]) | 
|  | 
| int | init_dsandvels (int inittype, int pos, int *whichvel, int *whichcoord, SFTYPE time, int i, int j, int k, FTYPE *pr, FTYPE *pstag) | 
|  | 
| int | init_dsandvels_koral (int *whichvel, int *whichcoord, int i, int j, int k, FTYPE *pr, FTYPE *pstag) | 
|  | 
| int | process_restart_toget_radiation (void) | 
|  | 
| static FTYPE | taper_func_exp (FTYPE R, FTYPE rin, FTYPE POTENTIALorPRESSURE) | 
|  | 
| FTYPE | setgpara (FTYPE myr, FTYPE th, FTYPE thpower) | 
|  | 
| FTYPE | setblandfordfield (FTYPE r, FTYPE th) | 
|  | 
| int | init_vpot_user (int *whichcoord, int l, SFTYPE time, int i, int j, int k, int loc, FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE *V, FTYPE *A) | 
|  | 
| int | init_postvpot (int i, int j, int k, FTYPE *pr, FTYPE *pstag, FTYPE *ucons) | 
|  | 
| void | shortout_Bd3 (FTYPE(*prim)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| void | Fcov_numerical (int whichcoord, FTYPE *X, FTYPE(*Fcov)[NDIM]) | 
|  | 
| FTYPE | mcov_func_mcoord (struct of_geom *ptrgeom, FTYPE *X, int ii, int jj) | 
|  | 
| FTYPE | kcov_func_mcoord (struct of_geom *ptrgeom, FTYPE *X, int ii, int jj) | 
|  | 
| void | Jcon_numerical (int whichcoord, FTYPE *X, FTYPE *Jcon) | 
|  | 
| FTYPE | Fcon_func_mcoord (struct of_geom *ptrgeom, FTYPE *X, int ii, int jj) | 
|  | 
| int | init_vpot2field_user (SFTYPE time, FTYPE(*A)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE(*pstag)[NSTORE2][NSTORE3][NPR], FTYPE(*ucons)[NSTORE2][NSTORE3][NPR], FTYPE(*Bhat)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| int | normalize_densities (FTYPE(*prim)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| int | getmax_densities_full (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], SFTYPE *rhomax, SFTYPE *umax, SFTYPE *uradmax, SFTYPE *utotmax, SFTYPE *pmax, SFTYPE *pradmax, SFTYPE *ptotmax) | 
|  | 
| int | get_maxes (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE *bsq_max, FTYPE *ptot_max, FTYPE *beta_min) | 
|  | 
| int | normalize_field (FTYPE(*prim)[NSTORE2][NSTORE3][NPR], FTYPE(*pstag)[NSTORE2][NSTORE3][NPR], FTYPE(*ucons)[NSTORE2][NSTORE3][NPR], FTYPE(*vpot)[NSTORE1+SHIFTSTORE1][NSTORE2+SHIFTSTORE2][NSTORE3+SHIFTSTORE3], FTYPE(*Bhat)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| int | jetbound (int i, int j, int k, int loc, FTYPE *prin, FTYPE *prflux, FTYPE(*prim)[NSTORE2][NSTORE3][NPR]) | 
|  | 
| static FTYPE | kappa_func_fits (int which, FTYPE rho, FTYPE B, FTYPE Tg, FTYPE Tr, FTYPE varexpf) | 
|  | 
| int | kappa_func_fits_all (FTYPE rho, FTYPE B, FTYPE Tg, FTYPE Tr, FTYPE varexpf, FTYPE *kappa, FTYPE *kappaemit, FTYPE *kappan, FTYPE *kappanemit, FTYPE *kappaes) | 
|  | 
| FTYPE | Gcompt (FTYPE rho0, FTYPE Tgas, FTYPE Tradff, FTYPE Ruu) | 
|  | 
| int | coolfunc_user (FTYPE h_over_r, FTYPE *pr, struct of_geom *geom, struct of_state *q, FTYPE(*dUcomp)[NPR]) | 
|  | 
| void | set_coord_parms_nodeps_user (int defcoordlocal) | 
|  | 
| void | set_coord_parms_deps_user (int defcoordlocal) | 
|  | 
| void | write_coord_parms_user (int defcoordlocal, FILE *out) | 
|  | 
| void | read_coord_parms_user (int defcoordlocal, FILE *in) | 
|  | 
| void | blcoord_user (FTYPE *X, FTYPE *V) | 
|  | 
| void | dxdxp_analytic_user (FTYPE *X, FTYPE *V, FTYPE(*dxdxp)[NDIM]) | 
|  | 
| FTYPE | setRin_user (int ihor, FTYPE ihoradjust) | 
|  | 
| int | setihor_user (void) | 
|  | 
USER initial conditions (usually links to code in initbasecode directory) 
Definition in file init.c.