cloudy trunk
Loading...
Searching...
No Matches
cddefines.h File Reference
#include "cdstd.h"
#include <cstdio>
#include <cstdlib>
#include <cctype>
#include <cmath>
#include <cassert>
#include <cstring>
#include <cfloat>
#include <climits>
#include <ctime>
#include <csignal>
#include <limits>
#include <string>
#include <sstream>
#include <iomanip>
#include <vector>
#include <valarray>
#include <complex>
#include <map>
#include <memory>
#include <stdexcept>
#include <algorithm>
#include <fstream>
#include <bitset>
#include "cloudyconfig.h"
#include "cpu.h"
#include "container_classes.h"
#include "iter_track.h"
#include "lines_service.h"
#include "physconst.h"
Include dependency graph for cddefines.h:

Go to the source code of this file.

Data Structures

struct  StaticAssertFailed< true >
class  Singleton< T >
class  cloudy_exit
class  bad_signal
class  bad_assert
class  t_debug
class  t_nodebug
class  debugtrace< Trace >
class  auto_vec< T >
struct  auto_vec< T >::auto_vec_ref< U >
struct  t_species
struct  t_CollRatesArray
struct  t_CollSplinesArray
struct  t_StoutColls
class  Integrator< Integrand, Method >

Macros

#define STATIC   static
#define float   PLEASE_USE_REALNUM_NOT_FLOAT
#define STATIC_ASSERT(x)
#define EXIT_SUCCESS   ES_SUCCESS
#define EXIT_FAILURE   ES_FAILURE
#define cdEXIT(FAIL)
#define puts(STR)
#define DEBUG
#define MALLOC(exp)
#define CALLOC   MyCalloc
#define REALLOC   MyRealloc
#define ASSERT(exp)
#define MESSAGE_ASSERT(msg, exp)
#define isnan   MyIsnan
#define DEBUG_ENTRY(funcname)
#define MIN2   min
#define MIN3(a, b, c)
#define MIN4(a, b, c, d)
#define MAX2   max
#define MAX3(a, b, c)
#define MAX4(a, b, c, d)
#define POW2   pow2
#define POW3   pow3
#define POW4   pow4
#define HMRATE(a, b, c)
#define PrintEfmt(F, V)

Typedefs

typedef float realnum
typedef float sys_float
typedef struct t_species species
typedef struct t_CollRatesArray CollRateCoeffArray
typedef struct t_CollSplinesArray CollSplinesArray
typedef struct t_StoutColls StoutColls

Enumerations

enum  exit_type {
  ES_SUCCESS =0 , ES_FAILURE =1 , ES_WARNINGS , ES_BOTCHES ,
  ES_CLOUDY_ABORT , ES_BAD_ASSERT , ES_BAD_ALLOC , ES_OUT_OF_RANGE ,
  ES_USER_INTERRUPT , ES_TERMINATION_REQUEST , ES_ILLEGAL_INSTRUCTION , ES_FP_EXCEPTION ,
  ES_SEGFAULT , ES_BUS_ERROR , ES_UNKNOWN_SIGNAL , ES_UNKNOWN_EXCEPTION ,
  ES_TOP
}
enum  { CHARS_SPECIES =10 }
enum  { CHARS_ISOTOPE_SYM = 6 }
enum  split_mode { SPM_RELAX , SPM_KEEP_EMPTY , SPM_STRICT }
enum  methods { Gaussian32 , Legendre }

Functions

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)
void MyAssert (const char *file, int line, const char *comment)
void cdPrepareExit (exit_type)
void ShowMe (void)
NORETURN void TotalInsanity (void)
template<class T>
TotalInsanityAsStub ()
NORETURN void BadRead (void)
int dbg_printf (int debug, const char *fmt,...)
int dprintf (FILE *fp, const char *format,...)
char * read_whole_line (char *chLine, int nChar, FILE *ioIN)
NORETURN void OUT_OF_RANGE (const char *str)
char tolower (char c)
unsigned char tolower (unsigned char c)
char toupper (char c)
unsigned char toupper (unsigned char c)
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 (sys_float a, double b)
double min (double a, sys_float b)
double powi (double, long int)
long max (int a, long b)
long max (long a, int b)
double max (sys_float a, double b)
double max (double a, sys_float b)
template<class T>
sign (T x, T y)
template<class T>
int sign3 (T x)
bool fp_equal (sys_float x, sys_float y, int n=3)
bool fp_equal (double x, double y, int n=3)
bool fp_equal_tol (sys_float x, sys_float y, sys_float tol)
bool fp_equal_tol (double x, double y, double tol)
bool fp_bound (sys_float lo, sys_float x, sys_float hi, int n=3)
bool fp_bound (double lo, double x, double hi, int n=3)
bool fp_bound_tol (sys_float lo, sys_float x, sys_float hi, sys_float tol)
bool fp_bound_tol (double lo, double x, double hi, double tol)
template<class T>
pow2 (T a)
template<class T>
pow3 (T a)
template<class T>
pow4 (T a)
sys_float SDIV (sys_float x)
double SDIV (double x)
sys_float safe_div (sys_float x, sys_float y, sys_float res_0by0)
sys_float safe_div (sys_float x, sys_float y)
double safe_div (double x, double y, double res_0by0)
double safe_div (double x, double y)
double hmrate4 (double a, double b, double c, double te)
template<class T>
void invalidate_array (T *p, size_t size)
void invalidate_array (double *p, size_t size)
void invalidate_array (sys_float *p, size_t size)
template<class T>
T * get_ptr (T *v)
template<class T>
T * get_ptr (valarray< T > &v)
template<class T>
T * get_ptr (vector< T > &v)
template<class T>
const T * get_ptr (const valarray< T > &v)
template<class T>
const T * get_ptr (const vector< T > &v)
void Split (const string &str, const string &sep, vector< string > &lst, split_mode mode)
bool FindAndReplace (string &str, const string &substr, const string &newstr)
bool FindAndErase (string &str, const string &substr)
double csphot (long int inu, long int ithr, long int iofset)
double RandGauss (double xMean, double s)
double MyGaussRand (double PctUncertainty)
double AnuUnit (realnum energy)
void cap4 (char *chCAP, const char *chLab)
void uncaps (char *chCard)
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)
int GetQuote (char *chLabel, char *chCard, char *chCardRaw, bool lgABORT)
const char * strstr_s (const char *haystack, const char *needle)
char * strstr_s (char *haystack, const char *needle)
const char * strchr_s (const char *s, int c)
char * strchr_s (char *s, int c)
long int ipow (long, long)
void PrintE82 (FILE *, double)
void PrintE71 (FILE *, double)
void PrintE93 (FILE *, double)
sys_float sexp (sys_float x)
double sexp (double x)
double dsexp (double x)
double plankf (long int ip)
istream & SafeGetline (istream &is, string &t)
double qg32 (double, double, double(*)(double))
void spsort (realnum x[], long int n, long int iperm[], int kflag, int *ier)

Variables

FILE * ioQQQ
FILE * ioStdin
FILE * ioMAP
FILE * ioPrnErr
bool lgAbort
bool lgTestCodeCalled
bool lgTestCodeEnabled
bool lgPrnErr
long int nzone
double fnzone
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 = 2000
const int LIMELM = 30
const int NISO = 2
const int NHYDRO_MAX_LEVEL = 401
const double MAX_DENSITY = 1.e24
const double DEPTH_OFFSET = 1.e-30
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 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 int ipKRYPTON = 35
const double SEXP_LIMIT = 84.
const double DSEXP_LIMIT = 680.

Macro Definition Documentation

◆ ASSERT

#define ASSERT ( exp)
Value:
do { \
if (UNLIKELY(!(exp))) \
{ \
bad_assert aa(__FILE__,__LINE__,"Failed: " #exp); \
if( cpu.i().lgAssertAbort() ) \
{ \
aa.print(); \
abort(); \
} \
else \
throw aa; \
} \
} while( 0 )
static t_cpu cpu
Definition cpu.h:355
#define UNLIKELY(x)
Definition cpu.h:387

Definition at line 578 of file cddefines.h.

Referenced by abscf(), AbundChange(), addComment(), TransitionProxy::AddHiState(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), AgeCheck(), iterator< bool, 2 >::alloc(), iterator< bool >::alloc(), iterator< bool, 2 >::alloc(), AssertFeIIDep(), atmdat_2phot_setSplineCoefs(), atmdat_2phot_shapefunction(), atmdat_CHIANTI_readin(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level2(), atom_level3(), atom_levelN(), atom_pop2(), atom_pop3(), atom_pop5(), AtomCSInterp(), t_fe2ovr_la::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(), CalcTwoPhotonEmission(), CalcTwoPhotonRates(), cdEmis_ip(), cdGetLineList(), cdLine(), cdLine_ip(), cdSPEC(), cdSPEC2(), ChargTranSumHeat(), ChckFill(), EmissionConstProxy::check(), EmissionProxy::check(), TransitionConstProxy::check(), TransitionProxy::check(), CHIANTI_Upsilon(), chIonLbl(), chLineLbl(), cloudy(), t_ADfA::coll_ion_hybrid(), t_ADfA::coll_ion_wrapper(), collision_strength_VF01(), CollisSuppres(), ColStrGBar(), CollisionProxy::ColUL(), molecule::compare(), conorm(), cont_gaunt_calc(), ContBandsCreate(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvRate2CS(), CoolAdd(), CoolCarb(), CoolEvaluate(), CoolNitr(), CoolOxyg(), coolpr(), TransitionProxy::copy(), create_isotopologues_one(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_PercivalRichards78(), CS_VS80(), da(), database_readin(), dBase_solve(), DebyeDeriv(), iter_track::deriv(), dftori(), t_mole_local::dissoc_rate(), DoBeckert_etal(), DoFSMixing(), DoSatelliteLines(), DoSutherland(), DumpLine(), DynaIonize(), DynaIterEnd(), DynaNewStep(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), eden_sum(), EdenChange(), EdenError(), ee1_safe(), EH2_eval(), emergent_line(), emit_frac(), esc_CRDcore(), esc_CRDwing(), esc_PRD(), esc_PRD_1side(), escmase(), F21(), F21_mx(), F21i(), F21i_log(), FastVoigtH(), Fe2_cooling(), Fe3_cs(), Fe3Lev14(), Fe4_cs(), Fe4Lev12(), Fe5_cs(), FeII_OTS(), FeIICollRatesBoltzmann(), FeIICreate(), FeIIPun1Depart(), FeIIPunPop(), FeIISumBand(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), fill_array(), multi_geom< d, ALLOC >::finalize(), find_solution(), FindIndex(), t_mole_local::findrk(), FindStrongestLineLabels(), FndLineHt(), fndstr(), ForbiddenAuls(), fp_bound(), fp_bound(), fp_bound_tol(), fp_bound_tol(), fp_equal(), fp_equal(), fp_equal_tol(), fp_equal_tol(), FreeFreeGaunt(), fsff(), funjac(), GammaBn(), GammaK(), get_total_abundance_ions(), GetBins(), GetDopplerWidth(), GetFracPop(), GetGF(), GetHS98CrossSection(), diatomics::GetIndices(), diatomics::getLine(), GetModel(), GetProbDistr_LowLimit(), getrf_wrapper(), getrs_wrapper(), GetStandardHeLines(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainDrift(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GravitationalPressure(), GridCompile(), GridGatherInCloudy(), gridXspec(), GrnVryDpth(), H21_cm_pops(), diatomics::H2_Accel(), diatomics::H2_CollidRateEvalAll(), diatomics::H2_ContPoint(), diatomics::H2_Cooling(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_PunchDo(), diatomics::H2_RadPress(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), diatomics::H2_RT_tau_inc(), diatomics::H2_X_coll_rate_evaluate(), diatomics::H2_X_sink_and_source(), t_ADfA::h_coll_str(), H_cross_section(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HCTIon(), HCTRecom(), he_1trans(), He_cross_section(), HeatSum(), HeCollidSetup(), HeCSInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), highen(), Hion_coll_ioniz_ratecoef(), HomogeneousSource(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), hydro_transprob(), hydro_vs_coll_recomb(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroCSInterp(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HyperfineCreate(), HyperfineCS(), Hypergeometric2F1(), diatomics::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), t_yield::init_yield(), InitCoreloadPostparse(), InitEmissivities(), InitGrid(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), InitSimPostparse(), InterpCollRate(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), iterator< bool, 2 >::invalidate(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_wrapper(), IonCSInterp(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipShells(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_Aul_update(), iso_collapsed_bnl_set(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_continuum_lower(), iso_cool(), iso_create(), iso_dielec_recomb_rate(), iso_error_generation(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_put_recomb_error(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_recomb_setup(), iso_renorm(), iso_RRCoef_Te(), iso_satellite(), iso_set_ion_rates(), iso_solve(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), iso_update_rates(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), L_mix_integrand_VF01(), lgCheckMonitors(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), Wind::lgStatic(), lgValidModel(), lincom(), lindst(), lindst(), LineConvRate2CS(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), LineStackCreate(), linfit(), linint(), LinterpTable(), LinterpVector(), log10_fsff(), log10_prodxx(), log_integral(), t_mole_global::make_species(), MD5string(), MeanMassOfElement(), mie_auxiliary2(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), diatomics::Mol_Photo_Diss_Rates(), MolDissocCrossSection(), mole_eval_balance(), mole_eval_dynamic_balance(), mole_generate_isotopologue_reactions(), diatomics::mole_H2_form(), mole_h2_grain_form(), diatomics::mole_H2_LTE(), mole_h_reactions(), mole_make_groups(), mole_make_list(), mole_partition_function(), mole_return_cached_species(), mole_rk_bigchange(), mole_solve(), mole_update_species_cache(), Monointerp::Monointerp(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), newisotope(), newreact(), newspecies(), nMatch(), Parser::nMatch1(), nWord(), OccupationNumberLine(), ofit(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), t_cpu_i::open_data, FunctLAMDA::operator()(), phymir_state< X, Y, NP, NSTR >::optimize(), optimize_func(), phymir_state< X, Y, NP, NSTR >::optimize_with_restart(), TransitionProxy::outline(), outline_base(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), parse_species_label(), parse_udfa(), ParseAtomISO(), ParseCosmicRays(), ParseCrashDo(), ParseDynaTime(), ParseElement(), ParseEnergy(), ParseFluc(), ParseGrid(), ParseIntensity(), ParseMonitorResults(), ParsePhi(), ParseQH(), ParseTable(), ParseVLaw(), PE_init(), t_ADfA::phfit(), PlanckIntegral(), PntForLine(), PressureRadiationLine(), PresTotCurrent(), PrintCenterLine(), PrintRates(), process_output(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtLinePres(), PrtZone(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), PutCS(), PutLine_base(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), RauchReadMPP(), read_Helike_cross_sections(), read_hm05(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_species_file(), ReadAugerData(), ReadBadnellAIData(), ReadCollisionRateTable(), ReadIsotopeFractions(), iterator< bool >::realloc(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), RefIndex(), iterator< bool, 2 >::reserve(), iterator< bool, 2 >::reserve(), iterator< bool, 2 >::reserve(), iterator< bool, 2 >::reserve(), iterator< bool, 2 >::reserve(), iterator< bool, 2 >::reserve(), iterator< bool >::reserve(), multi_geom< d, ALLOC >::reserve(), resetBltin(), rfield_opac_malloc(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_one(), RT_line_pumping(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_recom_effic(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), S62_Therm_ave_coll_str(), SanityCheckBegin(), save_line(), save_opacity(), SaveDo(), SaveFilesInit(), saveFITSfile(), SaveHeat(), SaveResults(), SaveSpecies(), SaveSpeciesOne(), ScaleAllDensities(), ScanProbDistr(), scqdri(), search_limit(), PresMode::set(), t_mole_local::set_location(), SetLimits(), SetLimitsSub(), Parser::setline(), SetNChrgStates(), GroupMap::setup(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), diatomics::SolveSomeGroundElectronicLevels(), spline_cubic_set(), sprt_wl(), StarburstInitialize(), StarkCollTransProb_VF01(), states_nelemfill(), store_new_densities(), StoutCollRate(), Integrator< Integrand, Method >::sum(), sum_radiation(), SumDensities(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), tbl_fun(), TempInterp(), TempInterp2(), tfidle(), total_molecule_elems(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), Flux::uu(), WavlenErrorGet(), writeCloudyDetails(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yfunc(), iterator< bool, 2 >::zero(), iter_track::zero_fit(), and ZoneStart().

◆ CALLOC

#define CALLOC   MyCalloc

now special version of calloc - it dies if cannot allocate space.

Definition at line 510 of file cddefines.h.

Referenced by CoolSave(), F21(), F21_mx(), H_photo_cs_log10(), InitGridCoStar(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), and SaveHeat().

◆ cdEXIT

#define cdEXIT ( FAIL)
Value:
throw cloudy_exit( __func__, __FILE__, __LINE__, FAIL )
#define __func__
Definition cpu.h:182

Definition at line 434 of file cddefines.h.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level3(), atom_levelN(), atom_pop5(), AtomSeqBeryllium(), Badnell_rec_init(), 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(), cdMain(), cdRead(), cdSPEC(), cdSPEC2(), ChargTranPun(), ChckFill(), CheckVal(), chi2_func(), cnewton(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContSetIntensity(), ConvFail(), CoolEvaluate(), CoolOxyg(), coolpr(), CoolSave(), CoStarInterpolate(), database_readin(), dBase_solve(), dense_tabden(), dgaunt(), do_dump_state(), do_restore_state(), Parser::doSetVar(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaIterStart(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), factorial(), Fe26cs123(), Fe3Lev14(), Fe4Lev12(), FeII_Colden(), FeIICollRatesBoltzmann(), FeIICreate(), FeIILevelPops(), FeIIPunData(), FeIISaveLines(), ffun1(), fill(), FillGFF(), find_arr(), find_solution(), FindIndex(), fsff(), fudge(), gauss_legendre(), Energy::get(), GetBins(), GetFracPop(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetQuote(), GetStandardHeLines(), GrainCharge(), GrainsInit(), grid_do(), gridXspec(), diatomics::H2_Colden(), diatomics::H2_CollidRateRead(), diatomics::H2_Level_low_matrix(), diatomics::H2_ParseSave(), diatomics::H2_Punch_line_data(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), Parser::help(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), diatomics::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitIndexArrays(), InitSimPostparse(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ion_recom_calculate(), ipoint(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgOptimize_do(), ligbar(), LimitSh(), lines(), lines_setup(), map_do(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), newreact(), Parser::NoNumb(), oi_level_pops(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), optimize_func(), optimize_phymir(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), Flux::p_InternalFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_rd_state(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), parse_save_colden(), parse_save_line(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseAtom(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), plot(), pltopc(), pltr(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), ptrcer(), punchFITS_SpectraData(), qintr(), t_ADfA::rad_rec(), radius_next(), RauchInitializeSub(), RauchReadMPP(), rd_block(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), ReadAugerData(), ReadTable(), RT_continuum(), RT_DestProb(), RT_line_escape(), RT_line_one(), RT_recom_effic(), RT_tau_init(), SanityCheck(), SanityCheckBegin(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveLineData(), SaveLineStuff(), SaveResults1Line(), SaveSpecies(), search_limit(), Energy::set(), PresMode::set(), SetLimits(), size_distr(), solveions(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), state_do(), states_nelemfill(), StuffComment(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), TempInterp(), tfidle(), TotalInsanity(), totlin(), uderiv(), ufunct(), vary_input(), wr_block(), XERBLA(), y0b01(), Yfunc(), t_mole_global::zero(), zero(), and zoneDensity().

◆ DEBUG

#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 489 of file cddefines.h.

◆ DEBUG_ENTRY

#define DEBUG_ENTRY ( funcname)
Value:
((void)0)

Definition at line 684 of file cddefines.h.

Referenced by AbortErrorMessage(), abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AbundancesZero(), AbundChange(), t_PredCont::add(), addComment(), TransitionProxy::AddHiState(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), advection_set_default(), AgeCheck(), AGN_He1_CS(), AGN_Hemis(), AngerJ(), anomal(), AnuUnit(), append_file(), AssertFeIIDep(), AtlasCompile(), AtlasInterpolate(), atmdat_2phot_setSplineCoefs(), atmdat_2phot_shapefunction(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_outer_shell(), atmdat_readin(), atmdat_STOUT_readin(), AtmospheresAvail(), atom_level2(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop2(), atom_pop3(), atom_pop5(), AtomCSInterp(), t_fe2ovr_la::atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), 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(), broken(), Bruggeman(), C6cs123(), Ca20cs123(), calcc(), diatomics::CalcPhotoionizationRate(), CalcTwoPhotonEmission(), CalcTwoPhotonRates(), canonicalize_reaction(), canonicalize_reaction_label(), cap4(), caps(), caunin(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClock(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDrive(), cdEmis(), cdEmis(), cdEmis_ip(), cdErrors(), cdExecTime(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInit(), cdInput(), cdIonFrac(), cdLine(), cdLine(), cdLine_ip(), cdLine_ip(), cdMain(), cdNoExec(), cdNotes(), cdNwcns(), cdOutput(), cdPressure_depth(), cdPressure_last(), cdPrtWL(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), ChckFill(), check_co_ion_converge(), check_grid_file(), CheckVal(), t_mole_local::chem_heat(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), ChiantiCollRate(), chIonLbl(), chIonLbl(), chkCaHeps(), ChkUnits(), chLineLbl(), CloseSaveFiles(), cloudy(), cmshft(), cnewton(), CodeReview(), t_ADfA::coll_ion(), t_ADfA::coll_ion_hybrid(), t_ADfA::coll_ion_wrapper(), ColliderList::ColliderList(), collision_strength_VF01(), CollisionJunk(), CollisionZero(), CollisSuppres(), ColStrGBar(), Parser::CommandError(), conorm(), conpmp(), diatomics::Cont_Diss_Heat_Rate(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolChro(), CoolCoba(), CoolDima(), CoolEvaluate(), CoolHeatError(), CoolIron(), CoolMagn(), CoolNeon(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolSave(), CoolScan(), CoolSili(), CoolSodi(), CoolSulf(), CoolSum(), CoolZero(), CoStarCompile(), CoStarInterpolate(), CoStarListModels(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_PercivalRichards78(), CS_ThermAve_PR78(), csphot(), csscal(), d3_np_fs(), da(), database_prep(), database_readin(), dBase_solve(), dbg_printf(), DebyeDeriv(), dense_tabden(), dftori(), dgaunt(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), diatoms_init(), t_mole_local::dissoc_rate(), dist(), DLASWP(), dmpary(), do_dump_state(), do_restore_state(), DoFSMixing(), DoSatelliteLines(), Parser::doSetVar(), dprintf(), Drive_cdLine(), DrvCaseBHS(), DrvContPump(), DrvEscP(), DrvHyas(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpLine(), DynaCreateArrays(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaPunchTimeDep(), DynaSave(), DynaSaveLast(), DynaStartZone(), DynaZero(), e2(), eden_sum(), EdenChange(), ee1(), ee1_safe(), eina(), ellpk(), emergent_line(), emit_frac(), EmLineJunk(), EmLineZero(), endFindLevLine(), erfce(), esc_CRDcore(), esc_CRDwing(), esc_CRDwing_1side(), esc_PRD(), esc_PRD_1side(), esca0k2(), esccon(), escmase(), evalf(), exp1(), expn(), extin(), F21(), F21_mx(), F21i(), F21i_log(), factorial(), FastVoigtH(), Fe26cs123(), Fe2_cooling(), t_fe2ovr_la::fe2par(), Fe3Lev14(), Fe4Lev12(), FeII_Colden(), FeII_LineZero(), FeII_OTS(), FeII_RT_Make(), FeII_RT_Out(), FeII_RT_tau_reset(), FeII_RT_TauInc(), FeIIAccel(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIIIntenZero(), FeIILevelPops(), FeIILyaPump(), FeIIPoint(), FeIIPrint(), FeIIPun1Depart(), FeIIPunchColden(), FeIIPunchLevels(), FeIIPunchLineStuff(), FeIIPunchOpticalDepth(), FeIIPunData(), FeIIPunDepart(), FeIIPunPop(), FeIIRadPress(), FeIIReset(), FeIISaveLines(), FeIISumBand(), FeIIZero(), FFmtRead(), Parser::FFmtRead(), ffun(), ffun(), ffun1(), fiddle(), fill(), fill_array(), FillExtraLymanLine(), FillGFF(), FillJ(), t_PredCont::find(), find_arr(), find_solution(), findatom(), FindHCoStar(), FindIndex(), FindNeg(), t_mole_local::findrate(), t_mole_local::findrk(), findspecies(), findspecieslocal(), FindTempChangeFactor(), FindVCoStar(), fixit(), FndLineHt(), fndneg(), fndstr(), ForbiddenAuls(), FreeGrid(), fsff(), fstats(), fudge(), funjac(), GammaBn(), GammaK(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), gauss_init(), gauss_legendre(), gbar0(), gbar1(), Energy::get(), get_total_abundance_ions(), GetBins(), GetDensity(), diatomics::GetDissociationRate(), GetDissociationRateCoeff(), Parser::GetElem(), GetFracPop(), GetGF(), diatomics::GetHeatRate(), GetHubbleFactor(), diatomics::getLine(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), t_cpu_i::getPathList(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), GetStandardHeLines(), gett2(), gett2o3(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrainZero(), GravitationalPressure(), grid_do(), GridCompile(), GridGatherInCloudy(), GridInterpolate(), gridXspec(), GrnStdDpth(), GrnVryDpth(), diatomics::gs_rate(), diatomics::H2_Accel(), diatomics::H2_Colden(), diatomics::H2_CollidRateEvalAll(), diatomics::H2_CollidRateEvalOne(), diatomics::H2_CollidRateRead(), diatomics::H2_ContPoint(), diatomics::H2_Cooling(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_LinesAdd(), diatomics::H2_LineZero(), diatomics::H2_ParseSave(), diatomics::H2_Prt_column_density(), diatomics::H2_Prt_line_tau(), diatomics::H2_Prt_Zone(), diatomics::H2_PrtDepartCoef(), diatomics::H2_Punch_line_data(), diatomics::H2_PunchDo(), diatomics::H2_PunchLineStuff(), diatomics::H2_RadPress(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), diatomics::H2_Reset(), diatomics::H2_RT_diffuse(), diatomics::H2_RT_OTS(), diatomics::H2_RT_tau_inc(), diatomics::H2_RT_tau_reset(), diatomics::H2_RTMake(), diatomics::H2_Solomon_rate(), diatomics::H2_X_coll_rate_evaluate(), diatomics::H2_X_sink_and_source(), diatomics::H2_zero_pops_too_low(), t_ADfA::h_coll_str(), 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(), HCoolRatio(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), HeatZero(), HeCollidSetup(), HeCSInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), HelikeTransProbSetup(), Parser::help(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), hmiopc(), hmirat(), HomogeneousSource(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), humlik(), hv(), Hydcs123(), hydro_transprob(), hydro_vs_coll_recomb(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroCSInterp(), HydroEinstA(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HyperfineCreate(), HyperfineCS(), hypho(), IDAMAX(), ILAENV(), IncidentContinuumHere(), ColliderList::init(), diatomics::init(), t_input::init(), t_mole_global::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), t_fe2ovr_la::init_pointers(), phymir_state< X, Y, NP, NSTR >::init_state_file_name(), phymir_state< X, Y, NP, NSTR >::init_strings(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitEmissivities(), InitEnthalpy(), initFindLevLine(), InitGrid(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), InitSimPostparse(), input_readvector(), InterpCollRate(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_wrapper(), ion_zero(), IonCSInterp(), IonHelium(), IonHydro(), IonNelem(), ipContEnergy(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipow(), ipShells(), isactive(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_charge_transfer_update(), iso_collapsed_Aul_update(), iso_collapsed_bnl_print(), iso_collapsed_bnl_set(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_cross_section(), iso_departure_coefficients(), iso_dielec_recomb_rate(), iso_error_generation(), iso_get_total_num_levels(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_extra(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_radrecomb_from_cross_section(), iso_recomb_auxiliary_free(), iso_recomb_check(), iso_recomb_malloc(), iso_recomb_setup(), iso_renorm(), iso_RRCoef_Te(), iso_satellite(), iso_satellite_update(), iso_set_ion_rates(), iso_solve(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), iso_zero(), ispassive(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Junk(), TransitionProxy::Junk(), Kurucz79Compile(), Kurucz79Interpolate(), L_mix_integrand_VF01(), lagrange(), ld01_fun(), LeidenCollRate(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConserveEnergy(), phymir_state< X, Y, NP, NSTR >::lgConvergedRestart(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), lgFileReadable(), lgInputComment(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgOptimize_do(), lgValidAsciiFile(), lgValidBinFile(), lgValidModel(), ligbar(), LimitSh(), linadd(), lincom(), lindst(), lindst(), 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(), LineStackCreate(), linfit(), linint(), LinterpTable(), LinterpVector(), log10_fsff(), log_integral(), LSAME(), Magnetic_evaluate(), Magnetic_init(), Magnetic_reinit(), main(), t_mole_global::make_species(), MakeCS(), MakeHCTData(), map_do(), MD5datafile(), MD5file(), MD5string(), MD5swap(), t_mean::MeanInc(), t_mean::MeanIon(), MeanMassOfElement(), t_mean::MeanZero(), mie_auxiliary(), mie_auxiliary2(), 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_form(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_write_form(), mie_write_opc(), MihalasCompile(), MihalasInterpolate(), diatomics::Mol_Photo_Diss_Rates(), molcol(), MolDissocCrossSection(), diatomics::MolDissocOpacity(), mole_check_reverse_reactions(), mole_cmp_num_in_out_reactions(), mole_create_react(), mole_drive(), mole_effects(), mole_eval_balance(), mole_eval_dynamic_balance(), mole_eval_sources(), mole_findrate_s(), mole_generate_isotopologue_reactions(), mole_get_equilibrium_constant(), diatomics::mole_H2_form(), diatomics::mole_H2_LTE(), mole_h_fixup(), mole_h_reactions(), mole_make_groups(), mole_make_list(), mole_partition_function(), mole_punch(), mole_rk_bigchange(), mole_solve(), mole_update_limiting_reactants(), mole_update_rks(), mole_update_sources(), mole_update_species_cache(), MyAssert(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), Ne10cs123(), neiii_cs(), NewChargeData(), newelement(), newisotope(), newpt(), newreact(), newspecies(), newton_step(), nMatch(), Parser::NoNumb(), notein(), nWord(), OccupationNumberLine(), ofit(), oi_cs(), oi_level_pops(), oi_othercs(), oii_cs(), oiii_cs(), oiv_cs(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), t_cpu_i::open_data, t_cpu_i::open_data, phymir_state< X, Y, NP, NSTR >::optimize(), optimize_func(), optimize_phymir(), optimize_subplex(), phymir_state< X, Y, NP, NSTR >::optimize_with_restart(), order(), TransitionProxy::outline(), outline_base(), outline_base_bin(), outsum(), ov_cs(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_evaluate_hyperblock(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), phymir_state< X, Y, NP, NSTR >::p_execute_job_parallel(), Flux::p_get(), Flux::p_InternalFluxUnit(), Flux::p_InternalFluxUnitNoCheck(), phymir_state< X, Y, NP, NSTR >::p_lgLimitExceeded(), phymir_state< X, Y, NP, NSTR >::p_phygrm(), phymir_state< X, Y, NP, NSTR >::p_process_output(), phymir_state< X, Y, NP, NSTR >::p_rd_state(), phymir_state< X, Y, NP, NSTR >::p_reset_hyperblock(), phymir_state< X, Y, NP, NSTR >::p_reset_transformation_matrix(), Flux::p_set(), EnergyEntry::p_set_ip(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), Flux::p_ValidFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_wr_state(), pah1_fun(), pah2_fun(), pah3_fun(), parse_reaction(), parse_save_average(), parse_save_colden(), parse_save_line(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseAtom(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCaseB(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), partx(), PE_init(), t_ADfA::phfit(), pintr(), PlanckIntegral(), plankf(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), powi(), PressureChange(), PressureRadiationLine(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintRates(), PrintShortZero(), prme(), process_output(), prt_constants(), prt_LineLabels(), prt_smooth_predictions(), prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLinePres(), PrtLineSum(), PrtMacros(), PrtMeanIon(), prtmet(), PrtTwoPhotonEmissCoef(), PrtZone(), ptrcer(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), PunFeII(), PutCS(), PutExtra(), PutLine(), PutLine(), PutLine_base(), qg32(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandGauss(), RauchCompile(), RauchInitializeSub(), RauchInterpolateCOWD(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), RauchReadMPP(), rayleh(), rd_block(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_species_file(), read_whole_line(), t_input::readarray(), ReadAugerData(), ReadBadnellAIData(), ReadCollisionRateTable(), ReadIsotopeFractions(), ReadTable(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), t_ADfA::rec_lines(), RefIndex(), register_reaction_vectors(), rfield_opac_malloc(), ritoa(), ritodf(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_driving(), RT_line_electron_scatter(), RT_line_escape(), RT_line_fine_opacity(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_pumping(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_OTS_Zero(), RT_recom_effic(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), RTesc_lya_1side(), S62_Therm_ave_coll_str(), SanityCheck(), SanityCheckBegin(), Save1LineData(), save_average(), save_colden(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveFeII_cont(), SaveFilesInit(), saveFITSfile(), SaveGaunts(), SaveHeat(), SaveLineData(), SaveLineIntensity(), SaveLineStuff(), SaveResults(), SaveResults1Line(), SaveSpecial(), SaveSpecies(), SaveSpeciesOne(), ScanProbDistr(), scqdri(), search_limit(), SearchModel(), Energy::set(), PresMode::set(), set_fractionation(), t_mole_local::set_isotope_abundances(), t_mole_local::set_location(), t_cpu_i::set_signal_handlers(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setstp(), sexp(), sexp(), ShowMe(), sii_cs(), siii_cs(), simplx(), t_lfact::Singleton< t_lfact >, t_mole_local::sink_rate(), t_mole_local::sink_rate_tot(), t_mole_local::sink_rate_tot(), sinpar(), siv_cs(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), solveions(), diatomics::SolveSomeGroundElectronicLevels(), sortd(), t_mole_local::source_rate_tot(), t_mole_local::source_rate_tot(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), Split(), sprt_wl(), spsort(), StandardEnergyUnit(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), StarkCollTransProb_VF01(), start(), state_do(), state_get_put(), states_nelemfill(), states_popfill(), states_propprint(), stepDensity(), Stognienko(), store_new_densities(), StoutCollRate(), StuffComment(), subopt(), sumcon(), sviii_cs(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), t_fe2ovr_la::t_fe2ovr_la(), t_mean::t_mean(), t_fe2ovr_la::tau_inc(), tauff(), TauZero(), tbl_fun(), TempChange(), TempChange(), TempInterp(), TempInterp2(), TestCode(), TexcLine(), tfidle(), Therm_ave_coll_str_int_PR78(), ThetaNu(), timestep_next(), TlustyCompile(), TlustyInterpolate(), total_molecule_deut(), total_molecule_elems(), total_molecules(), total_molecules_gasphase(), total_network_elems(), TotalInsanity(), totlin(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), uncaps(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), UpdateUTAs(), Flux::uu(), ValidateGrid(), vary_input(), warnin(), WavlenErrorGet(), wcnint(), WernerCompile(), WernerInterpolate(), WMBASICCompile(), WMBASICInterpolate(), wr_block(), XERBLA(), xinvrs(), xmap(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yan_H2_CS(), Yfunc(), TransitionProxy::Zero(), Zero(), t_mole_global::zero(), zero(), t_fe2ovr_la::zero_opacity(), ZeroContin(), zoneDensity(), ZoneEnd(), and ZoneStart().

◆ EXIT_FAILURE

#define EXIT_FAILURE   ES_FAILURE

Definition at line 140 of file cddefines.h.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level3(), atom_levelN(), atom_pop5(), AtomSeqBeryllium(), Badnell_rec_init(), 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(), cdRead(), cdSPEC(), cdSPEC2(), ChargTranPun(), ChckFill(), CheckVal(), chi2_func(), cnewton(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContSetIntensity(), ConvFail(), CoolEvaluate(), coolpr(), CoolSave(), database_readin(), dBase_solve(), dense_tabden(), dgaunt(), do_dump_state(), do_restore_state(), Parser::doSetVar(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaIterStart(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), factorial(), Fe26cs123(), Fe3Lev14(), Fe4Lev12(), FeII_Colden(), FeIICollRatesBoltzmann(), FeIICreate(), FeIILevelPops(), FeIIPunData(), FeIISaveLines(), ffun1(), fill(), FillGFF(), find_arr(), find_solution(), FindIndex(), fsff(), fudge(), gauss_legendre(), Energy::get(), GetBins(), GetFracPop(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetQuote(), GetStandardHeLines(), GrainCharge(), GrainsInit(), grid_do(), gridXspec(), diatomics::H2_Colden(), diatomics::H2_CollidRateRead(), diatomics::H2_Level_low_matrix(), diatomics::H2_ParseSave(), diatomics::H2_Punch_line_data(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), diatomics::init(), t_yield::init_yield(), InitGrid(), InitSimPostparse(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ipoint(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgOptimize_do(), ligbar(), LimitSh(), lines(), lines_setup(), map_do(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), newreact(), Parser::NoNumb(), oi_level_pops(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), optimize_func(), optimize_phymir(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), Flux::p_InternalFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_rd_state(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), parse_save_colden(), parse_save_line(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseAtom(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), plot(), pltopc(), pltr(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), ptrcer(), punchFITS_SpectraData(), qintr(), t_ADfA::rad_rec(), radius_next(), RauchInitializeSub(), RauchReadMPP(), rd_block(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), ReadAugerData(), ReadTable(), RT_continuum(), RT_DestProb(), RT_line_escape(), RT_recom_effic(), RT_tau_init(), SanityCheck(), SanityCheckBegin(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveLineData(), SaveLineStuff(), SaveResults1Line(), SaveSpecies(), search_limit(), Energy::set(), PresMode::set(), SetLimits(), size_distr(), solveions(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), state_do(), states_nelemfill(), StuffComment(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), TempInterp(), tfidle(), TotalInsanity(), totlin(), uderiv(), ufunct(), vary_input(), wr_block(), XERBLA(), y0b01(), Yfunc(), t_mole_global::zero(), zero(), and zoneDensity().

◆ EXIT_SUCCESS

◆ float

#define float   PLEASE_USE_REALNUM_NOT_FLOAT

Definition at line 108 of file cddefines.h.

◆ HMRATE

#define HMRATE ( a,
b,
c )
Value:
hmrate4(a,b,c,phycon.te)
double hmrate4(double a, double b, double c, double te)
Definition cddefines.h:1048
t_phycon phycon
Definition phycon.cpp:6

Definition at line 1046 of file cddefines.h.

Referenced by ChargTranEval(), and ion_photo().

◆ isnan

◆ MALLOC

#define MALLOC ( exp)
Value:
(MyMalloc(exp,__FILE__, __LINE__))
void * MyMalloc(size_t size, const char *file, int line)
Definition service.cpp:1448

use special version of malloc - it tests result and dies if cannot allocate space

Definition at line 501 of file cddefines.h.

Referenced by AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_readin(), atmdat_STOUT_readin(), AtomSeqBoron(), Badnell_rec_init(), cdSPEC(), ContBandsCreate(), ContCreateMesh(), database_readin(), dBase_solve(), DynaCreateArrays(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), FeIIBandsCreate(), FeIIContCreate(), FeIICreate(), FillGFF(), GetStandardHeLines(), gridXspec(), diatomics::H2_Level_low_matrix(), HelikeTransProbSetup(), HyperfineCreate(), hypho(), initFindLevLine(), InitGrid(), InitIndexArrays(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), iso_cascade(), iso_recomb_malloc(), IterStart(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), LineStackCreate(), map_do(), mole_h2_grain_form(), mole_make_groups(), OpacityAddTotal(), OpacityCreateAll(), parse_udfa(), ParseCrashDo(), ParseDynaTime(), ParseMonitorResults(), ParsePrtLineSum(), plot_sparsity(), pltcon(), pltopc(), PrtFinal(), punchFITS_GenericData(), RauchInitializeSub(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), read_SH98_He1_cross_sections(), RebinAtmosphere(), rfield_opac_malloc(), SanityCheckBegin(), SaveNewContinuum(), spline_cubic_set(), StarburstInitialize(), StoutCollRate(), and zero().

◆ MAX2

#define MAX2   max

MAX2 takes two arguments, returns the larger of the two

Definition at line 782 of file cddefines.h.

Referenced by abund_starburst(), AbundancesPrt(), AgeCheck(), AssertFeIIDep(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop5(), AtomCSInterp(), t_fe2ovr_la::atoms_fe2ovr(), Badnell_rec_init(), badprt(), bhintegrand_log(), C6cs123(), Ca20cs123(), cdColm(), cdTimescales(), ChargTranSumHeat(), chkCaHeps(), cloudy(), collision_strength_VF01(), ColStrGBar(), ContCreateMesh(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolMagn(), CoolNick(), CoolNitr(), CoolOxyg(), CoolSave(), CoolSili(), CoolSodi(), CoolSulf(), CoStarListModels(), cross_section(), da(), dBase_solve(), DebyeDeriv(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), DoBeckert_etal(), DoSutherland(), DrvCaseBHS(), DTRSM(), DynaStartZone(), EdenChange(), F2_1(), Fe26cs123(), Fe2_cooling(), FeIICollRatesBoltzmann(), FeIICreate(), FeIILevelPops(), FeIILyaPump(), FeIISaveLines(), ffun1(), fill(), fstats(), GammaBn(), GammaK(), GbarRateCoeff(), GetFracPop(), diatomics::GetHeatRate(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainCharge(), GrainChrgTransferRates(), GrainCollHeating(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainRateDr(), GrainsInit(), GrainTemperature(), diatomics::gs_rate(), h21_t_lt_10(), H21cm_proton(), diatomics::H2_LevelPops(), diatomics::H2_PunchDo(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadEnergies(), diatomics::H2_RT_tau_inc(), H_cross_section(), H_photo_cs_log10(), HCoolRatio(), HCTIon(), HCTRecom(), he_1trans(), HeatSum(), HeCSInterp(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), HomogeneousSource(), t_ADfA::hpfit(), Hydcs123(), hydro_vs_coll_str(), HydroEinstA(), HydroLevel(), Hypergeometric2F1(), hypho(), InitBinAugerData(), InitCoreload(), InterpolateModel(), ion_photo(), ion_recomb(), ion_trim(), IonHydro(), iso_allocate(), iso_collapsed_bnl_set(), iso_continuum_lower(), iso_cool(), iso_level(), iso_rad_rec_cooling_extra(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_radrecomb_from_cross_section(), iso_recomb_check(), iso_recomb_malloc(), iso_update_num_levels(), iter_end_check(), IterRestart(), lgCheckMonitors(), lgCoolHeatCheckConverge(), lgNucleiConserved(), limitedDensityScaling(), lincom(), 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(), map_do(), molcol(), mole_effects(), mole_h_reactions(), Ne10cs123(), oi_othercs(), oiv_cs(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1SubshellInduc(), OpacityCreate1Element(), optimize_subplex(), TransitionProxy::outline(), outline_base(), ParseAtomISO(), ParseGrid(), ParseIterations(), ParsePrint(), ParseRangeOption(), ParseSave(), ParseSet(), ParseStop(), ParseTrace(), pltcon(), pltmap(), pltopc(), pltr(), PresTotCurrent(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtHeader(), PrtZone(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), rayleh(), RebinQHeatResults(), RT_continuum(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_electron_scatter(), RT_line_fine_opacity(), RT_line_one(), RT_line_one_tau_reset(), RT_LineWidth(), RT_OTS(), RT_OTS_Update(), RT_recom_effic(), RT_stark(), RT_tau_init(), RTesc_lya(), RTesc_lya_1side(), SanityCheckBegin(), save_colden(), save_line(), save_opacity(), SaveDo(), saveFITSfile(), SaveSpecies(), ScanProbDistr(), SetLimits(), SetLimitsSub(), setstp(), sii_cs(), spldrv_safe(), splint_safe(), tauff(), tfidle(), timestep_next(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), UpdatePot(), UpdatePot1(), xNI_coll_stren(), y0b01(), Yan_H2_CS(), and ZoneStart().

◆ MAX3

#define MAX3 ( a,
b,
c )
Value:
(max(max(a,b),c))
long max(int a, long b)
Definition cddefines.h:775

MAX3 takes 3 arguments, returns the largest of the 3

Definition at line 787 of file cddefines.h.

Referenced by fstats(), GetProbDistr_LowLimit(), pltcon(), pltmap(), and pltopc().

◆ MAX4

#define MAX4 ( a,
b,
c,
d )
Value:
(max(max(a,b),max(c,d)))

MAX4 takes 4 arguments, returns the largest of the 4

Definition at line 792 of file cddefines.h.

Referenced by InterpolateGff(), iso_collapsed_bnl_set(), and sinpar().

◆ MESSAGE_ASSERT

#define MESSAGE_ASSERT ( msg,
exp )
Value:
ASSERT( (msg) ? (exp) : false )
#define ASSERT(exp)
Definition cddefines.h:578

Definition at line 606 of file cddefines.h.

◆ MIN2

#define MIN2   min

MIN2 takes two arguments, returns the smaller of the two

Definition at line 761 of file cddefines.h.

Referenced by abund_starburst(), AgeCheck(), atmdat_3body(), atmdat_LAMDA_readin(), atom_oi_calc(), C6cs123(), Ca20cs123(), ChargTranEval(), ChargTranSumHeat(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolAlum(), CoolArgo(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolMagn(), CoolNick(), CoolNitr(), CoolOxyg(), coolpr(), CoolSave(), CoolSili(), CoolSodi(), CoolSulf(), CS_l_mixing_PS64(), da(), dBase_solve(), dense_parametric_wind(), DGETF2(), DGETRF(), DoBeckert_etal(), DoSutherland(), DynaStartZone(), esc_CRDcore(), esc_CRDwing(), esc_PRD_1side(), Fe26cs123(), FeIICollRatesBoltzmann(), FeIICreate(), FeIIPunData(), FeIIPunPop(), ffun1(), fill_array(), FillJ(), ForbiddenAuls(), fstats(), GammaBn(), GammaK(), GammaPrt(), GetDissociationRateCoeff(), diatomics::GetHeatRate(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainScreen(), GrainTemperature(), h21_t_ge_10(), H21cm_electron(), H21cm_proton(), diatomics::H2_PunchDo(), diatomics::H2_ReadEnergies(), diatomics::H2_RT_tau_inc(), HCoolRatio(), HCTIon(), HCTRecom(), HeatSum(), Hion_coll_ioniz_ratecoef(), Hydcs123(), HydroEinstA(), Hypergeometric2F1(), hypho(), ILAENV(), InterpolateModel(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_solver(), ion_trim(), ipLineEnergy(), ipoint(), iso_assign_quantum_numbers(), iso_collapsed_bnl_set(), iso_collapsed_update(), iso_collide(), iso_continuum_lower(), iso_ionize_recombine(), iso_level(), iso_put_recomb_error(), iso_radiative_recomb(), iso_radrecomb_from_cross_section(), iso_satellite_update(), iso_update_rates(), lgCheckMonitors(), limitedDensityScaling(), lines_hydro(), map_do(), mole_get_equilibrium_constant(), Ne10cs123(), newton_step(), oi_cs(), oi_othercs(), oiv_cs(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreateAll(), outline_base(), ov_cs(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), ParseAtomISO(), ParseCommands(), ParseCosmicRays(), ParseRangeOption(), ParseSave(), ParseSet(), ParseStop(), partx(), PlanckIntegral(), pltcon(), pltmap(), pltopc(), pltr(), PressureRadiationLine(), PresTotCurrent(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtLinePres(), PrtMeanIon(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), read_SH98_He1_cross_sections(), RebinQHeatResults(), RebinSingleCell(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_fine_opacity(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_LineWidth(), RT_OTS_Update(), RT_recom_effic(), RT_stark(), RT_tau_init(), RTesc_lya(), RTesc_lya_1side(), SanityCheckBegin(), save_opacity(), SaveDo(), SaveHeat(), SaveLineData(), SetLimits(), SetLimitsSub(), setstp(), sii_cs(), simplx(), siv_cs(), spldrv_safe(), splint_safe(), subopt(), sumcon(), timestep_next(), uderiv(), UpdatePot(), writeCloudyDetails(), xinvrs(), xNI_coll_stren(), and ZoneStart().

◆ MIN3

#define MIN3 ( a,
b,
c )
Value:
(min(min(a,b),c))
long min(int a, long b)
Definition cddefines.h:723

MIN3 takes 3 arguments, returns the smallest of the 3

Definition at line 766 of file cddefines.h.

Referenced by atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), iso_continuum_lower(), ParseCommands(), pltcon(), pltmap(), pltopc(), and radius_first().

◆ MIN4

#define MIN4 ( a,
b,
c,
d )
Value:
(min(min(a,b),min(c,d)))

MIN4 takes 4 arguments, returns the smallest of the 4

Definition at line 771 of file cddefines.h.

Referenced by InterpolateGff(), iso_collapsed_bnl_set(), and radius_first().

◆ POW2

#define POW2   pow2

POW2 takes 1 argument, and squares it

Definition at line 929 of file cddefines.h.

Referenced by abund_starburst(), AssertFeIIDep(), collision_strength_VF01(), ColStrGBar(), ContSetIntensity(), CoolAlum(), CoolEvaluate(), CoolMagn(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_PercivalRichards78(), DebyeDeriv(), dist(), DoFSMixing(), DoSutherland(), DrvCaseBHS(), DynaIonize(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), eina(), esc_CRDwing_1side(), FeIICollRatesBoltzmann(), FeIICreate(), FillExtraLymanLine(), ForbiddenAuls(), FreeFreeGaunt(), fstats(), gbar0(), gbar1(), GetAveVelocity(), GetDopplerWidth(), GetGF(), GetHubbleFactor(), GetProbDistr_HighLimit(), gett2(), gett2o3(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GravitationalPressure(), diatomics::H2_Cooling(), H2_vib_dist(), t_ADfA::H_rad_rec(), helike_energy(), helike_transprob(), t_ADfA::hpfit(), hydro_vs_coll_str(), HydroEinstA(), HydroOscilStr(), HydroRecCool(), hypho(), diatomics::init(), InitSimPostparse(), IonCSInterp(), iso_assign_quantum_numbers(), iso_cool(), iso_create(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_extra(), iso_state_lifetime(), lgCheckMonitors(), lgCompileAtmosphere(), lgConserveEnergy(), lines_hydro(), lines_lv1_li_ne(), lines_setup(), Magnetic_evaluate(), mole_effects(), mole_h2_grain_form(), mole_h_reactions(), ofit(), oi_cs(), OpacityAddTotal(), OpacityCreateAll(), k2DampArg::operator()(), optimize_subplex(), t_ADfA::phfit(), PlanckIntegral(), plankf(), PresTotCurrent(), PrtFinal(), qheat(), radius_first(), rayleh(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_all(), RTesc_lya_1side(), S62_Therm_ave_coll_str(), SaveDo(), StarkCollTransProb_VF01(), sum_radiation(), tfidle(), ThetaNu(), uderiv(), UpdatePot1(), UpdatePot2(), y0b01(), zoneDensity(), and ZoneStart().

◆ POW3

◆ POW4

#define POW4   pow4

POW4 takes 1 argument, and raises it to the power 4

Definition at line 943 of file cddefines.h.

Referenced by ConvTempEdenIoniz(), GetHubbleFactor(), hydro_transprob(), iso_state_lifetime(), mie_write_opc(), PressureRadiationLine(), search_limit(), and size_distr().

◆ PrintEfmt

#define PrintEfmt ( F,
V )
Value:
F, V

create string with val and format, to print with s, much faster than above, totally native on non-MS systems

Parameters
*fmt
val

Definition at line 1472 of file cddefines.h.

Referenced by GammaPrt(), GetModel(), diatomics::H2_Prt_Zone(), HydroLevel(), InterpolateGridCoStar(), InterpolateRectGrid(), iso_collide(), iso_level(), iso_photo(), iso_radiative_recomb(), map_do(), PrintRatio(), prme(), PrtAllTau(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtZone(), RT_tau_init(), and Save1LineData().

◆ puts

#define puts ( STR)
Value:
Using_puts_before_cdEXIT_is_no_longer_needed

Definition at line 437 of file cddefines.h.

◆ REALLOC

#define REALLOC   MyRealloc

now special version of calloc - it dies if cannot allocate space.

Definition at line 519 of file cddefines.h.

Referenced by mole_make_groups(), opacity_more_memory(), ParseIterations(), and StarburstInitialize().

◆ STATIC

#define STATIC   static

Definition at line 97 of file cddefines.h.

Referenced by AbortErrorMessage(), addKeyword_num(), addKeyword_txt(), advection_set_default(), AGN_Hemis(), AngerJ(), anomal(), Badnell_DR_rate_eval(), Badnell_RR_rate_eval(), badprt(), BadStart(), bh(), bh_log(), bhG(), bhg(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), bigk(), blkdata1(), Bruggeman(), ByteSwap(), C6cs123(), Ca20cs123(), calcc(), calcc(), canonicalize_reaction(), canonicalize_reaction_label(), cdasum(), cdasum(), cdaxpy(), cdaxpy(), cdClock(), cdcopy(), cdcopy(), ChckFill(), check_grid_file(), CheckVal(), ChemImportance(), chi2_func(), ChiantiCollRate(), chkCaHeps(), ChkUnits(), chMolBranch(), cmshft(), cnewton(), collision_strength_VF01(), CollisSuppres(), ColStrGBar(), compare_udfa(), compareEmis(), conorm(), conpmp(), ContBandsCreate(), ContRate(), CoolHeatError(), CoStarListModels(), cross_section(), CS_PercivalRichards78(), CS_ThermAve_PR78(), csscal(), csscal(), d3_np_fs(), da(), database_prep(), DebyeDeriv(), dftori(), dgaunt(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), dist(), dist(), DLASWP(), dmpary(), DoBeckert_etal(), doop(), DoSatelliteLines(), DoSutherland(), Drive_cdLine(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DSCAL(), DSWAP(), DTRSM(), DumpCoolStack(), DumpHeatStack(), DynaNewStep(), DynaSaveLast(), EdenError(), EH2_eval(), endFindLevLine(), escmase(), evalf(), evalf(), exp1(), ExponentialInt(), extin(), F21(), F21_mx(), F21i(), F21i_log(), F2_1(), Fe26cs123(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIILyaPump(), fhunt(), fiddle(), fill(), fill_array(), FillExtraLymanLine(), FillGFF(), FillJ(), find_solution(), findatom(), FindHCoStar(), FindIndex(), FindNeg(), FindStrongestLineLabels(), FindVCoStar(), FITTED(), fndneg(), fndstr(), ForbiddenAuls(), FreeFreeGaunt(), FreeGrid(), fsff(), fstats(), fstats(), funjac(), GauntIntegrand(), gbar0(), gbar1(), GbarRateCoeff(), get_total_abundance_ions(), GetBins(), getcsvfield(), GetDissociationRateCoeff(), GetFracPop(), GetHS98CrossSection(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetProbDistr_LowLimit(), GetStandardHeLines(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainIonColl(), GrainRateDr(), GrainScreen(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrnStdDpth(), GrnStdDpth(), GrnVryDpth(), grouped_elems(), h21_t_ge_10(), h21_t_lt_10(), H2_vib_dist(), H_Einstein_A_lin(), H_photo_cs_lin(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), HighestIonStage(), hmiopc(), HomogeneousSource(), hrii(), hrii_log(), Hydcs123(), hydro_vs_coll_str(), HyperGeoInt(), Hypergeometric2F1(), IDAMAX(), ILAENV(), init_eps(), InitBinAugerData(), InitEmissivities(), initFindLevLine(), InitGrid(), InitGridCoStar(), InitIndexArrays(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ipFindLevLine(), ipShells(), isactive(), iso_allocate(), iso_assign_quantum_numbers(), iso_put_recomb_error(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_extra(), iso_recomb_integrand(), iso_satellite(), iso_zero(), ispassive(), JIndex(), Jint(), L_mix_integrand_VF01(), ld01_fun(), LeidenCollRate(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConvEden(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), lgFileReadable(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgRadiative(), lgReactBalance(), lgTestPressureConvergence(), lgTrivialSolution(), lgValidAsciiFile(), lgValidBinFile(), lgValidModel(), limitedDensityScaling(), LimitSh(), lincom(), LinterpTable(), LinterpVector(), log10_fsff(), log_integral(), logPressureState(), LSAME(), MakeHCTData(), MD5swap(), MeanMassOfElement(), mie_auxiliary(), mie_auxiliary2(), mie_calc_ial(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_data(), mie_next_data(), mie_next_line(), mie_next_line(), mie_read_double(), mie_read_form(), mie_read_form(), mie_read_long(), mie_read_mix(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_repair(), mie_write_form(), mole_check_reverse_reactions(), mole_effects(), mole_eval_dynamic_balance(), mole_generate_isotopologue_reactions(), mole_get_equilibrium_constant(), mole_h2_grain_form(), mole_h_fixup(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_ion_trim(), mole_partition_function(), mole_system_error(), mole_update_limiting_reactants(), Ne10cs123(), NewChargeData(), newelement(), newisotope(), newpt(), newpt(), newreact(), newspecies(), newspecies(), ofit(), oi_level_pops(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityCreate1Element(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), order(), order(), pah1_fun(), pah2_fun(), pah3_fun(), parse_base(), parse_reaction(), parse_udfa(), ParseExp(), ParseExpr(), ParseNumber(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParseProduct(), partx(), partx(), PE_init(), pintr(), PlanckIntegral(), PlanckIntegral(), plot_sparsity(), pltcon(), pltmap(), pltopc(), pltr(), pltr(), pnegopc(), PrintRates(), PrintShortZero(), prt_constants(), prt_smooth_predictions(), PrtElem(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtMacros(), prtPunOpacSummary(), ptrcer(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), PutLine_base(), qg32complex(), qheat_init(), qintr(), RauchInitializeSub(), RauchReadMPP(), rayleh(), read_continuum_mesh(), read_data(), read_Helike_cross_sections(), read_hm05(), read_SH98_He1_cross_sections(), read_species_file(), ReadAugerData(), ReadBadnellAIData(), ReadIsotopeFractions(), ReadTable(), RealF2_1(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), register_reaction_vectors(), resetBltin(), rfield_opac_malloc(), ritoa(), ritodf(), RT_line_electron_scatter(), RT_line_escape(), RT_line_fine_opacity(), RT_line_pumping(), RT_OTS_AddCont(), RTesc_lya_1side(), S62_Therm_ave_coll_str(), SanityCheckBegin(), SanityCheckFinal(), SaveFeII_cont(), SaveGaunts(), SaveLineIntensity(), SaveLineStuff(), SaveNewContinuum(), SaveResults(), SaveResults1Line(), SaveSpeciesOne(), ScanProbDistr(), search_limit(), SearchModel(), set_fractionation(), SetLimits(), SetLimitsSub(), setstp(), setstp(), simplx(), simplx(), t_lfact::Singleton< t_lfact >, sinpar(), sinpar(), size_distr(), sortd(), sortd(), SpeciesJunk(), StarkCollTransProb_VF01(), StarkCollTransProb_VF01(), start(), start(), state_do(), states_nelemfill(), states_popfill(), states_propprint(), stepDensity(), Stognienko(), store_new_densities(), StoutCollRate(), strkar(), subopt(), subopt(), sum_radiation(), sumcon(), tauff(), tbl_fun(), TempInterp(), TempInterp2(), Therm_ave_coll_str_int_PR78(), ThetaNu(), timestep_next(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), ValidateGrid(), writeCloudyDetails(), X1Int(), X2Int(), XERBLA(), xinvrs(), xmap(), xNI_coll_stren(), y0b(), y0b01(), y0psa(), y1psa(), and ZeroContin().

◆ STATIC_ASSERT

#define STATIC_ASSERT ( x)

Typedef Documentation

◆ CollRateCoeffArray

◆ CollSplinesArray

◆ realnum

typedef float realnum

Definition at line 103 of file cddefines.h.

◆ species

typedef struct t_species species

Definition at line 1224 of file cddefines.h.

◆ StoutColls

typedef struct t_StoutColls StoutColls

◆ sys_float

typedef float sys_float

Definition at line 106 of file cddefines.h.

Enumeration Type Documentation

◆ anonymous enum

anonymous enum
Enumerator
CHARS_ISOTOPE_SYM 

Definition at line 275 of file cddefines.h.

◆ anonymous enum

anonymous enum
Enumerator
CHARS_SPECIES 

Definition at line 274 of file cddefines.h.

◆ exit_type

enum exit_type
Enumerator
ES_SUCCESS 
ES_FAILURE 
ES_WARNINGS 
ES_BOTCHES 
ES_CLOUDY_ABORT 
ES_BAD_ASSERT 
ES_BAD_ALLOC 
ES_OUT_OF_RANGE 
ES_USER_INTERRUPT 
ES_TERMINATION_REQUEST 
ES_ILLEGAL_INSTRUCTION 
ES_FP_EXCEPTION 
ES_SEGFAULT 
ES_BUS_ERROR 
ES_UNKNOWN_SIGNAL 
ES_UNKNOWN_EXCEPTION 
ES_TOP 

Definition at line 115 of file cddefines.h.

◆ methods

enum methods
Enumerator
Gaussian32 
Legendre 

Definition at line 1500 of file cddefines.h.

◆ split_mode

enum split_mode

split_mode defines how the routine Split generates substrings SPM_RELAX: multiple adjacent separators will be coalesced into one this way you can never get an empty substring SPM_KEEP_EMPTY: multiple adjacent separators will result in empty substrings to be added to the list SPM_STRICT: empty substrings are illegal

Enumerator
SPM_RELAX 
SPM_KEEP_EMPTY 
SPM_STRICT 

Definition at line 1321 of file cddefines.h.

Function Documentation

◆ AnuUnit()

double AnuUnit ( realnum energy)

AnuUnit produce continuum energy in arbitrary units, ip is on C scale

Definition at line 173 of file service.cpp.

References DEBUG_ENTRY, Energy::get(), and save.

Referenced by AGN_Hemis(), Save1Line(), Save1LineData(), save_opacity(), SaveDo(), SaveNewContinuum(), and SaveSpeciesOne().

Here is the call graph for this function:

◆ BadRead()

NORETURN void BadRead ( void )

BadRead tried to read internal data and failed

Definition at line 901 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, ioQQQ, NORETURN, and ShowMe().

Referenced by diatomics::H2_Read_hminus_distribution(), and HelikeTransProbSetup().

Here is the call graph for this function:

◆ broken()

void broken ( void )

broken set flag saying that the code is broken

Definition at line 982 of file service.cpp.

References broke, and DEBUG_ENTRY.

Referenced by fill_array(), and PresTotCurrent().

◆ cap4()

void cap4 ( char * chCAP,
const char * chLab )

cap4 convert first 4 char of input line chLab into chCAP all in caps, null termination

Parameters
chCAPoutput string, cap'd first 4 char of chLab,
chLabwith null terminating input string ending with eol

Definition at line 240 of file service.cpp.

References DEBUG_ENTRY, and toupper().

Referenced by cdEmis(), cdLine(), lgCheckMonitors(), optimize_func(), ParseNorm(), and PrtFinal().

Here is the call graph for this function:

◆ caps()

void caps ( char * chCard)

caps convert input command line (through eol) to ALL CAPS

Parameters
chCard- line image as string of characters

Definition at line 280 of file service.cpp.

References DEBUG_ENTRY, and toupper().

Referenced by cdColm(), cdEmis(), cdIonFrac(), cdRead(), cdTemp(), t_input::echo(), Parser::newlineProcess(), and PrtFinal().

Here is the call graph for this function:

◆ cdPrepareExit()

void cdPrepareExit ( exit_type exit_status)

prepare termination of the code, but do not terminate yet

Definition at line 202 of file cdinit.cpp.

References cdInput(), cdOutput(), CloseSaveFiles(), cpu, grid, ioQQQ, and SaveGrid().

Referenced by cdMain().

Here is the call graph for this function:

◆ CodeReview()

void CodeReview ( void )

CodeReview - placed next to code that needs to be checked

Definition at line 1000 of file service.cpp.

References broke, and DEBUG_ENTRY.

◆ csphot()

double csphot ( long int inu,
long int ithr,
long int iofset )

csphot returns photoionization cross section from opacity stage using std pointers

Parameters
inuINU is array index pointing to frequency where opacity is to be evaluated on f not c scale
ithrITHR is pointer to threshold
iofsetIOFSET is offset as defined in opac0

Definition at line 1602 of file service.cpp.

References DEBUG_ENTRY, and opac.

Referenced by OpacityAddTotal().

◆ dbg_printf()

int 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 1031 of file service.cpp.

References DEBUG_ENTRY, ioQQQ, and trace.

◆ dprintf()

int dprintf ( FILE * fp,
const char * format,
... )

dprintf – version of fprintf which prepends DEBUG

Definition at line 1009 of file service.cpp.

References DEBUG_ENTRY.

Referenced by atmdat_readin(), CoolCarb(), CoolNitr(), CoolOxyg(), CoolSili(), CoolSulf(), DumpCoolStack(), DumpHeatStack(), iso_radiative_recomb_effective(), iter_track::print_status(), and qheat_init().

◆ dsexp()

double dsexp ( double x)

◆ e2()

double e2 ( double t)

e2 second exponential integral

Parameters
toptical depth argument

Definition at line 299 of file service.cpp.

References DEBUG_ENTRY, ee1(), max(), and sexp().

Referenced by DrvCaseBHS(), humlik(), IterRestart(), IterStart(), MakeHCTData(), newton_step(), my_Integrand_escConE2::operator()(), ParseDrive(), RT_continuum(), RT_tau_reset(), and SanityCheckBegin().

Here is the call graph for this function:

◆ ee1()

double ee1 ( double x)

ee1 first exponential integral

Parameters
xoptical depth argument, returns e1(tau)

Definition at line 312 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, and ioQQQ.

Referenced by e2(), Hion_coll_ioniz_ratecoef(), Hydcs123(), ParseDrive(), and SanityCheckBegin().

◆ ee1_safe()

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.

Parameters
xoptical depth argument, returns e1(tau) * exp(x)

Definition at line 356 of file service.cpp.

References ASSERT, and DEBUG_ENTRY.

◆ FFmtRead()

double FFmtRead ( const char * chCard,
long int * ipnt,
long int last,
bool * lgEOL )

FFmtRead - the free-format number reader

Parameters
*chCardstring giving the line image
*ipntthe index for the character in the string where we shall start
lastthe number of characters in the string - do not search beyond it
*lgEOLtrue if hit end of line with no number

Definition at line 381 of file service.cpp.

References ASSERT, DEBUG_ENTRY, ioQQQ, and min().

Referenced by atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), ContBandsCreate(), database_readin(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), diatomics::GetIndices(), GetStandardHeLines(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), HeCollidSetup(), HelikeTransProbSetup(), HyperfineCreate(), iso_recomb_setup(), FunctLAMDA::operator()(), ParseDrive(), ptrcer(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), read_SH98_He1_cross_sections(), ReadCollisionRateTable(), and ReadIsotopeFractions().

Here is the call graph for this function:

◆ FindAndErase()

bool FindAndErase ( string & str,
const string & substr )
inline

in string str, erase the first instance of substr returns true if an instance of substr was erased

Definition at line 1343 of file cddefines.h.

References FindAndReplace().

Here is the call graph for this function:

◆ FindAndReplace()

bool FindAndReplace ( string & str,
const string & substr,
const string & newstr )
inline

in string str, replace the first instance of substr with newstr returns true if an instance of substr was found and replaced

Definition at line 1331 of file cddefines.h.

Referenced by FindAndErase().

◆ fixit()

void fixit ( void )

fixit set flag saying that this code needs attention, but is not broken, code is in service.cpp

Definition at line 991 of file service.cpp.

References broke, and DEBUG_ENTRY.

Referenced by AbundChange(), atmdat_CHIANTI_readin(), atmdat_readin(), atom_oi_calc(), ChargTranSumHeat(), ContCreatePointers(), ConvBase(), CoolEvaluate(), create_isotopologues_one(), database_readin(), diatomics::diatomics(), DynaCreateArrays(), FndLineHt(), ForbiddenAuls(), GetAveVelocity(), GetDensity(), gridXspec(), diatomics::H2_CollidRateEvalAll(), diatomics::H2_LevelPops(), diatomics::H2_X_sink_and_source(), HeatSum(), HomogeneousSource(), diatomics::init(), IonCSInterp(), IonHydro(), iso_collide(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_satellite(), lgNetEdenSrcSmall(), lines(), lines_helium(), lines_hydro(), t_mole_global::make_species(), mole_check_reverse_reactions(), mole_create_react(), mole_generate_isotopologue_reactions(), diatomics::mole_H2_form(), mole_h2_grain_form(), mole_h_reactions(), mole_partition_function(), mole_solve(), OpacityAddTotal(), OpacityCreateAll(), ParseAtomH2(), ParseCosmology(), ParseDont(), pressureZone(), PresTotCurrent(), PrtZone(), punchFITS_PrimaryHeader(), radius_next(), read_data(), ReadIsotopeFractions(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_escape(), RT_line_one_tauinc(), RT_OTS_Update(), RT_tau_init(), SaveNewContinuum(), set_fractionation(), SetDeuteriumIonization(), diatomics::SolveExcitedElectronicLevels(), state_get_put(), states_nelemfill(), store_new_densities(), zero(), and zoneDensity().

◆ fp_bound() [1/2]

bool fp_bound ( double lo,
double x,
double hi,
int n = 3 )
inline

Definition at line 889 of file cddefines.h.

References ASSERT, fp_equal(), and isnan.

Here is the call graph for this function:

◆ fp_bound() [2/2]

bool fp_bound ( sys_float lo,
sys_float x,
sys_float hi,
int n = 3 )
inline

checks whether a number is within bounds

Definition at line 877 of file cddefines.h.

References ASSERT, fp_equal(), and isnan.

Referenced by DynaStartZone().

Here is the call graph for this function:

◆ fp_bound_tol() [1/2]

bool fp_bound_tol ( double lo,
double x,
double hi,
double tol )
inline

Definition at line 913 of file cddefines.h.

References ASSERT, fp_equal_tol(), and isnan.

Here is the call graph for this function:

◆ fp_bound_tol() [2/2]

bool fp_bound_tol ( sys_float lo,
sys_float x,
sys_float hi,
sys_float tol )
inline

Definition at line 901 of file cddefines.h.

References ASSERT, fp_equal_tol(), and isnan.

Here is the call graph for this function:

◆ fp_equal() [1/2]

bool fp_equal ( double x,
double y,
int n = 3 )
inline

Definition at line 835 of file cddefines.h.

References ASSERT, isnan, max(), min(), and sign3().

Here is the call graph for this function:

◆ fp_equal() [2/2]

◆ fp_equal_tol() [1/2]

bool fp_equal_tol ( double x,
double y,
double tol )
inline

Definition at line 865 of file cddefines.h.

References ASSERT, isnan, and max().

Here is the call graph for this function:

◆ fp_equal_tol() [2/2]

bool fp_equal_tol ( sys_float x,
sys_float y,
sys_float tol )
inline

Definition at line 854 of file cddefines.h.

References ASSERT, isnan, and max().

Referenced by atmdat_readin(), ffun1(), fp_bound_tol(), fp_bound_tol(), get_total_abundance_ions(), diatomics::H2_LevelPops(), diatomics::mole_H2_form(), and TransitionProxy::outline().

Here is the call graph for this function:

◆ fudge()

double fudge ( long int ipnt)

fudge enter fudge factors, or some arbitrary number, with fudge command return value is the fudge factor fudge(-1) queries the routine for the number of fudge parameters that were entered, zero returned if none

Parameters
ipntinteger saying which of the possible numbers on the fudge command to use - 0 would be the first

Definition at line 481 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, fudgec, and ioQQQ.

Referenced by atmdat_readin(), GrainChargeTemp(), InitEmissivities(), and PresTotCurrent().

◆ get_ptr() [1/5]

template<class T>
const T * get_ptr ( const valarray< T > & v)
inline

Definition at line 1091 of file cddefines.h.

◆ get_ptr() [2/5]

template<class T>
const T * get_ptr ( const vector< T > & v)
inline

Definition at line 1095 of file cddefines.h.

◆ get_ptr() [3/5]

template<class T>
T * get_ptr ( T * v)
inline

◆ get_ptr() [4/5]

template<class T>
T * get_ptr ( valarray< T > & v)
inline

Definition at line 1083 of file cddefines.h.

◆ get_ptr() [5/5]

template<class T>
T * get_ptr ( vector< T > & v)
inline

Definition at line 1087 of file cddefines.h.

◆ GetQuote()

int GetQuote ( char * chLabel,
char * chCard,
char * chCardRaw,
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

Parameters
*chLabelnull terminated string between quotes
*chCardinput line, imagae, we set string between quotes to spaces
lgABORTif true then abort if no double quotes found, if false then return null string in this case,
Returns
0 if found double quotes, 1 if did not, string between quotes set to spaces

Definition at line 513 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, ioQQQ, lgAbort, strchr_s(), and TotalInsanity().

Referenced by cdRead().

Here is the call graph for this function:

◆ hmrate4()

double hmrate4 ( double a,
double b,
double c,
double te )
inline

Definition at line 1048 of file cddefines.h.

◆ invalidate_array() [1/3]

void invalidate_array ( double * p,
size_t size )
inline

Definition at line 1067 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

◆ invalidate_array() [2/3]

void invalidate_array ( sys_float * p,
size_t size )
inline

Definition at line 1072 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

◆ invalidate_array() [3/3]

template<class T>
void invalidate_array ( T * p,
size_t size )
inline

Definition at line 1061 of file cddefines.h.

Referenced by iterator< bool, 2 >::invalidate(), and iterator< bool >::invalidate().

◆ ipow()

long int ipow ( long m,
long n )

ipow

Returns
m^n

Definition at line 639 of file service.cpp.

References DEBUG_ENTRY, and is_odd().

Here is the call graph for this function:

◆ is_odd() [1/2]

bool is_odd ( int j)
inline

checks whether argument is odd

Definition at line 714 of file cddefines.h.

Referenced by expn(), fsff(), diatomics::init(), ipow(), ParseSave(), powi(), and SaveDo().

◆ is_odd() [2/2]

bool is_odd ( long j)
inline

Definition at line 715 of file cddefines.h.

◆ max() [1/4]

double max ( double a,
sys_float b )
inline

Definition at line 778 of file cddefines.h.

◆ max() [2/4]

◆ max() [3/4]

long max ( long a,
int b )
inline

Definition at line 776 of file cddefines.h.

◆ max() [4/4]

double max ( sys_float a,
double b )
inline

Definition at line 777 of file cddefines.h.

◆ min() [1/4]

double min ( double a,
sys_float b )
inline

Definition at line 726 of file cddefines.h.

◆ min() [2/4]

◆ min() [3/4]

long min ( long a,
int b )
inline

Definition at line 724 of file cddefines.h.

◆ min() [4/4]

double min ( sys_float a,
double b )
inline

Definition at line 725 of file cddefines.h.

◆ MyAssert()

void MyAssert ( const char * file,
int line,
const char * comment )

MyAssert a version of assert that fails gracefully

Parameters
*file
line

Definition at line 153 of file service.cpp.

References cdEXIT, conv, DEBUG_ENTRY, EXIT_FAILURE, fnzone, ioQQQ, iteration, nzone, ShowMe(), and TorF().

Referenced by cdMain().

Here is the call graph for this function:

◆ MyCalloc()

void * MyCalloc ( size_t num,
size_t size )

MyCalloc wrapper for calloc(). Returns a good pointer or dies.

Parameters
numuse same type as library function CALLOC
size

Definition at line 1533 of file service.cpp.

References ASSERT, cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, and ioQQQ.

◆ MyGaussRand()

double MyGaussRand ( double PctUncertainty)

A custom wrapper for RandGauss than truncates at two standard deviations.

Parameters
PctUncertainty

Definition at line 1683 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and RandGauss().

Referenced by iso_error_generation().

Here is the call graph for this function:

◆ MyMalloc()

void * MyMalloc ( size_t size,
const char * file,
int line )

MyMalloc wrapper for malloc(). Returns a good pointer or dies.

Parameters
sizeuse same type as library function malloc
file
line

Definition at line 1448 of file service.cpp.

References ASSERT, cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, ioQQQ, set_NaN(), and struc.

Here is the call graph for this function:

◆ MyRealloc()

void * MyRealloc ( void * p,
size_t size )

MyRealloc wrapper for realloc(). Returns a good pointer or dies.

Parameters
numuse same type as library function REALLOC
size

Definition at line 1569 of file service.cpp.

References ASSERT, cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, and ioQQQ.

◆ nint()

long nint ( double x)
inline

◆ nMatch()

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

Parameters
*chKey
*chCard

Definition at line 451 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and strstr_s().

Referenced by atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), cdRead(), t_input::echo(), mie_read_mix(), mie_read_rfi(), mie_read_szd(), ParseGrain(), ParseSave(), PrtFinal(), SaveDo(), StandardEnergyUnit(), StandardFluxUnit(), and vary_input().

Here is the call graph for this function:

◆ OUT_OF_RANGE()

◆ plankf()

double plankf ( long int ip)

plankf evaluate Planck function for any cell at current electron temperature

Parameters
ip

Definition at line 1707 of file service.cpp.

References DEBUG_ENTRY, FR1RYD, POW2, and rfield.

Referenced by SaveDo().

◆ pow2()

◆ pow3()

◆ pow4()

template<class T>
T pow4 ( T a)
inline

Definition at line 945 of file cddefines.h.

◆ powi()

◆ PrintE71()

void PrintE71 ( FILE * ioOUT,
double value )

print with 1p,e8.1 format onto stream FILE

Definition at line 788 of file service.cpp.

References DEBUG_ENTRY.

Referenced by PrtFinal().

◆ PrintE82()

void PrintE82 ( FILE * ioOUT,
double value )

print with 1p,e8.2 format onto stream FILE all are located in printe82.c

Definition at line 739 of file service.cpp.

References DEBUG_ENTRY.

Referenced by AbundancesSet(), IonHydro(), PrtAllTau(), PrtFinal(), and PrtHeader().

◆ PrintE93()

void PrintE93 ( FILE * ioOUT,
double value )

print with 1p,e9.3 format onto stream FILE

Definition at line 838 of file service.cpp.

References DEBUG_ENTRY.

Referenced by HydroLevel(), PrtAllTau(), PrtFinal(), PrtHeader(), PrtHydroTrace1a(), PrtZone(), and save_opacity().

◆ qg32()

double qg32 ( double xl,
double xu,
double(* fct )(double) )

32 point gaussian quadrature integration

Parameters
xllower limit to integration
xu- upper limit to integration
(*fct)- pointer to routine to be integrated, arg is x val

Definition at line 1053 of file service.cpp.

References DEBUG_ENTRY.

Referenced by AngerJ(), cont_gaunt_calc(), CS_ThermAve_PR78(), iso_radrecomb_from_cross_section(), Recomb_Seaton59(), and SanityCheckBegin().

◆ RandGauss()

double RandGauss ( double xMean,
double s )

normal random variate generator

Parameters
xMeanmean value
sstandard deviation s

Definition at line 1643 of file service.cpp.

References BIGDOUBLE, DEBUG_ENTRY, genrand_real3(), x1, and x2.

Referenced by Badnell_rec_init(), diatomics::init(), and MyGaussRand().

Here is the call graph for this function:

◆ read_whole_line()

◆ safe_div() [1/4]

double safe_div ( double x,
double y )
inline

Definition at line 1035 of file cddefines.h.

References safe_div().

Here is the call graph for this function:

◆ safe_div() [2/4]

double safe_div ( double x,
double y,
double res_0by0 )
inline

safe_div( x, y ) - do a really safe division x/y returns +/-DBL_MAX if the division would have overflowed (includes div by 0) returns NaN (i.e. crashes) when x or y are NaN, returns res_0by0 when evaluating 0/0

Definition at line 1002 of file cddefines.h.

References isnan, and sign3().

Here is the call graph for this function:

◆ safe_div() [3/4]

sys_float safe_div ( sys_float x,
sys_float y )
inline

Definition at line 994 of file cddefines.h.

References safe_div().

Here is the call graph for this function:

◆ safe_div() [4/4]

sys_float safe_div ( sys_float x,
sys_float y,
sys_float res_0by0 )
inline

safe_div( x, y ) - do a really safe division x/y returns +/-FLT_MAX if the division would have overflowed (includes div by 0) returns NaN (i.e. crashes) when x or y are NaN, returns res_0by0 when evaluating 0/0

Definition at line 961 of file cddefines.h.

References isnan, and sign3().

Referenced by ConvEdenIoniz(), ConvTempEdenIoniz(), eden_sum(), EdenError(), GetFracPop(), iso_departure_coefficients(), iter_track::next_val(), iter_track::next_val(), RT_diffuse(), safe_div(), safe_div(), and SaveDo().

Here is the call graph for this function:

◆ SafeGetline()

istream & SafeGetline ( istream & is,
string & t )

Definition at line 1770 of file service.cpp.

Referenced by CloudyPrintReference(), and DatabasePrintReference().

◆ SDIV() [1/2]

double SDIV ( double x)
inline

Definition at line 954 of file cddefines.h.

References SMALLFLOAT.

◆ SDIV() [2/2]

sys_float SDIV ( sys_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 952 of file cddefines.h.

References SMALLFLOAT.

Referenced by AbundancesSet(), t_fe2ovr_la::atoms_fe2ovr(), AtomSeqBoron(), cdTemp(), ChargTranEval(), check_co_ion_converge(), ChemImportance(), ContRate(), ConvBase(), ConvInitSolution(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolNitr(), CoolOxyg(), CoolSave(), DynaPunchTimeDep(), Fe2_cooling(), FeIILevelPops(), FeIIPunPop(), fill_array(), frac_H2star_hminus(), funjac(), GammaPrt(), GrainDrive(), diatomics::gs_rate(), H21_cm_pops(), diatomics::H2_Calc_Average_Rates(), diatomics::H2_Cooling(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_Prt_column_density(), diatomics::H2_Prt_Zone(), diatomics::H2_PunchDo(), diatomics::H2_Solomon_rate(), diatomics::H2_X_sink_and_source(), HeatSum(), HomogeneousSource(), ion_recomb(), ion_trim(), iso_cool(), iso_level(), iter_end_check(), IterEnd(), IterStart(), lgCheckMonitors(), lgCoolHeatCheckConverge(), lgNetEdenSrcSmall(), lgStatesConserved(), lines_continuum(), lines_grains(), t_mole_global::make_species(), t_mean::MeanInc(), diatomics::Mol_Photo_Diss_Rates(), mole_effects(), mole_h2_grain_form(), mole_h_rate_diagnostics(), mole_return_cached_species(), mole_solve(), oi_othercs(), ParseTable(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtColumns(), PrtComment(), PrtFinal(), PrtZone(), radius_first(), radius_increment(), radius_next(), RT_continuum(), RT_continuum_shield_fcn(), RT_line_all(), RT_line_one_tauinc(), RT_OTS_Update(), RT_stark(), SaveDo(), SaveHeat(), SaveLineData(), diatomics::SolveExcitedElectronicLevels(), diatomics::SolveSomeGroundElectronicLevels(), and timestep_next().

◆ sexp() [1/2]

double sexp ( double x)

Definition at line 933 of file service.cpp.

References DEBUG_ENTRY, and SEXP_LIMIT.

◆ sexp() [2/2]

◆ ShowMe()

◆ sign()

template<class T>
T sign ( T x,
T y )
inline

FP sign transfer (fortran sign function) - sign of y times abs value of x

Parameters
x
y

Definition at line 800 of file cddefines.h.

Referenced by bessel_jn(), bessel_yn(), ConvEdenIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolSave(), lgReactBalance(), iter_track::next_val(), qheat_init(), setstp(), xinvrs(), and ZoneStart().

◆ sign3()

template<class T>
int sign3 ( T x)
inline

sign3 returns -1 for negative arguments, +1 for positive, and 0 for zero (pascal sign function)

Definition at line 808 of file cddefines.h.

Referenced by find_arr(), fp_equal(), fp_equal(), iter_track::init_bracket(), mie_read_rfi(), RebinFind(), safe_div(), and safe_div().

◆ Split()

void Split ( const string & str,
const string & sep,
vector< string > & lst,
split_mode mode )

Split: split a string into substrings using "sep" as separator

Definition at line 106 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, ioQQQ, SPM_KEEP_EMPTY, and SPM_STRICT.

Referenced by t_cpu_i::t_cpu_i(), and t_version::t_version().

◆ spsort()

void spsort ( realnum x[],
long int n,
long int iperm[],
int kflag,
int * ier )

spsort netlib routine to sort array returning sorted indices

Parameters
x[]input array to be sorted
nnumber of values in x
iperm[]permutation output array
kflagflag saying what to do - 1 sorts into increasing order, not changing
kflagthe original routine
*iererror condition, should be 0

Definition at line 1100 of file service.cpp.

References DEBUG_ENTRY.

Referenced by atmdat_CHIANTI_readin(), CoolSave(), diatomics::H2_PunchDo(), PrtFinal(), PrtLinePres(), SanityCheckBegin(), and SaveHeat().

◆ strchr_s() [1/2]

char * strchr_s ( char * s,
int c )
inline

Definition at line 1444 of file cddefines.h.

◆ strchr_s() [2/2]

const char * strchr_s ( const char * s,
int c )
inline

◆ strstr_s() [1/2]

char * strstr_s ( char * haystack,
const char * needle )
inline

Definition at line 1434 of file cddefines.h.

◆ strstr_s() [2/2]

const char * strstr_s ( const char * haystack,
const char * needle )
inline

◆ TestCode()

void TestCode ( void )

TestCode set flag saying that test code is in place

Definition at line 972 of file service.cpp.

References DEBUG_ENTRY, and lgTestCodeCalled.

Referenced by RT_continuum().

◆ tolower() [1/2]

char tolower ( char c)
inline

Definition at line 691 of file cddefines.h.

References tolower().

Referenced by atmdat_CHIANTI_readin(), tolower(), tolower(), and uncaps().

Here is the call graph for this function:

◆ tolower() [2/2]

unsigned char tolower ( unsigned char c)
inline

Definition at line 695 of file cddefines.h.

References tolower().

Here is the call graph for this function:

◆ TorF()

◆ TotalInsanity()

NORETURN void TotalInsanity ( void )

TotalInsanity general error handler for something that cannot happen, exits

Definition at line 886 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, ioQQQ, NORETURN, and ShowMe().

Referenced by AbundancesPrt(), iterator< bool, 2 >::alloc(), atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_readin(), atom_level3(), atom_levelN(), AtomCSInterp(), Badnell_rec_init(), cdInit(), cdLine(), cdMain(), cdRead(), CHIANTI_Upsilon(), t_ADfA::coll_ion_wrapper(), collision_strength_VF01(), conorm(), ContSetIntensity(), ConvInitSolution(), ConvIterCheck(), ConvTempEdenIoniz(), CoolCarb(), CoolEvaluate(), CoolNitr(), CoolOxyg(), CoolSave(), CoolSili(), CoolSulf(), cross_section(), CS_PercivalRichards78(), database_readin(), dawson(), dBase_solve(), DebyeDeriv(), DynaPunchTimeDep(), DynaSave(), multi_geom< d, ALLOC >::finalize(), ForbiddenAuls(), ForcePass(), t_cpu_i::getPathList(), GetQuote(), GrainChargeTemp(), GrainMakeDiffuse(), GravitationalPressure(), GridGatherInCloudy(), GrnStdDpth(), H21_cm_pops(), diatomics::H2_LevelPops(), he_1trans(), helike_quantum_defect(), diatomics::init(), t_yield::init_yield(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), IonCSInterp(), irsl2ind(), iso_assign_quantum_numbers(), iso_collapsed_Aul_update(), iso_collapsed_bnl_set(), iso_collide(), iso_create(), iso_cross_section(), iso_get_total_num_levels(), iso_radrecomb_from_cross_section(), iter_end_check(), lgCheckMonitors(), lgInputComment(), lgOptimize_do(), lines(), lines_setup(), t_mean::MeanIon(), mole_effects(), mole_h_reactions(), Opacity_iso_photo_cs(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), iterator< bool, 2 >::p_setupArray(), pah2_fun(), pah3_fun(), ParseAtomFeII(), ParseAtomISO(), ParseBlackbody(), ParseCosmology(), ParseGrain(), ParseMonitorResults(), ParseSave(), ParseSet(), ParseTable(), PrtColumns(), PrtComment(), PrtFinal(), PrtMeanIon(), radius_first(), radius_next(), read_hm05(), read_SH98_He1_cross_sections(), ReadBadnellAIData(), rfield_opac_malloc(), RT_continuum(), RT_continuum_shield_fcn(), RT_OTS_ChkSum(), save_average(), SaveDo(), sprt_wl(), StarburstInitialize(), state_get_put(), states_nelemfill(), SumDensities(), tbl_fun(), tfidle(), timestep_next(), TlustyInterpolate(), TotalInsanityAsStub(), vary_input(), zoneDensity(), and ZoneStart().

Here is the call graph for this function:

◆ TotalInsanityAsStub()

template<class T>
T TotalInsanityAsStub ( )

Definition at line 449 of file cddefines.h.

References TotalInsanity(), and ZeroNum.

Referenced by MPI::t_MPI::total_insanity().

Here is the call graph for this function:

◆ toupper() [1/2]

char toupper ( char c)
inline

Definition at line 700 of file cddefines.h.

References toupper().

Referenced by cap4(), caps(), database_readin(), diatomics::diatomics(), mie_read_word(), process_output(), toupper(), and toupper().

Here is the call graph for this function:

◆ toupper() [2/2]

unsigned char toupper ( unsigned char c)
inline

Definition at line 704 of file cddefines.h.

References toupper().

Here is the call graph for this function:

◆ uncaps()

void uncaps ( char * chCard)

uncaps convert input command line (through eol) to all lowercase

Parameters
chCard- line image as string of characters

Definition at line 263 of file service.cpp.

References DEBUG_ENTRY, and tolower().

Referenced by atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), and database_readin().

Here is the call graph for this function:

Variable Documentation

◆ DEPTH_OFFSET

const double DEPTH_OFFSET = 1.e-30

this is used to add to depth to prevent div or log of zero

Definition at line 272 of file cddefines.h.

Referenced by ParseSet(), PrtComment(), and zero().

◆ DSEXP_LIMIT

const double DSEXP_LIMIT = 680.

this is -ln of smallest number dsexp can handle

Definition at line 1478 of file cddefines.h.

Referenced by dsexp().

◆ FILENAME_PATH_LENGTH

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 246 of file cddefines.h.

◆ FILENAME_PATH_LENGTH_2

◆ fnzone

◆ INPUT_LINE_LENGTH

◆ ioMAP

FILE* ioMAP
extern

Definition at line 9 of file cdinit.cpp.

Referenced by CloseSaveFiles(), iter_end_check(), ParseMap(), ParseSave(), and SaveFilesInit().

◆ ioPrnErr

FILE* ioPrnErr
extern

we shall write errors to this file, it is set to stderr in cdInit

Definition at line 9 of file cddefines.cpp.

Referenced by PrtComment(), t_cpu_i::t_cpu_i(), and zero().

◆ ioQQQ

FILE* ioQQQ
extern

ioQQQ is the file handle to the output file itself, ioQQQ is set to stdout by default, and is reset to anything else by calling cdOutput

Definition at line 7 of file cddefines.cpp.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), AGN_Hemis(), AtlasCompile(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_LAMDA_readin(), atmdat_outer_shell(), atmdat_readin(), atmdat_STOUT_readin(), AtmospheresAvail(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop5(), AtomSeqBeryllium(), Badnell_rec_init(), badprt(), BadRead(), bangin(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), caunin(), cdClock(), cdColm(), cdDrive(), cdExecTime(), cdH2_colden(), cdInit(), cdIonFrac(), cdLine(), cdLine_ip(), cdMain(), cdOutput(), cdPrepareExit(), cdRead(), cdSPEC(), cdSPEC2(), cdTemp(), ChargTranPun(), ChargTranSumHeat(), ChckFill(), CheckVal(), t_mole_local::chem_heat(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), chMolBranch(), CloseSaveFiles(), cloudy(), CloudyPrintReference(), cnewton(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolCarb(), CoolEvaluate(), CoolHeatError(), CoolNitr(), CoolOxyg(), coolpr(), CoolSave(), CoolSili(), CoolSulf(), CoolSum(), CoStarCompile(), CoStarListModels(), database_readin(), DatabasePrintReference(), dBase_solve(), dbg_printf(), dense_tabden(), dgaunt(), dmpary(), do_dump_state(), do_restore_state(), DoFSMixing(), doop(), Parser::doSetVar(), Drive_cdLine(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DumpCoolStack(), DumpHeatStack(), DumpLine(), DynaEndZone(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), Parser::echo(), eden_sum(), EdenError(), ee1(), ellpk(), endFindLevLine(), esc_CRDwing_1side(), escmase(), expn(), F2_1(), factorial(), Fe26cs123(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), FeII_Colden(), FeII_RT_Make(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIICreate(), FeIILevelPops(), FeIIPunData(), FeIIRadPress(), FeIISaveLines(), FFmtRead(), Parser::FFmtRead(), ffun(), ffun1(), fill(), FillExtraLymanLine(), FillGFF(), FillJ(), find_arr(), find_solution(), FindIndex(), fndneg(), fndstr(), FreeFreeGaunt(), fudge(), funjac(), GammaPrtShells(), gauss_legendre(), Energy::get(), get_total_abundance_ions(), GetBins(), GetFracPop(), GetLineRec(), GetModel(), GetNextLine(), Parser::getNumberCheckAlwaysLogLim(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), GetStandardHeLines(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), grid_do(), GridCompile(), gridXspec(), GrnStdDpth(), H21_cm_pops(), diatomics::H2_Colden(), diatomics::H2_CollidRateEvalAll(), diatomics::H2_CollidRateRead(), diatomics::H2_Cooling(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_ParseSave(), diatomics::H2_Prt_Zone(), diatomics::H2_PrtDepartCoef(), diatomics::H2_Punch_line_data(), diatomics::H2_RadPress(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), diatomics::H2_Reset(), diatomics::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(), HeatSum(), HeCollidSetup(), HeCSInterp(), HelikeTransProbSetup(), highen(), HomogeneousSource(), t_ADfA::hpfit(), hv(), Hydcs123(), HydroEinstA(), HydroLevel(), HydroRecCool(), HyperfineCreate(), IncidentContinuumHere(), diatomics::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitSimPostparse(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_trim(), ion_wrapper(), IonHelium(), IonHydro(), IonNelem(), ipContEnergy(), ipFindLevLine(), ipLineEnergy(), ipoint(), ipShells(), iso_cascade(), iso_collapsed_bnl_print(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_recomb_setup(), iso_renorm(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), Kurucz79Compile(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConserveEnergy(), lgConvTemp(), lgCoolNetConverge(), lgElemsConserved(), lgNetEdenSrcSmall(), lgOptimize_do(), lgStatesConserved(), lgValidModel(), ligbar(), LimitSh(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_setup(), lines_table(), LineStackCreate(), main(), map_do(), t_mean::MeanIon(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), MihalasCompile(), mole_check_reverse_reactions(), mole_cmp_num_in_out_reactions(), mole_eval_balance(), mole_generate_isotopologue_reactions(), diatomics::mole_H2_LTE(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_print_species_reactions(), mole_rk_bigchange(), mole_solve(), mole_system_error(), mole_update_rks(), mole_update_species_cache(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), newreact(), newspecies(), newton_step(), Parser::NoNumb(), notein(), oi_level_pops(), opacity_more_memory(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), t_cpu_i::open_data, t_cpu_i::open_data, optimize_func(), optimize_phymir(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), phymir_state< X, Y, NP, NSTR >::p_execute_job_parallel(), Flux::p_InternalFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_process_output(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), parse_save_colden(), parse_save_line(), Parse_Save_Line_RT(), parse_species_label(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseAtom(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFail(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PlanckIntegral(), plot(), pltcon(), pltmap(), pltopc(), pltr(), PntForLine(), PressureChange(), PresTotCurrent(), bad_assert::print(), print_delimiter(), iter_track::print_history(), iter_track::print_status(), t_cpu_i::printDataPath(), PrintRates(), PrintRatio(), prme(), process_output(), prt_constants(), prt_smooth_predictions(), PrtAllTau(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLineSum(), PrtMacros(), PrtMeanIon(), prtmet(), prtPunOpacSummary(), PrtTwoPhotonEmissCoef(), PrtZone(), ptrcer(), punchFITS_SpectraData(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RauchCompile(), RauchInitializeSub(), RauchReadMPP(), read_continuum_mesh(), read_Helike_cross_sections(), read_hm05(), read_whole_line(), t_input::readarray(), ReadAugerData(), ReadBadnellAIData(), ReadTable(), RebinQHeatResults(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_escape(), RT_line_one(), RT_line_one_tau_reset(), RT_OTS(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_recom_effic(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya_1side(), SanityCheck(), SanityCheckBegin(), save_average(), save_colden(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveHeat(), SaveLineData(), SaveLineStuff(), SaveResults1Line(), SaveSpecies(), ScaleAllDensities(), ScanProbDistr(), search_limit(), Energy::set(), SetLimits(), GroupMap::setup(), ShowMe(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), solveions(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), state_do(), state_get_put(), states_nelemfill(), stepDensity(), store_new_densities(), StuffComment(), SumDensities(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), t_fe2ovr_la::t_fe2ovr_la(), t_version::t_version(), TempChange(), TempChange(), TempInterp(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), uderiv(), ufunct(), UpdatePot(), UpdateUTAs(), ValidateGrid(), vary_input(), warnin(), WernerCompile(), WMBASICCompile(), XERBLA(), y0b01(), Yfunc(), t_mole_global::zero(), zero(), zoneDensity(), and ZoneStart().

◆ ioStdin

FILE* ioStdin
extern

◆ ipALUMINIUM

const int ipALUMINIUM = 12

Definition at line 317 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), CoolAlum(), CoolEvaluate(), PrtZone(), and SaveDo().

◆ ipARGON

const int ipARGON = 17

◆ ipBERYLLIUM

const int ipBERYLLIUM = 3

Definition at line 308 of file cddefines.h.

Referenced by AbundancesZero(), and PrtZone().

◆ ipBORON

const int ipBORON = 4

Definition at line 309 of file cddefines.h.

Referenced by AbundancesZero(), and PrtZone().

◆ ipCALCIUM

const int ipCALCIUM = 19

◆ ipCARBON

◆ ipCHLORINE

const int ipCHLORINE = 16

Definition at line 321 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), CoolChlo(), and CoolEvaluate().

◆ ipCHROMIUM

const int ipCHROMIUM = 23

Definition at line 328 of file cddefines.h.

Referenced by AbundancesZero(), CoolChro(), and CoolEvaluate().

◆ ipCOBALT

const int ipCOBALT = 26

Definition at line 331 of file cddefines.h.

Referenced by AbundancesZero(), and CoolEvaluate().

◆ ipCOPPER

const int ipCOPPER = 28

Definition at line 333 of file cddefines.h.

Referenced by AbundancesZero().

◆ ipCRD

const int ipCRD = -1

◆ ipCRDW

◆ ipDEST_INCOM

const int ipDEST_INCOM = 2

Definition at line 300 of file cddefines.h.

Referenced by RT_DestProb(), and RT_line_escape().

◆ ipDEST_K2

const int ipDEST_K2 = 1

Definition at line 298 of file cddefines.h.

Referenced by RT_DestProb(), and RT_line_escape().

◆ ipDEST_SIMPL

const int ipDEST_SIMPL = 3

Definition at line 302 of file cddefines.h.

Referenced by RT_DestProb().

◆ ipFLUORINE

const int ipFLUORINE = 8

Definition at line 313 of file cddefines.h.

Referenced by AbundancesZero().

◆ ipHELIUM

const int ipHELIUM = 1

◆ ipHYDROGEN

const int ipHYDROGEN = 0

these are indices for some elements, on the C scale

Definition at line 305 of file cddefines.h.

Referenced by AbundancesPrt(), AbundancesSet(), AbundancesZero(), AbundChange(), AGN_Hemis(), atmdat_readin(), atom_oi_calc(), t_fe2ovr_la::atoms_fe2ovr(), Badnell_rec_init(), diatomics::CalcPhotoionizationRate(), cdColm(), cdIonFrac(), cdTemp(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chkCaHeps(), conorm(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolIron(), CoolNeon(), CoolNick(), CoolOxyg(), CoolSili(), CoolSulf(), dBase_solve(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaPunchTimeDep(), DynaSave(), DynaSaveLast(), DynaStartZone(), eden_sum(), EdenChange(), Fe2_cooling(), FeIILevelPops(), FeIILyaPump(), fill_array(), find_solution(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainMakeDiffuse(), GrainRateDr(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrnStdDpth(), GrnVryDpth(), H21_cm_pops(), diatomics::H2_PunchDo(), diatomics::H2_PunchLineStuff(), diatomics::H2_X_coll_rate_evaluate(), t_ADfA::h_coll_str(), he_1trans(), HeatSum(), helike_quantum_defect(), highen(), HomogeneousSource(), Hydcs123(), HydroCSInterp(), ColliderList::init(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitDefaultsPreparse(), InitSimPostparse(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_trim(), ion_wrapper(), IonHydro(), iso_assign_quantum_numbers(), iso_charge_transfer_update(), iso_collapsed_bnl_set(), iso_collapsed_update(), iso_continuum_lower(), iso_cool(), iso_create(), iso_level(), iso_photo(), iso_suprathermal(), iso_update_rates(), iso_zero(), iter_end_check(), IterRestart(), IterStart(), lgCheckMonitors(), lgOH_ChargeTransferDominant(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_li_ne(), lines_molecules(), logPressureState(), t_mole_global::make_species(), map_do(), t_mean::MeanInc(), mie_read_form(), mole_effects(), diatomics::mole_H2_form(), mole_h2_grain_form(), mole_h_fixup(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_solve(), newspecies(), oi_cs(), oi_othercs(), OpacityAddTotal(), OpacityCreateAll(), pah1_fun(), ParseAtomISO(), ParseCommands(), ParseDLaw(), ParseElement(), ParseFluc(), ParseGlobule(), ParseHDEN(), ParsePrint(), ParseSave(), pltopc(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtMeanIon(), PrtZone(), radius_first(), radius_increment(), radius_next(), read_Helike_cross_sections(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_pumping(), RT_OTS(), RT_tau_init(), SanityCheckBegin(), save_opacity(), SaveDo(), SaveLineData(), SaveSpecial(), ScaleAllDensities(), ScaleIonDensities(), scalingDensity(), t_dense::SetGasPhaseDensity(), state_get_put(), states_nelemfill(), SumDensities(), tfidle(), total_molecule_elems(), total_network_elems(), t_dense::zero(), zero(), and zoneDensity().

◆ ipIRON

◆ ipKRYPTON

const int ipKRYPTON = 35

Definition at line 335 of file cddefines.h.

Referenced by HeatSum().

◆ ipLITHIUM

◆ ipLY_A

const int ipLY_A = -2

◆ ipMAGNESIUM

const int ipMAGNESIUM = 11

◆ ipMANGANESE

const int ipMANGANESE = 24

Definition at line 329 of file cddefines.h.

Referenced by AbundancesZero(), and ChargTranEval().

◆ ipNEON

const int ipNEON = 9

◆ ipNICKEL

const int ipNICKEL = 27

Definition at line 332 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), ConvBase(), and CoolEvaluate().

◆ ipNITROGEN

const int ipNITROGEN = 6

◆ ipOXYGEN

◆ ipPHOSPHORUS

const int ipPHOSPHORUS = 14

Definition at line 319 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), CoolEvaluate(), and CoolPhos().

◆ ipPOTASSIUM

const int ipPOTASSIUM = 18

Definition at line 323 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), CoolEvaluate(), and OpacityCreateAll().

◆ ipPRD

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 290 of file cddefines.h.

Referenced by atmdat_readin(), database_prep(), lines_setup(), ParseAtomFeII(), ParseAtomISO(), ReadBadnellAIData(), RT_continuum_shield_fcn(), RT_line_escape(), and zero().

◆ ipRecEsc

const int ipRecEsc = 2

◆ ipRecNetEsc

◆ ipRecRad

◆ ipSCANDIUM

const int ipSCANDIUM = 20

Definition at line 325 of file cddefines.h.

Referenced by AbundancesZero(), CoolEvaluate(), and CoolScan().

◆ ipSILICON

const int ipSILICON = 13

◆ ipSODIUM

const int ipSODIUM = 10

Definition at line 315 of file cddefines.h.

Referenced by AbundancesZero(), ChargTranEval(), CoolEvaluate(), CoolSodi(), and SaveDo().

◆ ipSULPHUR

const int ipSULPHUR = 15

◆ ipTITANIUM

const int ipTITANIUM = 21

Definition at line 326 of file cddefines.h.

Referenced by AbundancesZero(), and ChargTranEval().

◆ ipVANADIUM

const int ipVANADIUM = 22

Definition at line 327 of file cddefines.h.

Referenced by AbundancesZero().

◆ ipZINC

const int ipZINC = 29

Definition at line 334 of file cddefines.h.

Referenced by AbundancesZero(), and helike_energy().

◆ iteration

◆ lgAbort

◆ lgPrnErr

bool lgPrnErr
extern

this is flag saying whether to print errors to standard error output

Definition at line 13 of file cddefines.cpp.

Referenced by ParsePrint(), PrtComment(), t_cpu_i::t_cpu_i(), and zero().

◆ lgTestCodeCalled

bool lgTestCodeCalled
extern

flag lgTestIt turned on if routine TestCode ever called, only generates comment that test code is in place

Definition at line 11 of file cddefines.cpp.

Referenced by PrtComment(), TestCode(), and zero().

◆ lgTestCodeEnabled

bool lgTestCodeEnabled
extern

flag lgTestOn set true with SET TEST command for some test code to be run somewhere

Definition at line 12 of file cddefines.cpp.

Referenced by ParseSet(), and zero().

◆ LIMELM

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 258 of file cddefines.h.

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesZero(), AbundChange(), atmdat_3body(), atmdat_readin(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), cdColm(), cdIonFrac(), cdTemp(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chIonLbl(), t_ADfA::coll_ion_wrapper(), collision_strength_VF01(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvInitSolution(), ConvIterCheck(), CoolEvaluate(), CoolSave(), CoolZero(), dBase_solve(), DumpHeatStack(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), eden_sum(), fill_array(), FillGFF(), get_total_abundance_ions(), Parser::GetElem(), GetStandardHeLines(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainScreen(), GrainsInit(), GrainUpdateRadius1(), HCTIon(), HCTRecom(), HeatSum(), HeatZero(), helike_quantum_defect(), HelikeTransProbSetup(), highen(), HighestIonStage(), Hydcs123(), HydroLevel(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitSimPostparse(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_wrapper(), IonCSInterp(), ipFindLevLine(), ipShells(), iso_allocate(), iso_assign_quantum_numbers(), iso_charge_transfer_update(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_put_error(), iso_radiative_recomb(), iso_recomb_malloc(), iso_recomb_setup(), iso_satellite(), iso_suprathermal(), iso_update_rates(), iso_zero(), IterRestart(), IterStart(), lgNetEdenSrcSmall(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), t_mole_global::make_species(), MakeHCTData(), map_do(), t_mean::MeanInc(), mie_read_form(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), mie_write_opc(), mole_eval_dynamic_balance(), mole_eval_sources(), mole_h_rate_diagnostics(), mole_make_groups(), NewChargeData(), newisotope(), OpacityAdd1Element(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), GrainVar::p_clear0(), GrainVar::p_clear1(), ParseAbundances(), ParseAtomISO(), ParseCompile(), ParseDrive(), ParseElement(), ParseMetal(), ParsePrint(), ParseSave(), ParseSet(), PresTotCurrent(), prt_smooth_predictions(), PrtColumns(), PrtComment(), PrtLinePres(), PrtMeanIon(), prtmet(), PrtZone(), radius_increment(), radius_next(), ReadAugerData(), rfield_opac_malloc(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_OTS_Update(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), SanityCheckBegin(), save_opacity(), SaveDo(), SaveGaunts(), SaveHeat(), SaveLineData(), SaveLineStuff(), SaveResults(), ScaleAllDensities(), t_mole_local::set_location(), state_get_put(), states_nelemfill(), store_new_densities(), SumDensities(), t_mean::t_mean(), t_yield::t_yield(), tfidle(), total_molecule_elems(), total_network_elems(), UpdatePot1(), UpdateRecomZ0(), UpdateUTAs(), t_dense::zero(), and zero().

◆ MAX_DENSITY

const double MAX_DENSITY = 1.e24

this is the maximum particle density allowed in cm^-3

Definition at line 269 of file cddefines.h.

Referenced by AbundancesSet(), find_solution(), get_total_abundance_ions(), iso_continuum_lower(), ParseHDEN(), and store_new_densities().

◆ NHYDRO_MAX_LEVEL

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 266 of file cddefines.h.

Referenced by t_ADfA::H_rad_rec(), t_ADfA::hpfit(), iso_radiative_recomb(), iso_recomb_setup(), Opacity_iso_photo_cs(), ParseAtomISO(), and t_ADfA::t_ADfA().

◆ NISO

const int NISO = 2

the number of iso sequences now in the code

Definition at line 261 of file cddefines.h.

Referenced by atmdat_readin(), Badnell_rec_init(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvIterCheck(), CoolDima(), CoolEvaluate(), CoolSum(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), DynaZero(), fill_array(), FindNeg(), FndLineHt(), HeatSum(), InitCoreload(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitSimPostparse(), ion_collis(), ion_CX(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), ipShells(), iso_allocate(), iso_assign_quantum_numbers(), iso_collapsed_update(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_radiative_recomb(), iso_recomb_auxiliary_free(), iso_recomb_malloc(), iso_recomb_setup(), iso_satellite(), iso_satellite_update(), iso_suprathermal(), iso_update_rates(), iso_zero(), IterRestart(), IterStart(), lgTrivialSolution(), lines(), lines_continuum(), OpacityAdd1Element(), OpacityAddTotal(), ParseElement(), PresTotCurrent(), PrintRates(), PrtComment(), PrtLinePres(), prtmet(), PrtZone(), radius_increment(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_OTS_Update(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), SanityCheckBegin(), SaveLineData(), SaveLineStuff(), ScaleIonDensities(), state_get_put(), states_nelemfill(), store_new_densities(), and zero().

◆ nzone

long int nzone
extern

nzone is zone counter, incremented in routine cloudy is zero during search phase, 1 for first zone at illuminated face

Definition at line 14 of file cddefines.cpp.

Referenced by AbundChange(), AgeCheck(), AGN_Hemis(), t_fe2ovr_la::atoms_fe2ovr(), diatomics::CalcPhotoionizationRate(), cdDepth_depth(), cdMain(), cdnZone(), cdPressure_depth(), t_mole_local::chem_heat(), cloudy(), ContNegative(), ConvBase(), ConvFail(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolCarb(), CoolEvaluate(), CoolHeatError(), dmpary(), DynaIonize(), DynaNewStep(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), EdenChange(), escmase(), Fe2_cooling(), FeIIAddLines(), FeIIRadPress(), fndstr(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), gett2(), gett2o3(), GrainChargeTemp(), GrainDrive(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_RT_tau_inc(), HeatSum(), HomogeneousSource(), ion_photo(), ion_trim(), IonHelium(), iso_cool(), iso_level(), iso_photo(), iso_set_ion_rates(), iso_update_rates(), iter_end_check(), IterEnd(), lgCheckMonitors(), lgConserveEnergy(), lgElemsConserved(), lgNetEdenSrcSmall(), lgStatesConserved(), lines_continuum(), lines_hydro(), lines_lv1_k_zn(), map_do(), mole_effects(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_rk_bigchange(), mole_solve(), MyAssert(), NewChargeData(), OpacityAddTotal(), pltcon(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtLineSum(), PrtZone(), qheat(), radius_first(), radius_increment(), radius_next(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_one(), RT_OTS(), RT_stark(), RT_tau_inc(), save_line(), SaveDo(), SaveLineIntensity(), stepDensity(), store_new_densities(), zero(), zoneDensity(), and ZoneStart().

◆ SEXP_LIMIT

const double SEXP_LIMIT = 84.

this is -ln of smallest number sexp can handle

Definition at line 1476 of file cddefines.h.

Referenced by RT_diffuse(), RT_iso_integrate_RRC(), sexp(), sexp(), and tfidle().

◆ ZeroNum

const double ZeroNum
extern

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 cdinit.cpp.

Referenced by ParseCrashDo(), and TotalInsanityAsStub().