#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <assert.h>
#include <string.h>
#include <float.h>
#include <limits.h>
#include <time.h>
#include <string>
#include <vector>
#include <valarray>
#include <complex>
#include "cpu.h"
Go to the source code of this file.
Data Structures | |
class | Singleton< T > |
class | t_debugprt |
struct | EmLine |
Defines | |
#define | EXTERN extern |
#define | STATIC static |
#define | DEBUG |
#define | PARALLEL_MODE false |
#define | MALLOC(exp) (MyMalloc(exp,__FILE__, __LINE__)) |
#define | CALLOC MyCalloc |
#define | REALLOC MyRealloc |
#define | ASSERT(exp) |
#define | isnan MyIsnan |
#define | DEBUG_ENTRY(STR) ((void)0) |
#define | DEBUG_EXIT(STR) ((void)0) |
#define | MIN2 min |
#define | MIN3(a, b, c) (MIN2(MIN2(a,b),c)) |
#define | MIN4(a, b, c, d) (MIN2(MIN2(a,b),MIN2(c,d))) |
#define | MAX2 max |
#define | MAX3(a, b, c) (MAX2(MAX2(a,b),c)) |
#define | MAX4(a, b, c, d) (MAX2(MAX2(a,b),MAX2(c,d))) |
#define | POW2 pow2 |
#define | POW3 pow3 |
#define | POW4(X) (POW2(X)*POW2(X)) |
#define | _ERR_ -1 |
#define | HMRATE(a, b, c) hmrate4(a,b,c,phycon.te) |
Functions | |
char | TorF (bool l) |
bool | is_odd (int j) |
bool | is_odd (long j) |
long | nint (double x) |
long | min (int a, long b) |
long | min (long a, int b) |
double | min (float a, double b) |
double | min (double a, float b) |
long | max (int a, long b) |
long | max (long a, int b) |
double | max (float a, double b) |
double | max (double a, float b) |
template<class T > | |
T | sign (T x, T y) |
template<class T > | |
int | sign3 (T x) |
bool | fp_equal (float x, float y) |
bool | fp_equal (double x, double y) |
int | pow2 (int a) |
long | pow2 (long a) |
float | pow2 (float a) |
double | pow2 (double a) |
int | pow3 (int a) |
long | pow3 (long a) |
float | pow3 (float a) |
double | pow3 (double a) |
float | SDIV (float x) |
double | SDIV (double x) |
double | hmrate4 (double a, double b, double c, double te) |
double | fudge (long int ipnt) |
void | broken (void) |
void | fixit (void) |
void | CodeReview (void) |
void | TestCode (void) |
void * | MyMalloc (size_t size, const char *file, int line) |
void * | MyCalloc (size_t num, size_t size) |
void * | MyRealloc (void *p, size_t size) |
NORETURN void | MyAssert (const char *file, int line) |
NORETURN void | cdEXIT (int) |
void | path_not_set (void) |
void | ShowMe (void) |
NORETURN void | TotalInsanity (void) |
NORETURN void | BadRead (void) |
NORETURN void | BadOpen (void) |
NORETURN void | NoNumb (char *chCard) |
void | dbg_printf (int debug, const char *fmt,...) |
void | cdDefines (void) |
double | csphot (long int inu, long int ithr, long int iofset) |
double | RandGauss (double xMean, double s) |
double | MyGaussRand (double PctUncertainty) |
double | AnuUnit (float energy) |
void | cap4 (char *chCAP, char *chLab) |
void | caps (char *chCard) |
double | e2 (double t) |
double | ee1 (double x) |
double | ee1_safe (double x) |
double | FFmtRead (const char *chCard, long int *ipnt, long int last, bool *lgEOL) |
long | nMatch (const char *chKey, const char *chCard) |
long int | GetElem (char *chCARD_CAPS) |
int | GetQuote (char *chLabel, char *chCard, bool lgABORT) |
double | powi (double, long int) |
long int | ipow (long, long) |
void | PrintE82 (FILE *, double) |
void | PrintE71 (FILE *, double) |
void | PrintE93 (FILE *, double) |
char * | PrintEfmt (const char *fmt, double val) |
double | sexp (double x) |
double | dsexp (double x) |
double | plankf (long int ip) |
double | qg32 (double, double, double(*)(double)) |
void | spsort (float x[], long int n, long int iperm[], int kflag, int *ier) |
Variables | |
EXTERN FILE * | ioQQQ |
EXTERN FILE * | ioStdin |
FILE * | ioMAP |
EXTERN FILE * | ioPrnErr |
EXTERN bool | lgAbort |
EXTERN bool | lgTestCodeCalled |
EXTERN bool | lgTestCodeEnabled |
EXTERN bool | lgPrnErr |
EXTERN bool | lgAssertFPE |
EXTERN long int | nzone |
EXTERN double | fnzone |
EXTERN long int | iteration |
const double | ZeroNum |
const int | FILENAME_PATH_LENGTH = 200 |
const int | FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2 |
const int | INPUT_LINE_LENGTH = 200 |
const int | LIMELM = 30 |
const int | NISO = 2 |
const int | NHYDRO_MAX_LEVEL = 401 |
const int | N_H_MOLEC = 8 |
const double | TEND = 4000. |
const double | DEPTH_OFFSET = 1.e-30 |
const int | ipELECTRON = 0 |
const int | ipPROTON = 1 |
const int | ipHE_PLUS = 2 |
const int | ipRecEsc = 2 |
const int | ipRecNetEsc = 1 |
const int | ipRecRad = 0 |
const int | ipPRD = 1 |
const int | ipCRD = -1 |
const int | ipCRDW = 2 |
const int | ipLY_A = -2 |
const int | ipDEST_K2 = 1 |
const int | ipDEST_INCOM = 2 |
const int | ipDEST_SIMPL = 3 |
const int | ipH1s = 0 |
const int | ipH2s = 1 |
const int | ipH2p = 2 |
const int | ipHe1s1S = 0 |
const int | ipHe2s3S = 1 |
const int | ipHe2s1S = 2 |
const int | ipHe2p3P0 = 3 |
const int | ipHe2p3P1 = 4 |
const int | ipHe2p3P2 = 5 |
const int | ipHe2p1P = 6 |
const int | ipHe3s3S = 7 |
const int | ipHe3s1S = 8 |
const int | ipHe3p3P = 9 |
const int | ipHe3d3D = 10 |
const int | ipHe3d1D = 11 |
const int | ipHe3p1P = 12 |
const int | ipHe4s3S = 13 |
const int | ipHe4s1S = 14 |
const int | ipHe4p3P = 15 |
const int | ipHe4d3D = 16 |
const int | ipHe4d1D = 17 |
const int | ipHe4f3F = 18 |
const int | ipHe4f1F = 19 |
const int | ipHe4p1P = 20 |
const int | ipHe5s3S = 21 |
const int | ipHe5s1S = 22 |
const int | ipHe5p3P = 23 |
const int | ipHe5d3D = 24 |
const int | ipHe5d1D = 25 |
const int | ipHe5f3F = 26 |
const int | ipHe5f1F = 27 |
const int | ipHe5g3G = 28 |
const int | ipHe5g1G = 29 |
const int | ipHe5p1P = 30 |
const int | ipH_LIKE = 0 |
const int | ipHE_LIKE = 1 |
const int | ipLI_LIKE = 2 |
const int | ipBE_LIKE = 3 |
const int | ipB_LIKE = 4 |
const int | ipC_LIKE = 5 |
const int | ipN_LIKE = 6 |
const int | ipO_LIKE = 7 |
const int | ipF_LIKE = 8 |
const int | ipHYDROGEN = 0 |
const int | ipHELIUM = 1 |
const int | ipLITHIUM = 2 |
const int | ipBERYLLIUM = 3 |
const int | ipBORON = 4 |
const int | ipCARBON = 5 |
const int | ipNITROGEN = 6 |
const int | ipOXYGEN = 7 |
const int | ipFLUORINE = 8 |
const int | ipNEON = 9 |
const int | ipSODIUM = 10 |
const int | ipMAGNESIUM = 11 |
const int | ipALUMINIUM = 12 |
const int | ipSILICON = 13 |
const int | ipPHOSPHORUS = 14 |
const int | ipSULPHUR = 15 |
const int | ipCHLORINE = 16 |
const int | ipARGON = 17 |
const int | ipPOTASSIUM = 18 |
const int | ipCALCIUM = 19 |
const int | ipSCANDIUM = 20 |
const int | ipTITANIUM = 21 |
const int | ipVANADIUM = 22 |
const int | ipCHROMIUM = 23 |
const int | ipMANGANESE = 24 |
const int | ipIRON = 25 |
const int | ipCOBALT = 26 |
const int | ipNICKEL = 27 |
const int | ipCOPPER = 28 |
const int | ipZINC = 29 |
const double | SEXP_LIMIT = 84. |
#define _ERR_ -1 |
macro to determine size of an array - from p 22, Practice of Programming, by B.W. Kernighan & Rob Pike, Addison Wesley. use: double dbug[100]; for( i=0; i<NELEMS(dbug); i++) ....
Definition at line 596 of file cddefines.h.
#define ASSERT | ( | exp | ) |
Value:
if (!(exp)) \ MyAssert(__FILE__, __LINE__)
Definition at line 380 of file cddefines.h.
Referenced by abscf(), addComment(), addKeyword_num(), addKeyword_txt(), AgeCheck(), AssertFeIIDep(), atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atmdat_HS_caseB(), atmdat_readin(), atom_level2(), atom_level3(), atom_levelN(), atom_pop2(), atom_pop3(), AtomCSInterp(), atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), bh(), bh_log(), bhg(), bhG(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), cdDLine(), cdEmis_ip(), cdLine(), cdLine_ip(), cdSPEC2(), ChargTranSumHeat(), ChckFill(), chLineLbl(), CO_create_react(), CO_drive(), CO_findrk(), CO_Init(), CO_solve(), CO_update_species_cache(), collision_strength_VF01(), ColStrGBar(), CompileAtmosphereCoStar(), conorm(), cont_gaunt_calc(), ContBandsCreate(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvRate2CS(), CoolAdd(), CoolCarb(), CoolDima(), CoolEvaluate(), CoolNitr(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_VS80(), da(), DebyeDeriv(), defect(), dftori(), t_yield::do_kill_yield(), DoBeckert_etal(), DoFSMixing(), DoSutherland(), DynaEndIter(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), eden_sum(), ee1_safe(), EH2_eval(), emergent_line(), esc_CRDcore(), esc_CRDwing(), esc_PRD(), escmase(), F21(), F21_mx(), F21i(), F21i_log(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeII_OTS(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIICreate(), FeIIPun1Depart(), FeIIPunPop(), FeIISumBand(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), FindIndex(), fndstr(), ForbiddenAuls(), FreeFreeGaunt(), fsff(), GammaBn(), GammaBnPL(), GammaK(), GammaPL(), GetFracPop(), GetGF(), GetModel(), GetProbDistr_LowLimit(), getrf_wrapper(), getrs_wrapper(), GetStandardHeLines(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainDrift(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GridGather(), gridXspec(), GrnStdDpth(), GrnVryDpth(), H2_collid_rates(), H2_Cooling(), H2_Create(), H2_Level_low_matrix(), H2_LevelPops(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_X_coll_rate_evaluate(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HCTIon(), HCTRecom(), he_1trans(), he_assign(), He_cross_section(), he_energy(), He_RRCoef_Te(), HeatPunch(), HeatSum(), HeCollid(), HeCreate(), HeCSInterp(), HeLikeError(), HeLikeLevel(), HelikeRecombSetup(), HeRecom(), highen(), Hion_coll_ioniz_ratecoef(), HLineTransOpacSet(), hmole(), hmole_step(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), hydro_vs_ioniz(), t_hydrobranch::HydroBranchFunc(), HydroCollid(), HydroLevel(), HydroLevelPop(), HydroOscilStr(), HydroRecCool(), HydroRecom(), HydroRenorm(), HydroT2Low(), HyperfineCreate(), HyperfineCS(), Hypergeometric2F1(), init_eps(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitGridCoStar(), InitIndexArrays(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_collis(), ion_photo(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonCSInterp(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipShells(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), iter_end_check(), IterEnd(), IterRestart(), L_mix_integrand_VF01(), lgCheckAsserts(), lgCompileAtmosphere(), lgConvPres(), lgIonizConverg(), lgMolecAver(), lgValidModel(), linadd(), lindst(), LineConvRate2CS(), lines_helium(), lines_hydro(), lines_setup(), linint(), LinterpTable(), LinterpVector(), log10_fsff(), log10_prodxx(), log_integral(), MeanIonRadius(), MeanIonVolume(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), mie_write_opc(), mole_H2_form(), mole_H2_LTE(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), newelement(), NewGrainBin(), newreaction(), newspecies(), nMatch(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), optimize_func(), ParseAssertResults(), ParseAtomHeLike(), ParseCommands(), ParseCosmicRays(), ParseCrashDo(), ParseElement(), ParseFluc(), ParseOptimize(), ParsePrint(), ParsePunch(), ParseTable(), PE_init(), PlanckIntegral(), PntForLine(), PressureChange(), PresTotCurrent(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_He_like_DeparCoef(), prt_He_like_Pops(), prt_wl(), PrtComment(), PrtFinal(), PrtLinePres(), PrtMeanIon(), PrtZone(), punch_average(), punch_line(), punch_opacity(), PunchDo(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSfile(), PunchNewContinuum(), punResults(), PutCS(), putError(), PutHetCol(), PutLine(), qheat(), qheat_init(), radius_first(), radius_increment(), radius_next(), read_hm05(), t_hydrobranch::ReadBlock(), ReadTable(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), RefIndex(), resetBltin(), ReturnGrainBins(), rfield_opac_malloc(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_line_one(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_recom_effic(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), S62_Therm_ave_coll_str(), SanityCheckBegin(), ScanProbDistr(), scqdri(), search_limit(), SetLimits(), SetLimitsSub(), SetNChrgStates(), size_distr(), Spec_cont(), spline_cubic_set(), sprt_wl(), StarburstInitialize(), StarkCollTransProb_VF01(), t_ADfA::t_ADfA(), t_hydrobranch::t_hydrobranch(), tbl_fun(), TempInterp(), tfidle(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), WavlenErrorGet(), writeCloudyDetails(), and ZoneStart().
#define CALLOC MyCalloc |
now special version of calloc - it dies if cannot allocate space.
Definition at line 361 of file cddefines.h.
Referenced by CompileAtmosphereCoStar(), CoolPunch(), F21(), F21_mx(), H_photo_cs_log10(), HeatPunch(), InitGridCoStar(), lgCompileAtmosphere(), and ParseTable().
#define DEBUG |
to avoid errors introduced by C's infamous double-negative logic, this uses NDEBUG (the ANSI std macro used to tell assert that we are not debugging) to define DEBUG
Definition at line 329 of file cddefines.h.
#define DEBUG_ENTRY | ( | STR | ) | ((void)0) |
Definition at line 432 of file cddefines.h.
Referenced by abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AbundancesZero(), addComment(), addentry(), addKeyword_num(), addKeyword_txt(), advection_set_detault(), AgeCheck(), AGN_He1_CS(), anomal(), AnuUnit(), AssertFeIIDep(), AtlasCompile(), AtlasInterpolate(), atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atmdat_3body(), atmdat_dielrec_fe(), atmdat_DielSupres(), atmdat_outer_shell(), atmdat_readin(), AtmospheresAvail(), atom_level2(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop2(), atom_pop3(), atom_pop5(), AtomCSInterp(), atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), aver(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), BadOpen(), badprt(), BadRead(), BadStart(), bangin(), bessel_i0(), bessel_i0_scaled(), bessel_i1(), bessel_i1_scaled(), bessel_j0(), bessel_j1(), bessel_jn(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bh(), bh_log(), bhg(), bhG(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), bigk(), blkdata1(), Bruggeman(), C6cs123(), Ca20cs123(), calcc(), cap4(), caps(), caunin(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDLine(), cdDrive(), cdEmis(), cdEmis_ip(), cdErrors(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInp(), cdIonFrac(), cdLine(), cdLine_ip(), cdLineListPunch(), cdNoExec(), cdNotes(), cdNwcns(), cdOutp(), cdPressure_depth(), cdPressure_last(), cdPrtWL(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), ChckFill(), CheckVal(), chi2_func(), chIonLbl(), chkCaHeps(), ChkUnits(), chLineLbl(), ClosePunchFiles(), cmshft(), cnewton(), CO_create_react(), CO_dissoc_rate(), CO_drive(), CO_findrate(), CO_findrate_s(), CO_findrk(), CO_Init(), co_lnu_c_o_lnu(), CO_OTS(), CO_PopsEmisCool(), CO_punch_mol(), CO_sink_rate(), CO_source_rate(), CO_step(), CO_update_rks(), CO_update_species_cache(), CO_zero(), t_ADfA::coll_ion(), collision_strength_VF01(), ColStrGBar(), CompileAtmosphereCoStar(), con_pump_op(), cone2(), conorm(), conpmp(), conrec(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolChro(), CoolCoba(), CoolDima(), CoolEvaluate(), CoolFluo(), CoolIron(), CoolMagn(), CoolMang(), CoolNeon(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolPunch(), CoolScan(), CoolSili(), CoolSodi(), CoolSulf(), CoolSum(), CoolTita(), CoolVana(), CoolZero(), CoolZinc(), CoStarCompile(), CoStarInterpolate(), CoStarListModels(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), csphot(), csscal(), d3_np_fs(), da(), dbg_printf(), DebyeDeriv(), dense_fabden(), dense_tabden(), dftori(), dgaunt(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), dist(), DLASWP(), dmpary(), Drive_cdLine(), DrvCaseBHS(), DrvContPump(), DrvEscP(), DrvHyas(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpLine(), DynaCreateArrays(), DynaEndIter(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaPresChngFactor(), DynaPrtZone(), DynaPunch(), DynaPunchTimeDep(), DynaStartZone(), DynaZero(), eden_sum(), ee1(), ee1_safe(), eina(), emergent_line(), EmLineJunk(), EmLineZero(), endFindLevLine(), esc_CRDcore(), esc_CRDwing(), esc_CRDwing_1side(), esc_PRD(), esc_PRD_1side(), esca0k2(), esccon(), escConE2(), escmase(), evalf(), exp1(), expn(), extend(), extin(), F21(), F21_mx(), F21i(), F21i_log(), Fe11Lev5(), Fe13Lev5(), fe14cs(), Fe26cs123(), Fe2_cooling(), Fe2_ovr_DataInit(), fe2par(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), Fe_10_11_13_cs(), FeII_Colden(), FeII_InterEnergy(), FeII_LineZero(), FeII_OTS(), FeII_RT_Make(), FeII_RT_Out(), FeII_RT_tau_reset(), FeII_RT_TauInc(), FeIIAccel(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIIFillLow16(), FeIIIntenZero(), FeIILevelPops(), FeIILyaPump(), FeIIOvrLap(), FeIIPoint(), FeIIPrint(), FeIIPun1Depart(), FeIIPunchColden(), FeIIPunchLevels(), FeIIPunchLines(), FeIIPunchLineStuff(), FeIIPunchOpticalDepth(), FeIIPunData(), FeIIPunDepart(), FeIIPunPop(), FeIIRadPress(), FeIIReset(), FeIISumBand(), FeIIZero(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), FillJ(), find_arr(), findelement(), FindHCoStar(), FindIndex(), FindNeg(), findspecies(), FindVCoStar(), FndLineHt(), fndneg(), fndstr(), FreeGrid(), freehash(), fsff(), fstats(), fudge(), GammaBn(), GammaBnPL(), GammaK(), GammaPL(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), gauss_init(), gauss_legendre(), gbar0(), gbar1(), getbin(), GetElem(), GetFracPop(), GetGF(), GetLineRec(), GetMaxhLine(), GetModel(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrainZero(), grid_do(), GridCompile(), GridGather(), GridInitialize(), GridInterpolate(), gridXspec(), grn_abs(), GrnStdDpth(), GrnVryDpth(), H1cs123(), H2_Accel(), H2_Colden(), H2_collid_rates(), H2_ContPoint(), H2_Cooling(), H2_Create(), H2_gs_rates(), H2_Init(), H2_InterEnergy(), H2_Level_low_matrix(), H2_LevelPops(), H2_LinesAdd(), H2_LineZero(), H2_ParsePunch(), H2_Prt_column_density(), H2_Prt_line_tau(), H2_Prt_Zone(), H2_Punch_line_data(), H2_PunchDo(), H2_PunchLineStuff(), H2_RadPress(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_Reset(), H2_RT_diffuse(), H2_RT_OTS(), H2_RT_tau_inc(), H2_RT_tau_reset(), H2_RTMake(), H2_Solomon_rate(), H2_X_coll_rate_evaluate(), H2_Zero(), H2_zero_pops_too_low(), H_Einstein_A(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), hashfunction(), HCoolRatio(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), He_RRCoef_Te(), HeatPunch(), HeatSum(), HeCollid(), HeCreate(), HeLike(), HelikeCheckRecomb(), HeLikeLevel(), HeRecom(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), HLineTransOpacSet(), hmiopc(), hmirat(), hmole(), hmole_init(), hmole_reactions(), hmole_step(), hmrate(), t_ADfA::hpfit(), hrii(), hrii_log(), Hydcs123(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), hydro_vs_ioniz(), t_hydrobranch::HydroBranchFunc(), HydroCollid(), HydroEinstA(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroOscilStr(), HydroRecCool(), HydroRecom(), HydroRenorm(), HydroT2Low(), HyperfineCreate(), HyperfineCS(), hypho(), IDAMAX(), ILAENV(), init_eps(), InitEmissivities(), InitEnthalpy(), initFindLevLine(), InitGrid(), InitGridCoStar(), InitIndexArrays(), input_init(), input_readarray(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_collis(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_zero(), IonAlumi(), IonArgon(), IonBeryl(), IonBoron(), IonCalci(), IonCarbo(), IonChlor(), IonChrom(), IonCobal(), IonCoppe(), IonCSInterp(), IonFluor(), IonHelium(), IonIron(), IonLithi(), IonMagne(), IonManga(), IonNeon(), IonNicke(), IonNitro(), IonOxyge(), IonPhosi(), IonPotas(), IonScand(), IonSilic(), IonSodiu(), IonSulph(), IonTitan(), IonVanad(), IonZinc(), ipContEnergy(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipow(), ipShells(), isactive(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), iso_zero(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Kurucz79Compile(), Kurucz79Interpolate(), L_mix_integrand_VF01(), lagrange(), lgCheckAsserts(), lgCompileAtmosphere(), lgFileReadable(), lgInputComment(), lgIonizConverg(), lgMolecAver(), lgOptimize_do(), lgTauGood(), lgValidAsciiFile(), lgValidBinFile(), lgValidModel(), ligbar(), LimitSh(), linadd(), lindst(), LineConvRate2CS(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_molecules(), lines_setup(), lines_table(), linfit(), linint(), LinterpTable(), LinterpVector(), locate(), log10_fsff(), log_integral(), lookup_key(), LSAME(), Magnetic_evaluate(), Magnetic_init(), Magnetic_reinit(), MakeCS(), MakeDeriv(), MakeHCTData(), makelist(), makeplist(), map_do(), maxchain(), MeanInc(), MeanIonRadius(), MeanIonVolume(), MeanZero(), mie_auxiliary(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_data(), mie_next_line(), mie_read_double(), mie_read_float(), mie_read_form(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_write_form(), mie_write_opc(), MihalasCompile(), MihalasInterpolate(), molcol(), mole_H2_form(), mole_H2_LTE(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), Ne10cs123(), NewChargeData(), newelement(), NewGrainBin(), newhash(), newpt(), newreact(), newspecies(), nMatch(), noneq_offset(), NoNumb(), notein(), nxtchr(), OccupationNumberLine(), ofit(), oi3Pcs(), oi_level_pops(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), opfun(), optimize_func(), optimize_phymir(), optimize_subplex(), order(), outline(), outsum(), pah1_fun(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), partx(), path_not_set(), PE_init(), pfeii(), t_ADfA::phfit(), phygrm(), pintr(), PlanckIntegral(), plankf(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), powi(), PressureChange(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintEfmt(), prme(), prt_constants(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_LineLabels(), prt_smooth_predictions(), prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtContinuum(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace2(), PrtLinePres(), PrtLineSum(), PrtMeanIon(), prtmet(), PrtZone(), ptrcer(), Punch1LineData(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punch_opacity(), PunchDo(), PunchFilesInit(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSfile(), PunchGaunts(), PunchLineData(), PunchLineStuff(), PunchSpecial(), PunFeII(), PunLineIntensity(), punResults(), PunResults1Line(), PutCS(), PutExtra(), PutHetCol(), PutLine(), qg32(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandGauss(), RauchCompile(), RauchInitializeSub(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), rayleh(), rd_continue(), read_hm05(), t_hydrobranch::ReadBlock(), ReadTable(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), t_ADfA::rec_lines(), RefIndex(), ReturnGrainBins(), rfield_opac_malloc(), ritodf(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_OTS_Zero(), RT_radiative_acceleration(), RT_recom_effic(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), RTesc_lya_1side(), S2cs(), S62_Therm_ave_coll_str(), SanityCheckBegin(), ScanProbDistr(), search_limit(), SearchModel(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setstp(), sexp(), ShowMe(), simplx(), sinpar(), size_distr(), sortd(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), sprt_wl(), spsort(), StarburstCompile(), StarburstInitialize(), StarkCollTransProb_VF01(), start(), state_do(), state_get_put(), Stognienko(), StuffComment(), subopt(), sumcon(), t_ADfA::t_ADfA(), t_hydrobranch::t_hydrobranch(), tauff(), tbl_fun(), TeBrent(), TempInterp(), TestCode(), TexcLine(), tfidle(), th85rate(), Therm_ave_coll_str_int_VF01(), ThetaNu(), timestep_next(), TlustyCompile(), TlustyInterpolate(), TotalInsanity(), totlin(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), ValidateGrid(), vary_input(), velset(), vfun(), vib_evap(), warnin(), WavlenErrorGet(), wcnint(), WernerCompile(), WernerInterpolate(), WMBASICCompile(), WMBASICInterpolate(), wr_continue(), XERBLA(), xinvrs(), xmap(), Yan_H2_CS(), zero(), ZeroContin(), Zerologic(), ZoneEnd(), and ZoneStart().
#define DEBUG_EXIT | ( | STR | ) | ((void)0) |
Definition at line 433 of file cddefines.h.
Referenced by abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AbundancesZero(), addComment(), addentry(), addKeyword_num(), addKeyword_txt(), advection_set_detault(), AgeCheck(), AGN_He1_CS(), anomal(), AnuUnit(), AssertFeIIDep(), AtlasCompile(), AtlasInterpolate(), atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atmdat_3body(), atmdat_dielrec_fe(), atmdat_DielSupres(), atmdat_outer_shell(), atmdat_readin(), AtmospheresAvail(), atom_level2(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop2(), atom_pop3(), atom_pop5(), atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), aver(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), BadOpen(), badprt(), BadRead(), BadStart(), bangin(), bessel_i0(), bessel_i0_scaled(), bessel_i1(), bessel_i1_scaled(), bessel_j0(), bessel_j1(), bessel_jn(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bh(), bh_log(), bhg(), bhG(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), bigk(), blkdata1(), Bruggeman(), C6cs123(), Ca20cs123(), calcc(), cap4(), caps(), caunin(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDLine(), cdDrive(), cdEmis(), cdEmis_ip(), cdErrors(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInit(), cdInp(), cdIonFrac(), cdLine(), cdLine_ip(), cdLineListPunch(), cdNoExec(), cdNotes(), cdNwcns(), cdOutp(), cdPressure_depth(), cdPressure_last(), cdPrtWL(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), CheckVal(), chi2_func(), chIonLbl(), chkCaHeps(), ChkUnits(), chLineLbl(), ClosePunchFiles(), cmshft(), cnewton(), CO_create_react(), CO_dissoc_rate(), CO_drive(), CO_findrate(), CO_findrate_s(), CO_findrk(), CO_Init(), co_lnu_c_o_lnu(), CO_OTS(), CO_PopsEmisCool(), CO_punch_mol(), CO_sink_rate(), CO_solve(), CO_source_rate(), CO_step(), CO_update_rks(), CO_update_species_cache(), CO_zero(), t_ADfA::coll_ion(), collision_strength_VF01(), ColStrGBar(), CompileAtmosphereCoStar(), con_pump_op(), cone2(), conorm(), conpmp(), conrec(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolChro(), CoolCoba(), CoolDima(), CoolEvaluate(), CoolFluo(), CoolIron(), CoolMagn(), CoolMang(), CoolNeon(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolPunch(), CoolScan(), CoolSili(), CoolSodi(), CoolSulf(), CoolSum(), CoolTita(), CoolVana(), CoolZero(), CoolZinc(), CoStarCompile(), CoStarInterpolate(), CoStarListModels(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), csphot(), csscal(), d3_np_fs(), da(), dbg_printf(), DebyeDeriv(), dense_fabden(), dense_tabden(), dftori(), dgaunt(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), dist(), DLASWP(), dmpary(), DrvContPump(), DrvEscP(), DrvHyas(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpLine(), DynaCreateArrays(), DynaEndIter(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaPunchTimeDep(), DynaSaveLast(), DynaStartZone(), DynaZero(), eden_sum(), ee1(), ee1_safe(), eina(), emergent_line(), EmLineJunk(), EmLineZero(), endFindLevLine(), esc_CRDcore(), esc_CRDwing(), esc_CRDwing_1side(), esc_PRD(), esc_PRD_1side(), esca0k2(), esccon(), escConE2(), escmase(), evalf(), exp1(), expn(), extend(), extin(), F21(), F21_mx(), F21i(), F21i_log(), Fe11Lev5(), Fe13Lev5(), fe14cs(), Fe26cs123(), Fe2_cooling(), Fe2_ovr_DataInit(), fe2par(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), Fe_10_11_13_cs(), FeII_Colden(), FeII_InterEnergy(), FeII_LineZero(), FeII_OTS(), FeII_RT_Make(), FeII_RT_Out(), FeII_RT_tau_reset(), FeII_RT_TauInc(), FeIIAccel(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIIFillLow16(), FeIIIntenZero(), FeIILevelPops(), FeIILyaPump(), FeIIOvrLap(), FeIIPoint(), FeIIPrint(), FeIIPun1Depart(), FeIIPunchColden(), FeIIPunchLevels(), FeIIPunchLines(), FeIIPunchLineStuff(), FeIIPunchOpticalDepth(), FeIIPunData(), FeIIPunDepart(), FeIIPunPop(), FeIIRadPress(), FeIIReset(), FeIISumBand(), FeIIZero(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), FillJ(), find_arr(), findelement(), FindHCoStar(), FindIndex(), FindNeg(), findspecies(), FindVCoStar(), FndLineHt(), fndneg(), fndstr(), FreeGrid(), freehash(), fsff(), fstats(), fudge(), GammaBn(), GammaBnPL(), GammaK(), GammaPL(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), gauss_init(), gauss_legendre(), gbar0(), gbar1(), getbin(), GetElem(), GetFracPop(), GetGF(), GetLineRec(), GetMaxhLine(), GetModel(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrainZero(), grid_do(), GridCompile(), GridGather(), GridInitialize(), GridInterpolate(), gridXspec(), GrnStdDpth(), GrnVryDpth(), H1cs123(), H2_Accel(), H2_Colden(), H2_collid_rates(), H2_ContPoint(), H2_Cooling(), H2_Create(), H2_gs_rates(), H2_Init(), H2_InterEnergy(), H2_Level_low_matrix(), H2_LevelPops(), H2_LinesAdd(), H2_LineZero(), H2_ParsePunch(), H2_Prt_column_density(), H2_Prt_line_tau(), H2_Prt_Zone(), H2_Punch_line_data(), H2_PunchDo(), H2_PunchLineStuff(), H2_RadPress(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadEnergies(), H2_ReadTransprob(), H2_Reset(), H2_RT_diffuse(), H2_RT_OTS(), H2_RT_tau_inc(), H2_RT_tau_reset(), H2_RTMake(), H2_Solomon_rate(), H2_X_coll_rate_evaluate(), H2_Zero(), H2_zero_pops_too_low(), H_Einstein_A(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), hashfunction(), HCoolRatio(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), He_RRCoef_Te(), HeatPunch(), HeatSum(), HeatZero(), HeCollid(), HeCreate(), HelikeCheckRecomb(), HeLikeLevel(), HeRecom(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), HLineTransOpacSet(), hmiopc(), hmirat(), hmole(), hmole_init(), hmole_reactions(), hmole_step(), hmrate(), t_ADfA::hpfit(), hrii(), hrii_log(), Hydcs123(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), hydro_vs_ioniz(), t_hydrobranch::HydroBranchFunc(), HydroCollid(), HydroEinstA(), HydroLevel(), HydroLevelPop(), HydroOscilStr(), HydroRecCool(), HydroRecom(), HydroRenorm(), HydroT2Low(), HyperfineCreate(), HyperfineCS(), hypho(), IDAMAX(), ILAENV(), init_eps(), InitEmissivities(), InitEnthalpy(), initFindLevLine(), InitGrid(), InitGridCoStar(), InitIndexArrays(), input_init(), input_readarray(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_collis(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_zero(), IonAlumi(), IonArgon(), IonBeryl(), IonBoron(), IonCalci(), IonCarbo(), IonChlor(), IonChrom(), IonCobal(), IonCoppe(), IonCSInterp(), IonFluor(), IonHelium(), IonIron(), IonLithi(), IonMagne(), IonManga(), IonNeon(), IonNicke(), IonNitro(), IonOxyge(), IonPhosi(), IonPotas(), IonScand(), IonSilic(), IonSodiu(), IonSulph(), IonTitan(), IonVanad(), IonZinc(), ipContEnergy(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipow(), ipShells(), isactive(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), iso_zero(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Kurucz79Compile(), Kurucz79Interpolate(), L_mix_integrand_VF01(), lagrange(), lgCheckAsserts(), lgCompileAtmosphere(), lgFileReadable(), lgInputComment(), lgIonizConverg(), lgMolecAver(), lgOptimize_do(), lgTauGood(), lgValidAsciiFile(), lgValidBinFile(), lgValidModel(), ligbar(), LimitSh(), linadd(), lindst(), LineConvRate2CS(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_molecules(), lines_setup(), lines_table(), linfit(), linint(), LinterpTable(), LinterpVector(), locate(), log10_fsff(), log_integral(), lookup_key(), LSAME(), Magnetic_evaluate(), Magnetic_init(), Magnetic_reinit(), MakeCS(), MakeDeriv(), MakeHCTData(), makelist(), makeplist(), map_do(), maxchain(), MeanInc(), MeanIonRadius(), MeanIonVolume(), MeanZero(), mie_auxiliary(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_data(), mie_next_line(), mie_read_double(), mie_read_float(), mie_read_form(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_write_form(), mie_write_opc(), MihalasCompile(), MihalasInterpolate(), molcol(), mole_H2_form(), mole_H2_LTE(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), Ne10cs123(), NewChargeData(), newelement(), NewGrainBin(), newhash(), newpt(), newreact(), newspecies(), nMatch(), noneq_offset(), NoNumb(), notein(), nxtchr(), OccupationNumberLine(), ofit(), oi3Pcs(), oi_level_pops(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), opfun(), optimize_func(), optimize_phymir(), optimize_subplex(), order(), outline(), outsum(), pah1_fun(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), partx(), path_not_set(), PE_init(), pfeii(), t_ADfA::phfit(), phygrm(), pintr(), PlanckIntegral(), plankf(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), powi(), PressureChange(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintEfmt(), prme(), prt_constants(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_LineLabels(), prt_smooth_predictions(), prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtContinuum(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace2(), PrtLinePres(), PrtLineSum(), PrtMeanIon(), prtmet(), PrtZone(), Punch1LineData(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punch_opacity(), PunchDo(), PunchFilesInit(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSfile(), PunchGaunts(), PunchLineData(), PunchLineStuff(), PunchSpecial(), PunFeII(), PunLineIntensity(), punResults(), PunResults1Line(), PutCS(), PutExtra(), PutHetCol(), PutLine(), qg32(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandGauss(), RauchCompile(), RauchInitializeSub(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), rayleh(), rd_continue(), read_hm05(), t_hydrobranch::ReadBlock(), ReadTable(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), t_ADfA::rec_lines(), RefIndex(), ReturnGrainBins(), rfield_opac_malloc(), ritodf(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_OTS_Zero(), RT_radiative_acceleration(), RT_recom_effic(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), RTesc_lya_1side(), S2cs(), S62_Therm_ave_coll_str(), SanityCheckBegin(), ScanProbDistr(), search_limit(), SearchModel(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setstp(), sexp(), ShowMe(), simplx(), sinpar(), size_distr(), sortd(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), sprt_wl(), spsort(), StarburstCompile(), StarburstInitialize(), StarkCollTransProb_VF01(), start(), state_do(), state_get_put(), Stognienko(), StuffComment(), subopt(), sumcon(), t_ADfA::t_ADfA(), t_hydrobranch::t_hydrobranch(), tauff(), tbl_fun(), TeBrent(), TempInterp(), TestCode(), TexcLine(), tfidle(), th85rate(), Therm_ave_coll_str_int_VF01(), ThetaNu(), timestep_next(), TlustyCompile(), TlustyInterpolate(), TotalInsanity(), totlin(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), ValidateGrid(), vary_input(), velset(), vfun(), warnin(), WavlenErrorGet(), wcnint(), WernerCompile(), WernerInterpolate(), WMBASICCompile(), WMBASICInterpolate(), wr_continue(), xinvrs(), xmap(), Yan_H2_CS(), zero(), ZeroContin(), Zerologic(), ZoneEnd(), and ZoneStart().
#define EXTERN extern |
define EXTERN as nothing before including cddefines.h to allocate global data
Definition at line 39 of file cddefines.h.
#define HMRATE | ( | a, | |||
b, | |||||
c | ) | hmrate4(a,b,c,phycon.te) |
Definition at line 606 of file cddefines.h.
Referenced by ChargTranEval(), hmole_step(), and IonCarbo().
#define isnan MyIsnan |
Definition at line 391 of file cddefines.h.
Referenced by CO_findrk(), CO_solve(), CO_update_species_cache(), fp_equal(), hmole_step(), ion_solver(), IterRestart(), ParseCrashDo(), and PressureChange().
#define MALLOC | ( | exp | ) | (MyMalloc(exp,__FILE__, __LINE__)) |
use special version of malloc - it tests result and dies if cannot allocate space
Definition at line 352 of file cddefines.h.
Referenced by addentry(), AGN_Hemis(), atmdat_readin(), atom_levelN(), AtomSeqBoron(), cdGetLineList(), cdInit(), cdSPEC(), cdSPEC2(), CO_Colden(), CO_create_react(), CO_Init(), CO_PopsEmisCool(), CO_zero(), CompileAtmosphereCoStar(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ConvEdenIoniz(), CoolCarb(), CoolIron(), CoolNitr(), CoolOxyg(), CoolSili(), CoolSulf(), DebyeDeriv(), DynaCreateArrays(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeIIBandsCreate(), FeIIContCreate(), FeIICreate(), FillGFF(), gauss_legendre(), GetStandardHeLines(), GrainDrift(), GrainMakeDiffuse(), GrainsInit(), GridInitialize(), gridXspec(), H2_Create(), H2_Level_low_matrix(), HeCollid(), HeCreate(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), hmole_step(), Hydrogenic(), HydroLevelPop(), HyperfineCreate(), hypho(), initFindLevLine(), InitGrid(), InitIndexArrays(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), ion_solver(), iso_cool(), iso_create(), IterStart(), lgCompileAtmosphere(), lines_helium(), main(), map_do(), MeanZero(), mie_calc_ial(), mie_integrate(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_write_opc(), newelement(), NewGrainBin(), newhash(), newreact(), newreaction(), newspecies(), OpacityAddTotal(), OpacityCreateAll(), ParseAssertResults(), ParseCrashDo(), ParseDynaTime(), ParseInterp(), ParsePunch(), pltcon(), pltopc(), PressureChange(), PrtFinal(), PrtLineSum(), punch_average(), punchFITS_GenericData(), PunchNewContinuum(), qheat(), qheat_init(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), RebinAtmosphere(), RebinQHeatResults(), rfield_opac_malloc(), RT_diffuse(), RT_OTS_Update(), SanityCheckBegin(), sinpar(), spline_cubic_set(), StarburstInitialize(), UpdatePot1(), ValidateGrid(), and zero().
#define MAX2 max |
MAX2 takes two arguments, returns the larger of the two
Definition at line 480 of file cddefines.h.
Referenced by abund_starburst(), AbundancesPrt(), AgeCheck(), AssertFeIIDep(), atmdat_DielSupres(), atmdat_readin(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop5(), atoms_fe2ovr(), badprt(), bhintegrand_log(), C6cs123(), Ca20cs123(), cdColm(), cdDefines(), cdTimescales(), ChargTranSumHeat(), chkCaHeps(), CO_PopsEmisCool(), CO_solve(), collision_strength_VF01(), ColStrGBar(), conorm(), ContCreateMesh(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolIron(), CoolMagn(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPota(), CoolPunch(), CoolSili(), CoolSodi(), CoolSulf(), CoStarListModels(), cross_section(), da(), DebyeDeriv(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), DoBeckert_etal(), DoSutherland(), DrvCaseBHS(), DrvHyas(), DTRSM(), DynaPresChngFactor(), DynaStartZone(), eden_sum(), F2_1(), fe14cs(), Fe26cs123(), Fe2_cooling(), Fe7Lev8(), Fe_10_11_13_cs(), FeIICollRatesBoltzmann(), FeIICreate(), FeIILevelPops(), FeIILyaPump(), FeIIPunchLines(), ffun1(), fill(), find_arr(), fstats(), GammaBn(), GammaBnPL(), GammaK(), GammaPL(), GetFracPop(), GetModel(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainCharge(), GrainChrgTransferRates(), GrainCollHeating(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainRateDr(), GrainsInit(), GrainTemperature(), H1cs123(), h21_t_lt_10(), H2_collid_rates(), H2_Create(), H2_gs_rates(), H2_LevelPops(), H2_PunchDo(), H2_RT_tau_inc(), H_photo_cs_log10(), HCTIon(), HCTRecom(), he_1trans(), HeatSum(), HeCreate(), HeCSInterp(), HelikeCheckRecomb(), HeLikeLevel(), HelikeRecombSetup(), HeRecom(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), HLineTransOpacSet(), hmole_reactions(), hmole_step(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), Hydcs123(), hydro_vs_coll_str(), t_hydrobranch::HydroBranchFunc(), HydroEinstA(), HydroLevel(), HydroRecom(), Hypergeometric2F1(), hypho(), InterpolateModel(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_solver(), ion_trim(), IonIron(), IonMagne(), IonOxyge(), iso_cool(), iso_create(), iter_end_check(), IterRestart(), lgCheckAsserts(), lgConvPres(), lgIonizConverg(), lgOptimize_do(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_molecules(), map_do(), MeanIonRadius(), MeanIonVolume(), MeanZero(), mie_cs(), mie_find_slope(), mie_integrate(), mie_read_mix(), mie_repair(), mie_write_opc(), molcol(), Ne10cs123(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), optimize_func(), optimize_phymir(), optimize_subplex(), pah1_fun(), ParseAtomHeLike(), ParseCommands(), ParseInterp(), ParseOptimize(), ParsePrint(), ParsePunch(), ParseRangeOption(), ParseStop(), ParseTrace(), PE_init(), pltcon(), pltmap(), pltopc(), pltr(), PressureChange(), PresTotCurrent(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtHeader(), PrtZone(), punch_colden(), punch_opacity(), PunchDo(), punchFITSfile(), PunchNewContinuum(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), radrecomb(), rayleh(), RebinQHeatResults(), RT_diffuse(), RT_line_all(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_Update(), RT_recom_effic(), RT_stark(), RTesc_lya(), RTesc_lya_1side(), S2cs(), SanityCheckBegin(), ScanProbDistr(), search_limit(), SetLimits(), SetLimitsSub(), setstp(), sinpar(), spldrv_safe(), splint_safe(), state_get_put(), tauff(), tfidle(), timestep_next(), TryDoubleStep(), uderiv(), UpdatePot(), UpdatePot1(), vary_input(), xNI_coll_stren(), Yan_H2_CS(), and ZoneStart().
#define MAX3 | ( | a, | |||
b, | |||||
c | ) | (MAX2(MAX2(a,b),c)) |
MAX3 takes 3 arguments, returns the largest of the 3
Definition at line 485 of file cddefines.h.
Referenced by fstats(), GetProbDistr_LowLimit(), HeCreate(), pltcon(), pltmap(), and pltopc().
#define MAX4 | ( | a, | |||
b, | |||||
c, | |||||
d | ) | (MAX2(MAX2(a,b),MAX2(c,d))) |
MAX2 takes 4 arguments, returns the largest of the 4
Definition at line 490 of file cddefines.h.
Referenced by InterpolateGff(), radius_next(), and sinpar().
#define MIN2 min |
MIN2 takes two arguments, returns the smaller of the two
Definition at line 458 of file cddefines.h.
Referenced by abund_starburst(), AgeCheck(), atmdat_3body(), atmdat_DielSupres(), atmdat_readin(), atom_oi_calc(), C6cs123(), Ca20cs123(), ChargTranSumHeat(), chi2_func(), CO_PopsEmisCool(), CO_solve(), ContRate(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolFluo(), CoolMagn(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolPunch(), CoolSili(), CoolSodi(), CoolSulf(), CS_l_mixing_PS64(), da(), dense_fabden(), DGETF2(), DGETRF(), DoBeckert_etal(), DoSutherland(), DrvHyas(), DynaStartZone(), esc_CRDcore(), esc_CRDwing(), esc_PRD_1side(), fe14cs(), Fe26cs123(), Fe_10_11_13_cs(), FeIICollRatesBoltzmann(), FeIIPunData(), ffun1(), FillJ(), find_arr(), fstats(), GammaBn(), GammaBnPL(), GammaK(), GammaPL(), GammaPrt(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainScreen(), GrainTemperature(), GridCompile(), H1cs123(), h21_t_ge_10(), H21cm_electron(), H2_PunchDo(), H2_RT_tau_inc(), HCTIon(), HCTRecom(), HeatPunch(), HeatSum(), HeCreate(), HeLikeLevel(), HeRecom(), Hion_coll_ioniz_ratecoef(), HLineTransOpacSet(), hmole_step(), Hydcs123(), t_hydrobranch::HydroBranchFunc(), HydroEinstA(), HydroLevel(), HydroLevelPop(), HydroRecom(), HydroT2Low(), Hypergeometric2F1(), hypho(), ILAENV(), InterpolateModel(), ion_collis(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), IonIron(), IonOxyge(), ipLineEnergy(), ipoint(), iso_continuum_lower(), iso_create(), lgOptimize_do(), lines_hydro(), map_do(), mie_auxiliary(), mie_integrate(), mie_read_mix(), mie_read_rfi(), mie_write_opc(), Ne10cs123(), oi3Pcs(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), optimize_func(), optimize_phymir(), pah1_fun(), ParseAtomHLike(), ParseBlackbody(), ParseCommands(), ParseCosmicRays(), ParseInterp(), ParseRangeOption(), ParseSet(), ParseStop(), partx(), PlanckIntegral(), pltcon(), pltmap(), pltopc(), pltr(), PressureChange(), PresTotCurrent(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtHydroTrace2(), PrtLinePres(), PrtMeanIon(), punch_opacity(), PunchDo(), PunchLineData(), PunchNewContinuum(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), radrecomb(), RebinQHeatResults(), RebinSingleCell(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS_Update(), RT_recom_effic(), RT_stark(), RT_tau_init(), RTesc_lya(), RTesc_lya_1side(), S2cs(), SanityCheckBegin(), SetLimits(), SetLimitsSub(), setstp(), simplx(), spldrv_safe(), splint_safe(), subopt(), sumcon(), TeBrent(), timestep_next(), uderiv(), UpdatePot(), UpdatePot1(), vary_input(), writeCloudyDetails(), xinvrs(), xNI_coll_stren(), and ZoneStart().
#define MIN3 | ( | a, | |||
b, | |||||
c | ) | (MIN2(MIN2(a,b),c)) |
MIN3 takes 3 arguments, returns the smallest of the 3
Definition at line 463 of file cddefines.h.
Referenced by atmdat_3body(), iso_continuum_lower(), ParseCommands(), pltcon(), pltmap(), pltopc(), radius_first(), radius_next(), and RT_line_static().
#define MIN4 | ( | a, | |||
b, | |||||
c, | |||||
d | ) | (MIN2(MIN2(a,b),MIN2(c,d))) |
MIN2 takes 4 arguments, returns the smallest of the 4
Definition at line 468 of file cddefines.h.
Referenced by InterpolateGff(), radius_first(), and radius_next().
#define PARALLEL_MODE false |
as the code is developed this should become part of the design for future true parallel processing. This flag should be false if it is not necessary for a given instance of a routine to keep separate memory. This is the case in a serial machine, or an MPI run where there are n instances of the code running on n processors. This should be true if an instance of a routine must have its own unique memory, so that other instances of the routine, which may be running in parallel on another processor, does not share the same memory.
Definition at line 342 of file cddefines.h.
Referenced by ion_solver().
#define POW2 pow2 |
POW2 takes 1 argument, and squares it
Definition at line 549 of file cddefines.h.
Referenced by abund_starburst(), anomal(), AssertFeIIDep(), atmdat_readin(), Bruggeman(), chi2_func(), cnewton(), collision_strength_VF01(), ColStrGBar(), conorm(), ContSetIntensity(), CoolAlum(), CoolEvaluate(), CoolMagn(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_S62(), DebyeDeriv(), dense_fabden(), dist(), DoFSMixing(), DoSutherland(), DrvCaseBHS(), DynaIonize(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), eina(), FeIICollRatesBoltzmann(), FeIICreate(), FreeFreeGaunt(), fstats(), GammaBnPL(), GammaPL(), gauss_legendre(), gbar0(), gbar1(), GetGF(), GetProbDistr_HighLimit(), gett2(), gett2o3(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), H2_collid_rates(), H2_Cooling(), H2_Create(), H2_vib_dist(), t_ADfA::H_rad_rec(), HeCreate(), Hion_colldeexc_cs(), HLineTransOpacSet(), hmole_reactions(), hmole_step(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), t_hydrobranch::HydroBranchFunc(), HydroEinstA(), HydroOscilStr(), HydroRecCool(), hypho(), ion_recom_calculate(), ion_recomb(), IonCSInterp(), iso_cool(), iso_create(), lgCheckAsserts(), lgCompileAtmosphere(), lgConvPres(), lines_hydro(), lines_lv1_li_ne(), lines_setup(), Magnetic_evaluate(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_integrate(), mie_read_opc(), mie_read_szd(), noneq_offset(), ofit(), oi3Pcs(), Opacity_iso_photo_cs(), OpacityAddTotal(), OpacityCreateAll(), optimize_phymir(), optimize_subplex(), pah1_fun(), t_ADfA::phfit(), phygrm(), PlanckIntegral(), plankf(), PresTotCurrent(), PrtFinal(), PunchDo(), qheat(), radius_first(), radius_increment(), radius_next(), rayleh(), rfield_opac_malloc(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_one(), RTesc_lya_1side(), S62_Therm_ave_coll_str(), sinpar(), size_distr(), StarkCollTransProb_VF01(), Stognienko(), tfidle(), ThetaNu(), uderiv(), UpdatePot1(), UpdatePot2(), velset(), WaveFunction(), and ZoneStart().
#define POW3 pow3 |
POW3 takes 1 argument, and cubes it
Definition at line 559 of file cddefines.h.
Referenced by abund_starburst(), collision_strength_VF01(), cross_section(), DebyeDeriv(), FeIICollRatesBoltzmann(), ffun1(), GetProbDistr_LowLimit(), GrainDrift(), GrainsInit(), HLineTransOpacSet(), hmole_step(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), HydroOscilStr(), HydroRecCool(), iso_cool(), lines_setup(), mie_auxiliary(), mie_integrate(), OpacityCreateAll(), pah1_fun(), ParseAtomHLike(), punch_opacity(), RebinAtmosphere(), sinpar(), UpdatePot1(), and WaveFunction().
#define POW4 | ( | X | ) | (POW2(X)*POW2(X)) |
POW4 takes 1 argument, and raises it to the power 4
Definition at line 568 of file cddefines.h.
Referenced by mie_write_opc(), search_limit(), and size_distr().
#define REALLOC MyRealloc |
now special version of calloc - it dies if cannot allocate space.
Definition at line 370 of file cddefines.h.
Referenced by ConvEdenIoniz(), extend(), opacity_more_memory(), ParseCommands(), PressureChange(), and StarburstInitialize().
#define STATIC static |
Definition at line 46 of file cddefines.h.
double AnuUnit | ( | float | energy | ) |
AnuUnit produce continuum energy in arbitrary units, ip is on C scale
Definition at line 123 of file service.cpp.
References cdEXIT(), t_punch::chConPunEnr, DEBUG_ENTRY, DEBUG_EXIT, EVRYD, ioQQQ, t_punch::ipConPun, punch, RYD_INF, RYDLAM, and SPEEDLIGHT.
Referenced by AGN_Hemis(), pun1Line(), punch_opacity(), PunchDo(), and PunchNewContinuum().
NORETURN void BadOpen | ( | void | ) |
BadOpen tried to open data files and failed
Definition at line 1169 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, ioQQQ, and ShowMe().
Referenced by main().
NORETURN void BadRead | ( | void | ) |
BadRead tried to read internal data and failed
Definition at line 1151 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, ioQQQ, and ShowMe().
Referenced by H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), and HelikeTransProbSetup().
void broken | ( | void | ) |
broken set flag saying that the code is broken
Definition at line 1263 of file service.cpp.
References broke, and t_broke::lgBroke.
Referenced by ion_solver(), and IonNitro().
void cap4 | ( | char * | chCAP, | |
char * | chLab | |||
) |
cap4 convert first 4 char of input line chLab into chCAP all in caps, null termination
chCAP | output string, cap'd first 4 char of chLab, | |
chLab | with null terminating input string ending with eol |
Definition at line 251 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by cdDLine(), cdEmis(), cdLine(), GetOptColDen(), IterStart(), lgCheckAsserts(), optimize_func(), ParseDLaw(), ParseElement(), ParseInterp(), ParseNorm(), ParseStop(), ParseTLaw(), and PrtFinal().
void caps | ( | char * | chCard | ) |
caps convert input command line (through eol) to ALL CAPS
chCard | - line image as string of characters |
Definition at line 278 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by cdColm(), cdEmis(), cdIonFrac(), cdRead(), cdTemp(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), input_readarray(), ParseAbundances(), ParseCommands(), ParseDynaTime(), ParseElement(), ParseInterp(), PrtFinal(), PrtLineSum(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), and punResults().
void cdDefines | ( | void | ) |
Definition at line 123 of file cddefines.cpp.
References chOptimFileName, ionbal, ipCARBON, ipH_LIKE, ipHE_LIKE, ipHELIUM, ipHYDROGEN, ipIRON, ipNITROGEN, ipOXYGEN, ipZINC, iso, lgHydroMalloc, LIMELM, MAX2, t_iso::n_HighestResolved_max, t_iso::nCollapsed_max, t_ionbal::nCompRecoilElec, t_iso::nTopOff, t_iso::numLevels_max, and t_iso::numPrintLevels.
Referenced by cdInit().
NORETURN void cdEXIT | ( | int | ) |
the Cloudy exit handler
Definition at line 314 of file cdinit.cpp.
References ClosePunchFiles(), ioQQQ, and lgMPI.
Referenced by abund_starburst(), AbundancesSet(), AbundancesTable(), AGN_Hemis(), AnuUnit(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_readin(), atom_level3(), atom_levelN(), atom_pop5(), AtomSeqBeryllium(), aver(), Badnell_rec_init(), BadOpen(), BadRead(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bhG(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdInit(), cdRead(), cdSPEC(), cdSPEC2(), cdVersion(), ChargTranPun(), ChckFill(), CheckVal(), chi2_func(), ChkUnits(), cnewton(), CO_Colden(), CO_PopsEmisCool(), CO_solve(), CO_zero(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvTempEdenIoniz(), CoolEvaluate(), coolpr(), CoStarInterpolate(), dense_fabden(), dense_tabden(), dgaunt(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaEndIter(), eden_sum(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), factorial(), Fe11Lev5(), Fe13Lev5(), Fe26cs123(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeII_Colden(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIILevelPops(), FeIIPunchLines(), FeIIPunData(), ffun1(), fill(), FillGFF(), find_arr(), FindIndex(), fsff(), fudge(), gauss_legendre(), GetFracPop(), GetLineRec(), GetModel(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetQuote(), GetStandardHeLines(), GrainCharge(), GrainMakeDiffuse(), GrainsInit(), grid_do(), gridXspec(), H1cs123(), H2_Colden(), H2_Cooling(), H2_Create(), H2_Level_low_matrix(), H2_ParsePunch(), H2_Punch_line_data(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), he_1trans(), HeatPunch(), HeatSum(), HeCreate(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), HeRecom(), Hion_colldeexc_cs(), hmole_step(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), t_hydrobranch::HydroBranchFunc(), HydroCollid(), HydroEinstA(), HydroLevel(), HydroLevelPop(), HydroRecCool(), HydroRecom(), HyperfineCreate(), hypho(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitIndexArrays(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ion_recom_calculate(), ion_solver(), IonCarbo(), ipoint(), iter_end_check(), IterStart(), lfactorial(), lgCheckAsserts(), lgConvPres(), lgOptimize_do(), ligbar(), LimitSh(), lines(), lines_setup(), MakeDeriv(), makelist(), makeplist(), map_do(), mie_auxiliary(), mie_cs(), mie_cs_size_distr(), mie_integrate(), mie_next_line(), mie_read_double(), mie_read_float(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), NewGrainBin(), NoNumb(), oi_level_pops(), OpacityCreateAll(), OpacityCreateReilMan(), optimize_func(), optimize_phymir(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGrain(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), plot(), pltopc(), pltr(), pnegopc(), PntForLine(), PresTotCurrent(), prt_smooth_predictions(), PrtComment(), PrtContinuum(), PrtElem(), PrtFinal(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punch_opacity(), PunchDo(), punchFITS_SpectraData(), punchFITSfile(), PunchLineData(), PunchLineStuff(), PunResults1Line(), qintr(), t_ADfA::rad_rec(), radius_increment(), radius_next(), RauchInitializeSub(), rd_continue(), read_continuum_mesh(), read_hm05(), ReadTable(), RT_DestProb(), RT_line_one(), RT_line_static(), RT_recom_effic(), RT_tau_init(), SanityCheck(), SanityCheckBegin(), search_limit(), SetLimits(), size_distr(), solveions(), spline_cubic_set(), state_do(), state_get_put(), StuffComment(), t_ADfA::t_ADfA(), t_hydrobranch::t_hydrobranch(), TeBrent(), TempInterp(), tfidle(), TotalInsanity(), totlin(), uderiv(), ufunct(), UpdatePot1(), vary_input(), XERBLA(), and zero().
void CodeReview | ( | void | ) |
CodeReview - placed next to code that needs to be checked
Definition at line 1281 of file service.cpp.
References broke, and t_broke::lgCheckit.
double csphot | ( | long int | inu, | |
long int | ithr, | |||
long int | iofset | |||
) |
csphot returns photoionization cross section from opacity stage using std pointers
inu | INU is array index pointing to frequency where opacity is to be evaluated on f not c scale | |
ithr | ITHR is pointer to threshold | |
iofset | IOFSET is offset as defined in opac0 |
Definition at line 1921 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, opac, and t_opac::OpacStack.
Referenced by OpacityAddTotal().
void dbg_printf | ( | int | debug, | |
const char * | fmt, | |||
... | ||||
) |
dbg_printf is a debug print routine that was provided by Peter Teuben, as a component from his NEMO package. It offers run-time specification of the level of debugging
Definition at line 1292 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, t_trace::debug_level, ioQQQ, and trace.
double dsexp | ( | double | x | ) |
dsexp safe exponential function for doubles
x |
Definition at line 1227 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by FeIICollRatesBoltzmann(), HeCollid(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), and lines_helium().
double e2 | ( | double | t | ) |
e2 second exponential integral
t | optical depth argument |
Definition at line 300 of file service.cpp.
References ee1(), max(), and sexp().
Referenced by DrvCaseBHS(), IterRestart(), IterStart(), MakeHCTData(), ParseDrive(), radius_increment(), RT_tau_reset(), and SanityCheckBegin().
double ee1 | ( | double | x | ) |
ee1 first exponential integral
x | optical depth argument, returns e1(tau) |
Definition at line 312 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, and ioQQQ.
Referenced by e2(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), Hydcs123(), ParseDrive(), and SanityCheckBegin().
double ee1_safe | ( | double | x | ) |
this one same as ee1, except is divided by a factor of exp(x), and is only to be used for x>1.
x | optical depth argument, returns e1(tau) * exp(x) |
Definition at line 360 of file service.cpp.
References ASSERT, DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by Hion_colldeexc_cs().
double FFmtRead | ( | const char * | chCard, | |
long int * | ipnt, | |||
long int | last, | |||
bool * | lgEOL | |||
) |
FFmtRead - the free-format number reader
*chCard | string giving the line image | |
*ipnt | the index for the character in the string where we shall start | |
last | the number of characters in the string - do not search beyond it | |
*lgEOL | true if hit end of line with no number |
Definition at line 433 of file service.cpp.
References ASSERT, DEBUG_ENTRY, DEBUG_EXIT, expn(), and nxtchr().
Referenced by abund_starburst(), atmdat_readin(), cdGetLineList(), ContBandsCreate(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetStandardHeLines(), H2_ParsePunch(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCreate(), HelikeRecombSetup(), HelikeTransProbSetup(), HyperfineCreate(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseHDEN(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), read_continuum_mesh(), and read_hm05().
void fixit | ( | void | ) |
fixit set flag saying that this code needs attention, but is not broken, code is in service.cpp
Definition at line 1272 of file service.cpp.
References broke, and t_broke::lgFixit.
Referenced by CO_solve(), grn_abs(), hmole_step(), newreact(), and ParsePunch().
bool fp_equal | ( | double | x, | |
double | y | |||
) | [inline] |
bool fp_equal | ( | float | x, | |
float | y | |||
) | [inline] |
double fudge | ( | long int | ipnt | ) |
fudge enter fudge factors, or some arbitrary number, with fudge command
ipnt |
Definition at line 670 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, t_fudgec::fudgea, fudgec, ioQQQ, and t_fudgec::nfudge.
Referenced by Fe7Lev8(), GrainChargeTemp(), and InitEmissivities().
long int GetElem | ( | char * | chCARD_CAPS | ) |
GetElem scans line image, finds element. returns atomic number j, on C scale. Returns , -1 if no hit. chCARD_CAPS must have been converted to all CAPS by caps() to work
chCARD_CAPS |
Definition at line 700 of file service.cpp.
References t_elementnames::chElementNameShort, DEBUG_ENTRY, DEBUG_EXIT, elementnames, LIMELM, and nMatch().
Referenced by ParseAssertResults(), ParseAtomHeLike(), ParseAtomHLike(), ParseElement(), ParsePrint(), ParsePunch(), ParseSet(), ParseTrace(), and punch_average().
int GetQuote | ( | char * | chLabel, | |
char * | chCard, | |||
bool | lgABORT | |||
) |
GetQuote get any name between double quotes off command line return string as chLabel, is null terminated returns zero for success, 1 for did not find double quotes
*chLabel | we will generate a label and stuff it here | |
*chCard | local cap'd line, we will blank this out | |
lgABORT | if true then abort if no double quotes found, if false then return null string in this case |
Definition at line 732 of file service.cpp.
References cdEXIT(), t_input::chOrgCard, DEBUG_ENTRY, DEBUG_EXIT, input, and ioQQQ.
Referenced by ParseAssertResults(), ParseCompile(), ParseGrain(), ParseInit(), ParseNorm(), ParseOptimize(), ParsePunch(), ParseSet(), ParseState(), ParseStop(), and ParseTable().
double hmrate4 | ( | double | a, | |
double | b, | |||
double | c, | |||
double | te | |||
) | [inline] |
Definition at line 608 of file cddefines.h.
long int ipow | ( | long | , | |
long | ||||
) |
ipow
Definition at line 875 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, and is_odd().
bool is_odd | ( | long | j | ) | [inline] |
Definition at line 442 of file cddefines.h.
bool is_odd | ( | int | j | ) | [inline] |
checks whether argument is odd
Definition at line 441 of file cddefines.h.
Referenced by expn(), fsff(), H2_Create(), ipow(), and powi().
double max | ( | double | a, | |
float | b | |||
) | [inline] |
Definition at line 475 of file cddefines.h.
double max | ( | float | a, | |
double | b | |||
) | [inline] |
Definition at line 474 of file cddefines.h.
long max | ( | long | a, | |
int | b | |||
) | [inline] |
Definition at line 473 of file cddefines.h.
long max | ( | int | a, | |
long | b | |||
) | [inline] |
Definition at line 472 of file cddefines.h.
Referenced by e2(), fp_equal(), maxchain(), and TempInterp().
double min | ( | double | a, | |
float | b | |||
) | [inline] |
Definition at line 453 of file cddefines.h.
double min | ( | float | a, | |
double | b | |||
) | [inline] |
Definition at line 452 of file cddefines.h.
long min | ( | long | a, | |
int | b | |||
) | [inline] |
Definition at line 451 of file cddefines.h.
long min | ( | int | a, | |
long | b | |||
) | [inline] |
Definition at line 450 of file cddefines.h.
Referenced by fp_equal(), ParseCommands(), and TempInterp().
NORETURN void MyAssert | ( | const char * | file, | |
int | line | |||
) |
MyAssert a version of assert that fails gracefully
*file | ||
line |
Definition at line 73 of file service.cpp.
References cdEXIT(), conv, fnzone, ioQQQ, iteration, lgAssertFPE, t_conv::lgSearch, nzone, ShowMe(), TorF(), and ZeroNum.
void* MyCalloc | ( | size_t | num, | |
size_t | size | |||
) |
MyCalloc wrapper for calloc(). Returns a good pointer or dies.
num | use same type as library function CALLOC | |
size |
Definition at line 1840 of file service.cpp.
References ASSERT, cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, and ioQQQ.
double MyGaussRand | ( | double | PctUncertainty | ) |
A custom wrapper for RandGauss than truncates at two standard deviations.
PctUncertainty |
Definition at line 2012 of file service.cpp.
References ASSERT, DEBUG_ENTRY, DEBUG_EXIT, and RandGauss().
Referenced by HeLikeError().
void* MyMalloc | ( | size_t | size, | |
const char * | file, | |||
int | line | |||
) |
MyMalloc wrapper for malloc(). Returns a good pointer or dies.
size | use same type as library function malloc | |
file | ||
line |
Definition at line 1755 of file service.cpp.
References ASSERT, cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, ioQQQ, set_nan(), and set_nanf().
void* MyRealloc | ( | void * | p, | |
size_t | size | |||
) |
MyRealloc wrapper for realloc(). Returns a good pointer or dies.
num | use same type as library function REALLOC | |
size |
Definition at line 1882 of file service.cpp.
References ASSERT, cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, and ioQQQ.
long nint | ( | double | x | ) | [inline] |
nint rounds to the nearest long int
Definition at line 446 of file cddefines.h.
Referenced by GrainCharge(), GrainsInit(), grid_do(), InitEmissivities(), mie_write_form(), ParseSet(), t_ADfA::phfit(), sinpar(), and size_distr().
long nMatch | ( | const char * | chKey, | |
const char * | chCard | |||
) |
nMatch determine whether match to a keyword occurs on command line, return value is 0 if no match, and position of match within string if hit
*chKey | ||
*chCard |
Definition at line 638 of file service.cpp.
References ASSERT, DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by abund_starburst(), cdRead(), ChkUnits(), GetElem(), GetOptTemp(), H2_ParsePunch(), lines_helium(), mie_read_mix(), mie_read_rfi(), mie_read_szd(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGrain(), ParseHDEN(), ParseInit(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), PrtFinal(), punch_average(), Punch_Line_RT(), and punResults().
NORETURN void NoNumb | ( | char * | chCard | ) |
NoNumb general error handler for no numbers on input line
*chCard |
Definition at line 1187 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, and ioQQQ.
Referenced by ParseAssertResults(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseCommands(), ParseConstant(), ParseCosmicRays(), ParseDynaTime(), ParseDynaWind(), ParseF_nu(), ParseIonPar(), ParseMagnet(), ParseNorm(), ParsePunch(), ParseSet(), ParseStop(), punch_average(), and punch_colden().
void path_not_set | ( | void | ) |
path_not_set say that path has not been set
Definition at line 99 of file service.cpp.
References chDataPath, DEBUG_ENTRY, DEBUG_EXIT, ioQQQ, and lgDataPathSet.
Referenced by atmdat_readin(), Badnell_rec_init(), ContBandsCreate(), FeIICreate(), H2_ReadCollRates(), HeCreate(), HelikeTransProbSetup(), HyperfineCreate(), InitGrid(), mie_read_opc(), OpacityCreateAll(), ParseInit(), and read_continuum_mesh().
double plankf | ( | long int | ip | ) |
plankf evaluate Planck function for any cell at current electron temperature
ip |
Definition at line 2040 of file service.cpp.
References t_rfield::anu, t_rfield::ContBoltz, DEBUG_ENTRY, DEBUG_EXIT, FR1RYD, POW2, and rfield.
Referenced by PunchDo().
double pow2 | ( | double | a | ) | [inline] |
Definition at line 553 of file cddefines.h.
float pow2 | ( | float | a | ) | [inline] |
Definition at line 552 of file cddefines.h.
long pow2 | ( | long | a | ) | [inline] |
Definition at line 551 of file cddefines.h.
int pow2 | ( | int | a | ) | [inline] |
Definition at line 550 of file cddefines.h.
Referenced by C6cs123(), Ca20cs123(), Fe26cs123(), hrii(), Hydcs123(), linfit(), log10_prodxx(), and Ne10cs123().
double pow3 | ( | double | a | ) | [inline] |
Definition at line 563 of file cddefines.h.
float pow3 | ( | float | a | ) | [inline] |
Definition at line 562 of file cddefines.h.
long pow3 | ( | long | a | ) | [inline] |
Definition at line 561 of file cddefines.h.
int pow3 | ( | int | a | ) | [inline] |
Definition at line 560 of file cddefines.h.
Referenced by H_Einstein_A_lin(), and H_Einstein_A_log10().
double powi | ( | double | , | |
long | int | |||
) |
powi raise x to integer power
Definition at line 836 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, and is_odd().
Referenced by add_mx(), atmdat_DielSupres(), bhg(), bhG(), DebyeDeriv(), expn(), F21i_log(), FeIILyaPump(), FeIIRadPress(), fsff(), GrainCharge(), H1cs123(), H2_RadPress(), t_ADfA::H_rad_rec(), Hion_coll_ioniz_ratecoef(), Hion_colldeexc_cs(), hmole_step(), hrii(), hrii_log(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_excit(), t_hydrobranch::HydroBranchFunc(), HydroRecCool(), InitEmissivities(), iso_cool(), ParseBackgrd(), PlanckIntegral(), PresTotCurrent(), PrtLinePres(), rayleh(), SanityCheckBegin(), size_distr(), and unmxify().
void PrintE71 | ( | FILE * | , | |
double | ||||
) |
print with 1p,e8.1 format onto stream FILE
Definition at line 1032 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by PrtFinal().
void PrintE82 | ( | FILE * | , | |
double | ||||
) |
print with 1p,e8.2 format onto stream FILE all are located in printe82.c
Definition at line 983 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by AbundancesSet(), optimize_func(), PrtAllTau(), PrtFinal(), and PrtHeader().
void PrintE93 | ( | FILE * | , | |
double | ||||
) |
print with 1p,e9.3 format onto stream FILE
Definition at line 1082 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by HydroLevel(), PrtAllTau(), PrtFinal(), PrtHeader(), PrtHydroTrace1a(), PrtZone(), and punch_opacity().
char* PrintEfmt | ( | const char * | fmt, | |
double | val | |||
) |
create string with val and format, to print with s, much faster than above, totally native on non-MS systems
*fmt | ||
val |
Definition at line 928 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by aver(), GammaPrt(), GetModel(), H2_Prt_column_density(), H2_Prt_Zone(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroRecom(), InterpolateGridCoStar(), InterpolateRectGrid(), iso_photo(), map_do(), prme(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_He_like_DeparCoef(), prt_He_like_Pops(), PrtAllTau(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace2(), PrtZone(), Punch1LineData(), and RT_tau_init().
double qg32 | ( | double | , | |
double | , | |||
double(*)(double) | ||||
) |
32 point gaussian quadrature integration
xl | lower limit to integration | |
xu | - upper limit to integration | |
(*fct) | - pointer to routine to be integrated, arg is x val |
Definition at line 1317 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by AngerJ(), CalculateRadialIntegral(), collision_strength_VF01(), conpmp(), cont_gaunt_calc(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_VS80(), DrvContPump(), esccon(), radrecomb(), and Recomb_Seaton59().
double RandGauss | ( | double | xMean, | |
double | s | |||
) |
normal random variate generator
xMean | mean value | |
s | standard deviation s |
Definition at line 1969 of file service.cpp.
References BIGDOUBLE, DEBUG_ENTRY, DEBUG_EXIT, x1, and x2.
Referenced by H2_Create(), ion_recomb(), and MyGaussRand().
double SDIV | ( | double | x | ) | [inline] |
float SDIV | ( | float | x | ) | [inline] |
SDIV safe division - div by SDIV(x) - if abs val of arg >SMALLFLOAT, returns arg, if < SMALLFLOAT, returns SMALLFLOAT - with negative arg return is +SMALLFLOAT so sign changes
Definition at line 576 of file cddefines.h.
References SMALLFLOAT.
Referenced by AbundancesSet(), atoms_fe2ovr(), cdTemp(), ChargTranEval(), CO_drive(), CO_solve(), ConvBase(), ConvEdenIoniz(), ConvInitSolution(), ConvIterCheck(), CoolCarb(), CoolChlo(), CoolDima(), CoolEvaluate(), CoolNitr(), CoolOxyg(), DynaPunchTimeDep(), DynaStartZone(), eden_sum(), Fe2_cooling(), FeIILevelPops(), FeIIPunPop(), ffun(), GammaPrt(), GrainDrive(), H21_cm_pops(), H2_collid_rates(), H2_Cooling(), H2_gs_rates(), H2_Level_low_matrix(), H2_LevelPops(), H2_Prt_column_density(), H2_Prt_Zone(), H2_PunchDo(), H2_RTMake(), H2_Solomon_rate(), H2_X_coll_rate_evaluate(), HeatSum(), HeLikeLevel(), hmole(), hmole_reactions(), hmole_step(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroT2Low(), ion_recom_calculate(), ion_recomb(), ion_solver(), ion_trim(), IonSilic(), iso_cool(), iter_end_check(), IterEnd(), IterStart(), lgCheckAsserts(), lgConvEden(), lgMolecAver(), lines_continuum(), lines_grains(), MeanInc(), OccupationNumberLine(), ParseTable(), PresTotCurrent(), prt_smooth_predictions(), PrtColumns(), PrtFinal(), PrtHydroTrace2(), PrtZone(), PunchDo(), PunchLineData(), radius_first(), radius_increment(), radius_next(), RT_continuum_shield_fcn(), RT_line_all(), RT_line_one_tauinc(), RT_line_static(), RT_OTS_Update(), RT_stark(), and timestep_next().
double sexp | ( | double | x | ) |
sexp safe exponential function
Definition at line 1204 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, and SEXP_LIMIT.
Referenced by atmdat_dielrec_fe(), atom_level2(), atom_levelN(), atom_pop5(), Badnell_DR_rate_eval(), ChargTranEval(), CO_PopsEmisCool(), ColStrGBar(), con_pump_op(), CoolEvaluate(), CoolIron(), CoolOxyg(), dense_fabden(), e2(), extin(), ffun1(), H21_cm_pops(), H21cm_electron(), H2_collid_rates(), H2_Create(), H2_vib_dist(), H2_X_coll_rate_evaluate(), HCTRecom(), HeCollid(), HeCreate(), highen(), hmole_reactions(), hmole_step(), ion_recom_calculate(), ion_recomb(), IterEnd(), IterRestart(), IterStart(), lines_continuum(), lines_helium(), lines_lv1_na_ar(), mole_H2_LTE(), opfun(), ParseAgn(), ParseDrive(), PrtFinal(), PunchDo(), radius_increment(), RT_continuum_shield_fcn(), velset(), vfun(), and vib_evap().
void ShowMe | ( | void | ) |
print comment asking to show output to me
Definition at line 190 of file service.cpp.
References t_hmi::BiggestH2, cdCautions(), cdPrintCommands(), cdWarnings(), t_version::chInfo, t_version::chVersion, conv, t_hextra::cryden, DEBUG_ENTRY, DEBUG_EXIT, hextra, hmi, input, ioQQQ, t_warnings::ncaun, t_input::nSaveIni, t_conv::nTeFail, t_warnings::nwarn, version, and warnings.
Referenced by atom_level3(), aver(), BadOpen(), BadRead(), cnewton(), CO_solve(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvTempEdenIoniz(), CoolEvaluate(), coolpr(), eden_sum(), escmase(), Fe11Lev5(), Fe13Lev5(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), fill(), FindIndex(), GetFracPop(), GrainCharge(), H2_ReadTransprob(), HeatSum(), HeLikeLevel(), HydroLevel(), HydroRecom(), ion_solver(), ipoint(), iter_end_check(), lgCheckAsserts(), lgConvPres(), ligbar(), lines(), lines_setup(), mie_auxiliary(), mie_cs_size_distr(), mie_read_mix(), mie_read_rfi(), mie_repair(), mie_write_opc(), MyAssert(), ParseInterp(), PresTotCurrent(), prt_smooth_predictions(), PrtComment(), PunchDo(), radius_first(), radius_increment(), radius_next(), RauchInitializeSub(), RT_line_static(), RT_tau_init(), SanityCheckBegin(), size_distr(), tfidle(), TotalInsanity(), and zero().
T sign | ( | T | x, | |
T | y | |||
) | [inline] |
floating point sign transfer (fortran sign function) - sign of y times abs value of x
x | ||
y |
Definition at line 498 of file cddefines.h.
Referenced by bessel_jn(), bessel_yn(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolPunch(), DynaPresChngFactor(), setstp(), TeBrent(), xinvrs(), and ZoneStart().
int sign3 | ( | T | x | ) | [inline] |
sign3 returns -1 for negative arguments, +1 for positive, and 0 for zero (pascal sign function)
Definition at line 506 of file cddefines.h.
Referenced by find_arr(), fp_equal(), mie_read_rfi(), and RebinFind().
void spsort | ( | float | x[], | |
long int | n, | |||
long int | iperm[], | |||
int | kflag, | |||
int * | ier | |||
) |
spsort netlib routine to sort array returning sorted indices
x[] | input array to be sorted | |
n | number of values in x | |
iperm[] | permutation output array | |
kflag | flag saying what to do - 1 sorts into increasing order, not changing | |
kflag | the original routine | |
*ier | error condition, should be 0 |
Definition at line 1386 of file service.cpp.
References DEBUG_ENTRY, and DEBUG_EXIT.
Referenced by CoolPunch(), H2_Create(), H2_PunchDo(), HeatPunch(), PrtFinal(), PrtLinePres(), and SanityCheckBegin().
void TestCode | ( | void | ) |
testcde set flag saying that test code is in place
Definition at line 1249 of file service.cpp.
References DEBUG_ENTRY, DEBUG_EXIT, and lgTestCodeCalled.
char TorF | ( | bool | l | ) | [inline] |
Definition at line 437 of file cddefines.h.
Referenced by CO_drive(), CO_solve(), ConvBase(), ConvEdenIoniz(), ConvIoniz(), ConvPresTempEdenIoniz(), eden_sum(), GrainCharge(), GrainChargeTemp(), GrainsInit(), H2_LevelPops(), HydroLevelPop(), ion_solver(), lgIonizConverg(), lgMolecAver(), MyAssert(), PressureChange(), PrtFinal(), PrtHydroTrace1(), PunchDo(), RT_OTS_PrtRate(), and tfidle().
NORETURN void TotalInsanity | ( | void | ) |
TotalInsanity general error handler for something that cannot happen, exits
Definition at line 1130 of file service.cpp.
References cdEXIT(), DEBUG_ENTRY, DEBUG_EXIT, ioQQQ, and ShowMe().
Referenced by AbundancesPrt(), atmdat_readin(), atom_level3(), atom_levelN(), AtomCSInterp(), cdInit(), cdLine(), cdRead(), ConvIterCheck(), ConvTempEdenIoniz(), CoolCarb(), CoolEvaluate(), CoolIron(), CoolNitr(), CoolOxyg(), CoolSili(), CoolSulf(), DebyeDeriv(), dense_fabden(), DynaPunch(), DynaPunchTimeDep(), Fe7Lev8(), Fe_10_11_13_cs(), ForbiddenAuls(), GrainChargeTemp(), GrnStdDpth(), H2_Create(), H2_LevelPops(), hmole_reactions(), hmole_step(), t_hydrobranch::HydroBranchFunc(), t_yield::init_yield(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), ion_recom_calculate(), IonCSInterp(), iso_cool(), lgCheckAsserts(), lgConvPres(), lgInputComment(), lgMolecAver(), lgOptimize_do(), lines(), lines_setup(), Opacity_iso_photo_cs(), ParseAssertResults(), ParseAtomFeII(), ParseAtomHeLike(), ParseAtomHLike(), ParseGrain(), ParsePunch(), ParseTable(), PresTotCurrent(), prt_wl(), PrtColumns(), PrtComment(), PrtFinal(), punch_average(), PunchDo(), radius_first(), radius_increment(), radius_next(), read_hm05(), rfield_opac_malloc(), RT_continuum_shield_fcn(), RT_OTS_ChkSum(), sprt_wl(), state_get_put(), tbl_fun(), timestep_next(), TlustyInterpolate(), and ZoneStart().
const double DEPTH_OFFSET = 1.e-30 |
this is used to add to depth to prevent div or log of zero
Definition at line 190 of file cddefines.h.
Referenced by ParseSet(), and zero().
const int FILENAME_PATH_LENGTH = 200 |
FILENAME_PATH_LENGTH is the size of the string that holds the path. The longest string that can be held is one less than this, due to the end end of string sentinel in C. Increase this is a larger string is needed to hold the path on your system
Definition at line 157 of file cddefines.h.
Referenced by AtmospheresAvail().
const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2 |
twice the above, so that we can add file name to end of full path
Definition at line 160 of file cddefines.h.
Referenced by atmdat_readin(), AtmospheresAvail(), Badnell_rec_init(), cdGetLineList(), CompileAtmosphereCoStar(), ContBandsCreate(), FeIIBandsCreate(), FeIICreate(), FillGFF(), GetStandardHeLines(), GridCompile(), GridInterpolate(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCreate(), HelikeRecombSetup(), HelikeTransProbSetup(), HyperfineCreate(), t_yield::init_yield(), InitGrid(), mie_next_line(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_write_form(), mie_write_opc(), OpacityCreateAll(), ParseCompile(), ParseGrain(), ParseInit(), ParseTable(), punch_average(), punch_opacity(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), StarburstInitialize(), t_ADfA::t_ADfA(), and t_hydrobranch::t_hydrobranch().
EXTERN double fnzone |
this is nzone + conv.nPres2Ioniz/100 in ConvBase
Definition at line 132 of file cddefines.h.
Referenced by cloudy(), CO_drive(), CO_PopsEmisCool(), CO_solve(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvIoniz(), ConvPresTempEdenIoniz(), CoolCarb(), CoolEvaluate(), CoolOxyg(), dense_fabden(), eden_sum(), GammaPrt(), GammaPrtShells(), GetFracPop(), GrainCharge(), GrainChargeTemp(), H2_Cooling(), H2_LevelPops(), H2_Reset(), HeLikeLevel(), hmole(), hmole_reactions(), hmole_step(), Hydrogenic(), HydroLevelPop(), ion_recomb(), ion_solver(), ion_trim(), IonSilic(), iso_photo(), MyAssert(), PresTotCurrent(), PrtHydroTrace2(), PunchSpecial(), radius_increment(), RT_line_all(), RT_line_static(), RT_OTS(), RT_OTS_PrtRate(), and zero().
const int INPUT_LINE_LENGTH = 200 |
this is limit to longest line of information that is scanned in, end of line char is actually at this +1, dim of vector is this + 1 all routines that scan in information should use this to dim vars
Definition at line 165 of file cddefines.h.
Referenced by abund_starburst(), AgeCheck(), atmdat_readin(), Badnell_rec_init(), BadStart(), cdEmis(), cdGetLineList(), cdInit(), cdIonFrac(), cdLine(), cdRead(), cdTemp(), ContBandsCreate(), ConvEdenIoniz(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetStandardHeLines(), grid_do(), H2_ParsePunch(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCreate(), HelikeRecombSetup(), HelikeTransProbSetup(), HyperfineCreate(), lgCheckAsserts(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseHDEN(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), prt_smooth_predictions(), PrtComment(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), PunLineIntensity(), punResults(), RauchInitializeSub(), read_continuum_mesh(), ReadTable(), StarburstInitialize(), state_get_put(), and writeCloudyDetails().
FILE* ioMAP |
Definition at line 9 of file cddefines.cpp.
Referenced by ClosePunchFiles(), iter_end_check(), ParseMap(), ParsePunch(), and PunchFilesInit().
EXTERN FILE* ioPrnErr |
we shall write errors to this file, it is set to stderr in cdInit
Definition at line 106 of file cddefines.h.
EXTERN FILE* ioQQQ |
ioQQQ is the file hand to the output file itself, ioQQQ is set to stdout by default in cdInit, and is reset to anything else by calling cdOutp
Definition at line 98 of file cddefines.h.
Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AGN_Hemis(), AnuUnit(), AtlasCompile(), atmdat_2phot_rate(), atmdat_3body(), atmdat_dielrec_fe(), atmdat_outer_shell(), atmdat_readin(), AtmospheresAvail(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop5(), AtomSeqBeryllium(), aver(), Badnell_rec_init(), BadOpen(), badprt(), BadRead(), bangin(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), CalculateRadialIntegral(), caunin(), cdClock(), cdCO_colden(), cdColm(), cdDrive(), cdExecTime(), cdEXIT(), cdGetLineList(), cdH2_colden(), cdInit(), cdIonFrac(), cdLine(), cdOutp(), cdRead(), cdSPEC(), cdSPEC2(), cdTemp(), ChargTranPun(), ChargTranSumHeat(), ChckFill(), CheckVal(), chi2_func(), ChkUnits(), chMolBranch(), cloudy(), cnewton(), CO_Colden(), CO_drive(), CO_PopsEmisCool(), CO_solve(), CO_zero(), CompileAtmosphereCoStar(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolCarb(), CoolDima(), CoolEvaluate(), CoolIron(), CoolNitr(), CoolOxyg(), coolpr(), CoolSili(), CoolSulf(), CoolSum(), CoStarCompile(), CoStarListModels(), dbg_printf(), dense_fabden(), dense_tabden(), dgaunt(), dmpary(), t_yield::do_kill_yield(), DoFSMixing(), Drive_cdLine(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DumpLine(), DynaEndIter(), DynaEndZone(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaStartZone(), eden_sum(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), F2_1(), factorial(), Fe11Lev5(), Fe13Lev5(), Fe26cs123(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeII_Colden(), FeII_RT_Make(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIILevelPops(), FeIIPunchLines(), FeIIPunData(), FeIIRadPress(), ffun(), ffun1(), fill(), FillGFF(), FillJ(), find_arr(), FindIndex(), fndneg(), fndstr(), FreeFreeGaunt(), fudge(), GammaPrtShells(), gauss_legendre(), GetFracPop(), GetLineRec(), GetModel(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), GetStandardHeLines(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainMakeDiffuse(), GrainsInit(), GrainTemperature(), grid_do(), GridCompile(), gridXspec(), H1cs123(), H2_Colden(), H2_collid_rates(), H2_Cooling(), H2_Create(), H2_He_coll(), H2_He_coll_init(), H2_Level_low_matrix(), H2_LevelPops(), H2_ParsePunch(), H2_Prt_Zone(), H2_Punch_line_data(), H2_RadPress(), H2_Read_hminus_distribution(), H2_ReadCollRates(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_Reset(), H2_RTMake(), H2_X_coll_rate_evaluate(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatPunch(), HeatSum(), HeCollid(), HeCreate(), HeCSInterp(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), HeRecom(), highen(), Hion_colldeexc_cs(), hmole(), hmole_reactions(), hmole_step(), t_ADfA::hpfit(), hv(), Hydcs123(), t_hydrobranch::HydroBranchFunc(), HydroCollid(), HydroEinstA(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecCool(), HydroRecom(), HydroT2Low(), HyperfineCreate(), t_yield::init_yield(), InitEmissivities(), InitGrid(), input_readarray(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonAlumi(), IonBeryl(), IonBoron(), IonCarbo(), IonHelium(), IonIron(), IonMagne(), IonNeon(), IonNitro(), IonOxyge(), IonSilic(), IonSodiu(), ipContEnergy(), ipFindLevLine(), ipLineEnergy(), ipoint(), ipShells(), iso_cool(), iso_photo(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), Kurucz79Compile(), lfactorial(), lgCheckAsserts(), lgCompileAtmosphere(), lgConvPres(), lgIonizConverg(), lgMolecAver(), lgOptimize_do(), lgValidModel(), ligbar(), LimitSh(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_setup(), lines_table(), main(), MakeDeriv(), makelist(), makeplist(), map_do(), MeanIonRadius(), MeanIonVolume(), mie_auxiliary(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_line(), mie_read_double(), mie_read_float(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), MihalasCompile(), mole_H2_LTE(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), NewGrainBin(), NoNumb(), notein(), oi_level_pops(), opacity_more_memory(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), optimize_func(), optimize_phymir(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomHeLike(), ParseAtomHLike(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseF_nu(), ParseFluc(), ParseGrain(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), path_not_set(), PlanckIntegral(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), PressureChange(), PresTotCurrent(), prme(), prt_constants(), prt_H_like_DeparCoef(), prt_H_like_Pops(), prt_He_like_DeparCoef(), prt_He_like_Pops(), prt_smooth_predictions(), PrtAllTau(), PrtComment(), PrtContinuum(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtHydroTrace2(), PrtLinePres(), PrtLineSum(), PrtMeanIon(), prtPunOpacSummary(), PrtZone(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punch_opacity(), PunchDo(), punchFITS_SpectraData(), punchFITSfile(), PunchLineData(), PunchLineStuff(), PunResults1Line(), qheat(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RauchCompile(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), ReadTable(), RebinQHeatResults(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_one(), RT_line_one_tau_reset(), RT_line_static(), RT_OTS(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_recom_effic(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya_1side(), SanityCheck(), SanityCheckBegin(), ScanProbDistr(), search_limit(), SetLimits(), ShowMe(), size_distr(), solveions(), spline_cubic_set(), StarburstCompile(), StarburstInitialize(), state_do(), state_get_put(), StuffComment(), t_ADfA::t_ADfA(), t_hydrobranch::t_hydrobranch(), TeBrent(), TempInterp(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), ValidateGrid(), vary_input(), warnin(), WernerCompile(), WMBASICCompile(), wr_continue(), XERBLA(), zero(), and ZoneStart().
EXTERN FILE* ioStdin |
Definition at line 100 of file cddefines.h.
Referenced by cdInit(), cdInp(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), main(), ParseDrive(), and ptrcer().
const int ipALUMINIUM = 12 |
Definition at line 299 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolAlum(), IonAlumi(), PrtZone(), and PunchDo().
const int ipARGON = 17 |
Definition at line 304 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolArgo(), ForbiddenAuls(), and IonArgon().
const int ipB_LIKE = 4 |
Definition at line 280 of file cddefines.h.
const int ipBE_LIKE = 3 |
const int ipBERYLLIUM = 3 |
Definition at line 290 of file cddefines.h.
Referenced by AbundancesZero(), IonBeryl(), and PrtZone().
const int ipBORON = 4 |
Definition at line 291 of file cddefines.h.
Referenced by AbundancesZero(), IonBoron(), and PrtZone().
const int ipC_LIKE = 5 |
Definition at line 281 of file cddefines.h.
const int ipCALCIUM = 19 |
Definition at line 306 of file cddefines.h.
Referenced by AbundancesZero(), CoolCalc(), IonCalci(), and lines_lv1_k_zn().
const int ipCARBON = 5 |
Definition at line 292 of file cddefines.h.
Referenced by AbundancesSet(), AbundancesZero(), cdDefines(), ChargTranEval(), CO_drive(), CO_Init(), co_lnu_c_o_lnu(), CO_solve(), ContRate(), ContSetIntensity(), CoolCarb(), cross_section(), DynaIonize(), GrainCollHeating(), GrainRateDr(), HeatSum(), HeLikeLevel(), hydro_vs_coll_str(), ion_solver(), IonCarbo(), IonCSInterp(), IonIron(), IonMagne(), lgMolecAver(), lines_lv1_li_ne(), OpacityAddTotal(), pah1_fun(), ParsePunch(), prt_smooth_predictions(), PrtComment(), PrtZone(), PunchDo(), radius_increment(), and radius_next().
const int ipCHLORINE = 16 |
Definition at line 303 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CO_Init(), CO_solve(), CoolChlo(), and IonChlor().
const int ipCHROMIUM = 23 |
Definition at line 310 of file cddefines.h.
Referenced by AbundancesZero(), CoolChro(), and IonChrom().
const int ipCOBALT = 26 |
const int ipCOPPER = 28 |
const int ipCRD = -1 |
Definition at line 212 of file cddefines.h.
Referenced by FeIIZero(), lines_setup(), ParseAtomFeII(), ParseAtomHeLike(), ParseAtomHLike(), RT_continuum_shield_fcn(), RT_line_static(), and zero().
const int ipCRDW = 2 |
Definition at line 214 of file cddefines.h.
Referenced by FeIIZero(), H2_Create(), HeCreate(), lines_helium(), ParseAtomFeII(), ParseAtomHeLike(), ParseAtomHLike(), RT_continuum_shield_fcn(), RT_line_static(), and zero().
const int ipDEST_INCOM = 2 |
const int ipDEST_K2 = 1 |
const int ipDEST_SIMPL = 3 |
const int ipELECTRON = 0 |
Definition at line 193 of file cddefines.h.
Referenced by AGN_He1_CS(), AtomCSInterp(), HeCollid(), HeCreate(), hydro_vs_coll_str(), HydroCollid(), IonCSInterp(), and S62_Therm_ave_coll_str().
const int ipF_LIKE = 8 |
const int ipFLUORINE = 8 |
const int ipH1s = 0 |
some levels for hydrogenic species
Definition at line 226 of file cddefines.h.
Referenced by atom_oi_calc(), atoms_fe2ovr(), cdTemp(), ChargTranSumHeat(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvIterCheck(), CoolCalc(), CoolEvaluate(), Fe2_cooling(), FeIILevelPops(), FeIILyaPump(), GammaBnPL(), GrainTemperature(), H21_cm_pops(), HeatSum(), HeLike(), HeLikeLevel(), hmole_step(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecom(), HydroT2Low(), ion_recomb(), ion_solver(), IonHelium(), ipShells(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), IterRestart(), lines_general(), lines_hydro(), lines_lv1_k_zn(), OpacityAddTotal(), OpacityCreateAll(), pfeii(), PresTotCurrent(), prt_H_like_DeparCoef(), prt_H_like_Pops(), PrtAllTau(), PrtComment(), PrtContinuum(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtHydroTrace2(), PrtLinePres(), PrtZone(), punch_opacity(), PunchDo(), PunchLineData(), PunchSpecial(), radius_increment(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_OTS(), RT_stark(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), and SanityCheckBegin().
const int ipH2p = 2 |
Definition at line 228 of file cddefines.h.
Referenced by cdTemp(), ContCreatePointers(), ContSetIntensity(), ConvIterCheck(), CoolCalc(), Fe2_cooling(), FeIILevelPops(), FeIILyaPump(), GrainTemperature(), H21_cm_pops(), HLineTransOpacSet(), hmole_step(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroT2Low(), iso_cool(), iso_create(), IterStart(), lines_continuum(), lines_general(), lines_hydro(), lines_lv1_k_zn(), OpacityAddTotal(), PresTotCurrent(), PrtAllTau(), PrtComment(), PrtHydroTrace1(), PrtHydroTrace2(), PunchDo(), PunchSpecial(), radius_increment(), RT_DestProb(), RT_line_all(), RT_OTS(), RT_stark(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), SanityCheckBegin(), and zero().
const int ipH2s = 1 |
Definition at line 227 of file cddefines.h.
Referenced by ContCreatePointers(), ContRate(), GammaPL(), GrainRateDr(), HLineTransOpacSet(), hmole_step(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecom(), HydroRenorm(), HydroT2Low(), iso_cool(), iso_create(), lines_continuum(), lines_general(), lines_hydro(), PresTotCurrent(), PrtAllTau(), PrtHydroTrace1(), PunchDo(), PunchSpecial(), RT_stark(), RT_tau_init(), and SanityCheckBegin().
const int ipH_LIKE = 0 |
these are array indices for isoelectronic sequences, same as element but used for array addressing to make context totally clear
Definition at line 276 of file cddefines.h.
Referenced by atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atom_oi_calc(), atoms_fe2ovr(), cdDefines(), cdTemp(), ChargTranSumHeat(), chkCaHeps(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvIterCheck(), ConvTempEdenIoniz(), CoolCalc(), CoolEvaluate(), DynaZero(), Fe2_cooling(), FeIILevelPops(), FeIILyaPump(), GammaBnPL(), GammaPL(), GrainRateDr(), GrainTemperature(), H21_cm_pops(), HeatSum(), HLineTransOpacSet(), hmole_step(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecCool(), HydroRecom(), HydroRenorm(), HydroT2Low(), ion_recomb(), ion_solver(), IonHelium(), IonMagne(), IonOxyge(), ipShells(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), iso_zero(), IterRestart(), IterStart(), lgCheckAsserts(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), Opacity_iso_photo_cs(), OpacityAddTotal(), OpacityCreateAll(), ParseAtomHLike(), ParseDont(), ParseElement(), ParseTrace(), pfeii(), PresTotCurrent(), prt_H_like_DeparCoef(), prt_H_like_Pops(), PrtAllTau(), PrtComment(), PrtContinuum(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtHydroTrace2(), PrtLinePres(), prtmet(), PrtZone(), punch_opacity(), PunchDo(), PunchLineData(), PunchLineStuff(), PunchSpecial(), radius_first(), radius_increment(), radius_next(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), SanityCheckBegin(), state_get_put(), tfidle(), zero(), and Zerologic().
const int ipHe1s1S = 0 |
some levels for he-like species
Definition at line 233 of file cddefines.h.
Referenced by ContCreatePointers(), cross_section(), defect(), ForbiddenAuls(), he_1trans(), HeCollid(), HeCreate(), HeLike(), HeLikeError(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), HeRecom(), ion_recomb(), ion_solver(), IonCSInterp(), iso_ionize_recombine(), lgCheckAsserts(), lines_helium(), OpacityAddTotal(), optimize_func(), PrtAllTau(), PrtZone(), PunchLineData(), RT_tau_init(), RT_tau_reset(), and SanityCheckBegin().
const int ipHe2p1P = 6 |
Definition at line 241 of file cddefines.h.
Referenced by ForbiddenAuls(), he_1trans(), HeCollid(), HeCreate(), HeLikeLevel(), PrtAllTau(), PrtZone(), RT_tau_init(), RT_tau_reset(), and zero().
const int ipHe2p3P0 = 3 |
Definition at line 238 of file cddefines.h.
Referenced by AGN_He1_CS(), AtomCSInterp(), ForbiddenAuls(), he_1trans(), HeCollid(), HeCreate(), HeLikeLevel(), HeRecom(), IonCSInterp(), lgCheckAsserts(), lines_helium(), optimize_func(), PresTotCurrent(), prt_He_like_DeparCoef(), prt_He_like_Pops(), PrtAllTau(), PrtZone(), and radrecomb().
const int ipHe2p3P1 = 4 |
Definition at line 239 of file cddefines.h.
Referenced by AGN_He1_CS(), AtomCSInterp(), he_1trans(), HeCollid(), HeCreate(), HeLikeLevel(), HeRecom(), IonCSInterp(), lgCheckAsserts(), lines_helium(), optimize_func(), PresTotCurrent(), prt_He_like_DeparCoef(), prt_He_like_Pops(), PrtAllTau(), PrtZone(), and radrecomb().
const int ipHe2p3P2 = 5 |
Definition at line 240 of file cddefines.h.
Referenced by AGN_He1_CS(), AtomCSInterp(), ConvIterCheck(), ForbiddenAuls(), he_1trans(), HeCollid(), HeCreate(), HeLikeLevel(), HeRecom(), IonCSInterp(), lines_helium(), PresTotCurrent(), prt_He_like_DeparCoef(), prt_He_like_Pops(), PrtAllTau(), PrtZone(), and radrecomb().
const int ipHe2s1S = 2 |
Definition at line 237 of file cddefines.h.
Referenced by ContCreatePointers(), he_1trans(), HeCollid(), HeCreate(), HeLikeLevel(), IonCSInterp(), lines_helium(), PrtAllTau(), and PrtZone().
const int ipHe2s3S = 1 |
Definition at line 236 of file cddefines.h.
Referenced by AGN_He1_CS(), ConvIterCheck(), ForbiddenAuls(), he_1trans(), HeCollid(), HeCreate(), HeLike(), HeLikeError(), HeLikeLevel(), HeRecom(), IonCSInterp(), lines_helium(), PresTotCurrent(), PrtAllTau(), PrtZone(), radius_increment(), and RT_diffuse().
const int ipHe3d1D = 11 |
const int ipHe3d3D = 10 |
Definition at line 247 of file cddefines.h.
Referenced by AGN_He1_CS(), lines_helium(), PrtAllTau(), and PrtZone().
const int ipHe3p1P = 12 |
const int ipHe3p3P = 9 |
Definition at line 246 of file cddefines.h.
Referenced by AGN_He1_CS(), lines_helium(), PrtAllTau(), and PrtZone().
const int ipHe3s1S = 8 |
const int ipHe3s3S = 7 |
Definition at line 244 of file cddefines.h.
Referenced by AGN_He1_CS(), he_1trans(), lines_helium(), PrtAllTau(), and PrtZone().
const int ipHe4d1D = 17 |
Definition at line 256 of file cddefines.h.
const int ipHe4d3D = 16 |
const int ipHe4f1F = 19 |
Definition at line 258 of file cddefines.h.
const int ipHe4f3F = 18 |
Definition at line 257 of file cddefines.h.
const int ipHe4p1P = 20 |
Definition at line 259 of file cddefines.h.
const int ipHe4p3P = 15 |
const int ipHe4s1S = 14 |
Definition at line 253 of file cddefines.h.
const int ipHe4s3S = 13 |
const int ipHe5d1D = 25 |
Definition at line 266 of file cddefines.h.
const int ipHe5d3D = 24 |
Definition at line 265 of file cddefines.h.
const int ipHe5f1F = 27 |
Definition at line 268 of file cddefines.h.
const int ipHe5f3F = 26 |
Definition at line 267 of file cddefines.h.
const int ipHe5g1G = 29 |
Definition at line 270 of file cddefines.h.
const int ipHe5g3G = 28 |
Definition at line 269 of file cddefines.h.
const int ipHe5p1P = 30 |
Definition at line 271 of file cddefines.h.
const int ipHe5p3P = 23 |
Definition at line 264 of file cddefines.h.
const int ipHe5s1S = 22 |
Definition at line 263 of file cddefines.h.
const int ipHe5s3S = 21 |
Definition at line 262 of file cddefines.h.
const int ipHE_LIKE = 1 |
Definition at line 277 of file cddefines.h.
Referenced by atmdat_2phot_rate(), atmdat_2phot_shapefunction(), AtomCSInterp(), cdDefines(), collision_strength_VF01(), ContCreatePointers(), ContSetIntensity(), ConvIterCheck(), CS_l_mixing_PS64(), CS_l_mixing_S62(), defect(), DoFSMixing(), he_1trans(), he_assign(), He_cross_section(), He_RRCoef_Te(), HeatSum(), HeCollid(), HeCreate(), HeCSInterp(), HeLike(), HelikeCheckRecomb(), HeLikeError(), HeLikeLevel(), HelikeRecombSetup(), HeRecom(), hmole_reactions(), ion_recomb(), ion_solver(), IonCSInterp(), IonHelium(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), lgCheckAsserts(), lines(), lines_helium(), lines_hydro(), Opacity_iso_photo_cs(), OpacityAddTotal(), OpacityCreateAll(), optimize_func(), ParseAtomHeLike(), ParseCompile(), ParseDont(), ParseElement(), ParsePrint(), ParseTrace(), PresTotCurrent(), printCustomAs(), prt_He_like_DeparCoef(), prt_He_like_Pops(), PrtAllTau(), PrtComment(), PrtFinal(), PrtLinePres(), PrtZone(), punch_opacity(), PunchLineData(), putError(), radius_increment(), radrecomb(), RT_diffuse(), RT_line_driving(), RT_tau_init(), RT_tau_reset(), SanityCheckBegin(), WaveFunction(), zero(), and Zerologic().
const int ipHE_PLUS = 2 |
const int ipHELIUM = 1 |
Definition at line 288 of file cddefines.h.
Referenced by AbundancesSet(), AbundancesZero(), AGN_Hemis(), AtomCSInterp(), CalculateRadialIntegral(), cdDefines(), ChargeTransferUpdate(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), CO_Init(), CO_PopsEmisCool(), ContCreatePointers(), ContSetIntensity(), ConvBase(), CoolCarb(), CoolEvaluate(), CoolOxyg(), cross_section(), defect(), eden_sum(), ForbiddenAuls(), GetStandardHeLines(), GrainDrift(), GrainRateDr(), H2_PunchDo(), H2_X_coll_rate_evaluate(), He1Autoionize(), he_1trans(), He_cross_section(), he_energy(), HeatSum(), HeCollid(), HeCreate(), HeCSInterp(), HeLike(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), HeRecom(), highen(), hmole_reactions(), hmole_step(), Hydrogenic(), HydroLevel(), t_yield::init_yield(), ion_recomb(), ion_solver(), ion_trim(), IonCSInterp(), IonHelium(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), IterRestart(), lgCheckAsserts(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_li_ne(), lines_molecules(), map_do(), OpacityAddTotal(), OpacityCreateAll(), optimize_func(), ParseAtomHeLike(), ParseCompile(), ParseElement(), ParsePrint(), ParsePunch(), PressureChange(), printCustomAs(), PrtAllTau(), PrtComment(), PrtFinal(), PrtHeader(), PrtMeanIon(), PrtZone(), punch_opacity(), PunchDo(), radius_increment(), radius_next(), RT_diffuse(), RT_OTS(), SanityCheckBegin(), and zero().
const int ipHYDROGEN = 0 |
these are incides to some elements, on the C scale
Definition at line 287 of file cddefines.h.
Referenced by AbundancesPrt(), AbundancesSet(), AbundancesZero(), AGN_Hemis(), atom_oi_calc(), atoms_fe2ovr(), Badnell_rec_init(), cdColm(), cdDefines(), cdIonFrac(), cdTemp(), ChargeTransferUpdate(), ChargTranSumHeat(), chkCaHeps(), CO_drive(), CO_Init(), CO_solve(), conorm(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolIron(), CoolNick(), CoolOxyg(), CoolSili(), CoolSulf(), crnurate(), defect(), DynaCreateArrays(), DynaEndIter(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaPunch(), DynaPunchTimeDep(), DynaSaveLast(), DynaStartZone(), eden_sum(), Fe2_cooling(), FeIILevelPops(), FeIILyaPump(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainMakeDiffuse(), GrainRateDr(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrnStdDpth(), GrnVryDpth(), H21_cm_pops(), H2_Cooling(), H2_LevelPops(), H2_PunchDo(), H2_X_coll_rate_evaluate(), he_1trans(), HeatSum(), HeCollid(), HeLikeLevel(), highen(), hmole(), hmole_step(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecom(), HydroRenorm(), HydroT2Low(), t_yield::init_yield(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonMagne(), IonOxyge(), IonSilic(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iter_end_check(), IterRestart(), IterStart(), lgCheckAsserts(), lgConvPres(), lgMolecAver(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_li_ne(), lines_molecules(), map_do(), MeanInc(), mie_read_form(), mole_H2_form(), newspecies(), OpacityAddTotal(), OpacityCreateAll(), pah1_fun(), ParseAtomHLike(), ParseCommands(), ParseElement(), ParseFluc(), ParseGlobule(), ParseHDEN(), ParsePrint(), ParsePunch(), pfeii(), pltopc(), PressureChange(), PresTotCurrent(), prt_smooth_predictions(), PrtAllTau(), PrtColumns(), PrtComment(), PrtContinuum(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtHydroTrace2(), PrtMeanIon(), PrtZone(), punch_opacity(), PunchDo(), PunchLineData(), PunchSpecial(), radius_first(), radius_increment(), radius_next(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_OTS(), RT_stark(), RT_tau_init(), SanityCheckBegin(), state_get_put(), tfidle(), zero(), and Zerologic().
const int ipIRON = 25 |
Definition at line 312 of file cddefines.h.
Referenced by AbundancesZero(), atmdat_readin(), atoms_fe2ovr(), cdDefines(), ChargTranEval(), CO_drive(), CO_Init(), CoolIron(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeII_RT_Out(), FeIILevelPops(), FeIILyaPump(), FeIIPunPop(), FeIISumBand(), HeCreate(), ion_recom_calculate(), ion_recomb(), IonIron(), lines(), lines_lv1_k_zn(), pfeii(), PunchDo(), radius_next(), and zero().
const int ipLI_LIKE = 2 |
const int ipLITHIUM = 2 |
Definition at line 289 of file cddefines.h.
Referenced by AbundancesSet(), AbundancesZero(), ChargeTransferUpdate(), ChargTranEval(), CO_drive(), CO_solve(), CoolEvaluate(), eden_sum(), HelikeRecombSetup(), hmole_step(), ion_recombAGN(), IonLithi(), iso_create(), PressureChange(), PrtZone(), and punch_opacity().
const int ipLY_A = -2 |
Definition at line 216 of file cddefines.h.
Referenced by ParseAtomHeLike(), ParseAtomHLike(), RT_continuum_shield_fcn(), RT_line_all(), RT_line_one(), RT_line_static(), and zero().
const int ipMAGNESIUM = 11 |
Definition at line 298 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CO_drive(), CO_Init(), CoolMagn(), IonMagne(), OpacityAddTotal(), and PunchDo().
const int ipMANGANESE = 24 |
Definition at line 311 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), and IonManga().
const int ipN_LIKE = 6 |
Definition at line 282 of file cddefines.h.
const int ipNEON = 9 |
Definition at line 296 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolNeon(), and IonNeon().
const int ipNICKEL = 27 |
Definition at line 314 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), and IonNicke().
const int ipNITROGEN = 6 |
Definition at line 293 of file cddefines.h.
Referenced by AbundancesZero(), cdDefines(), ChargTranEval(), CO_Init(), CO_solve(), CoolNitr(), IonNitro(), lines_lv1_li_ne(), OpacityAddTotal(), PrtZone(), radius_increment(), and radius_next().
const int ipO_LIKE = 7 |
Definition at line 283 of file cddefines.h.
const int ipOXYGEN = 7 |
Definition at line 294 of file cddefines.h.
Referenced by AbundancesSet(), AbundancesZero(), atom_oi_calc(), cdDefines(), ChargeTransferUpdate(), ChargTranEval(), CO_drive(), CO_Init(), co_lnu_c_o_lnu(), CO_solve(), ContCreatePointers(), ContSetIntensity(), ConvInitSolution(), CoolOxyg(), GrainCollHeating(), HeatSum(), HeCreate(), HeCSInterp(), hmole(), hmole_step(), ion_recom_calculate(), IonOxyge(), iter_end_check(), lgMolecAver(), lines_helium(), lines_lv1_li_ne(), OpacityAddTotal(), OpacityCreateAll(), ParsePunch(), ParseSet(), PrtComment(), PrtFinal(), PrtZone(), PunchDo(), radius_increment(), radius_next(), and zero().
const int ipPHOSPHORUS = 14 |
Definition at line 301 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolPhos(), and IonPhosi().
const int ipPOTASSIUM = 18 |
Definition at line 305 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), IonPotas(), and OpacityCreateAll().
const int ipPRD = 1 |
with the above, the total radiative rec per ion is iso.RadRecomb[ipISO][nelem][n][ipRecRad]* iso.RadRecomb[ipISO][nelem][n][ipRecNetEsc]*dense.eden;
Definition at line 210 of file cddefines.h.
Referenced by HeCreate(), lines_setup(), ParseAtomFeII(), ParseAtomHeLike(), ParseAtomHLike(), RT_continuum_shield_fcn(), RT_line_static(), and zero().
const int ipPROTON = 1 |
const int ipRecEsc = 2 |
Definition at line 199 of file cddefines.h.
Referenced by HeRecom(), HydroRecom(), iso_create(), lines_continuum(), PunchDo(), RT_diffuse(), and RT_OTS().
const int ipRecNetEsc = 1 |
Definition at line 201 of file cddefines.h.
Referenced by HeRecom(), HydroRecom(), iso_cool(), iso_create(), iso_ionize_recombine(), IterStart(), and PunchDo().
const int ipRecRad = 0 |
Definition at line 203 of file cddefines.h.
Referenced by HeRecom(), HydroRecCool(), HydroRecom(), iso_cool(), iso_create(), iso_ionize_recombine(), IterStart(), lines_continuum(), PunchDo(), and RT_OTS().
const int ipSCANDIUM = 20 |
Definition at line 307 of file cddefines.h.
Referenced by AbundancesZero(), CoolScan(), and IonScand().
const int ipSILICON = 13 |
Definition at line 300 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CO_drive(), CO_Init(), CO_solve(), IonIron(), IonMagne(), IonSilic(), and PunchDo().
const int ipSODIUM = 10 |
Definition at line 297 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolSodi(), IonSodiu(), and PunchDo().
const int ipSULPHUR = 15 |
Definition at line 302 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CO_drive(), CO_Init(), CO_solve(), CoolSulf(), ion_recom_calculate(), IonIron(), IonMagne(), IonSulph(), lines_lv1_na_ar(), ParseSet(), PunchDo(), and radius_increment().
const int ipTITANIUM = 21 |
Definition at line 308 of file cddefines.h.
Referenced by AbundancesZero(), ChargTranEval(), CoolTita(), and IonTitan().
const int ipVANADIUM = 22 |
Definition at line 309 of file cddefines.h.
Referenced by AbundancesZero(), CoolVana(), and IonVanad().
const int ipZINC = 29 |
Definition at line 316 of file cddefines.h.
Referenced by AbundancesZero(), cdDefines(), he_energy(), and IonZinc().
EXTERN long int iteration |
the iteration counter, set and incremented in routine cloudy, ==1 during first iteration, 2 during second, etc
Definition at line 136 of file cddefines.h.
Referenced by cloudy(), CO_drive(), CO_solve(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolEvaluate(), DynaEndIter(), DynaIonize(), DynaStartZone(), emergent_line(), Fe2_cooling(), FeIILyaPump(), FeIIRadPress(), H2_Level_low_matrix(), H2_LevelPops(), H2_Reset(), hmole(), hmole_reactions(), hmole_step(), ion_solver(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), lgCheckAsserts(), lgMolecAver(), main(), MyAssert(), PressureChange(), PresTotCurrent(), PrtComment(), PrtFinal(), PunchDo(), PunchSpecial(), radius_first(), radius_increment(), radius_next(), RT_line_one_tau_reset(), RT_OTS_AddLine(), RT_tau_reset(), state_get_put(), vib_evap(), zero(), and ZoneStart().
EXTERN bool lgAbort |
this set true when abort sequence is initiated - serious meltdown is happening
Definition at line 109 of file cddefines.h.
Referenced by cdDrive(), cdNwcns(), cloudy(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolHeatError(), eden_sum(), GrainChargeTemp(), GrainMakeDiffuse(), grid_do(), H2_LevelPops(), ion_trim(), iter_end_check(), IterRestart(), IterStart(), lgOptimize_do(), prt_smooth_predictions(), PrtComment(), PrtFinal(), radius_increment(), radius_next(), RT_diffuse(), RT_line_static(), and zero().
EXTERN bool lgAssertFPE |
this tells the code to throw an fpe when an assert is thrown, set true with SET ASSERT FPE command
Definition at line 125 of file cddefines.h.
Referenced by MyAssert(), ParseSet(), and zero().
EXTERN bool lgPrnErr |
this is flag saying whether to print errors to standard error output
Definition at line 121 of file cddefines.h.
Referenced by cdInit(), ParsePrint(), and zero().
EXTERN bool lgTestCodeCalled |
flag lgTestIt turned on if routine TestCode ever called, only generates comment that test code is in place
Definition at line 113 of file cddefines.h.
Referenced by PrtComment(), TestCode(), and zero().
EXTERN bool lgTestCodeEnabled |
flag lgTestOn set true with SET TEST command for some test code to be run somewhere
Definition at line 117 of file cddefines.h.
Referenced by ParseSet(), and zero().
const int LIMELM = 30 |
This is the number of elements included in the code, is used to set lengths of many vectors
Definition at line 169 of file cddefines.h.
Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesZero(), atmdat_3body(), atmdat_DielSupres(), atmdat_readin(), Badnell_rec_init(), cdColm(), cdDefines(), cdIonFrac(), cdTemp(), ChargeTransferUpdate(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chIonLbl(), CO_drive(), CO_Init(), CO_solve(), collision_strength_VF01(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvInitSolution(), ConvIterCheck(), CoolEvaluate(), defect(), t_yield::do_kill_yield(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), eden_sum(), FillGFF(), GammaBnPL(), GammaPL(), GetElem(), GetStandardHeLines(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainScreen(), GrainsInit(), GrainUpdateRadius1(), GrainZero(), H2_Create(), HCTIon(), HCTRecom(), He1Autoionize(), HeatPunch(), HeatSum(), HeatZero(), HeCollid(), HeCreate(), HeLike(), HeLikeLevel(), HelikeRecombSetup(), HelikeTransProbSetup(), HeRecom(), highen(), HighestIonStage(), hmole_reactions(), hmole_step(), Hydcs123(), HydroCollid(), Hydrogenic(), HydroLevel(), HydroLevelPop(), HydroRecom(), HydroT2Low(), t_yield::init_yield(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonCSInterp(), ipFindLevLine(), ipShells(), iso_continuum_lower(), iso_cool(), iso_create(), iso_photo(), iso_zero(), IterRestart(), IterStart(), lgIonizConverg(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), MakeHCTData(), map_do(), MeanInc(), MeanZero(), mie_read_form(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), mie_write_opc(), NewChargeData(), newspecies(), OpacityAdd1Element(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), ParseAbundances(), ParseAtomHeLike(), ParseAtomHLike(), ParseCompile(), ParseDrive(), ParseElement(), ParseMetal(), ParsePrint(), ParsePunch(), PressureChange(), PresTotCurrent(), PrtColumns(), PrtComment(), PrtLinePres(), PrtMeanIon(), prtmet(), PrtZone(), punch_opacity(), PunchDo(), PunchGaunts(), PunchLineData(), PunchLineStuff(), punResults(), putError(), radius_increment(), radius_next(), rfield_opac_malloc(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), SanityCheckBegin(), state_get_put(), t_yield::t_yield(), tfidle(), th85rate_co(), UpdatePot1(), UpdateRecomZ0(), velset(), zero(), and Zerologic().
const int N_H_MOLEC = 8 |
dimension of vector to do with number of iterations stored so, this is the the most that can possibly be performed number of hydrogen species in hmole
Definition at line 184 of file cddefines.h.
Referenced by atmdat_readin(), CO_solve(), ConvBase(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), eden_sum(), hmole(), hmole_step(), Hydrogenic(), IterRestart(), IterStart(), ParsePunch(), PressureChange(), PresTotCurrent(), PrtZone(), PunchDo(), radius_increment(), state_get_put(), and zero().
const int NHYDRO_MAX_LEVEL = 401 |
following is real limit to how many levels can be computed for model hydrogen atom - this has the one extra included, so at most iso.numLevels_max[ipH_LIKE] can be NHYDRO_MAX_LEVEL-1 and vectors should be dim NHYDRO_MAX_LEVEL
Definition at line 177 of file cddefines.h.
Referenced by t_ADfA::H_rad_rec(), t_ADfA::hpfit(), iso_create(), ParseAtomHLike(), and t_ADfA::t_ADfA().
const int NISO = 2 |
the number of iso sequences now in the code
Definition at line 172 of file cddefines.h.
Referenced by ContCreatePointers(), ConvBase(), ConvIterCheck(), CoolDima(), CoolEvaluate(), CoolSum(), DynaZero(), FindNeg(), FndLineHt(), GetMaxhLine(), HeatSum(), ion_collis(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), iso_cool(), iso_create(), iso_photo(), iso_zero(), IterRestart(), IterStart(), lines(), OpacityAdd1Element(), OpacityAddTotal(), ParseElement(), PresTotCurrent(), PrtComment(), PrtLinePres(), prtmet(), PunchLineData(), PunchLineStuff(), radius_increment(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), SanityCheckBegin(), state_get_put(), and zero().
EXTERN long int nzone |
nzone is zone counter, incremented in routine cloudy is zero during search phase, 1 for first zone at illuminated face
Definition at line 129 of file cddefines.h.
Referenced by AgeCheck(), AGN_Hemis(), atoms_fe2ovr(), cdDepth_depth(), cdnZone(), cdPressure_depth(), cloudy(), CO_drive(), CO_solve(), ContNegative(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCarb(), CoolDima(), CoolEvaluate(), dmpary(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), eden_sum(), escmase(), Fe2_cooling(), FeIIAddLines(), FeIIRadPress(), fndstr(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), gett2(), gett2o3(), GrainChargeTemp(), GrainDrive(), GrainUpdateRadius2(), H2_Cooling(), H2_Level_low_matrix(), H2_LevelPops(), H2_RT_tau_inc(), HeatSum(), HeLike(), HeLikeLevel(), hmole(), hmole_reactions(), hmole_step(), HydroLevel(), HydroLevelPop(), HydroRecom(), ion_solver(), ion_trim(), IonHelium(), IonMagne(), IonNitro(), IonOxyge(), IonSilic(), iso_cool(), iso_photo(), iter_end_check(), lgCheckAsserts(), lgConvPres(), lgMolecAver(), lines_continuum(), lines_hydro(), main(), MakeDeriv(), map_do(), MyAssert(), NewChargeData(), OpacityAddTotal(), pltcon(), PressureChange(), PresTotCurrent(), PrtComment(), PrtFinal(), PrtLineSum(), PrtZone(), punch_line(), PunchDo(), PunLineIntensity(), PutHetCol(), qheat(), radius_first(), radius_increment(), radius_next(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_one(), RT_line_static(), RT_OTS(), RT_OTS_Update(), zero(), and ZoneStart().
const double SEXP_LIMIT = 84. |
this is -ln of smallest number sexp can handle
Definition at line 975 of file cddefines.h.
Referenced by RT_diffuse(), sexp(), and tfidle().
const double TEND = 4000. |
stopping temperature
Definition at line 187 of file cddefines.h.
Referenced by AbundancesSet(), ParseCommands(), PrtComment(), and zero().
const double ZeroNum |
this is the number zero, used to trick clever compilers when dividing by it to crash program there is a routine called zero - this name cannot overlap definition is in cddefines.cpp
Definition at line 13 of file cddefines.cpp.
Referenced by MyAssert(), and ParseCrashDo().