Cloudy
Spectral Synthesis Code for Astrophysics
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 <array>
#include <vector>
#include <valarray>
#include <complex>
#include <map>
#include <tuple>
#include <regex>
#include <memory>
#include <stdexcept>
#include <algorithm>
#include <fstream>
#include <bitset>
#include <unordered_map>
#include <numeric>
#include "cloudyconfig.h"
#include "cpu.h"
Include dependency graph for cddefines.h:

Go to the source code of this file.

Classes

class  Singleton< T >
 
class  Output
 
class  Fixit
 
class  cloudy_exit
 
class  bad_signal
 
class  bad_assert
 
class  cloudy_abort
 
class  t_debug
 
class  t_nodebug
 
class  debugtrace< Trace >
 
class  t_wavl
 

Macros

#define NULL   nullptr
 
#define STATIC   static
 
#define float   PLEASE_USE_REALNUM_NOT_FLOAT
 
#define fopen   PLEASE_USE_open_data_NOT_fopen
 
#define EXIT_SUCCESS   ES_SUCCESS
 
#define EXIT_FAILURE   ES_FAILURE
 
#define lgBOUNDSCHECKVAL   false
 
#define fixit(a)
 
#define cdEXIT(FAIL)
 
#define puts(STR)
 
#define DEBUG
 
#define ASSERT(exp)
 
#define MESSAGE_ASSERT(msg, exp)
 
#define isnan   MyIsnan
 
#define DEBUG_ENTRY(funcname)
 
#define MIN2(a, b)
 
#define MIN3(a, b, c)
 
#define MIN4(a, b, c, d)
 
#define MAX2(a, b)
 
#define MAX3(a, b, c)
 
#define MAX4(a, b, c, d)
 
#define POW2   pow2
 
#define POW3   pow3
 
#define POW4   pow4
 
#define PrintEfmt(F, V)
 

Typedefs

typedef float realnum
 
typedef float sys_float
 

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_DOMAIN_ERROR , 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  wl_type { WL_NATIVE , WL_VACUUM , WL_AIR }
 

Functions

realnum operator""_r (unsigned long long l)
 
realnum operator""_r (long double l)
 
FILE * sys_fopen (const char *path, const char *mode)
 
double fudge (long int ipnt)
 
void broken (void)
 
void fixit_base (const char *func, const char *file, int line, const char *reason)
 
void CodeReview (void)
 
void TestCode (void)
 
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,...)
 
void cdBacktrace ()
 
int fprintf (const Output &stream, const char *format,...)
 
int dprintf (const Output &stream, const char *format,...)
 
bool read_whole_line (string &chLine, FILE *ioIN)
 
NORETURN void OUT_OF_RANGE (const char *str)
 
NORETURN void DOMAIN_ERROR (const string &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)
 
double powpq (double x, int p, int q)
 
double pow (double x, int i)
 
double pow (double x, long i)
 
sys_float pow (sys_float x, int i)
 
sys_float pow (sys_float x, long i)
 
double pow (sys_float x, double y)
 
double pow (double x, sys_float y)
 
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>
void vzero (vector< T > &vec)
 
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)
 
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, class U>
T * get_ptr (vector< T, U > &v)
 
template<class T>
const T * get_ptr (const valarray< T > &v)
 
template<class T, class U>
const T * get_ptr (const vector< T, U > &v)
 
double csphot (long int inu, long int ithr, long int iofset)
 
double AnuUnit (realnum energy)
 
void cap4 (char *chCAP, const char *chLab)
 
void uncaps (char *chCard)
 
void uncaps (string &chCard)
 
void caps (char *chCard)
 
void caps (string &chCard)
 
double FFmtRead (const char *chCard, long int *ipnt, long int last, bool *lgEOL)
 
long nMatch (const char *chKey, const char *chCard)
 
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)
 
size_t sncatf (char *buf, size_t bufSize, const char *fmt,...)
 
size_t sncatf (ostringstream &buf, const char *fmt,...)
 
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 exp10 (double x)
 
sys_float exp10f (sys_float x)
 
sys_float exp10 (sys_float x)
 
t_wavl operator""_vac (unsigned long long wavl)
 
t_wavl operator""_vac (long double wavl)
 
t_wavl operator""_air (unsigned long long wavl)
 
t_wavl operator""_air (long double wavl)
 
t_wavl t_vac (realnum w)
 
t_wavl t_air (realnum w)
 
double plankf (long int ip)
 
istream & SafeGetline (istream &is, string &t)
 
void spsort (realnum x[], long int n, long int iperm[], int kflag, int *ier)
 

Variables

FILE * ioQQQ
 
FILE * ioStdin
 
FILE * ioMAP
 
FILE * ioPrnErr
 
bool lgTestCodeCalled
 
bool lgTestCodeEnabled
 
bool lgPrnErr
 
long int nzone
 
double fnzone
 
long int iteration
 
const double ZeroNum
 
const void * ZeroPtr
 
const int FILENAME_PATH_LENGTH = 200
 
const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2
 
const int INPUT_LINE_LENGTH = 2000
 
const int NCHLAB = 20
 
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 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))) \
throw bad_assert(__FILE__,__LINE__,"Failed: " #exp); \
} while( 0 )
Definition cddefines.h:585
#define UNLIKELY(x)
Definition cpu.h:490

Referenced by abscf(), AbundChange(), addComment(), TransitionProxy::AddHiState(), addKeyword_dbl(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), AgeCheck(), iterator< bool, 2 >::alloc(), iterator< bool >::alloc(), iterator< bool, 2 >::alloc(), atmdat_2phot_setSplineCoefs(), atmdat_2phot_shapefunction(), atmdat_CHIANTI_readin(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level2(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), bh_log(), bhg_log(), bhG_mx(), bhGm_mx(), bhGp_mx(), bhintegrand_log(), t_gaunt::brems_cool(), t_gaunt::brems_opac(), t_gaunt::brems_rt(), t_gaunt::brems_sum_ions(), t_timesc::calc_therm_timesc(), CalcTwoPhotonEmission(), CalcTwoPhotonRates(), cdEmis_ip(), cdLine_ip(), cdMain(), cdSPEC2(), LinSv::chALabSet(), ChargTranPun(), ChargTranSumHeat(), EmissionConstProxy::check(), EmissionProxy::check(), TransitionConstProxy::check(), TransitionProxy::check(), check_mult_path(), LinSv::checkEmergent(), t_mesh::CheckMesh(), CHIANTI_Upsilon(), chIonLbl(), clean_up(), cloudy(), t_ADfA::coll_ion_hybrid(), t_ADfA::coll_ion_wrapper(), ColliderDensities::ColliderDensities(), collision_strength_VF01(), CollisSuppres(), ColStrGBar(), CollisionProxy::ColUL(), CollisionProxy::ColUL(), molecule::compare(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvRate2CS(), CoolAdd(), CoolEvaluate(), coolpr(), TransitionProxy::copy(), CoStarInitialize(), create_isotopologues_one_position(), cross_section(), t_hydro_tbl::cs(), CS_l_mixing(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), CS_l_mixing_S62(), CS_PercivalRichards78(), CS_VS80(), CSresolver(), da(), database_readin(), db_basename_to_spectral(), dBase_solve(), dBaseAbund(), DebyeDeriv(), iter_track::deriv(), dftori(), t_mole_local::dissoc_rate(), t_dynamics::doNonEquilibriumSolve(), DoSatelliteLines(), DumpLine(), DynaIonize(), DynaIterEnd(), DynaNewStep(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), EchoModel(), eden_sum(), EdenChange(), EH2_eval(), emergent_line(), emit_frac(), esc_2side_base(), esc_CRDcore(), esc_CRDwing(), esc_CRDwing_1side(), esc_PRD_1side(), escmase(), expn2_scaled(), F21_mx(), FastVoigtH(), FastVoigtH(), Parser::FFmtRead(), ffun(), ffun1(), fill_array(), multi_geom< d, ALLOC >::finalize(), find_solution(), FindIndex(), t_LineSave::findline(), t_mole_local::findrk(), FindStrongestLineLabels(), findUniqueLen(), flxCell(), FndLineHt(), fndstr(), ForbiddenAuls(), fp_bound(), fp_bound(), fp_bound_tol(), fp_bound_tol(), fp_equal(), fp_equal(), fp_equal_tol(), fp_equal_tol(), fsff_log10(), funjac(), GammaBn(), GammaK(), t_gaunt::gauntff(), Spectrum::get_flux(), get_total_abundance_ions(), GetDopplerWidth(), GetFracPop(), GetGF(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), GetHS98CrossSection(), diatomics::GetIndices(), diatomics::getLine(), GetProbDistr_LowLimit(), getrf_wrapper(), getrs_wrapper(), GetStandardHeLines(), GetString(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainDrift(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GravitationalPressure(), GridCompile(), GridRetrieveXSPECData(), gridXspec(), 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_Einstein_A(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HCSAR_interp(), HCTIon(), HCTRecom(), he_1trans(), He_cross_section(), HeatSum(), HeCSInterp(), HeCSTableInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), helike_transprob_collapsed_to_collapsed(), helike_transprob_collapsed_to_resolved(), highen(), Hion_coll_ioniz_ratecoef(), HlikeCSInterp(), HomogeneousSource(), t_ADfA::hpfit(), hri_log10(), hrii_log(), hunt_bisect(), hunt_bisect_reverse(), hv(), Hydcs123(), hydro_energy(), hydro_Fujimoto_deexcit(), hydro_Lebedev_deexcit(), hydro_transprob(), hydro_transprob_collapsed_to_collapsed(), hydro_transprob_collapsed_to_resolved(), hydro_vs_coll_recomb(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HyperfineCreate(), HyperfineCS(), HyperfineTspin(), igam(), igamc(), igamc_scaled(), diatomics::init(), LinSv::init(), ran_pool< T >::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), init_seed(), t_yield::init_yield(), InitCoreloadPostparse(), InitEmissivities(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), InitSimPostparse(), insertToken(), InterpCollRate(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), inv_ufunct(), iterator< bool, 2 >::invalidate(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_trim2(), ion_trim_small(), ion_trim_validate(), ion_wrapper(), ipFineCont(), ipLineEnergy(), t_mesh::ipointC(), ipShells(), isAtomicIonValid(), isBareNucleus(), iso_allocate(), iso_assign_extralyman_levels(), iso_assign_quantum_numbers(), iso_cascade(), iso_collide(), iso_collisional_ionization(), iso_continuum_lower(), iso_cool(), iso_create(), iso_dielec_recomb_rate(), iso_error_generation(), iso_get_collision_strength(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_put_recomb_error(), iso_rad_rec_cooling_discrete(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_recomb_setup(), iso_renorm(), iso_RRCoef_Te(), iso_satellite(), iso_set_ion_rates(), iso_setOpacity(), iso_solve(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), iso_update_rates(), iter_end_check(), IterRestart(), IterStart(), t_mesh::ithreshC(), lgCheckMonitors(), lgReadAtmosphereTail(), Wind::lgStatic(), lgValidModel(), lincom(), lindst1(), LineConvRate2CS(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), LineStackCreate(), linfit(), linint(), LoadIsotopes(), t_hydro_tbl::m1wn(), MakeInputLine(), mc_escape(), MD5string_core(), MeanMassOfElement(), mie_auxiliary2(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), diatomics::Mol_Photo_Diss_Rates(), MolDissocCrossSection(), mole_eval_balance(), mole_eval_dynamic_balance(), mole_eval_sources(), 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(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), t_ran::new_rank(), newisotope(), newreact(), newspecies(), nMatch(), Parser::nMatch1(), DepthTable::nvals(), nWord(), OccupationNumberLine(), ofit(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), t_cpu_i::open_data, Atom_LevelN::operator()(), my_Integrand_S62::operator()(), setCollRate::operator()(), Spectrum::operator[](), phymir_state< X, Y, NP, NSTR >::optimize(), optimize_func(), phymir_state< X, Y, NP, NSTR >::optimize_with_restart(), TransitionProxy::outline(), outline_base(), t_gaunt::p_gauntff_vec_sub(), t_hydro_tbl::p_initn(), t_hydro_tbl::p_initnl(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), t_wavl::p_RefIndex(), EnergyEntry::p_set_ip(), t_mesh::p_SetupMesh(), ran_pool< T >::p_update_pool(), parse_reaction(), parse_save_average(), parse_species_label(), parse_udfa(), ParseAbundances(), ParseCompile(), ParseCosmicRays(), ParseCrashDo(), ParseDatabaseISO(), ParseDynaTime(), ParseElement(), ParseEnergy(), ParseFluc(), ParseGrid(), ParseIntensity(), ParseInterp(), ParseMonitorResults(), ParsePhi(), ParseQH(), ParseTable(), ParseVLaw(), PE_init(), t_ADfA::phfit(), PlanckIntegral(), PntForLine(), PressureRadiationLine(), PresTotCurrent(), PrintCenterLine(), PrintRates(), PrintSpectrum(), process_output(), processIndices(), prt_LineLabels(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtLinePres(), PrtZone(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSimg_ExtensionHeader(), punchFITSimg_PrimaryHeader(), PutCS(), PutLine(), qheat(), qheat_init(), qintr(), QN2ind(), radius_first(), radius_increment(), radius_next(), RauchReadMPP(), read_Helike_cross_sections(), read_Hummer_Storey(), read_ionization_potentials(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_species_file(), read_UTA_lines(), ReadAugerData(), ReadBadnellAIData(), ReadCollisionRateTable(), ReadTable(), iterator< bool >::realloc(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), reduced_mass_rel(), renorm_solution(), 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(), setCollRate::resize(), Spectrum::resize(), rfield_opac_alloc(), RT_continuum(), RT_continuum_shield_fcn_point(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_one_escape(), RT_line_one_fine(), 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(), RTesc_lya(), S62BesselInvert(), SanityCheckBegin(), save_opacity(), SaveDo(), saveFITSfile(), SaveHeat(), SaveResults(), SaveSpecies(), SaveSpeciesBands(), saveXSPEC(), ScaleAllDensities(), ScanProbDistr(), scqdri(), search_limit(), SecIoniz(), PresMode::set(), t_mole_local::set_ion_locations(), SetLimits(), SetLimitsSub(), SetNChrgStates(), t_mesh::setResolutionScaleFactor(), GroupMap::setup(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), diatomics::SolveSomeGroundElectronicLevels(), spectral_to_chemical(), spline_cubic_set(), store_new_densities(), StoutCollRate(), sum_radiation(), SumDensities(), t_ADfA::t_ADfA(), tbl_fun(), TempInterp(), TempInterp2(), total_molecule_elems(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), TruncatedNormal(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), Flux::uu(), WavlenErrorGet(), t_hydro_tbl::wn(), WriteASCIIHead(), y0b(), y0psa(), y1psa(), y2pa(), y2s(), Yfunc(), Yfunc(), iterator< bool, 2 >::zero(), iter_track::zero_fit(), ZoneEnd(), and ZoneStart().

◆ cdEXIT

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

Referenced by abund_starburst(), AbundancesSet(), t_PredCont::add(), LinSv::addComponent(), LinSv::addComponentID(), AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdInput(), cdMain(), cdMemory(), cdRead(), cdSPEC2(), ChargTranPun(), band_emission::check_index_fatal(), pseudo_cont::check_index_fatal(), check_LAMDA_comment(), t_mesh::CheckMesh(), CheckVal(), chi2_func(), chkCaHeps(), cnewton(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContSetIntensity(), ConvCrossSect2CollStr(), ConvFail(), CoolEvaluate(), CoolHyperfine(), coolpr(), CoolSave(), CoStarInterpolate(), d1mach(), dBase_solve(), Parser::doSetVar(), DynaIterStart(), e1(), e1_scaled(), e2(), ellpk(), Parser::Error(), DataParser::errorAbort(), ErrorMessage(), esc_CRDwing(), escmase(), expn(), extractLevels(), factorial(), fc2_scl(), Fe26cs123(), ffun1(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fudge(), gauss_legendre(), Energy::get(), Parser::getElement(), Parser::getFirstChunk(), Parser::getFirstChunkRaw(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), GetJenkins09(), getLevelsGeneric(), Parser::getline(), GetLineRec(), GetMetalsDeplete(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), getSpeciesGeneric(), getTransition(), GrainCharge(), GrainsInit(), grid_do(), GridRetrieveXSPECData(), gridXspec(), GrnVryDpth(), 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_Read_LTE_cooling_per_H2(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), H_Einstein_A_log10(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), Parser::help(), t_ADfA::hpfit(), hri_log10(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), diatomics::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitIndexArrays(), InitSimPostparse(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ipoint(), iso_create(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgReadAtmosphereTail(), LimitSh(), lines(), bands_file::load(), LoadIsotopes(), LinSv::makeBlend(), MakeInputLine(), map_do(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_next_line(), mie_read_mix(), mie_read_number(), mie_read_ocn(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), mole_create_react(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), Ne10cs123(), newreact(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), optimize_do(), 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(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIllumination(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLineList(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), prtLineType(), punchFITS_SpectraData(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_next(), RandomCrash(), RauchReadMPP(), rd_block(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), read_level2_lines(), read_mewe_gbar(), read_SH98_He1_cross_sections(), read_UTA_lines(), Parser::readLaw(), Parser::readList(), ReadTable(), t_conv::register_(), RT_continuum(), RT_DestProb(), RT_line_escape(), RT_line_one_fine(), RT_recom_effic(), RT_tau_init(), S2Aul(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesPseudoCont(), search_limit(), Energy::set(), PresMode::set(), setIsoNelemFlag(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), size_distr(), solveions(), speciesCheck(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), StoutCollRate(), StuffComment(), t_ADfA::t_ADfA(), t_physconst::t_physconst(), DepthTable::tabval(), TempInterp(), test_isMolecule(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), wr_block(), XERBLA(), xerror_(), y0b01(), Yfunc(), Yfunc(), 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

◆ DEBUG_ENTRY

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

Referenced by abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundChange(), band_cont::accumulate(), Spectrum::accumulate_flux(), t_PredCont::add(), addBandsFile(), addComment(), TransitionProxy::AddHiState(), addKeyword_dbl(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), addUniqueSpeciesBand(), advection_set_default(), AgeCheck(), AGN_He1_CS(), AGN_Hemis(), AngerJ(), anomal(), AnuUnit(), append_file(), append_file(), 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(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), badprt(), BadRead(), bessel_i0(), bessel_i0_i1(), bessel_i0_i1_scaled(), bessel_i0_scaled(), bessel_i1(), bessel_i1_scaled(), bessel_j0(), bessel_j1(), bessel_jn(), bessel_k0(), bessel_k0_k1(), bessel_k0_k1_scaled(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bh_log(), bhg_log(), bhG_mx(), bhGm_mx(), bhGp_mx(), bhintegrand_log(), bigk(), LinSv::biglabel(), blkdata1(), t_gaunt::brems_cool(), t_gaunt::brems_opac(), t_gaunt::brems_rt(), t_gaunt::brems_sum_ions(), broken(), Bruggeman(), C6cs123(), Ca20cs123(), calcc(), diatomics::CalcPhotoionizationRate(), CalcTwoPhotonEmission(), CalcTwoPhotonRates(), canonicalize_reaction(), canonicalize_reaction_label(), cap4(), caps(), caps(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClock(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDrive(), cdEmis(), cdEmis(), cdEmis(), cdEmis_ip(), cdErrors(), cdExecTime(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInit(), cdInput(), cdIonFrac(), cdLine(), cdLine(), cdLine_ip(), cdMain(), cdNoExec(), cdNotes(), cdNwcns(), cdOutput(), cdOutput(), cdPressure_depth(), cdPressure_last(), cdRead(), cdReasonGeo(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), check_co_ion_converge(), t_cpu_i::check_data, check_grid_file(), check_mult_path(), DataParser::checkMagic(), DataParser::checkMagic(), DataParser::checkMagic(), DataParser::checkMagic(), t_mesh::CheckMesh(), CheckVal(), t_mole_local::chem_heat(), chemical_to_spectral(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), ChiantiCollRate(), chIonLbl(), chIonLbl(), chkCaHeps(), ChkUnits(), TransitionProxy::chLabel(), clean_up(), 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(), t_broke::comment(), conorm(), conpmp(), conpmp_qg32(), conpmp_romb(), ConserveEnergy(), diatomics::Cont_Diss_Heat_Rate(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), convert_double(), convert_float(), convert_zig(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolDima(), CoolEvaluate(), CoolH2_GA08(), CoolHeatError(), CoolHyperfine(), coolpr(), CoolSave(), CoolSum(), CoolZero(), CoStarCompile(), CoStarInitialize(), CoStarInterpolate(), CoStarListModels(), create_isotopologues(), create_isotopologues_one_position(), save_img_matrix::createImage(), save_img_matrix::createImage_FITS(), save_img_matrix::createImage_PPM(), t_hydro_tbl::cs(), CS_l_mixing(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), CS_l_mixing_S62(), CS_PercivalRichards78(), CS_ThermAve_PR78(), csphot(), CSresolver(), csscal(), d1mach(), d3_np_fs(), da(), database_prep(), database_readin(), db_basename_to_spectral(), dBase_solve(), dBaseTrim(), dBaseUpdateCollCoeffs(), dbg_printf(), DebyeDeriv(), dftori(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), diatomics::diatomics(), diatoms_init(), t_mole_local::dissoc_rate(), dist(), DLASWP(), dmpary(), doData(), doHeader(), t_dynamics::doNonEquilibriumSolve(), doop(), DoSatelliteLines(), Parser::doSetVar(), dprintf(), dprintf(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpAtmosphere(), DumpLine(), DynaCreateArrays(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaPunchTimeDep(), DynaSave(), DynaSaveLast(), DynaStartZone(), e1(), e1_scaled(), e2(), EchoModel(), eden_sum(), EdenChange(), eeBremsCooling(), eeBremsSpectrum(), eina(), ellpk(), emergent_line(), emit_frac(), EmLineJunk(), EmLineZero(), erfce(), Parser::Error(), DataParser::errorAbort(), ErrorMessage(), esc_2side_base(), esc_CRDcore(), esc_CRDwing_1side(), esc_PRD_1side(), esca0k2(), esccon(), escmase(), evalf(), exp1(), expn(), extin(), extractLevels(), F21_mx(), F21i_log(), factorial(), FastVoigtH(), FastVoigtH(), Fe26cs123(), FFmtRead(), Parser::FFmtRead(), ffun(), ffun(), ffun1(), fill_array(), fill_ext_src_and_snk(), FillExtraLymanLine(), FillJ(), t_PredCont::find(), find_arr(), find_solution(), findBandsFile(), FindHCoStar(), FindIndex(), t_LineSave::findline(), FindNeg(), findnuclide(), t_mole_local::findrate(), t_mole_local::findrk(), findSpecBand(), findspecies(), findspecies_validate(), findspecieslocal(), findspecieslocal_validate(), FindTempChangeFactor(), findUniqueLen(), FindVCoStar(), fix_grid_file(), fixit_base(), FndLineHt(), fndneg(), fndstr(), ForbiddenAuls(), FPRead(), fsff_log10(), fstats(), fudge(), funjac(), ga08_oH2_e(), ga08_oH2_e_a10_b1e4(), ga08_oH2_H(), ga08_oH2_H_b100(), ga08_oH2_H_b1000(), ga08_oH2_H_b6000(), ga08_oH2_H_stitch_100(), ga08_oH2_H_stitch_1000(), ga08_oH2_He(), ga08_oH2_He_b6000(), ga08_oH2_oH2(), ga08_oH2_oH2_a100_b6000(), ga08_oH2_p(), ga08_oH2_p_a10_b1e4(), ga08_oH2_pH2(), ga08_oH2_pH2_a100_b6000(), ga08_pH2_e(), ga08_pH2_e_a1000_b1e4(), ga08_pH2_e_a10_b1000(), ga08_pH2_H(), ga08_pH2_H_b100(), ga08_pH2_H_b1000(), ga08_pH2_H_b6000(), ga08_pH2_H_stitch_100(), ga08_pH2_He(), ga08_pH2_He_b6000(), ga08_pH2_oH2(), ga08_pH2_oH2_a100_b6000(), ga08_pH2_p(), ga08_pH2_p_a10_b1e4(), ga08_pH2_pH2(), ga08_pH2_pH2_a100_b6000(), ga08_sum(), GammaBn(), GammaK(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), t_gaunt::gauntff(), gauss_init(), gauss_legendre(), gbar0(), gbar1(), gegenbauer(), Energy::get(), get_data_minmax(), get_data_minmax(), Spectrum::get_flux(), get_total_abundance_ions(), getAdjPseudoIndex(), GetAveVelocity(), t_cpu_i::getchecksums(), getCode(), GetDensity(), diatomics::GetDissociationRate(), GetDissociationRateCoeff(), Parser::GetElem(), Parser::getElement(), GetEscape(), Parser::getFirstChunk(), Parser::getFirstChunkRaw(), GetFracPop(), GetGF(), diatomics::GetHeatRate(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), GetHubbleFactor(), band_cont::getInten(), getIntenTypeStr(), GetJenkins09(), getLevelsGeneric(), diatomics::getLine(), DataParser::getline(), DataParser::getLineID(), Parser::getLineID(), GetLineRec(), getMolecules(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), getPseudoIndex(), getPseudoWlRange(), Parser::GetQuote(), getSpeciesGeneric(), GetStandardHeLines(), GetString(), Parser::getSymbol(), gett2(), gett2o3(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GravitationalPressure(), grid_do(), GridCompile(), GridInterpolate(), GridRetrieveXSPECData(), 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_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_Read_LTE_cooling_per_H2(), 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_log10(), H_photo_cs(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HaardtMadauCompile(), HaardtMadauInterpolate(), Parser::hasCommand(), HCoolRatio(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), HeatZero(), HeCollidSetup(), HeCSInterp(), HeCSTableInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), helike_transprob_collapsed_to_collapsed(), helike_transprob_collapsed_to_resolved(), HelikeTransProbSetup(), Parser::help(), highen(), Hion_coll_ioniz_ratecoef(), HlikeCSInterp(), hmiopc(), hmirat(), HomogeneousSource(), t_ADfA::hpfit(), hri_log10(), hrii_log(), humlik(), hv(), Hydcs123(), hydro_energy(), hydro_Fujimoto_deexcit(), hydro_Lebedev_deexcit(), hydro_transprob(), hydro_transprob_collapsed_to_collapsed(), hydro_transprob_collapsed_to_resolved(), hydro_vanRegemorter_deexcit(), hydro_vs_coll_recomb(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroCSInterp(), HydroEinstA(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HyperfineCreate(), HyperfineCS(), HyperfineTspin(), hypho(), IDAMAX(), igam(), igamc(), igamc_scaled(), ILAENV(), IncidentContinuumHere(), ColliderList::init(), diatomics::init(), LinSv::init(), t_mole_global::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), init_seed(), phymir_state< X, Y, NP, NSTR >::init_state_file_name(), phymir_state< X, Y, NP, NSTR >::init_strings(), init_struc(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitDynaTimestep(), InitEmissivities(), InitEnthalpy(), InitGrid(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), t_cpu_i::initPath(), InitSimPostparse(), input_readvector(), band_emission::insert(), insertToken(), int2string(), InterpCollRate(), diatomics::interpolate_LTE_Cooling(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), IntRead(), IntRead(), inv_ufunct(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_trim2(), ion_trim_from_set(), ion_trim_from_set(), ion_trim_init(), ion_trim_invalidate(), ion_trim_small(), ion_trim_untrim(), ion_trim_validate(), ion_widen(), ion_wrapper(), ion_zero(), IonHelium(), IonHydro(), IonNelem(), ipContEnergy(), ipFineCont(), ipLineEnergy(), ipow(), ipShells(), isactive(), isAtomicIonValid(), isBareNucleus(), LinSv::isCat(), t_dynamics::isInitialRelaxIteration(), isMolecule(), iso_allocate(), iso_assign_extralyman_levels(), iso_assign_quantum_numbers(), iso_cascade(), iso_charge_transfer_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_collision_strength(), iso_get_total_num_levels(), iso_init(), iso_init_energies(), iso_ionize_recombine(), iso_level(), iso_multiplet_opacities_one(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_put_error(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_discrete(), iso_rad_rec_cooling_extra(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_radrecomb_from_cross_section(), iso_recomb_alloc(), iso_recomb_auxiliary_free(), iso_recomb_check(), 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(), isSpecies(), isSpeciesActive(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Junk(), TransitionProxy::Junk(), KhaireSrianandCompile(), KhaireSrianandInterpolate(), Kurucz79Compile(), Kurucz79Interpolate(), LinSv::label(), lagrange(), ld01_fun(), LeidenCollRate(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), phymir_state< X, Y, NP, NSTR >::lgConvergedRestart(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), DataParser::lgEODMarker(), lgFileReadable(), lgInputComment(), lgInputEOF(), lgIsCommentSeq(), lgIsExpungedCommentSeq(), lgNeedTimestep(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgReactionTrivial(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgValidASCIIFile(), lgValidIdxFile(), lgValidModel(), LimitSh(), linadd(), linadd(), lincom(), lindst(), lindst(), lindst(), lindst1(), LineConvRate2CS(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_helium(), lines_hydro(), lines_iron_Ka(), lines_molecules(), lines_setup(), lines_table(), LineStackCreate(), linfit(), bands_file::load(), LoadIsotopes(), log_integral(), LSAME(), diatomics::LTE_Cooling_per_H2(), t_hydro_tbl::m1wn(), Parser::m_getCommandToken(), Magnetic_evaluate(), Magnetic_reinit(), main(), t_mole_global::make_species(), LinSv::makeBlend(), makeChemical(), makeChemical(), MakeCS(), MakeHCTData(), MakeInputLine(), map_do(), matchGeneric(), maybeNumber(), MD5_Transform(), MD5datafile(), MD5datastream(), MD5file(), MD5string(), MD5string(), MD5string_core(), MD5swap(), t_mean::MeanInc(), t_mean::MeanIon(), MeanMassOfElement(), t_mean::MeanMoleculeTemp(), 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_form(), mie_read_mix(), mie_read_number(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_step(), 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_condition(), mole_get_equilibrium_condition(), diatomics::mole_H2_form(), mole_h2_grain_form(), diatomics::mole_H2_LTE(), mole_h_fixup(), mole_h_reactions(), mole_ion_trim(), mole_make_groups(), mole_make_list(), mole_partition_function(), mole_rk_bigchange(), mole_save(), mole_solve(), mole_update_limiting_reactants(), mole_update_rks(), mole_update_sources(), mole_update_species_cache(), MyAssert(), Ne10cs123(), NewChargeData(), newelement(), newisotope(), newpt(), newreact(), newspecies(), newton_step(), nMatch(), Parser::NoNumb(), nWord(), OccupationNumberLine(), ofit(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), t_cpu_i::open_data, t_cpu_i::open_data, t_cpu_i::open_data, Atom_LevelN::operator()(), FunctLAMDA::operator()(), my_Integrand_S62::operator()(), phymir_state< X, Y, NP, NSTR >::optimize(), optimize_do(), optimize_func(), optimize_phymir(), optimize_subplex(), phymir_state< X, Y, NP, NSTR >::optimize_with_restart(), order(), TransitionProxy::outline(), outline_base(), outline_base_bin(), outsum(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_clear1(), DataParser::p_close(), t_ran::p_dbl(), 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(), t_ran::p_flt(), t_gaunt::p_gauntff_vec(), t_gaunt::p_gauntff_vec_sub(), t_ran::p_generate_random_seed(), Flux::p_get(), DataParser::p_getQuoteOptional(), t_ran::p_init(), t_hydro_tbl::p_initcs(), t_hydro_tbl::p_initn(), t_hydro_tbl::p_initnl(), t_hydro_tbl::p_initnn(), t_hydro_tbl::p_initwn(), Flux::p_InternalFluxUnit(), Flux::p_InternalFluxUnitNoCheck(), phymir_state< X, Y, NP, NSTR >::p_lgLimitExceeded(), DataParser::p_newlineProcess(), DataParser::p_open(), 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(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), t_wavl::p_RefIndex(), phymir_state< X, Y, NP, NSTR >::p_reset_hyperblock(), phymir_state< X, Y, NP, NSTR >::p_reset_transformation_matrix(), t_hydro_tbl::p_RM(), t_ran::p_seed(), Flux::p_set(), EnergyEntry::p_set_ip(), t_gaunt::p_setup_brems(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), t_mesh::p_SetupEdges(), t_mesh::p_SetupMesh(), DataParser::p_showLocation(), t_ran::p_u64(), Flux::p_ValidFluxUnit(), t_wavl::p_wlAirVac(), phymir_state< X, Y, NP, NSTR >::p_wr_state(), t_ran::p_zig(), t_ran::p_ZigTailNormal(), pah1_fun(), pah2_fun(), pah3_fun(), parse_chemical(), parse_reaction(), parse_save_average(), parse_save_line(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCaseB(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExp(), ParseExpr(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIllumination(), ParseInit(), ParseInitFile(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLineList(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseProduct(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), parsespect(), ParseSphere(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), partx(), PE_init(), t_input::peekarray(), Parser::peekNextCommand(), t_ADfA::phfit(), pintr(), PlanckIntegral(), plankf(), pnegopc(), PntForLine(), powi(), powpq(), PressureChange(), PressureRadiationLine(), pressureZone(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintRates(), PrintShortZero(), PrintSpectrum(), prme(), process_output(), processIndices(), LinSv::prt(), prt_constants(), prt_LineLabels(), prt_smooth_predictions(), t_wavl::prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLinePres(), PrtLineSum(), PrtMacros(), PrtMeanIon(), prtmet(), PrtOneMonitor(), t_prt_matrix::prtRates(), PrtTwoPhotonEmissCoef(), PrtZone(), PseudoContCreate(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSimg_ExtensionData_matrix(), punchFITSimg_ExtensionData_vector(), punchFITSimg_ExtensionHeader(), punchFITSimg_PrimaryHeader(), PutCS(), PutLine(), PutLine(), PutLine(), qg32(), qheat(), qheat_init(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandomCrash(), RauchCompile(), RauchInitialize(), RauchInterpolateCOWD(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), RauchReadMPP(), rayleh(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), read_ionization_potentials(), read_level2_lines(), read_mewe_gbar(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_species_file(), read_UTA_lines(), read_whole_line(), t_input::readarray(), ReadAugerData(), ReadBadnellAIData(), ReadCollisionRateTable(), Parser::readLaw(), Parser::readList(), ReadTable(), RebinAtmosphere(), RebinQHeatResults(), RebinSingleCell(), rec6j(), t_ADfA::rec_lines(), reduce_a(), reduce_a(), reduce_ab(), reduce_ab(), reduce_ab(), reduce_ab_a(), reduce_ab_a(), reduce_ab_a(), reduce_ab_a(), reduce_abc(), reduce_abc(), reduce_abc(), reduce_abc(), reduce_abc_ab(), reduced_mass_rel(), t_conv::register_(), register_reaction_vectors(), renorm_solution(), t_prt_matrix::resolveLevels(), resolveSpecType(), rfield_opac_alloc(), ritoa(), ritodf(), RT_continuum(), RT_continuum_shield_fcn(), RT_continuum_shield_fcn_point(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_fine_clear(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_all_escape(), RT_line_driving(), RT_line_electron_scatter(), RT_line_escape(), RT_line_fine_opacity(), RT_line_one_escape(), RT_line_one_fine(), 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(), S2Aul(), S62BesselInvert(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), Save1LineData(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveFilesInit(), saveFITSfile(), saveFITSimg(), saveFITSimg(), SaveGaunts(), SaveGrid(), SaveHeat(), SaveLineData(), SaveLineIntensity(), SaveLineStuff(), SaveResults(), SaveSpecial(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesHeader(), SaveSpeciesOne(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScanProbDistr(), scqdri(), search_limit(), SearchModel(), SecIoniz(), Energy::set(), PresMode::set(), set_fractionation(), t_mole_local::set_ion_locations(), t_mole_local::set_isotope_abundances(), t_cpu_i::set_signal_handlers(), set_weighting(), set_xIntensity(), SetIsotopeFractions(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setProperties(), t_LineSave::setSortWL(), t_prt_matrix::setSpecies(), setstp(), t_rfield::setTrimming(), pseudo_cont::setup(), t_mean::setup_molecules(), setXtraRatesCa2(), setXtraRatesFe2(), setXtraRatesO1(), sexp(), sexp(), shieldFederman(), ShowMe(), simplx(), t_mole_local::sink_rate(), t_mole_local::sink_rate_tot(), t_mole_local::sink_rate_tot(), sinpar(), SixJFull(), size_distr(), sjs(), sncatf(), solve_system(), diatomics::SolveExcitedElectronicLevels(), solveions(), diatomics::SolveSomeGroundElectronicLevels(), sortd(), SortUnique(), t_mole_local::source_rate_tot(), t_mole_local::source_rate_tot(), specBandsExists(), species_gasphase_density(), SpeciesBandsAccum(), SpeciesBandsCreate(), SpeciesPseudoContAccum(), SpeciesPseudoContCreate(), spectral_to_chemical(), spectral_to_chemical(), spectral_to_chemical(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), Split(), t_wavl::sprt_wl(), spsort(), StandardEnergyUnitNoAbort(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), start(), states_nelemfill(), states_popfill(), states_propprint(), stepDensity(), sticking_probability_H_func(), sticking_probability_H_HM79(), Stognienko(), store_new_densities(), StoutCollRate(), StripComment(), StuffComment(), subopt(), band_emission::sumBand(), pseudo_cont::sumBand(), sumcon(), t_abund::SumDepletedAtoms(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), t_mean::t_mean(), t_ran::t_ran(), DepthTable::tabval(), tauff(), TauZero(), tbl_fun(), TempChange(), TempChange(), TempInterp(), TempInterp2(), test_cdTemp_molecules(), test_isMolecule(), 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(), TotalInsanity(), totlin(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), trim_levels(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), uncaps(), uncaps(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), UpdateUTAs(), Flux::uu(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), vary_input(), vasinh(), vasinh(), vexp(), vexp(), vexp10(), vexp10(), vexpm1(), vexpm1(), vfast_asinh(), vfast_asinh(), vhypot(), vhypot(), vlog(), vlog(), vlog10(), vlog10(), vlog1p(), vlog1p(), vsqrt(), vsqrt(), DataParser::warning(), WavlenErrorGet(), WernerCompile(), WernerInterpolate(), WMBASICCompile(), WMBASICInterpolate(), t_hydro_tbl::wn(), WriteASCIIData(), WriteASCIIHead(), XERBLA(), xerror_(), xinvrs(), xmap(), xoroshiro128plus(), xoroshiro128plus_jump(), xoshiro256starstar(), xoshiro256starstar_jump(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yan_H2_CS(), Yfunc(), Yfunc(), TransitionProxy::Zero(), Zero(), t_abund::zero(), t_atmdat::zero(), t_atoms::zero(), t_colden::zero(), t_CoolHeavy::zero(), t_dark_matter::zero(), t_DoppVel::zero(), t_dynamics::zero(), t_he::zero(), t_hextra::zero(), t_hmi::zero(), t_hydro::zero(), t_hyperfine::zero(), t_isoCTRL::zero(), t_line_col::zero(), t_LineSave::zero(), t_magnetic::zero(), t_mean::zero(), t_mole_global::zero(), t_opac::zero(), t_oxy::zero(), t_peimbt::zero(), t_phycon::zero(), t_pressure::zero(), t_prt_matrix::zero(), t_radius::zero(), t_rfield::zero(), t_rt::zero(), t_secondaries::zero(), t_thermal::zero(), t_warnings::zero(), zero(), ZeroContin(), zoneDensity(), ZoneEnd(), and ZoneStart().

◆ EXIT_FAILURE

#define EXIT_FAILURE   ES_FAILURE

Referenced by abund_starburst(), AbundancesSet(), t_PredCont::add(), LinSv::addComponent(), LinSv::addComponentID(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdMemory(), cdRead(), cdSPEC2(), ChargTranPun(), band_emission::check_index_fatal(), pseudo_cont::check_index_fatal(), check_LAMDA_comment(), t_mesh::CheckMesh(), CheckVal(), chi2_func(), chkCaHeps(), cnewton(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContSetIntensity(), ConvCrossSect2CollStr(), ConvFail(), CoolEvaluate(), CoolHyperfine(), coolpr(), CoolSave(), d1mach(), dBase_solve(), Parser::doSetVar(), DynaIterStart(), e1(), e1_scaled(), e2(), ellpk(), Parser::Error(), DataParser::errorAbort(), ErrorMessage(), esc_CRDwing(), escmase(), expn(), extractLevels(), factorial(), fc2_scl(), Fe26cs123(), ffun1(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fudge(), gauss_legendre(), Energy::get(), Parser::getElement(), Parser::getFirstChunk(), Parser::getFirstChunkRaw(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), GetJenkins09(), getLevelsGeneric(), Parser::getline(), GetLineRec(), GetMetalsDeplete(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), getSpeciesGeneric(), getTransition(), GrainCharge(), GrainsInit(), grid_do(), GridRetrieveXSPECData(), gridXspec(), GrnVryDpth(), 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_log10(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), t_ADfA::hpfit(), hri_log10(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), diatomics::init(), load_balance::init(), t_mole_global::init(), t_yield::init_yield(), InitGrid(), InitSimPostparse(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ipoint(), iso_create(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgReadAtmosphereTail(), LimitSh(), lines(), bands_file::load(), LoadIsotopes(), main(), LinSv::makeBlend(), MakeInputLine(), map_do(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_next_line(), mie_read_mix(), mie_read_number(), mie_read_ocn(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), mole_create_react(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), Ne10cs123(), newreact(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), optimize_do(), optimize_func(), optimize_phymir(), t_cpu_i::p_assertValidPath(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), Flux::p_InternalFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_rd_state(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), EnergyEntry::p_set_ip(), parse_reaction(), parse_save_average(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIllumination(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLineList(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), prtLineType(), punchFITS_SpectraData(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_next(), RandomCrash(), RauchReadMPP(), rd_block(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), read_level2_lines(), read_mewe_gbar(), read_SH98_He1_cross_sections(), read_UTA_lines(), Parser::readLaw(), Parser::readList(), ReadTable(), t_conv::register_(), RT_continuum(), RT_DestProb(), RT_line_escape(), RT_recom_effic(), RT_tau_init(), S2Aul(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesPseudoCont(), search_limit(), Energy::set(), PresMode::set(), setIsoNelemFlag(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), size_distr(), solveions(), speciesCheck(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), StoutCollRate(), StuffComment(), t_ADfA::t_ADfA(), t_physconst::t_physconst(), DepthTable::tabval(), TempInterp(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), wr_block(), XERBLA(), xerror_(), y0b01(), Yfunc(), Yfunc(), and zoneDensity().

◆ EXIT_SUCCESS

◆ fixit

#define fixit ( a)

◆ float

#define float   PLEASE_USE_REALNUM_NOT_FLOAT

◆ fopen

#define fopen   PLEASE_USE_open_data_NOT_fopen

Referenced by main(), and sys_fopen().

◆ isnan

◆ lgBOUNDSCHECKVAL

#define lgBOUNDSCHECKVAL   false

◆ MAX2

#define MAX2 ( a,
b )
Value:
max(a,b)
long max(int a, long b)
Definition cddefines.h:821

MAX2 takes two arguments, returns the larger of the two

Referenced by abund_starburst(), AbundancesPrt(), AgeCheck(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), atom_level2(), avg_shield(), Badnell_rec_init(), badprt(), bhintegrand_log(), C6cs123(), Ca20cs123(), t_timesc::calc_therm_timesc(), cdColm(), cdTimescales(), ChargTranSumHeat(), chkCaHeps(), cloudy(), collision_strength_VF01(), ColStrGBar(), ContCreateMesh(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), CoolAdd(), CoolEvaluate(), CoolSave(), CoStarListModels(), save_img_matrix::createImage_PPM(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), da(), dBase_solve(), DebyeDeriv(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), DTRSM(), DynaStartZone(), EdenChange(), ElectronFractions(), EvalJenkins(), Fe26cs123(), ffun1(), fstats(), GammaBn(), GammaK(), GbarRateCoeff(), GetFracPop(), diatomics::GetHeatRate(), GetHelikeCollisionStrength(), 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(), highen(), Hion_coll_ioniz_ratecoef(), HomogeneousSource(), t_ADfA::hpfit(), Hydcs123(), hydro_vs_coll_str(), HydroEinstA(), HydroLevel(), hypho(), init_struc(), InitBinAugerData(), InterpolateModel(), ion_photo(), ion_recomb(), ion_trim(), ion_trim2(), IonHydro(), 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_alloc(), iso_recomb_check(), iso_update_num_levels(), iter_end_check(), IterRestart(), lgCheckMonitors(), lgCoolHeatCheckConverge(), lgNucleiConserved(), limitedDensityScaling(), lincom(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_hydro(), lines_molecules(), map_do(), molcol(), mole_effects(), mole_h_reactions(), Ne10cs123(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), Atom_LevelN::operator()(), optimize_subplex(), TransitionProxy::outline(), outline_base(), ParseGrid(), ParseIterations(), ParseMetal(), ParsePrint(), ParseRangeOption(), ParseSave(), ParseSet(), ParseStop(), ParseTrace(), PresTotCurrent(), PrintSpectrum(), PrtAllTau(), PrtColumns(), PrtHeader(), PrtOneMonitor(), PrtZone(), qheat(), qheat_init(), radius_first(), radius_increment(), radius_next(), rayleh(), RebinQHeatResults(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_electron_scatter(), RT_line_one_fine(), 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_opacity(), SaveDo(), saveFITSfile(), SaveSpecies(), ScanProbDistr(), SecIoniz(), set_xIntensity(), SetLimits(), SetLimitsSub(), setstp(), setXtraRatesFe2(), setXtraRatesO1(), shieldFederman(), spldrv_safe(), splint_safe(), band_emission::sumBand(), pseudo_cont::sumBand(), tauff(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), UpdatePot(), UpdatePot1(), Yan_H2_CS(), and ZoneStart().

◆ MAX3

#define MAX3 ( a,
b,
c )
Value:
(max(max(a,b),c))

MAX3 takes 3 arguments, returns the largest of the 3

Referenced by fstats(), and GetProbDistr_LowLimit().

◆ 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

Referenced by QN2ind(), and sinpar().

◆ MESSAGE_ASSERT

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

◆ MIN2

#define MIN2 ( a,
b )
Value:
min(a,b)
long min(int a, long b)
Definition cddefines.h:766

MIN2 takes two arguments, returns the smaller of the two

Referenced by abund_starburst(), AgeCheck(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), C6cs123(), Ca20cs123(), t_timesc::calc_therm_timesc(), ChargTranEval(), ChargTranSumHeat(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolEvaluate(), coolpr(), save_img_matrix::createImage_PPM(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), da(), dBase_solve(), dense_parametric_wind(), DGETF2(), DGETRF(), DynaStartZone(), ElectronFractions(), esc_CRDcore(), esc_PRD_1side(), EvalJenkins(), Fe26cs123(), 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(), highen(), Hion_coll_ioniz_ratecoef(), Hydcs123(), HydroEinstA(), hypho(), ILAENV(), InterpolateModel(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_solver(), ion_trim(), ion_trim2(), iso_assign_quantum_numbers(), iso_collapsed_update(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_Max_Emitting_Level(), iso_radiative_recomb(), iso_radrecomb_from_cross_section(), iso_satellite_update(), iso_update_rates(), lgCheckMonitors(), limitedDensityScaling(), lines_hydro(), map_do(), mole_get_equilibrium_condition(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), Ne10cs123(), newton_step(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreateAll(), outline_base(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), ParseCommands(), ParseCosmicRays(), ParseDatabaseISO(), ParseRangeOption(), ParseSave(), ParseSet(), partx(), PressureRadiationLine(), PresTotCurrent(), PrintSpectrum(), prt_smooth_predictions(), PrtComment(), PrtLinePres(), PrtMeanIon(), qheat(), qheat_init(), radius_first(), radius_increment(), radius_next(), read_SH98_He1_cross_sections(), RebinQHeatResults(), RebinSingleCell(), RT_continuum_shield_fcn_point(), RT_diffuse(), RT_line_one_fine(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_LineWidth(), RT_recom_effic(), RT_stark(), RT_tau_init(), RTesc_lya(), RTesc_lya_1side(), SanityCheckBegin(), save_opacity(), SaveDo(), SaveLineData(), SecIoniz(), set_xIntensity(), SetLimits(), SetLimitsSub(), setstp(), setXtraRatesO1(), shieldFederman(), simplx(), spldrv_safe(), splint_safe(), subopt(), sumcon(), uderiv(), xinvrs(), and ZoneStart().

◆ MIN3

#define MIN3 ( a,
b,
c )

◆ 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

Referenced by radius_first().

◆ NULL

#define NULL   nullptr

Referenced by iterator< bool, 2 >::alloc(), iterator< bool >::alloc(), allocator_avx< U >::allocate(), append_file(), append_file(), genericState::associated(), ProxyIterator< EmissionProxy, EmissionConstProxy >::associated(), qStateConstProxy::associated(), qStateProxy::associated(), TransitionConstProxy::associated(), TransitionProxy::associated(), atmdat_CHIANTI_readin(), t_avx_pool::avx_alloc(), t_avx_pool::avx_free(), avx_ptr< T, lgBC >::avx_ptr(), bad_assert::bad_assert(), basic_pntr< T, lgBC >::basic_pntr(), basic_pntr< T, lgBC >::basic_pntr(), cdBacktrace(), cdInput(), cdMain(), cdOutput(), cdOutput(), cdRead(), cdSPEC2(), t_cpu_i::check_data, check_mult_path(), t_mole_local::chem_heat(), ChemImportance(), CloseSaveFiles(), Parser::ClosestMatch(), cloudy_abort::cloudy_abort(), column(), const_n_pointer< T, 1, ARPA_TYPE, false >::const_n_pointer(), const_n_pointer< T, 1, C_TYPE, false >::const_n_pointer(), const_n_pointer< T, N, ARPA_TYPE, false >::const_n_pointer(), const_n_pointer< T, N, C_TYPE, false >::const_n_pointer(), ConvBase(), CoStarInitialize(), d3_np_fs(), iterator< bool, 2 >::data(), iterator< bool, 2 >::data(), genericState::database(), dBase_solve(), density(), depart(), DOMAIN_ERROR(), DynaStartZone(), EdenChange(), EdenError(), ElectronFractions(), EmissionConstProxy::EmissionConstProxy(), EmissionProxy::EmissionProxy(), iterator< bool, 2 >::empty(), energy(), load_balance::finalize(), find_solution(), findnuclide(), flxCell(), genericState::genericState(), genericState::genericState(), genericState::genericState(), genericState::genericState(), GridGatherOutputParallel(), GridGatherOutputSequential(), Parser::help(), load_balance::init(), molezone::init(), Parser::init(), phymir_state< X, Y, NP, NSTR >::init_strings(), InitGrid(), t_cpu_i::initPath(), drList::insert(), insertToken(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), isCatalystProduct(), isCatalystReactant(), isCreated(), isDestroyed(), iso_recomb_setup(), genericState::isSpecies(), isSpeciesActive(), iter_end_check(), IterStart(), KhaireSrianandInterpolate(), genericState::label(), levels(), lgCheckMonitors(), lgCompileAtmosphere(), lgFileReadable(), lgReadAtmosphereTail(), lgValidIdxFile(), lincom(), t_mole_global::make_species(), mie_read_opc(), molcol(), mole_check_reverse_reactions(), mole_dominant_rates(), mole_eval_balance(), mole_eval_sources(), mole_findrate_s(), mole_print_species_reactions(), mole_return_cached_species(), mole_update_species_cache(), n_pointer< T, 1, ARPA_TYPE, false >::n_pointer(), n_pointer< T, 1, C_TYPE, false >::n_pointer(), n_pointer< T, N, ARPA_TYPE, false >::n_pointer(), n_pointer< T, N, C_TYPE, false >::n_pointer(), newreact(), newspecies(), nMatch(), Parser::nMatch1(), nWord(), diatomics::OpacityCreate(), t_cpu_i::open_data, Atom_LevelN::operator()(), iterator< bool >::operator=(), tree_vec::operator=(), const_n_pointer< T, N, ARPA_TYPE, true >::operator[](), n_pointer< T, N, ARPA_TYPE, true >::operator[](), optimize_phymir(), OUT_OF_RANGE(), avx_ptr< T, lgBC >::p_alloc(), phymir_state< X, Y, NP, NSTR >::p_barrier(), iterator< bool >::p_clear0(), tree_vec::p_clear0(), iterator< bool, 2 >::p_clear1(), iterator< bool >::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_clear1(), tree_vec::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), phymir_state< X, Y, NP, NSTR >::p_execute_job_parallel(), iterator< bool, 2 >::p_iterator_bc(), iterator< bool, 2 >::p_iterator_bc(), iterator< bool, 2 >::p_iterator_bc(), iterator< bool, 2 >::p_iterator_bc(), iterator< bool, 2 >::p_iterator_bc(), ran_pool< T >::p_update_pool(), phymir_state< X, Y, NP, NSTR >::p_wr_state(), parse_reaction(), parse_species_label(), parse_udfa(), ParseCommands(), ParseDatabaseH2(), ParseGrain(), ParseMap(), ParseMonitorResults(), Parser::Parser(), ParseSave(), ParseSpecies(), ParseTable(), plot_sparsity(), ProxyIterator< EmissionProxy, EmissionConstProxy >::ProxyIterator(), t_wavl::prt_wl(), PrtComment(), PutLine(), qheat(), qStateConstProxy::qStateConstProxy(), qStateProxy::qStateProxy(), radius_increment(), ran_pool< T >::ran_pool(), RauchInitialize(), read_UTA_lines(), read_whole_line(), iterator< bool >::realloc(), register_reaction_vectors(), iterator< bool >::reserve(), multi_geom< d, ALLOC >::reserve(), RT_line_all_escape(), RT_tau_init(), SaveAllSpeciesLabelsLevels(), SaveFilesInit(), SaveGrid(), SaveSpecies(), SaveSpeciesLines(), SaveSpeciesOptDep(), t_mole_local::set_isotope_abundances(), t_cpu_i::set_signal_handlers(), ShowMe(), t_mole_local::sink_rate(), solve_system(), t_mole_local::source_rate_tot(), species::species(), spldrv(), spline_cubic_set(), spline_cubic_val(), splint(), t_wavl::sprt_wl(), stellar_grid::stellar_grid(), band_emission::sumBand(), pseudo_cont::sumBand(), t_collider::t_collider(), t_cpu_i::t_cpu_i(), t_dense::t_dense(), tbl_fun(), total_molecule_deut(), total_molecule_elems(), total_molecules(), total_molecules_gasphase(), TotalInsanity(), two_photon::two_photon(), UpdatePot1(), VHstream(), writeCloudyDetails(), Yfunc(), avx_ptr< T, lgBC >::~avx_ptr(), and stellar_grid::~stellar_grid().

◆ POW2

#define POW2   pow2

POW2 takes 1 argument, and squares it

Referenced by abund_starburst(), collision_strength_VF01(), ColStrGBar(), ConserveEnergy(), ContSetIntensity(), CS_l_mixing_PS64(), CS_l_mixing_S62(), dist(), DynaIonize(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), eina(), esc_CRDwing_1side(), FillExtraLymanLine(), ForbiddenAuls(), fstats(), gbar0(), gbar1(), GetAveVelocity(), GetDopplerWidth(), GetGF(), GetHelikeCollisionStrength(), GetHubbleFactor(), gett2(), gett2o3(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainScreen(), GrainsInit(), GravitationalPressure(), diatomics::H2_Cooling(), H2_vib_dist(), t_ADfA::H_rad_rec(), helike_energy(), t_ADfA::hpfit(), hydro_energy(), hydro_Fujimoto_deexcit(), hydro_vs_coll_str(), HydroEinstA(), HydroOscilStr(), HydroRecCool(), hypho(), diatomics::init(), InitSimPostparse(), iso_assign_quantum_numbers(), iso_cool(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_extra(), iso_state_lifetime(), lgCheckMonitors(), lgReadAtmosphereTail(), lines(), lines_hydro(), lines_setup(), Magnetic_evaluate(), mole_effects(), mole_h2_grain_form(), mole_h_reactions(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), ofit(), OpacityCreateAll(), my_Integrand_S62::operator()(), optimize_subplex(), t_ADfA::phfit(), PlanckIntegral(), plankf(), PresTotCurrent(), PrtFinal(), radius_first(), rayleh(), RT_continuum(), RT_DestProb(), RT_fine_clear(), RTesc_lya_1side(), SaveDo(), shieldFederman(), sum_radiation(), tfidle(), ThetaNu(), UpdatePot1(), UpdatePot2(), zoneDensity(), and ZoneStart().

◆ POW3

◆ POW4

#define POW4   pow4

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

Referenced by ConvTempEdenIoniz(), GetHubbleFactor(), 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

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

◆ puts

#define puts ( STR)
Value:
Using_puts_before_cdEXIT_is_no_longer_needed

◆ STATIC

#define STATIC   static

Referenced by addBandsFile(), addKeyword_dbl(), addKeyword_num(), addKeyword_txt(), advection_set_default(), AGN_Hemis(), AngerJ(), AngerJ_asymp(), AngerJ_mac(), anomal(), avg_shield(), Badnell_DR_rate_eval(), Badnell_RR_rate_eval(), badprt(), bessjnu(), bh_log(), bhg_log(), bhG_mx(), bhGm_mx(), bhGp_mx(), bhintegrand_log(), bigk(), blkdata1(), Bruggeman(), ByteSwap(), C6cs123(), Ca20cs123(), calcc(), calcc(), canonicalize_reaction(), canonicalize_reaction_label(), cdasum(), cdasum(), cdaxpy(), cdaxpy(), cdClock(), cdcopy(), cdcopy(), check_grid_file(), check_mult_path(), CheckVal(), ChemImportance(), chi2_func(), ChiantiCollRate(), chkCaHeps(), ChkUnits(), chMolBranch(), clean_up(), cmshft(), cnewton(), collision_strength_VF01(), CollisSuppres(), ColStrGBar(), compare_udfa(), compareEmis(), conorm(), conpmp(), conpmp_qg32(), conpmp_romb(), ContBandsCreate(), ContRate(), convert_double(), convert_float(), convert_zig(), CoolH2_GA08(), CoolHeatError(), CoolHyperfine(), CoStarInitialize(), CoStarListModels(), cross_section(), CS_l_mixing_S62(), CSIntegral_QG32(), CSIntegral_Romberg(), CSIntegral_Romberg_alpha(), csscal(), csscal(), d3_np_fs(), da(), database_prep(), DebyeDeriv(), dftori(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), dist(), dist(), DLASWP(), dmpary(), doData(), doHeader(), doop(), DoSatelliteLines(), DSCAL(), DSWAP(), DTRSM(), DumpCoolStack(), DumpHeatStack(), DynaNewStep(), DynaSaveLast(), EchoModel(), EdenError(), eeBremsCooling(), EH2_eval(), ElectronFractions(), ErrorMessage(), escmase(), evalf(), evalf(), EvalJenkins(), exp1(), expe1(), ExponentialInt(), extin(), F21_mx(), F21i_log(), Fe26cs123(), fill_array(), fill_ext_src_and_snk(), FillExtraLymanLine(), FillJ(), find_solution(), findBandsFile(), FindHCoStar(), FindIndex(), FindNeg(), findSpecBand(), FindStrongestLineLabels(), FindTempChangeFactor(), FindVCoStar(), fix_grid_file(), fndneg(), fndstr(), ForbiddenAuls(), fsff_log10(), fstats(), fstats(), funjac(), ga08_oH2_e(), ga08_oH2_e_a10_b1e4(), ga08_oH2_H(), ga08_oH2_H_b100(), ga08_oH2_H_b1000(), ga08_oH2_H_b6000(), ga08_oH2_H_stitch_100(), ga08_oH2_H_stitch_1000(), ga08_oH2_He(), ga08_oH2_He_b6000(), ga08_oH2_oH2(), ga08_oH2_oH2_a100_b6000(), ga08_oH2_p(), ga08_oH2_p_a10_b1e4(), ga08_oH2_pH2(), ga08_oH2_pH2_a100_b6000(), ga08_pH2_e(), ga08_pH2_e_a1000_b1e4(), ga08_pH2_e_a10_b1000(), ga08_pH2_H(), ga08_pH2_H_b100(), ga08_pH2_H_b1000(), ga08_pH2_H_b6000(), ga08_pH2_H_stitch_100(), ga08_pH2_He(), ga08_pH2_He_b6000(), ga08_pH2_oH2(), ga08_pH2_oH2_a100_b6000(), ga08_pH2_p(), ga08_pH2_p_a10_b1e4(), ga08_pH2_pH2(), ga08_pH2_pH2_a100_b6000(), ga08_sum(), gbar0(), gbar1(), GbarRateCoeff(), get_data_minmax(), get_data_minmax(), get_total_abundance_ions(), getAdjPseudoIndex(), getcsvfield(), GetDissociationRateCoeff(), GetFracPop(), GetHS98CrossSection(), getIntenTypeStr(), GetJenkins09(), GetMetalsDeplete(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetProbDistr_LowLimit(), getPseudoIndex(), getPseudoWlRange(), GetStandardHeLines(), gett2(), gett2o3(), getTransition(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainIonColl(), GrainMakeDiffuseSingle(), GrainRateDr(), GrainScreen(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GridGatherOutput(), GridGatherOutputParallel(), GridGatherOutputSequential(), GrnStdDpth(), GrnStdDpth(), GrnVryDpth(), grouped_elems(), h21_t_ge_10(), h21_t_lt_10(), H2_vib_dist(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), HeCSTableInterp(), helike_transprob_collapsed_to_collapsed(), helike_transprob_collapsed_to_resolved(), HlikeCSInterp(), hmiopc(), HomogeneousSource(), hrii_log(), Hydcs123(), hydro_transprob_collapsed_to_collapsed(), hydro_transprob_collapsed_to_resolved(), hydro_vs_coll_str(), IDAMAX(), igamc_fraction(), ILAENV(), init_eps(), init_seed(), init_struc(), InitBinAugerData(), InitDynaTimestep(), InitEmissivities(), InitGrid(), InitGridCoStar(), InitIndexArrays(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_trim_from_set(), ipShells(), isactive(), isCatalystProduct(), isCatalystReactant(), isCreated(), isDestroyed(), iso_allocate(), iso_assign_extralyman_levels(), iso_assign_quantum_numbers(), iso_get_collision_strength(), iso_multiplet_opacities_one(), iso_put_recomb_error(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_discrete(), iso_rad_rec_cooling_extra(), iso_radrecomb_from_cross_section(), iso_recomb_integrand(), iso_satellite(), iso_zero(), ispassive(), JIndex(), Jint(), ld01_fun(), LeidenCollRate(), lgCompileAtmosphere(), lgConvEden(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), lgFileReadable(), lgIsRemote(), lgNeedTimestep(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgRadiative(), lgReactBalance(), lgReactionTrivial(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgTestPressureConvergence(), lgTrivialSolution(), lgValidASCIIFile(), lgValidIdxFile(), lgValidModel(), limitedDensityScaling(), LimitSh(), lincom(), lines_iron_Ka(), log_integral(), logPressureState(), LSAME(), MakeHCTData(), matchKey(), MD5_Transform(), MD5string_core(), 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_line(), mie_read_form(), mie_read_mix(), mie_read_number(), mie_read_ocn(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_repair(), mie_step(), mie_write_form(), mole_check_reverse_reactions(), mole_effects(), mole_eval_dynamic_balance(), mole_generate_isotopologue_reactions(), mole_get_equilibrium_condition(), mole_get_equilibrium_condition(), mole_h2_grain_form(), mole_h_fixup(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_partition_function(), mole_system_error(), mole_update_limiting_reactants(), Ne10cs123(), NewChargeData(), newelement(), newisotope(), newpt(), newpt(), newreact(), newspecies(), newspecies(), ofit(), Opacity_iso_photo_cs(), OpacityCreate1Element(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), open_abn_file(), order(), order(), pah1_fun(), pah2_fun(), pah3_fun(), parse_base(), parse_reaction(), parse_udfa(), ParseExp(), ParseExpr(), ParseNumber(), ParseProduct(), partx(), partx(), PE_init(), pintr(), PlanckIntegral(), PlanckIntegral(), plot_sparsity(), pnegopc(), PrintRates(), PrintShortZero(), PrintSpectrum(), prme(), prt_constants(), prt_header_cols(), prt_smooth_predictions(), PrtElem(), PrtHydroTrace1(), PrtHydroTrace1a(), prtLineType(), PrtMacros(), prtPunOpacSummary(), PseudoContCreate(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSimg_ExtensionData_matrix(), punchFITSimg_ExtensionData_vector(), punchFITSimg_ExtensionHeader(), punchFITSimg_PrimaryHeader(), qheat_init(), qintr(), RauchInitialize(), RauchReadMPP(), rayleh(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), read_ionization_potentials(), read_level2_lines(), read_mewe_gbar(), read_SH98_He1_cross_sections(), read_species_file(), read_UTA_lines(), ReadAugerData(), ReadBadnellAIData(), ReadTable(), RebinAtmosphere(), RebinQHeatResults(), RebinSingleCell(), reduced_mass_rel(), register_reaction_vectors(), renorm_solution(), resetBltin(), resolveSpecType(), rfield_opac_alloc(), ritoa(), ritodf(), RT_continuum_shield_fcn_point(), RT_DestHummer(), RT_iso_integrate_RRC(), RT_line_electron_scatter(), RT_line_escape(), RT_line_fine_opacity(), RT_line_pumping(), RT_OTS_AddCont(), RTesc_lya_1side(), S62BesselInvert(), SanityCheckBegin(), SanityCheckFinal(), SanityCheckGaunt(), save_DT(), SaveAllSpeciesLabelsLevels(), SaveGaunts(), SaveLineIntensity(), SaveLineStuff(), SaveResults(), SaveSpeciesHeader(), SaveSpeciesLines(), SaveSpeciesOne(), ScanProbDistr(), scqdri(), search_limit(), SearchModel(), set_fractionation(), set_weighting(), setIsoNelemFlag(), SetIsotopeFractions(), SetLimits(), SetLimitsSub(), setstp(), setstp(), setXtraRatesCa2(), setXtraRatesFe2(), setXtraRatesO1(), shieldFederman(), shieldRodgers(), shieldRodgersDoppler(), shieldRodgersLorentz(), simplx(), simplx(), sinpar(), sinpar(), size_distr(), sortd(), sortd(), specBandsExists(), spectral_to_chemical(), start(), start(), states_nelemfill(), states_popfill(), states_propprint(), stepDensity(), sticking_probability_H_func(), sticking_probability_H_HM79(), Stognienko(), store_new_densities(), StoutCollRate(), strkar(), subopt(), subopt(), sum_radiation(), sumcon(), tauff(), tbl_fun(), TempInterp(), TempInterp2(), ThetaNu(), timestep_next(), trim_levels(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), validate_magic_number_1arg(), validate_magic_number_3arg(), WriteASCIIData(), WriteASCIIHead(), writeCloudyDetails(), X1Int(), X2Int(), XERBLA(), xerror_(), xinvrs(), xmap(), y0b(), y0b01(), y0psa(), y1psa(), Yfunc(), Yfunc(), and ZeroContin().

Typedef Documentation

◆ realnum

typedef float realnum

◆ sys_float

typedef float sys_float

Enumeration Type Documentation

◆ anonymous enum

anonymous enum
Enumerator
CHARS_SPECIES 

◆ anonymous enum

anonymous enum
Enumerator
CHARS_ISOTOPE_SYM 

◆ 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_DOMAIN_ERROR 
ES_ILLEGAL_INSTRUCTION 
ES_FP_EXCEPTION 
ES_SEGFAULT 
ES_BUS_ERROR 
ES_UNKNOWN_SIGNAL 
ES_UNKNOWN_EXCEPTION 
ES_TOP 

◆ wl_type

enum wl_type

this determines the type of the wavelength used in t_wavl WL_NATIVE: the wavelength type is the same as the type used in the printout this option only exists for backward compatibility... WL_VACUUM: this wavelength is in vacuum WL_AIR: this wavelength is in air; will silently be interpreted as vacuum if < 2000 A

Enumerator
WL_NATIVE 
WL_VACUUM 
WL_AIR 

Function Documentation

◆ AnuUnit()

double AnuUnit ( realnum energy)

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

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

Referenced by AGN_Hemis(), energy(), pseudo_cont::getWl(), Save1Line(), Save1LineData(), save_opacity(), and SaveDo().

Here is the call graph for this function:

◆ BadRead()

NORETURN void BadRead ( void )

BadRead tried to read internal data and failed

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

Referenced by diatomics::H2_Read_hminus_distribution().

Here is the call graph for this function:

◆ broken()

void broken ( void )

broken set flag saying that the code is broken

References broke, and DEBUG_ENTRY.

Referenced by ion_solver(), 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

References DEBUG_ENTRY, and toupper().

Referenced by lgCheckMonitors(), and PrtFinal().

Here is the call graph for this function:

◆ caps() [1/2]

void caps ( char * chCard)

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

Parameters
chCard- line image as string of characters

References DEBUG_ENTRY, and toupper().

Referenced by cdColm(), cdIonFrac(), cdTemp(), cdTemp(), LinSv::chALabSet(), t_LineSave::findline(), Parser::getElement(), GetJenkins09(), DataParser::getKeywordOptional(), GetMetalsDeplete(), lgCheckMonitors(), LinSv::makeBlend(), Parser::newlineProcess(), ParseAbundances(), Parser::peekNextCommand(), and set_weighting().

Here is the call graph for this function:

◆ caps() [2/2]

void caps ( string & chCard)

References DEBUG_ENTRY.

◆ cdBacktrace()

void cdBacktrace ( )
inline

cdBacktrace – print backtrace and continue executing normally

References cpu, and NULL.

◆ cdPrepareExit()

void cdPrepareExit ( exit_type exit_status)

prepare termination of the code, but do not terminate yet

References cdInput(), cdOutput(), CloseSaveFiles(), cpu, fprintf(), grid, ioQQQ, MS_GRID, save, SaveGrid(), and trace.

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

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

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

References DEBUG_ENTRY, ioQQQ, and trace.

◆ DOMAIN_ERROR()

NORETURN void DOMAIN_ERROR ( const string & str)
inline

◆ dprintf() [1/2]

int dprintf ( const Output & stream,
const char * format,
... )

References DEBUG_ENTRY, fprintf(), and Output::fptr().

Here is the call graph for this function:

◆ dprintf() [2/2]

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

dprintf – version of fprintf which prepends DEBUG

References DEBUG_ENTRY, and fprintf().

Referenced by DumpCoolStack(), DumpHeatStack(), iso_radiative_recomb_effective(), iter_track::print_status(), qheat_init(), read_UTA_lines(), and Recomb_Seaton59().

Here is the call graph for this function:

◆ dsexp()

◆ exp10() [1/2]

double exp10 ( double x)
inline

exp10(x): faster alternative to pow(10.,x)

References BIGDOUBLE, and pow2.

Referenced by atmdat_HS_caseB(), Badnell_rec_init(), cdIonFrac(), cdRead(), cdTemp(), cdTemp(), CHIANTI_Upsilon(), ColStrGBar(), conorm(), ContSetIntensity(), CoolEvaluate(), CoStarInitialize(), CoStarListModels(), da(), dense_fabden(), ffun1(), GbarRateCoeff(), GetHelikeCollisionStrength(), Parser::getNumberCheckAlwaysLog(), Parser::getNumberCheckAlwaysLogLim(), Parser::getNumberCheckLogLinNegImplLog(), Parser::getNumberDefaultAlwaysLog(), Parser::getNumberDefaultNegImplLog(), GetOptColDen(), GetOptTemp(), H21cm_electron(), diatomics::H2_LevelPops(), diatomics::H2_Read_hminus_distribution(), t_ADfA::H_rad_rec(), hrii_log(), hydro_vanRegemorter_deexcit(), HydroRecCool(), HyperfineCS(), hypho(), InitEmissivities(), InterpolateGridCoStar(), InterpolateRectGrid(), iso_dielec_recomb_rate(), iso_rad_rec_cooling_extra(), iso_recomb_setup(), iso_RRCoef_Te(), lines(), lines_helium(), lines_hydro(), map_do(), mie_read_rfi(), mole_effects(), mxify_log10(), optimize_func(), pah2_fun(), pah3_fun(), ParseAbundances(), ParseAge(), ParseAgn(), ParseBlackbody(), ParseBremsstrahlung(), ParseCaseB(), ParseCExtra(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCovering(), ParseCylinder(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDistance(), ParseEden(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseHDEN(), ParseHExtra(), ParseInterp(), ParseLaser(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNeutrons(), ParseOptimize(), ParsePowerlawContinuum(), ParsePrint(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseStop(), ParseTable(), ParseTauMin(), ParseTurbulence(), PrintE71(), PrintE82(), PrintE93(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtHeader(), punchFITS_ParamData(), radius_first(), radius_next(), resetBltin(), RTesc_lya_1side(), S62BesselInvert(), SanityCheckGaunt(), SaveDo(), SaveGaunts(), SetLimits(), pseudo_cont::setup(), StarburstInitialize(), DepthTable::tabval(), uderiv(), vexp10(), vexp10(), vexp10(), vexp10(), vexp10(), WavlenErrorGet(), wr_exp10d(), wr_exp10f(), and xinvrs().

◆ exp10() [2/2]

sys_float exp10 ( sys_float x)
inline

References exp10f().

Here is the call graph for this function:

◆ exp10f()

sys_float exp10f ( sys_float x)
inline

exp10f(x): single precision version of exp10(x)

References BIGFLOAT, and pow2.

Referenced by exp10(), and diatomics::init().

◆ 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

References DEBUG_ENTRY, fprintf(), ioQQQ, max_pow10, min(), min_pow10, neg_pow10, pos_pow10, sign(), tolower(), and TotalInsanity().

Referenced by atmdat_LAMDA_readin(), Badnell_rec_init(), ContBandsCreate(), diatomics::GetIndices(), GetJenkins09(), GetMetalsDeplete(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), HyperfineCreate(), iso_recomb_setup(), bands_file::load(), LoadIsotopes(), FunctLAMDA::operator()(), t_mesh::p_ReadResolution(), ParseAbundances(), read_Helike_cross_sections(), read_SH98_He1_cross_sections(), and ReadCollisionRateTable().

Here is the call graph for this function:

◆ fixit_base()

void fixit_base ( const char * func,
const char * file,
int line,
const char * reason )

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

References broke, DEBUG_ENTRY, Singleton< FixitList >::Inst(), and FixitList::list.

Referenced by Fixit::Fixit().

Here is the call graph for this function:

◆ fp_bound() [1/2]

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

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

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

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

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

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

Here is the call graph for this function:

◆ fp_equal() [2/2]

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

◆ fp_equal_tol() [1/2]

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

References ASSERT, isnan, and max().

Here is the call graph for this function:

◆ fp_equal_tol() [2/2]

◆ fprintf()

int fprintf ( const Output & stream,
const char * format,
... )

overloads to allow interception of output

References Output::fptr().

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), t_PredCont::add(), addComment(), LinSv::addComponent(), LinSv::addComponentID(), addKeyword_dbl(), addKeyword_num(), addKeyword_txt(), AGN_He1_CS(), AGN_Hemis(), AtlasCompile(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_LAMDA_readin(), atmdat_outer_shell(), atmdat_readin(), atmdat_STOUT_readin(), AtmospheresAvail(), Badnell_rec_init(), badprt(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), cdCautions(), cdClock(), cdColm(), cdDrive(), cdErrors(), cdExecTime(), cdGetLineList(), cdH2_colden(), cdInit(), cdInput(), cdIonFrac(), cdLine_ip(), cdMain(), cdMemory(), cdNotes(), cdPrepareExit(), cdPrintCommands(), cdRead(), cdReasonGeo(), cdSPEC2(), cdSurprises(), cdTemp(), cdTemp(), cdWarnings(), ChargTranPun(), ChargTranSumHeat(), t_cpu_i::check_data, band_emission::check_index_fatal(), pseudo_cont::check_index_fatal(), check_LAMDA_comment(), check_mult_path(), t_mesh::CheckMesh(), CheckVal(), t_mole_local::chem_heat(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), chkCaHeps(), chMolBranch(), CloseSaveFiles(), cloudy(), CloudyPrintReference(), cnewton(), t_ADfA::coll_ion_wrapper(), collision_strength_VF01(), CollisSuppres(), Parser::CommandError(), conorm(), ConserveEnergy(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolEvaluate(), CoolHeatError(), CoolHyperfine(), coolpr(), CoolSave(), CoolSum(), CoStarCompile(), CoStarInitialize(), CoStarListModels(), save_img_matrix::createImage_PPM(), CS_l_mixing(), database_readin(), DatabasePrintReference(), dBase_solve(), dBaseAbund(), dmpary(), doData(), doHeader(), doop(), Parser::doSetVar(), dprintf(), dprintf(), DumpAtmosphere(), DumpLine(), DynaEndZone(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaPunchTimeDep(), DynaSave(), DynaStartZone(), e1(), e1_scaled(), e2(), Parser::echo(), t_input::echo(), EchoModel(), eden_sum(), EdenError(), ElectronFractions(), ellpk(), t_debug::enter(), Parser::Error(), DataParser::errorAbort(), ErrorMessage(), esc_2side_base(), esc_CRDwing(), escmase(), expn(), extractLevels(), factorial(), fc2_scl(), Fe26cs123(), FFmtRead(), Parser::FFmtRead(), ffun(), ffun1(), FillExtraLymanLine(), FillJ(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fndneg(), fndstr(), fudge(), funjac(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), gauss_legendre(), Energy::get(), get_total_abundance_ions(), Parser::getElement(), Parser::getFirstChunk(), Parser::getFirstChunkRaw(), GetFracPop(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), band_cont::getInten(), GetJenkins09(), getLevelsGeneric(), Parser::getline(), GetLineRec(), GetMetalsDeplete(), Parser::getNumberCheckAlwaysLogLim(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), getSpeciesGeneric(), Parser::getSymbol(), getTransition(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), grid_do(), GridCompile(), GridRetrieveXSPECData(), gridXspec(), GrnStdDpth(), GrnVryDpth(), 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_column_density(), diatomics::H2_Prt_Zone(), diatomics::H2_PrtDepartCoef(), diatomics::H2_Punch_line_data(), diatomics::H2_PunchDo(), diatomics::H2_RadPress(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_Read_LTE_cooling_per_H2(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), diatomics::H2_Reset(), diatomics::H2_X_coll_rate_evaluate(), H_Einstein_A_log10(), H_photo_cs_log10(), HaardtMadauCompile(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), helike_energy(), Parser::help(), highen(), HomogeneousSource(), t_ADfA::hpfit(), Hydcs123(), hydro_energy(), HydroEinstA(), HydroLevel(), HydroRecCool(), HyperfineCreate(), hypho(), IncidentContinuumHere(), diatomics::init(), load_balance::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitIndexArrays(), InitSimPostparse(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_trim(), ion_trim2(), ion_wrapper(), IonHelium(), IonHydro(), IonNelem(), ipContEnergy(), ipLineEnergy(), ipoint(), ipShells(), iso_cascade(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_get_collision_strength(), 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_solve(), iso_update_num_levels(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), KhaireSrianandCompile(), Kurucz79Compile(), t_debug::leave(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgConvTemp(), lgCoolNetConverge(), lgElemsConserved(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgReactBalance(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgStatesConserved(), lgValidModel(), LimitSh(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_iron_Ka(), lines_table(), LineStackCreate(), bands_file::load(), LoadIsotopes(), main(), LinSv::makeBlend(), MakeInputLine(), map_do(), maybeNumber(), mc_escape(), t_mean::MeanIon(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_next_line(), mie_read_mix(), mie_read_number(), mie_read_ocn(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_step(), mie_write_opc(), MihalasCompile(), molcol(), mole_check_reverse_reactions(), mole_cmp_num_in_out_reactions(), mole_create_react(), mole_dominant_rates(), mole_eval_balance(), mole_generate_isotopologue_reactions(), mole_h2_grain_form(), diatomics::mole_H2_LTE(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_print_species_reactions(), mole_rk_bigchange(), mole_save(), mole_solve(), mole_system_error(), mole_update_rks(), mole_update_species_cache(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), MyAssert(), Ne10cs123(), newreact(), newspecies(), newton_step(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), setCollRate::operator()(), optimize_do(), optimize_func(), optimize_phymir(), t_cpu_i::p_assertValidPath(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), Flux::p_InternalFluxUnit(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), EnergyEntry::p_set_ip(), t_mesh::p_SetupMesh(), DataParser::p_showLocation(), parse_chemical(), parse_reaction(), parse_save_average(), Parse_Save_Line_RT(), parse_species_label(), parse_udfa(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFail(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIllumination(), ParseInit(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLineList(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecies(), ParseSphere(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PlanckIntegral(), plot_sparsity(), pnegopc(), PntForLine(), PressureChange(), PresTotCurrent(), bad_assert::print(), print_delimiter(), iter_track::print_history(), t_cpu_i::PrintBacktrace(), PrintCenterLine(), t_cpu_i::printDataPath(), PrintE71(), PrintE82(), PrintE93(), Parser::PrintLine(), PrintLineDataHeader(), PrintRates(), PrintRatio(), PrintShortZero(), PrintSpectrum(), prme(), process_output(), LinSv::prt(), LinSv::prt_blend(), prt_constants(), t_physconst::prt_constants(), prt_header_cols(), prt_line_err(), prt_line_inlist(), prt_LineLabels(), prt_smooth_predictions(), prt_trans_opc_debug(), t_wavl::prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), isotope::prtIso(), isotope::prtIsoPairs(), PrtLinePres(), PrtLineSum(), prtLineType(), PrtMacros(), PrtMeanIon(), prtmet(), PrtOneMonitor(), prtPunOpacSummary(), t_prt_matrix::prtRates(), PrtTwoPhotonEmissCoef(), PrtZone(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSimg_ExtensionHeader(), punchFITSimg_PrimaryHeader(), qheat(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RauchCompile(), RauchInitialize(), RauchReadMPP(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), read_level2_lines(), read_mewe_gbar(), read_SH98_He1_cross_sections(), read_UTA_lines(), t_input::readarray(), ReadBadnellAIData(), Parser::readLaw(), Parser::readList(), ReadTable(), RebinQHeatResults(), rec6j(), t_conv::register_(), renorm_solution(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_all_escape(), RT_line_driving(), RT_line_escape(), RT_line_one_fine(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_pumping(), 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(), S2Aul(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), Save1Line(), Save1LineData(), save_average(), save_DT(), save_line(), Save_Line_RT(), save_opacity(), SaveAllSpeciesLabelsLevels(), SaveDo(), saveFITSfile(), SaveGaunts(), SaveGrid(), SaveHeat(), SaveLineData(), SaveLineIntensity(), SaveLineStuff(), SaveResults(), SaveSpecial(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesHeader(), SaveSpeciesLines(), SaveSpeciesOne(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScaleAllDensities(), ScanProbDistr(), search_limit(), SecIoniz(), Energy::set(), set_weighting(), set_xIntensity(), setIsoNelemFlag(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), GroupMap::setup(), setXtraRatesO1(), Parser::showLocation(), ShowMe(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), solveions(), speciesCheck(), speciesOff(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), states_nelemfill(), stepDensity(), StoutCollRate(), StuffCommand(), StuffComment(), band_emission::sumBand(), pseudo_cont::sumBand(), SumDensities(), t_ADfA::t_ADfA(), t_physconst::t_physconst(), DepthTable::tabval(), TempChange(), TempChange(), TempInterp(), test_cdTemp_molecules(), test_expn(), test_isMolecule(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), UpdatePot(), UpdateUTAs(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), vary_input(), DataParser::warning(), WernerCompile(), WMBASICCompile(), WriteASCIIData(), WriteASCIIHead(), XERBLA(), xerror_(), y0b01(), Yfunc(), Yfunc(), zero(), zoneDensity(), and ZoneStart().

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

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, fprintf(), fudgec, and ioQQQ.

Referenced by GrainChargeTemp(), and InitEmissivities().

Here is the call graph for this function:

◆ get_ptr() [1/5]

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

◆ get_ptr() [2/5]

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

◆ get_ptr() [3/5]

◆ get_ptr() [4/5]

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

◆ get_ptr() [5/5]

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

◆ invalidate_array() [1/3]

void invalidate_array ( double * p,
size_t size )
inline

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

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

◆ ipow()

long int ipow ( long m,
long n )

ipow

Returns
m^n

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

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

◆ is_odd() [2/2]

bool is_odd ( long j)
inline

◆ max() [1/4]

double max ( double a,
sys_float b )
inline

◆ max() [2/4]

long max ( int a,
long b )
inline

Referenced by iterator< bool >::alloc(), AngerJ(), atmdat_CHIANTI_readin(), bhintegrand_log(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), t_hydro_tbl::cs(), dawson10(), dBase_solve(), dqage_(), dqagie_(), dqagpe_(), dqagse_(), dqawce_(), dqawfe_(), dqawoe_(), dqawse_(), dqelg_(), dqk15_(), dqk15i_(), dqk15w_(), dqk21_(), dqk31_(), dqk41_(), dqk51_(), dqk61_(), dqng_(), eeBremsSpectrum(), find_arr(), fp_equal(), fp_equal(), fp_equal_tol(), fp_equal_tol(), t_gaunt::gauntff(), GetProbDistr_LowLimit(), GrainCharge(), GrainMakeDiffuse(), GrnStdDpth(), GrnVryDpth(), Parser::hasCommand(), IncidentContinuumHere(), InitBinAugerData(), phymir_state< X, Y, NP, NSTR >::initial_run(), ion_trim_init(), iso_collide(), iso_cool(), iso_level(), iso_satellite_update(), lgCheckMonitors(), lgFileReadable(), lines_general(), main(), matchKey(), t_mean::MeanInc(), t_mean::MeanIon(), t_mean::MeanMoleculeTemp(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_integrate(), mie_read_mix(), mie_repair(), mie_step(), mie_write_opc(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), secant_track::next_val(), optimize_func(), optimize_phymir(), avx_ptr< T, lgBC >::p_alloc(), phymir_state< X, Y, NP, NSTR >::p_evaluate_hyperblock(), t_gaunt::p_gauntff_vec_sub(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), pah1_fun(), ParseDatabaseISO(), ParseGrid(), ParseInterp(), ParseStop(), Parser::peekNextCommand(), PrettyTransmission(), qage_(), qagie_(), qagpe_(), qagse_(), qawce_(), qawfe_(), qawoe_(), qawse_(), qelg_(), qheat_init(), qk15_(), qk15i_(), qk15w_(), qk21_(), qk31_(), qk41_(), qk51_(), qk61_(), QN2ind(), qng_(), iterator< bool >::realloc(), RebinSingleCell(), rec6j(), multi_geom< d, ALLOC >::reserve(), t_conv::resetCountersZone(), ritoa(), RT_DestProb(), RT_line_all_escape(), RT_line_fine_opacity(), RT_stark(), SanityCheckBegin(), search_limit(), setIsoNelemFlag(), StoutCollArray::setpoints(), t_rfield::setTrimming(), sinpar(), SixJFull(), iterator< bool >::size(), sjs(), Integrator< Integrand, Method >::sum(), VecIntegrator< Integrand, Method >::sum(), t_dense::t_dense(), t_mean::t_mean(), TempInterp(), TempInterp2(), UpdatePot(), UpdatePot1(), phymir_state< X, Y, NP, NSTR >::xmin(), y0b(), y0b01(), Yfunc(), Yfunc(), and ZoneStart().

◆ max() [3/4]

long max ( long a,
int b )
inline

◆ max() [4/4]

double max ( sys_float a,
double b )
inline

◆ min() [1/4]

double min ( double a,
sys_float b )
inline

◆ min() [2/4]

long min ( int a,
long b )
inline

Referenced by t_gaunt::brems_cool(), t_gaunt::brems_rt(), chi2_func(), conorm(), ConvEdenIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolEvaluate(), t_hydro_tbl::cs(), CS_l_mixing_PS64_expI(), dawson10(), iter_track::deriv(), dqagpe_(), dqawce_(), dqk15_(), dqk15i_(), dqk15w_(), dqk21_(), dqk31_(), dqk41_(), dqk51_(), dqk61_(), dqng_(), eeBremsSpectrum(), FFmtRead(), find_arr(), fp_equal(), fp_equal(), t_gaunt::gauntff(), DataParser::getLineID(), GrainTemperature(), hmrate4(), load_balance::init(), Parser::init(), phymir_state< X, Y, NP, NSTR >::initial_run(), iso_put_recomb_error(), ld01_fun(), lines_general(), matchKey(), mie_auxiliary(), mie_auxiliary2(), mie_cs_size_distr(), mie_integrate(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_repair(), mie_write_opc(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), iter_track::next_val(), secant_track::next_val(), optimize_func(), optimize_phymir(), phymir_state< X, Y, NP, NSTR >::p_evaluate_hyperblock(), t_gaunt::p_gauntff_vec_sub(), t_hydro_tbl::p_initn(), t_hydro_tbl::p_initnl(), t_hydro_tbl::p_initnn(), t_hydro_tbl::p_initwn(), t_gaunt::p_setup_brems(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), pah1_fun(), ParseCommands(), ParseDatabaseISO(), PrintRates(), PrtFinal(), qagpe_(), qawce_(), qheat_init(), qk15_(), qk15i_(), qk15w_(), qk21_(), qk31_(), qk41_(), qk51_(), qk61_(), qng_(), read_SH98_He1_cross_sections(), RebinSingleCell(), rec6j(), RT_line_escape(), RT_line_fine_opacity(), SixJFull(), sjs(), Integrator< Integrand, Method >::sum(), VecIntegrator< Integrand, Method >::sum(), TempInterp(), TempInterp2(), UpdatePot(), UpdatePot1(), phymir_state< X, Y, NP, NSTR >::xmax(), y0b(), Yfunc(), Yfunc(), iter_track::zero_fit(), and ZoneStart().

◆ min() [3/4]

long min ( long a,
int b )
inline

◆ min() [4/4]

double min ( sys_float a,
double b )
inline

◆ MyAssert()

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

MyAssert a version of assert that fails gracefully

Parameters
*file
line

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

Referenced by cdMain().

Here is the call graph for this function:

◆ nint()

◆ 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

References ASSERT, DEBUG_ENTRY, NULL, and strstr_s().

Referenced by ParseGrain(), StandardEnergyUnitNoAbort(), StandardFluxUnit(), and vary_input().

Here is the call graph for this function:

◆ operator""_air() [1/2]

t_wavl operator""_air ( long double wavl)
inline

References WL_AIR.

◆ operator""_air() [2/2]

t_wavl operator""_air ( unsigned long long wavl)
inline

References WL_AIR.

◆ operator""_r() [1/2]

realnum operator""_r ( long double l)
inline

◆ operator""_r() [2/2]

realnum operator""_r ( unsigned long long l)
inline

◆ operator""_vac() [1/2]

t_wavl operator""_vac ( long double wavl)
inline

References WL_VACUUM.

◆ operator""_vac() [2/2]

t_wavl operator""_vac ( unsigned long long wavl)
inline

References WL_VACUUM.

◆ OUT_OF_RANGE()

◆ plankf()

double plankf ( long int ip)

plankf evaluate Planck function for any cell at current electron temperature

Parameters
ip

References DEBUG_ENTRY, POW2, and rfield.

Referenced by SaveDo().

◆ pow() [1/6]

double pow ( double x,
int i )
inline

References powi().

Referenced by AgeCheck(), Badnell_RR_rate_eval(), ChargTranEval(), t_ADfA::coll_ion(), CollisSuppres(), ColStrGBar(), ConvInitSolution(), CoolEvaluate(), cross_section(), CS_l_mixing_PS64_expI(), da(), dense_fabden(), dense_parametric_wind(), doop(), dqc25s_(), dqk15_(), dqk15i_(), dqk15w_(), dqk21_(), dqk31_(), dqk41_(), dqk51_(), dqk61_(), dqmomo_(), dqng_(), dqwgts_(), DynaFlux(), eeBremsCooling(), eeBremsSpectrum(), esc_PRD_1side(), EvalJenkins(), extin(), ffun1(), FillExtraLymanLine(), ForbiddenAuls(), ga08_oH2_e(), ga08_oH2_H(), ga08_oH2_H_b100(), ga08_oH2_He(), ga08_oH2_oH2(), ga08_oH2_p(), ga08_oH2_pH2(), ga08_pH2_e(), ga08_pH2_H(), ga08_pH2_H_b100(), ga08_pH2_He(), ga08_pH2_oH2(), ga08_pH2_p(), ga08_pH2_pH2(), GbarRateCoeff(), GetPotValues(), GetProbDistr_HighLimit(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), h21_t_ge_10(), t_ADfA::H_rad_rec(), HCoolRatio(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), helike_quantum_defect(), highen(), hmrate4(), t_ADfA::hpfit(), hydro_vs_coll_recomb(), hydro_vs_ioniz(), iso_continuum_lower(), iso_state_lifetime(), lines(), lines_hydro(), Magnetic_evaluate(), mie_read_opc(), mie_write_opc(), mole_create_react(), mole_h_reactions(), ofit(), OpacityCreatePowerLaw(), ParseAgn(), ParseDynaWind(), ParseExtinguish(), ParseRatio(), t_ADfA::phfit(), pow(), pow(), powpq(), pressureZone(), qc25s_(), qk15_(), qk15i_(), qk15w_(), qk21_(), qk31_(), qk41_(), qk51_(), qk61_(), qmomo_(), qng_(), qwgts_(), t_ADfA::rad_rec(), radius_next(), RebinAtmosphere(), RebinQHeatResults(), RebinSingleCell(), t_ADfA::rec_lines(), RT_LineWidth(), RT_stark(), RT_tau_init(), SecIoniz(), shieldFederman(), size_distr(), strkar(), tfidle(), uderiv(), GroupMap::updateMolecules(), xinvrs(), zoneDensity(), and ZoneStart().

Here is the call graph for this function:

◆ pow() [2/6]

double pow ( double x,
long i )
inline

References powi().

Here is the call graph for this function:

◆ pow() [3/6]

double pow ( double x,
sys_float y )
inline

References pow().

Here is the call graph for this function:

◆ pow() [4/6]

double pow ( sys_float x,
double y )
inline

References pow().

Here is the call graph for this function:

◆ pow() [5/6]

sys_float pow ( sys_float x,
int i )
inline

References powi().

Here is the call graph for this function:

◆ pow() [6/6]

sys_float pow ( sys_float x,
long i )
inline

References powi().

Here is the call graph for this function:

◆ pow2()

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

◆ pow3()

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

◆ pow4()

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

◆ powi()

◆ powpq()

◆ PrintE71()

void PrintE71 ( FILE * ioOUT,
double value )

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

References DEBUG_ENTRY, exp10(), fprintf(), and frac().

Referenced by PrtFinal().

Here is the call graph for this function:

◆ PrintE82()

void PrintE82 ( FILE * ioOUT,
double value )

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

References DEBUG_ENTRY, exp10(), fprintf(), and frac().

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

Here is the call graph for this function:

◆ PrintE93()

void PrintE93 ( FILE * ioOUT,
double value )

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

References DEBUG_ENTRY, exp10(), fprintf(), and frac().

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

Here is the call graph for this function:

◆ read_whole_line()

◆ safe_div() [1/4]

double safe_div ( double x,
double y )
inline

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

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

References safe_div().

Here is the call graph for this function:

◆ safe_div() [4/4]

◆ SafeGetline()

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

◆ SDIV() [1/2]

double SDIV ( double x)
inline

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

References SMALLFLOAT.

Referenced by AbundancesSet(), ChargTranEval(), check_co_ion_converge(), ChemImportance(), collision_strength_VF01(), ContRate(), ConvBase(), ConvInitSolution(), CoolEvaluate(), DynaPunchTimeDep(), fill_array(), frac_H2star_hminus(), funjac(), GammaPrt(), GrainDrive(), diatomics::gs_rate(), H21_cm_pops(), diatomics::H2_Calc_Average_Rates(), 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(), HomogeneousSource(), ion_recomb(), ion_trim(), iso_cool(), iso_level(), iter_end_check(), IterEnd(), IterStart(), lgCheckMonitors(), lgCoolHeatCheckConverge(), lgNetEdenSrcSmall(), lgStatesConserved(), lines(), lines_continuum(), lines_grains(), mc_escape(), t_mean::MeanInc(), diatomics::Mol_Photo_Diss_Rates(), mole_effects(), mole_h2_grain_form(), mole_h_rate_diagnostics(), mole_return_cached_species(), ParseAbundances(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtColumns(), PrtComment(), PrtFinal(), PrtLogLin(), PrtOneMonitor(), PrtZone(), radius_first(), radius_increment(), radius_next(), RT_continuum(), RT_line_all_escape(), RT_line_one_tauinc(), SaveDo(), SaveLineData(), SecIoniz(), shieldFederman(), diatomics::SolveExcitedElectronicLevels(), diatomics::SolveSomeGroundElectronicLevels(), and timestep_next().

◆ sexp() [1/2]

double sexp ( double x)

References DEBUG_ENTRY, and SEXP_LIMIT.

◆ sexp() [2/2]

◆ ShowMe()

◆ sign()

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

◆ 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)

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

◆ sncatf() [1/2]

size_t sncatf ( char * buf,
size_t bufSize,
const char * fmt,
... )

References strnlen().

Referenced by diatomics::H2_ParseSave(), parse_save_average(), and ParseSave().

Here is the call graph for this function:

◆ sncatf() [2/2]

size_t sncatf ( ostringstream & buf,
const char * fmt,
... )

References DEBUG_ENTRY.

◆ 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

References DEBUG_ENTRY.

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

◆ strchr_s() [1/2]

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

◆ 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

◆ strstr_s() [2/2]

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

◆ sys_fopen()

FILE * sys_fopen ( const char * path,
const char * mode )
inline

◆ t_air()

t_wavl t_air ( realnum w)
inline

References WL_AIR.

Referenced by GetStandardHeLines(), and lines().

◆ t_vac()

◆ TestCode()

void TestCode ( void )

TestCode set flag saying that test code is in place

References DEBUG_ENTRY, and lgTestCodeCalled.

◆ tolower() [1/2]

char tolower ( char c)
inline

References tolower().

Referenced by atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), elem_symbol_to_index(), FFmtRead(), iso_init_energies(), tolower(), tolower(), and uncaps().

Here is the call graph for this function:

◆ tolower() [2/2]

unsigned char tolower ( unsigned char c)
inline

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

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

Referenced by AbundancesPrt(), iterator< bool, 2 >::alloc(), atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_readin(), avg_shield(), Badnell_rec_init(), t_gaunt::brems_cool(), t_gaunt::brems_opac(), t_gaunt::brems_rt(), cdInit(), cdMain(), CHIANTI_Upsilon(), t_ADfA::coll_ion_wrapper(), CollisSuppres(), conorm(), ContSetIntensity(), ConvInitSolution(), ConvIterCheck(), ConvTempEdenIoniz(), CoolEvaluate(), CoolSave(), cross_section(), t_hydro_tbl::cs(), CSresolver(), database_readin(), dBase_solve(), dBaseUpdateCollCoeffs(), DebyeDeriv(), DynaPunchTimeDep(), DynaSave(), EdenChange(), F21_mx(), fc2(), FFmtRead(), multi_geom< d, ALLOC >::finalize(), FindIndex(), t_LineSave::findline(), flxCell(), ForbiddenAuls(), ForcePass(), get_iso_statw(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), getIntenTypeStr(), GrainChargeTemp(), GrainMakeDiffuse(), GravitationalPressure(), GrnStdDpth(), H21_cm_pops(), diatomics::H2_LevelPops(), diatomics::H2_Read_LTE_cooling_per_H2(), HaardtMadauInterpolate(), he_1trans(), helike_quantum_defect(), diatomics::init(), init_seed(), t_yield::init_yield(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), irsl2ind(), iso_assign_quantum_numbers(), iso_create(), iso_cross_section(), iso_get_collision_strength(), iso_get_total_num_levels(), iso_radrecomb_from_cross_section(), iter_end_check(), IterEnd(), lgCheckMonitors(), DataParser::lgEODMarker(), lgReadAtmosphereTail(), lines(), t_mole_global::make_species(), t_mean::MeanIon(), mie_auxiliary(), mie_auxiliary2(), mie_cs_size_distr(), mie_read_mix(), mie_read_rfi(), mie_repair(), mie_write_opc(), mole_effects(), mole_generate_isotopologue_reactions(), mole_h_reactions(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), Opacity_iso_photo_cs(), Atom_LevelN::operator()(), optimize_do(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), DataParser::p_isComment(), t_gaunt::p_setup_brems(), t_ran::p_u64(), pah2_fun(), pah3_fun(), ParseBlackbody(), ParseCosmology(), ParseCrashDo(), ParseDatabaseH2(), ParseDatabaseISO(), ParseGrain(), ParseTable(), PrintSpectrum(), PrtColumns(), PrtComment(), PrtFinal(), PrtMeanIon(), radius_first(), radius_next(), RauchInitialize(), read_SH98_He1_cross_sections(), read_UTA_lines(), ReadBadnellAIData(), rfield_opac_alloc(), RT_continuum(), RT_continuum_shield_fcn_point(), RT_line_driving(), RT_OTS_ChkSum(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), save_average(), save_DT(), SaveDo(), SaveFilesInit(), SaveLineStuff(), SaveSpecies(), SaveSpeciesPseudoCont(), sg(), size_distr(), StarburstInitialize(), states_nelemfill(), Integrator< Integrand, Method >::sum(), VecIntegrator< Integrand, Method >::sum(), SumDensities(), t_ran::t_ran(), t_version::t_version(), 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 ( )

References TotalInsanity(), and ZeroNum.

Referenced by total_insanity().

Here is the call graph for this function:

◆ toupper() [1/2]

char toupper ( char c)
inline

◆ toupper() [2/2]

unsigned char toupper ( unsigned char c)
inline

References toupper().

Here is the call graph for this function:

◆ uncaps() [1/2]

void uncaps ( char * chCard)

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

Parameters
chCard- line image as string of characters

References DEBUG_ENTRY, and tolower().

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

Here is the call graph for this function:

◆ uncaps() [2/2]

void uncaps ( string & chCard)

References DEBUG_ENTRY.

◆ vzero()

template<class T>
void vzero ( vector< T > & vec)
inline

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

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

◆ DSEXP_LIMIT

const double DSEXP_LIMIT = 680.

this is -ln of smallest number dsexp can handle

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

◆ FILENAME_PATH_LENGTH_2

const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2

twice the above, so that we can add file name to end of full path

Referenced by ParseGrain(), read_Hummer_Storey(), and save_opacity().

◆ fnzone

◆ INPUT_LINE_LENGTH

const int INPUT_LINE_LENGTH = 2000

this is limit to longest line of information that is scanned in, end of line char is actually at this +1, dim of vector is this + 1 all routines that scan in information should use this to dim vars

Referenced by AgeCheck(), prt_smooth_predictions(), and PrtComment().

◆ ioMAP

FILE* ioMAP
extern

◆ ioPrnErr

FILE* ioPrnErr
extern

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

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

◆ ioQQQ

FILE* ioQQQ
extern

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), t_PredCont::add(), LinSv::addComponent(), LinSv::addComponentID(), AGN_Hemis(), AtlasCompile(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_LAMDA_readin(), atmdat_outer_shell(), atmdat_readin(), atmdat_STOUT_readin(), AtmospheresAvail(), Badnell_rec_init(), badprt(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), cdClock(), cdColm(), cdDrive(), cdExecTime(), cdH2_colden(), cdInit(), cdInput(), cdIonFrac(), cdLine_ip(), cdMain(), cdMemory(), cdOutput(), cdOutput(), cdPrepareExit(), cdRead(), cdSPEC2(), cdTemp(), cdTemp(), ChargTranPun(), ChargTranSumHeat(), t_cpu_i::check_data, band_emission::check_index_fatal(), pseudo_cont::check_index_fatal(), check_LAMDA_comment(), check_mult_path(), t_mesh::CheckMesh(), CheckVal(), t_mole_local::chem_heat(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), chkCaHeps(), chMolBranch(), CloseSaveFiles(), cloudy(), CloudyPrintReference(), cnewton(), t_ADfA::coll_ion_wrapper(), collision_strength_VF01(), CollisSuppres(), Parser::CommandError(), conorm(), ConserveEnergy(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolEvaluate(), CoolHeatError(), CoolHyperfine(), coolpr(), CoolSave(), CoolSum(), CoStarCompile(), CoStarInitialize(), CoStarListModels(), CS_l_mixing(), database_readin(), DatabasePrintReference(), dBase_solve(), dBaseAbund(), dbg_printf(), dmpary(), doop(), Parser::doSetVar(), DumpCoolStack(), DumpHeatStack(), DumpLine(), DynaEndZone(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), e1(), e1_scaled(), e2(), Parser::echo(), EchoModel(), eden_sum(), EdenError(), ElectronFractions(), ellpk(), Parser::Error(), DataParser::errorAbort(), ErrorMessage(), esc_2side_base(), esc_CRDwing(), escmase(), expn(), extractLevels(), factorial(), fc2_scl(), Fe26cs123(), FFmtRead(), Parser::FFmtRead(), ffun(), ffun1(), FillExtraLymanLine(), FillJ(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fndneg(), fndstr(), fudge(), funjac(), GammaPrtShells(), gauss_legendre(), Energy::get(), get_total_abundance_ions(), Parser::getElement(), Parser::getFirstChunk(), Parser::getFirstChunkRaw(), GetFracPop(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), band_cont::getInten(), GetJenkins09(), getLevelsGeneric(), Parser::getline(), GetLineRec(), GetMetalsDeplete(), Parser::getNumberCheckAlwaysLogLim(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), getSpeciesGeneric(), Parser::getSymbol(), getTransition(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), grid_do(), GridCompile(), GridRetrieveXSPECData(), gridXspec(), GrnStdDpth(), GrnVryDpth(), 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_log10(), H_photo_cs_log10(), HaardtMadauCompile(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), helike_energy(), highen(), HomogeneousSource(), t_ADfA::hpfit(), Hydcs123(), hydro_energy(), HydroEinstA(), HydroLevel(), HydroRecCool(), HyperfineCreate(), IncidentContinuumHere(), diatomics::init(), load_balance::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitIndexArrays(), InitSimPostparse(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_trim(), ion_trim2(), ion_wrapper(), IonHelium(), IonHydro(), IonNelem(), ipContEnergy(), ipLineEnergy(), ipoint(), ipShells(), iso_cascade(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_get_collision_strength(), 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_solve(), iso_update_num_levels(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), KhaireSrianandCompile(), Kurucz79Compile(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgConvTemp(), lgCoolNetConverge(), lgElemsConserved(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgReactBalance(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgStatesConserved(), lgValidModel(), LimitSh(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_iron_Ka(), lines_table(), LineStackCreate(), bands_file::load(), LoadIsotopes(), main(), main(), LinSv::makeBlend(), MakeInputLine(), map_do(), maybeNumber(), mc_escape(), t_mean::MeanIon(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_next_line(), mie_read_mix(), mie_read_number(), mie_read_ocn(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_step(), mie_write_opc(), MihalasCompile(), mole_check_reverse_reactions(), mole_cmp_num_in_out_reactions(), mole_eval_balance(), mole_generate_isotopologue_reactions(), mole_h2_grain_form(), 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(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), MyAssert(), Ne10cs123(), newreact(), newspecies(), newton_step(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), setCollRate::operator()(), optimize_do(), 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(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), EnergyEntry::p_set_ip(), t_mesh::p_SetupMesh(), parse_chemical(), parse_reaction(), parse_save_average(), Parse_Save_Line_RT(), parse_species_label(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFail(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIllumination(), ParseInit(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLineList(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecies(), ParseSphere(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PlanckIntegral(), PntForLine(), PressureChange(), PresTotCurrent(), bad_assert::print(), print_delimiter(), iter_track::print_history(), iter_track::print_status(), t_cpu_i::PrintBacktrace(), t_cpu_i::printDataPath(), PrintRates(), PrintRatio(), PrintSpectrum(), prme(), process_output(), LinSv::prt_blend(), prt_constants(), prt_header_cols(), prt_smooth_predictions(), prt_trans_opc_debug(), PrtAllTau(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLineSum(), PrtMacros(), PrtMeanIon(), prtmet(), prtPunOpacSummary(), t_prt_matrix::prtRates(), PrtTwoPhotonEmissCoef(), PrtZone(), punchFITS_SpectraData(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RauchCompile(), RauchInitialize(), RauchReadMPP(), read_Helike_cross_sections(), read_Hummer_Storey(), read_level2_lines(), read_mewe_gbar(), read_SH98_He1_cross_sections(), read_UTA_lines(), t_input::readarray(), ReadBadnellAIData(), Parser::readLaw(), Parser::readList(), ReadTable(), RebinQHeatResults(), rec6j(), Recomb_Seaton59(), t_conv::register_(), renorm_solution(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_all_escape(), RT_line_driving(), RT_line_escape(), RT_line_one_fine(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_pumping(), 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(), S2Aul(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveHeat(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScaleAllDensities(), ScanProbDistr(), search_limit(), SecIoniz(), Energy::set(), set_weighting(), set_xIntensity(), setIsoNelemFlag(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), GroupMap::setup(), setXtraRatesO1(), ShowMe(), size_distr(), solve_system(), diatomics::SolveExcitedElectronicLevels(), solveions(), speciesCheck(), speciesOff(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), states_nelemfill(), stepDensity(), StoutCollRate(), StuffCommand(), StuffComment(), band_emission::sumBand(), pseudo_cont::sumBand(), SumDensities(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), DepthTable::tabval(), TempChange(), TempChange(), TempInterp(), test_cdTemp_molecules(), test_expn(), test_isMolecule(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), UpdatePot(), UpdateUTAs(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), vary_input(), DataParser::warning(), WernerCompile(), WMBASICCompile(), XERBLA(), xerror_(), y0b01(), Yfunc(), Yfunc(), zero(), zoneDensity(), and ZoneStart().

◆ ioStdin

FILE* ioStdin
extern

Referenced by cdInput(), cdMain(), and t_cpu_i::t_cpu_i().

◆ ipALUMINIUM

const int ipALUMINIUM = 12

Referenced by ChargTranEval(), PrtZone(), and SaveDo().

◆ ipARGON

◆ ipBERYLLIUM

const int ipBERYLLIUM = 3

Referenced by PrtZone().

◆ ipBORON

const int ipBORON = 4

Referenced by PrtZone().

◆ ipCALCIUM

◆ ipCARBON

◆ ipCHLORINE

const int ipCHLORINE = 16

Referenced by ChargTranEval().

◆ ipCHROMIUM

const int ipCHROMIUM = 23

◆ ipCOBALT

const int ipCOBALT = 26

◆ ipCOPPER

const int ipCOPPER = 28

◆ ipCRD

◆ ipCRDW

◆ ipFLUORINE

const int ipFLUORINE = 8

◆ ipHELIUM

const int ipHELIUM = 1

Referenced by AbundancesSet(), AGN_Hemis(), Badnell_rec_init(), t_gaunt::brems_sum_ions(), cdColm(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), ColliderList::ColliderList(), ContCreatePointers(), ContSetIntensity(), ConvBase(), CoolH2_GA08(), cross_section(), ElectronFractions(), FillExtraLymanLine(), ForbiddenAuls(), GetHelikeCollisionStrength(), GetStandardHeLines(), GrainDrift(), GrainRateDr(), diatomics::H2_X_coll_rate_evaluate(), he_1trans(), He_cross_section(), HeatSum(), HeCollidSetup(), HeCSInterp(), HeCSTableInterp(), helike_quantum_defect(), hydro_vanRegemorter_deexcit(), ColliderList::init(), t_yield::init_yield(), InitDefaultsPreparse(), ion_photo(), ion_recom_calculate(), ion_trim(), ion_trim2(), ion_wrapper(), IonHelium(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_update(), iso_continuum_lower(), iso_init(), iso_level(), iso_put_recomb_error(), iso_radiative_recomb(), iso_set_ion_rates(), iso_zero(), lgCheckMonitors(), lgIsLymanLineResolved(), LIKE_RREC_MAXN(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_molecules(), map_do(), mole_create_react(), mole_h_rate_diagnostics(), mole_h_reactions(), OpacityAddTotal(), OpacityCreateAll(), ParseElement(), ParseMonitorResults(), ParseSave(), PrintRates(), PrtAllTau(), PrtComment(), PrtFinal(), PrtHeader(), PrtMeanIon(), PrtZone(), radius_increment(), radius_next(), RT_diffuse(), RT_OTS(), RT_OTS_PrtRate(), RT_tau_init(), SanityCheckBegin(), save_opacity(), SaveDo(), SecIoniz(), t_mesh::ValidateEdges(), and t_secondaries::zero().

◆ ipHYDROGEN

const int ipHYDROGEN = 0

these are indices for some elements, on the C scale

Referenced by AbundancesPrt(), AbundancesSet(), AbundChange(), AGN_Hemis(), t_secondaries::alloc(), Badnell_rec_init(), t_gaunt::brems_sum_ions(), diatomics::CalcPhotoionizationRate(), cdColm(), cdIonFrac(), cdTemp(), cdTemp(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chkCaHeps(), ColliderList::ColliderList(), conorm(), ContCreatePointers(), ContRate(), ContSetIntensity(), ConvBase(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolDima(), CoolEvaluate(), CoolH2_GA08(), CoolHyperfine(), dBase_solve(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaPunchTimeDep(), DynaSave(), DynaSaveLast(), DynaStartZone(), eden_sum(), EdenChange(), ElectronFractions(), FillExtraLymanLine(), find_solution(), Parser::getElement(), GetHlikeCollisionStrength(), 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(), he_1trans(), HeatSum(), highen(), HlikeCSInterp(), HomogeneousSource(), Hydcs123(), hydro_vanRegemorter_deexcit(), ColliderList::init(), diatomics::init(), init_struc(), t_yield::init_yield(), InitBinAugerData(), InitDefaultsPreparse(), InitSimPostparse(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_trim(), ion_trim2(), ion_trim_from_set(), ion_trim_init(), ion_wrapper(), IonHydro(), iso_assign_quantum_numbers(), iso_charge_transfer_update(), iso_collapsed_update(), iso_continuum_lower(), iso_cool(), iso_create(), iso_init(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_setRedisFun(), iso_suprathermal(), iso_update_rates(), iso_zero(), iter_end_check(), IterRestart(), IterStart(), lgCheckMonitors(), lgElemsConserved(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_molecules(), logPressureState(), t_mole_global::make_species(), MakeHCTData(), 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(), OpacityAddTotal(), OpacityCreateAll(), pah1_fun(), ParseAbundances(), ParseCommands(), ParseDatabaseISO(), ParseDLaw(), ParseElement(), ParseFluc(), ParseGlobule(), ParseHDEN(), ParsePrint(), ParseSave(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtMeanIon(), PrtZone(), radius_first(), radius_increment(), radius_next(), read_ionization_potentials(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_all_escape(), RT_line_pumping(), RT_OTS(), RT_tau_inc(), RT_tau_init(), SanityCheckBegin(), save_opacity(), SaveDo(), SaveLineData(), SaveSpecial(), ScaleAllDensities(), ScaleIonDensities(), scalingDensity(), SecIoniz(), t_dense::SetGasPhaseDensity(), setIsoNelemFlag(), setXtraRatesCa2(), setXtraRatesFe2(), setXtraRatesO1(), states_nelemfill(), SumDensities(), t_atmdat::t_atmdat(), t_ionbal::t_ionbal(), tfidle(), total_molecule_elems(), t_mesh::ValidateEdges(), t_dense::zero(), t_secondaries::zero(), and zoneDensity().

◆ ipIRON

◆ ipKRYPTON

const int ipKRYPTON = 35

Referenced by ElectronFractions().

◆ ipLITHIUM

◆ ipLY_A

◆ ipMAGNESIUM

const int ipMAGNESIUM = 11

◆ ipMANGANESE

const int ipMANGANESE = 24

◆ ipNEON

◆ ipNICKEL

const int ipNICKEL = 27

Referenced by ChargTranEval().

◆ ipNITROGEN

◆ ipOXYGEN

◆ ipPHOSPHORUS

const int ipPHOSPHORUS = 14

Referenced by ChargTranEval().

◆ ipPOTASSIUM

const int ipPOTASSIUM = 18

Referenced by ChargTranEval(), 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;

Referenced by database_prep(), lines_setup(), ParseDatabaseISO(), read_UTA_lines(), ReadBadnellAIData(), RT_continuum_shield_fcn_point(), RT_line_escape(), and t_isoCTRL::zero().

◆ ipRecEsc

◆ ipRecNetEsc

◆ ipRecRad

◆ ipSCANDIUM

const int ipSCANDIUM = 20

◆ ipSILICON

const int ipSILICON = 13

◆ ipSODIUM

const int ipSODIUM = 10

Referenced by ChargTranEval(), and SaveDo().

◆ ipSULPHUR

const int ipSULPHUR = 15

◆ ipTITANIUM

const int ipTITANIUM = 21

◆ ipVANADIUM

const int ipVANADIUM = 22

◆ ipZINC

const int ipZINC = 29

◆ iteration

◆ lgPrnErr

bool lgPrnErr
extern

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

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

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

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

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundChange(), t_ionbal::alloc(), t_mole_local::alloc(), t_secondaries::alloc(), atmdat_3body(), atmdat_readin(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), t_gaunt::brems_cool(), t_gaunt::brems_opac(), t_gaunt::brems_rt(), t_gaunt::brems_sum_ions(), cdColm(), cdIonFrac(), cdTemp(), cdTemp(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chIonLbl(), t_ADfA::coll_ion_wrapper(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvInitSolution(), ConvIterCheck(), CoolDima(), CoolEvaluate(), CoolHyperfine(), CoolSave(), CoolZero(), t_hydro_tbl::cs(), database_readin(), dBase_solve(), dBaseAbund(), DumpHeatStack(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), eden_sum(), ElectronFractions(), elem_symbol_to_index(), EvalJenkins(), fill_array(), t_gaunt::gauntff(), get_total_abundance_ions(), Parser::GetElem(), Parser::getElement(), GetJenkins09(), GetMetalsDeplete(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainScreen(), GrainsInit(), GrainUpdateRadius1(), H_Einstein_A(), HCTIon(), HCTRecom(), HeatSum(), HeatZero(), HeCSInterp(), helike_quantum_defect(), HelikeTransProbSetup(), highen(), Hydcs123(), HydroLevel(), HyperfineCreate(), init_struc(), t_yield::init_yield(), InitBinAugerData(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitSimPostparse(), ion_collis(), ion_CX(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_trim2(), ion_trim_from_set(), ion_trim_init(), ion_wrapper(), ipShells(), iso_allocate(), iso_assign_extralyman_levels(), iso_assign_quantum_numbers(), iso_charge_transfer_update(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_init(), iso_init_energies(), iso_ionize_recombine(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_put_error(), iso_rad_rec_cooling_discrete(), iso_radiative_recomb(), iso_recomb_alloc(), 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_hydro_tbl::m1wn(), 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_make_groups(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), NewChargeData(), newisotope(), OpacityAdd1Element(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), GrainVar::p_clear0(), GrainVar::p_clear1(), t_gaunt::p_gauntff_vec_sub(), t_hydro_tbl::p_initnn(), t_hydro_tbl::p_initwn(), t_gaunt::p_read_table(), t_gaunt::p_setup_brems(), ParseAbundances(), ParseCompile(), ParseDatabaseISO(), ParseElement(), ParseMetal(), ParsePrint(), ParseSave(), ParseSet(), parsespect(), PresTotCurrent(), prt_smooth_predictions(), PrtColumns(), PrtComment(), PrtLinePres(), PrtMeanIon(), prtmet(), PrtZone(), radius_increment(), radius_next(), read_ionization_potentials(), read_UTA_lines(), ReadAugerData(), renorm_solution(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_all_escape(), 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(), SecIoniz(), setIsoNelemFlag(), SetIsotopeFractions(), spectral_to_chemical(), SumDensities(), t_abund::SumDepletedAtoms(), t_ADfA::t_ADfA(), t_atmdat::t_atmdat(), t_dense::t_dense(), t_ionbal::t_ionbal(), t_mean::t_mean(), t_yield::t_yield(), tfidle(), total_molecule_elems(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), t_hydro_tbl::tp(), UpdatePot1(), UpdateRecomZ0(), UpdateUTAs(), t_hydro_tbl::wn(), t_abund::zero(), t_atmdat::zero(), t_dense::zero(), t_ionbal::zero(), t_isoCTRL::zero(), t_mole_global::zero(), t_secondaries::zero(), and t_thermal::zero().

◆ MAX_DENSITY

const double MAX_DENSITY = 1.e24

◆ NCHLAB

◆ 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

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

◆ NISO

const int NISO = 2

the number of iso sequences now in the code

Referenced by t_ionbal::alloc(), Badnell_rec_init(), clean_up(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvIterCheck(), CoolDima(), CoolEvaluate(), CoolHyperfine(), CoolSum(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), fill_array(), FindNeg(), FndLineHt(), HeatSum(), init_struc(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitSimPostparse(), ion_collis(), ion_CX(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), ion_trim2(), ion_widen(), ipShells(), iso_allocate(), iso_assign_quantum_numbers(), iso_collapsed_update(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_init(), iso_init_energies(), iso_ionize_recombine(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_radiative_recomb(), iso_recomb_alloc(), iso_recomb_setup(), iso_satellite(), iso_satellite_update(), iso_suprathermal(), iso_update_rates(), iso_zero(), isoSpecies(), IterRestart(), IterStart(), lgTrivialSolution(), lines(), lines_continuum(), OpacityAdd1Element(), OpacityAddTotal(), ParseElement(), PresTotCurrent(), PrintRates(), PrtComment(), PrtLinePres(), prtmet(), PrtZone(), radius_increment(), renorm_solution(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_all_escape(), RT_line_driving(), RT_OTS(), RT_OTS_Update(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), SanityCheckBegin(), SaveLineData(), SaveLineStuff(), ScaleIonDensities(), SecIoniz(), setIsoNelemFlag(), spectral_to_chemical(), t_dynamics::zero(), and t_isoCTRL::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

Referenced by AbundChange(), AgeCheck(), AGN_Hemis(), t_timesc::calc_therm_timesc(), diatomics::CalcPhotoionizationRate(), cdDepth_depth(), cdMain(), cdnZone(), cdPressure_depth(), t_mole_local::chem_heat(), cloudy(), ConserveEnergy(), ContNegative(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolEvaluate(), CoolHeatError(), dBase_solve(), dmpary(), DynaIonize(), DynaNewStep(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), EdenChange(), escmase(), 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_trim(), ion_trim2(), IonHelium(), iso_cool(), iso_level(), iso_photo(), iso_set_ion_rates(), iso_update_rates(), iter_end_check(), IterEnd(), lgCheckMonitors(), lgElemsConserved(), lgNetEdenSrcSmall(), lgStatesConserved(), lines_continuum(), lines_hydro(), map_do(), mole_effects(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_rk_bigchange(), mole_solve(), MyAssert(), NewChargeData(), OpacityAddTotal(), Atom_LevelN::operator()(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtZone(), qheat(), radius_first(), radius_increment(), radius_next(), renorm_solution(), RT_continuum(), RT_continuum_shield_fcn(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_all_escape(), RT_line_one_fine(), RT_line_one_tauinc(), RT_OTS(), RT_stark(), RT_tau_inc(), save_line(), SaveDo(), SaveLineIntensity(), SpeciesPseudoContAccum(), stepDensity(), zero(), zoneDensity(), and ZoneStart().

◆ SEXP_LIMIT

const double SEXP_LIMIT = 84.

this is -ln of smallest number sexp can handle

Referenced by mole_get_equilibrium_condition(), RT_diffuse(), sexp(), and sexp().

◆ 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

Referenced by ParseCrashDo(), RandomCrash(), and TotalInsanityAsStub().

◆ ZeroPtr

const void* ZeroPtr
extern

this is used to trick compilers into dereferencing a null pointer in order to crash the program

Referenced by ParseCrashDo(), and RandomCrash().