cloudy  trunk
 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Data Structures | Macros | Typedefs | Enumerations | Functions | Variables
cddefines.h File Reference
#include "cdstd.h"
#include <cstdio>
#include <cstdlib>
#include <cctype>
#include <cmath>
#include <cassert>
#include <cstring>
#include <cfloat>
#include <climits>
#include <ctime>
#include <csignal>
#include <limits>
#include <string>
#include <sstream>
#include <iomanip>
#include <vector>
#include <valarray>
#include <complex>
#include <map>
#include <memory>
#include <stdexcept>
#include <algorithm>
#include <fstream>
#include <bitset>
#include "cloudyconfig.h"
#include "cpu.h"
Include dependency graph for cddefines.h:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Data Structures

struct  StaticAssertFailed< bool >
 
struct  StaticAssertFailed< true >
 
class  Singleton< T >
 
class  Output
 
class  Fixit
 
class  cloudy_exit
 
class  bad_signal
 
class  bad_assert
 
class  t_debug
 
class  t_nodebug
 
class  debugtrace< Trace >
 
class  auto_vec< T >
 
struct  auto_vec< T >::auto_vec_ref< U >
 

Macros

#define STATIC   static
 
#define float   PLEASE_USE_REALNUM_NOT_FLOAT
 
#define fopen   PLEASE_USE_open_data_NOT_fopen
 
#define STATIC_ASSERT(x)   ((void)StaticAssertFailed< (x) == true >())
 
#define EXIT_SUCCESS   ES_SUCCESS
 
#define EXIT_FAILURE   ES_FAILURE
 
#define lgBOUNDSCHECKVAL   false
 
#define fixit(a)
 
#define cdEXIT(FAIL)   throw cloudy_exit( __func__, __FILE__, __LINE__, FAIL )
 
#define puts(STR)   Using_puts_before_cdEXIT_is_no_longer_needed
 
#define DEBUG
 
#define MALLOC(exp)   (MyMalloc(exp, __FILE__, __LINE__))
 
#define MALLOC_AVX(exp)   (MyMalloc_avx(exp, __FILE__, __LINE__))
 
#define ASSERT(exp)
 
#define MESSAGE_ASSERT(msg, exp)   ASSERT( (msg) ? (exp) : false )
 
#define isnan   MyIsnan
 
#define DEBUG_ENTRY(funcname)   debugtrace<t_nodebug> DEBUG_ENTRY( funcname )
 
#define MIN2(a, b)   min(a,b)
 
#define MIN3(a, b, c)   (min(min(a,b),c))
 
#define MIN4(a, b, c, d)   (min(min(a,b),min(c,d)))
 
#define MAX2(a, b)   max(a,b)
 
#define MAX3(a, b, c)   (max(max(a,b),c))
 
#define MAX4(a, b, c, d)   (max(max(a,b),max(c,d)))
 
#define POW2   pow2
 
#define POW3   pow3
 
#define POW4   pow4
 
#define PrintEfmt(F, V)   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_USER_INTERRUPT, ES_TERMINATION_REQUEST, ES_ILLEGAL_INSTRUCTION,
  ES_FP_EXCEPTION, ES_SEGFAULT, ES_BUS_ERROR, ES_UNKNOWN_SIGNAL,
  ES_UNKNOWN_EXCEPTION, ES_TOP
}
 
enum  { CHARS_SPECIES =10 }
 
enum  { CHARS_ISOTOPE_SYM = 6 }
 

Functions

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 * MyMalloc (size_t size, const char *file, int line)
 
void * MyMalloc_avx (size_t size, const char *file, int line)
 
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,...)
 
int fprintf (const Output &stream, const char *format,...)
 
int dprintf (const Output &stream, const char *format,...)
 
char * read_whole_line (char *chLine, int nChar, FILE *ioIN)
 
NORETURN void OUT_OF_RANGE (const char *str)
 
char tolower (char c)
 
unsigned char tolower (unsigned char c)
 
char toupper (char c)
 
unsigned char toupper (unsigned char c)
 
char TorF (bool l)
 
bool is_odd (int j)
 
bool is_odd (long j)
 
long nint (double x)
 
long min (int a, long b)
 
long min (long a, int b)
 
double min (sys_float a, double b)
 
double min (double a, sys_float b)
 
double powi (double, long int)
 
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 >
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 RandGauss (double xMean, double s)
 
double MyGaussRand (double PctUncertainty)
 
double AnuUnit (realnum energy)
 
void cap4 (char *chCAP, const char *chLab)
 
void uncaps (char *chCard)
 
void caps (char *chCard)
 
double FFmtRead (const char *chCard, long int *ipnt, long int last, bool *lgEOL)
 
long nMatch (const char *chKey, const char *chCard)
 
int GetQuote (char *chLabel, char *chCard, char *chCardRaw, bool lgABORT)
 
const char * strstr_s (const char *haystack, const char *needle)
 
char * strstr_s (char *haystack, const char *needle)
 
const char * strchr_s (const char *s, int c)
 
char * strchr_s (char *s, int c)
 
long int ipow (long, long)
 
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)
 
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 lgAbort
 
bool lgTestCodeCalled
 
bool lgTestCodeEnabled
 
bool lgPrnErr
 
long int nzone
 
double fnzone
 
long int iteration
 
const double ZeroNum
 
const int FILENAME_PATH_LENGTH = 200
 
const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2
 
const int INPUT_LINE_LENGTH = 2000
 
const int NCHLAB = 10
 
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

#define ASSERT (   exp)
Value:
do { \
if (UNLIKELY(!(exp))) \
{ \
bad_assert aa(__FILE__,__LINE__,"Failed: " #exp); \
if( cpu.i().lgAssertAbort() ) \
{ \
aa.print(); \
abort(); \
} \
else \
throw aa; \
} \
} while( 0 )
t_cpu_i & i()
Definition: cpu.h:415
bool lgAssertAbort() const
Definition: cpu.h:382
#define UNLIKELY(x)
Definition: cpu.h:461
static t_cpu cpu
Definition: cpu.h:423

Definition at line 617 of file cddefines.h.

Referenced by abscf(), AbundChange(), addComment(), TransitionProxy::AddHiState(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), AgeCheck(), multi_arr< StoutColls, 2 >::alloc(), flex_arr< double >::alloc(), atmdat_2phot_setSplineCoefs(), atmdat_2phot_shapefunction(), atmdat_CHIANTI_readin(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), atom_level2(), avg_shield(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), bh(), bh_log(), bhG(), bhg(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), 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(), cdGetLineList(), cdLine_ip(), cdSPEC(), cdSPEC2(), LinSv::chALabSet(), ChargTranPun(), ChargTranSumHeat(), EmissionProxy::check(), TransitionProxy::check(), TransitionConstProxy::check(), EmissionConstProxy::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(), 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(), CS_l_mixing(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), CS_l_mixing_S62(), CS_PercivalRichards78(), CS_VS80(), da(), database_readin(), dBaseAbund(), DebyeDeriv(), iter_track::deriv(), dftori(), t_mole_local::dissoc_rate(), DoFSMixing(), DoSatelliteLines(), DumpLine(), DynaIonize(), DynaIterEnd(), DynaNewStep(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), eden_sum(), EdenChange(), EH2_eval(), emergent_line(), emit_frac(), esc_2side_base(), esc_CRDcore(), esc_PRD_1side(), escmase(), expn2_scaled(), F21(), F21_mx(), F21i(), F21i_log(), FastVoigtH(), Parser::FFmtRead(), ffun(), ffun1(), fill_array(), multi_geom< d, MEM_LAYOUT_VAL >::finalize(), find_solution(), FindIndex(), t_LineSave::findline(), t_mole_local::findrk(), FindStrongestLineLabels(), FndLineHt(), fndstr(), ForbiddenAuls(), fp_bound(), fp_bound_tol(), fp_equal(), fp_equal_tol(), fsff(), funjac(), GammaBn(), GammaK(), t_gaunt::gauntff(), get_total_abundance_ions(), GetBins(), GetDopplerWidth(), GetFracPop(), GetGF(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), GetHS98CrossSection(), diatomics::GetIndices(), diatomics::getLine(), GetModel(), t_cpu_i::getPathList(), GetProbDistr_LowLimit(), getrf_wrapper(), getrs_wrapper(), GetStandardHeLines(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainDrift(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GravitationalPressure(), GridCompile(), GridGatherInCloudy(), 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_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_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HCTIon(), HCTRecom(), he_1trans(), He_cross_section(), HeatSum(), HeCollidSetup(), 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(), hri_log10(), hrii(), hrii_log(), hunt_bisect(), hunt_bisect_reverse(), hv(), Hydcs123(), 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(), igam(), igamc(), igamc_scaled(), diatomics::init(), LinSv::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), t_yield::init_yield(), InitCoreloadPostparse(), InitEmissivities(), InitGridBin(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), InitSimPostparse(), InterpCollRate(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), multi_arr< StoutColls, 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(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_Aul_update(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_continuum_lower(), iso_cool(), iso_create(), iso_dielec_recomb_rate(), iso_error_generation(), iso_get_collision_strength(), iso_get_collision_strength_collapsed_to_collapsed_fast(), iso_get_collision_strength_collapsed_to_resolved(), 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(), log10_fsff(), log10_prodxx(), mc_escape(), MD5string(), MeanMassOfElement(), mie_auxiliary2(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), diatomics::Mol_Photo_Diss_Rates(), MolDissocCrossSection(), mole_eval_balance(), mole_eval_dynamic_balance(), mole_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(), MyGaussRand(), MyMalloc(), MyMalloc_avx(), newisotope(), newreact(), newspecies(), nMatch(), Parser::nMatch1(), nWord(), OccupationNumberLine(), ofit(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), open_data(), setCollRate::operator()(), Atom_LevelN::operator()(), my_Integrand_S62::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_gaunt::p_read_table(), t_mesh::p_ReadResolution(), EnergyEntry::p_set_ip(), t_mesh::p_SetupMesh(), 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(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtLinePres(), PrtZone(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), PutCS(), PutLine(), qheat(), qheat_init(), qintr(), radius_first(), radius_increment(), radius_next(), RauchReadMPP(), read_Helike_cross_sections(), read_Hummer_Storey(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_species_file(), read_UTA_lines(), ReadAugerData(), ReadBadnellAIData(), ReadCollisionRateTable(), ReadTable(), flex_arr< double >::realloc(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), reduced_mass_rel(), RefIndex(), renorm_solution(), multi_geom< d, MEM_LAYOUT_VAL >::reserve(), multi_arr< StoutColls, 2 >::reserve(), flex_arr< double >::reserve(), resetBltin(), setCollRate::resize(), rfield_opac_malloc(), RT_continuum(), RT_continuum_shield_fcn_point(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_iso_integrate_RRC(), RT_line_fine_opacity(), 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(), ScaleAllDensities(), ScanProbDistr(), scqdri(), search_limit(), SecIoniz(), PresMode::set(), t_mole_local::set_ion_locations(), SetLimits(), SetLimitsSub(), Parser::setline(), 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(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), Flux::uu(), WavlenErrorGet(), WriteASCIIHead(), writeCloudyDetails(), y0b(), y0psa(), y1psa(), y2pa(), y2s(), Yfunc(), t_input::zero(), multi_arr< StoutColls, 2 >::zero(), iter_track::zero_fit(), ZoneEnd(), and ZoneStart().

#define cdEXIT (   FAIL)    throw cloudy_exit( __func__, __FILE__, __LINE__, FAIL )

Definition at line 484 of file cddefines.h.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), LinSv::addComponent(), AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), AulTTError(), Badnell_rec_init(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), bhG(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdMain(), cdMemory(), cdRead(), cdSPEC(), cdSPEC2(), ChargTranPun(), pseudo_cont::check_index_fatal(), species_bands::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(), database_readin(), dBase_solve(), dgaunt(), dgaunt_check(), do_dump_state(), do_restore_state(), Parser::doSetVar(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaIterStart(), e1(), e1_scaled(), e2(), ellpk(), Parser::Error(), escmase(), expn(), factorial(), fc2_scl(), Fe26cs123(), ffun1(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fsff(), fudge(), gauss_legendre(), Energy::get(), GetBins(), Parser::getFirstChunk(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), getLevelsGeneric(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), GetPotValues(), GetQuote(), getSpecies(), GetStandardHeLines(), GrainCharge(), GrainsInit(), grid_do(), 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_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), Parser::help(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), diatomics::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitGridASCII(), InitGridBin(), InitIndexArrays(), InitSimPostparse(), input_readvector(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ipoint(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgOptimize_do(), lgReadAtmosphereTail(), LimitSh(), lines(), LoadIsotopes(), LinSv::makeBlend(), map_do(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), mole_create_react(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), MyAssert(), MyMalloc_base(), Ne10cs123(), newreact(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), 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(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), plot(), pltopc(), pltr(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), prtLineType(), punchFITS_SpectraData(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_next(), 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(), ReadAugerData(), 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(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesPseudoCont(), search_limit(), PresMode::set(), Energy::set(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), size_distr(), solveions(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), state_do(), StoutCollRate(), StuffComment(), t_ADfA::t_ADfA(), DepthTable::tabval(), TempInterp(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), ValidateMesh(), vary_input(), wr_block(), XERBLA(), xerror_(), y0b01(), Yfunc(), t_abund::zero(), and zoneDensity().

#define DEBUG

to avoid errors introduced by C's infamous double-negative logic, this uses NDEBUG (the ANSI std macro used to tell assert that we are not debugging) to define DEBUG

Definition at line 544 of file cddefines.h.

#define DEBUG_ENTRY (   funcname)    debugtrace<t_nodebug> DEBUG_ENTRY( funcname )

Definition at line 729 of file cddefines.h.

Referenced by AbortErrorMessage(), abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AbundChange(), band_cont::accumulate(), t_PredCont::add(), addBandsFile(), addComment(), TransitionProxy::AddHiState(), addKeyword_num(), addKeyword_txt(), TransitionProxy::AddLine2Stack(), TransitionProxy::AddLoState(), advection_set_default(), AgeCheck(), AGN_He1_CS(), AGN_Hemis(), AngerJ(), anomal(), AnuUnit(), append_file(), 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(), AulTTError(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), badprt(), BadRead(), BadStart(), t_warnings::bangin(), 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(), bh_log(), bhG(), bhg(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), 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(), t_warnings::caunin(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClock(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDrive(), cdEmis(), cdEmis_ip(), cdErrors(), cdExecTime(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInit(), cdInput(), cdIonFrac(), cdLine(), cdLine_ip(), cdMain(), cdNoExec(), cdNotes(), cdNwcns(), cdOutput(), cdPressure_depth(), cdPressure_last(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), check_co_ion_converge(), check_data(), check_grid_file(), check_mult_path(), t_mesh::CheckMesh(), CheckVal(), t_mole_local::chem_heat(), chemical_to_spectral(), ChemImportance(), chi2_func(), CHIANTI_Upsilon(), ChiantiCollRate(), 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(), diatomics::Cont_Diss_Heat_Rate(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolDima(), CoolEvaluate(), CoolH2_GA08(), CoolHeatError(), CoolHyperfine(), coolpr(), CoolSave(), CoolSum(), CoolZero(), CoStarCompile(), CoStarInitialize(), CoStarInterpolate(), CoStarListModels(), create_isotopologues(), create_isotopologues_one_position(), CS_l_mixing(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), CS_l_mixing_S62(), CS_PercivalRichards78(), CS_ThermAve_PR78(), csphot(), csscal(), d1mach(), d3_np_fs(), da(), database_prep(), database_readin(), dBase_solve(), dBaseTrim(), dBaseUpdateCollCoeffs(), dbg_printf(), DebyeDeriv(), dftori(), dgaunt(), dgaunt_check(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), diatomics::diatomics(), diatoms_init(), t_mole_local::dissoc_rate(), dist(), DLASWP(), dmpary(), do_dump_state(), do_restore_state(), doData(), DoFSMixing(), doHeader(), doop(), DoSatelliteLines(), Parser::doSetVar(), dprintf(), Drive_cdLine(), DrvCaseBHS(), DrvContPump(), DrvEscP(), DrvHyas(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpAtmosphere(), DumpLine(), DynaCreateArrays(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaPunchTimeDep(), DynaSave(), DynaSaveLast(), DynaStartZone(), e1(), e1_scaled(), e2(), eden_sum(), EdenChange(), eeBremsCooling(), eeBremsSpectrum(), eina(), ellpk(), emergent_line(), emit_frac(), EmLineJunk(), EmLineZero(), erf(), erfc(), erfce(), Parser::Error(), esc_2side_base(), esc_CRDcore(), esc_CRDwing_1side(), esc_PRD_1side(), esca0k2(), esccon(), escmase(), evalf(), exp1(), expn(), expx2(), extin(), F21(), F21_mx(), F21i(), F21i_log(), factorial(), FastVoigtH(), Fe26cs123(), Parser::FFmtRead(), FFmtRead(), 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(), findspecies(), findspecies_validate(), findspecieslocal(), findspecieslocal_validate(), FindTempChangeFactor(), FindVCoStar(), fixit_base(), FndLineHt(), fndneg(), fndstr(), ForbiddenAuls(), fsff(), 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_total_abundance_ions(), getAdjPseudoIndex(), GetAveVelocity(), GetBins(), GetDensity(), diatomics::GetDissociationRate(), GetDissociationRateCoeff(), Parser::GetElem(), Parser::getFirstChunk(), GetFracPop(), GetGF(), diatomics::GetHeatRate(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), GetHubbleFactor(), band_cont::getInten(), getIntenTypeStr(), getLevelsGeneric(), diatomics::getLine(), Parser::getLineID(), GetLineRec(), t_cpu_i::getMD5sums(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), t_cpu_i::getPathList(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), getPseudoIndex(), getPseudoWlRange(), Parser::GetQuote(), GetQuote(), getSortedLevel(), getSpecBandsIndex(), getSpecies(), GetStandardHeLines(), Parser::getSymbol(), gett2(), gett2o3(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrainZero(), GravitationalPressure(), grid_do(), GridCompile(), GridGatherInCloudy(), GridInterpolate(), gridXspec(), GrnStdDpth(), GrnVryDpth(), growth_romb(), 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_ReadTransprob(), diatomics::H2_Reset(), diatomics::H2_RT_diffuse(), diatomics::H2_RT_OTS(), diatomics::H2_RT_tau_inc(), diatomics::H2_RT_tau_reset(), diatomics::H2_RTMake(), diatomics::H2_Solomon_rate(), diatomics::H2_X_coll_rate_evaluate(), diatomics::H2_X_sink_and_source(), diatomics::H2_zero_pops_too_low(), t_ADfA::h_coll_str(), H_Einstein_A(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), 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(), hri_log10(), hrii(), hrii_log(), humlik(), hv(), Hydcs123(), 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(), HydroCSInterp(), HydroEinstA(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HyperfineCreate(), HyperfineCS(), hypho(), IDAMAX(), igam(), igamc(), igamc_scaled(), ILAENV(), IncidentContinuumHere(), ColliderList::init(), t_input::init(), diatomics::init(), t_mole_global::init(), LinSv::init(), init_eps(), phymir_state< X, Y, NP, NSTR >::init_minmax(), 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(), InitGridBin(), InitGridCoStar(), phymir_state< X, Y, NP, NSTR >::initial_run(), InitIndexArrays(), InitSimPostparse(), input_readvector(), species_bands::insert(), InterpCollRate(), diatomics::interpolate_LTE_Cooling(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), 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_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(), LinSv::isCat(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_charge_transfer_update(), iso_collapsed_Aul_update(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_cross_section(), iso_departure_coefficients(), iso_dielec_recomb_rate(), iso_error_generation(), iso_get_collision_strength(), iso_get_collision_strength_collapsed_to_collapsed_fast(), iso_get_collision_strength_collapsed_to_resolved(), iso_get_collision_strength_resolved(), iso_get_total_num_levels(), iso_ionize_recombine(), iso_level(), iso_multiplet_opacities_one(), iso_photo(), iso_prt_pops(), 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_auxiliary_free(), iso_recomb_check(), iso_recomb_malloc(), iso_recomb_setup(), iso_renorm(), iso_RRCoef_Te(), iso_satellite(), iso_satellite_update(), iso_set_ion_rates(), iso_solve(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), iso_zero(), ispassive(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Junk(), TransitionProxy::Junk(), Kurucz79Compile(), Kurucz79Interpolate(), LinSv::label(), lagrange(), ld01_fun(), LeidenCollRate(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgConserveEnergy(), phymir_state< X, Y, NP, NSTR >::lgConvergedRestart(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), lgFileReadable(), lgInputComment(), lgNeedTimestep(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgOptimize_do(), lgReactionTrivial(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgValidASCIIFile(), lgValidBinFile(), lgValidModel(), LimitSh(), linadd(), lincom(), 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(), linint(), bands_file::load(), LoadIsotopes(), log10_fsff(), log_integral(), LSAME(), diatomics::LTE_Cooling_per_H2(), Magnetic_evaluate(), Magnetic_reinit(), main(), t_mole_global::make_species(), LinSv::makeBlend(), makeChemical(), MakeCS(), MakeHCTData(), map_do(), matchGeneric(), maybeNumber(), MD5_Transform(), MD5datafile(), MD5file(), MD5string(), MD5swap(), t_mean::MeanInc(), t_mean::MeanIon(), MeanMassOfElement(), mie_auxiliary(), mie_auxiliary2(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_data(), mie_next_line(), mie_read_double(), mie_read_form(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_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(), 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(), MyGaussRand(), MyMalloc_base(), Ne10cs123(), NewChargeData(), newelement(), newisotope(), newpt(), newreact(), newspecies(), newton_step(), nMatch(), Parser::NoNumb(), t_warnings::notein(), nWord(), OccupationNumberLine(), ofit(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), diatomics::OpacityCreate(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), open_data(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), my_Integrand_S62::operator()(), phymir_state< X, Y, NP, NSTR >::optimize(), optimize_func(), optimize_phymir(), optimize_subplex(), phymir_state< X, Y, NP, NSTR >::optimize_with_restart(), order(), OscStr_f(), OscStr_f_log10(), TransitionProxy::outline(), outline_base(), outline_base_bin(), outsum(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_evaluate_hyperblock(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), phymir_state< X, Y, NP, NSTR >::p_execute_job_parallel(), t_gaunt::p_gauntff_vec(), t_gaunt::p_gauntff_vec_sub(), Flux::p_get(), Flux::p_InternalFluxUnit(), Flux::p_InternalFluxUnitNoCheck(), phymir_state< X, Y, NP, NSTR >::p_lgLimitExceeded(), phymir_state< X, Y, NP, NSTR >::p_phygrm(), phymir_state< X, Y, NP, NSTR >::p_process_output(), phymir_state< X, Y, NP, NSTR >::p_rd_state(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), phymir_state< X, Y, NP, NSTR >::p_reset_hyperblock(), phymir_state< X, Y, NP, NSTR >::p_reset_transformation_matrix(), Flux::p_set(), EnergyEntry::p_set_ip(), t_gaunt::p_setup_brems(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), t_mesh::p_SetupEdges(), t_mesh::p_SetupMesh(), Flux::p_ValidFluxUnit(), phymir_state< X, Y, NP, NSTR >::p_wr_state(), pah1_fun(), pah2_fun(), pah3_fun(), parse_reaction(), parse_save_average(), parse_save_line(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCaseB(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExp(), ParseExpr(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParseProduct(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), parsespect(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), partx(), PE_init(), t_ADfA::phfit(), pintr(), PlanckIntegral(), plankf(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), powi(), powpq(), PressureChange(), PressureRadiationLine(), pressureZone(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintRates(), PrintShortZero(), PrintSpectrum(), prme(), process_output(), LinSv::prt(), prt_constants(), prt_LineLabels(), prt_smooth_predictions(), 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(), PutCS(), PutLine(), qg32(), qheat(), qheat_init(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandGauss(), RauchCompile(), RauchInitialize(), RauchInterpolateCOWD(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), RauchReadMPP(), rayleh(), rd_block(), read_data(), read_Helike_cross_sections(), read_Hummer_Storey(), 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_ab(), reduce_ab_a(), reduce_abc(), reduce_abc_ab(), reduced_mass_rel(), RefIndex(), t_conv::register_(), register_reaction_vectors(), renorm_solution(), t_prt_matrix::resolveLevels(), resolveSpecType(), rfield_opac_malloc(), 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(), S62BesselInvert(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), Save1LineData(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), SaveFilesInit(), saveFITSfile(), SaveGaunts(), SaveGrid(), SaveHeat(), SaveLineData(), SaveLineIntensity(), SaveLineStuff(), SaveNewContinuum(), SaveResults(), SaveSpecial(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesHeader(), SaveSpeciesOne(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScanProbDistr(), scqdri(), search_limit(), SearchModel(), SecIoniz(), PresMode::set(), Energy::set(), set_fractionation(), t_mole_local::set_ion_locations(), t_mole_local::set_isotope_abundances(), t_cpu_i::set_signal_handlers(), set_xIntensity(), SetIsotopeFractions(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setProperties(), t_LineSave::setSortWL(), t_prt_matrix::setSpecies(), setstp(), t_rfield::setTrimming(), pseudo_cont::setup(), setXtraRatesCa2(), setXtraRatesFe2(), setXtraRatesO1(), sexp(), shieldFederman(), ShowMe(), simplx(), t_mole_local::sink_rate(), 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(), SpeciesBandsAccum(), SpeciesBandsCreate(), SpeciesPseudoContAccum(), SpeciesPseudoContCreate(), spectral_to_chemical(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), Split(), sprt_wl(), spsort(), StandardEnergyUnit(), StandardFluxUnit(), StarburstCompile(), StarburstInitialize(), start(), state_do(), state_get_put(), states_nelemfill(), states_popfill(), states_propprint(), stepDensity(), sticking_probability_H_func(), sticking_probability_H_HM79(), Stognienko(), store_new_densities(), StoutCollRate(), StuffComment(), subopt(), pseudo_cont::sumBand(), species_bands::sumBand(), sumcon(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), t_mean::t_mean(), DepthTable::tabval(), tauff(), TauZero(), tbl_fun(), TempChange(), TempInterp(), TempInterp2(), TestCode(), TexcLine(), tfidle(), Therm_ave_coll_str_int_PR78(), ThetaNu(), timestep_next(), TlustyCompile(), TlustyInterpolate(), total_molecule_deut(), total_molecule_elems(), total_molecules(), total_molecules_gasphase(), TotalInsanity(), totlin(), trim_levels(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), ufunct(), uncaps(), GroupMap::updateMolecules(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), UpdateUTAs(), Flux::uu(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), ValidateGrid(), ValidateMesh(), vary_input(), vasinh(), vexp(), vexp10(), vexpm1(), vfast_asinh(), vhypot(), vlog(), vlog10(), vlog1p(), vsqrt(), t_warnings::warnin(), WavlenErrorGet(), WernerCompile(), WernerInterpolate(), wlAirVac(), WMBASICCompile(), WMBASICInterpolate(), wr_block(), WriteASCIIData(), WriteASCIIHead(), XERBLA(), xerror_(), xinvrs(), xmap(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yan_H2_CS(), Yfunc(), t_NumDeriv::zero(), t_dark_matter::zero(), t_CoolHeavy::zero(), t_DoppVel::zero(), t_oxy::zero(), t_peimbt::zero(), t_phycon::zero(), t_secondaries::zero(), t_he::zero(), t_state::zero(), t_hextra::zero(), t_hmi::zero(), t_warnings::zero(), t_colden::zero(), t_pressure::zero(), t_radius::zero(), t_magnetic::zero(), Zero(), t_thermal::zero(), t_rfield::zero(), t_input::zero(), zero(), t_mean::zero(), t_hyperfine::zero(), t_dynamics::zero(), t_LineSave::zero(), t_hydro::zero(), t_opac::zero(), t_prt_matrix::zero(), t_atoms::zero(), TransitionProxy::Zero(), t_rt::zero(), t_abund::zero(), t_atmdat::zero(), t_line_col::zero(), t_mole_global::zero(), t_isoCTRL::zero(), ZeroContin(), zoneDensity(), ZoneEnd(), and ZoneStart().

#define EXIT_FAILURE   ES_FAILURE

Definition at line 168 of file cddefines.h.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), LinSv::addComponent(), AGN_Hemis(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), AulTTError(), Badnell_rec_init(), BadRead(), bessel_y0(), bessel_y1(), bessel_yn(), bhG(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdMemory(), cdRead(), cdSPEC(), cdSPEC2(), ChargTranPun(), pseudo_cont::check_index_fatal(), species_bands::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(), database_readin(), dBase_solve(), dgaunt(), do_dump_state(), do_restore_state(), Parser::doSetVar(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaIterStart(), e1(), e1_scaled(), e2(), ellpk(), Parser::Error(), escmase(), expn(), factorial(), fc2_scl(), Fe26cs123(), ffun1(), find_arr(), find_solution(), t_LineSave::findline(), findspecies_validate(), fsff(), fudge(), gauss_legendre(), Energy::get(), GetBins(), Parser::getFirstChunk(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), getLevelsGeneric(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), GetPotValues(), GetQuote(), getSpecies(), GetStandardHeLines(), GrainCharge(), GrainsInit(), grid_do(), 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_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), load_balance::init(), diatomics::init(), t_mole_global::init(), t_yield::init_yield(), InitGrid(), InitGridASCII(), InitGridBin(), InitSimPostparse(), input_readvector(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), ipoint(), iso_level(), iso_radiative_recomb(), iso_recomb_setup(), iso_set_ion_rates(), iso_update_num_levels(), iter_end_check(), IterStart(), lfactorial(), lgCheckMonitors(), lgOptimize_do(), lgReadAtmosphereTail(), LimitSh(), lines(), LoadIsotopes(), LinSv::makeBlend(), map_do(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), mole_create_react(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), MyAssert(), MyMalloc_base(), Ne10cs123(), newreact(), Parser::NoNumb(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), 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(), Parse_Save_Line_RT(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecial(), ParseSpecies(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), plot(), pltopc(), pltr(), PntForLine(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtElem(), PrtFinal(), PrtLineSum(), prtLineType(), punchFITS_SpectraData(), qintr(), r1mach(), t_ADfA::rad_rec(), radius_next(), 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(), ReadAugerData(), Parser::readLaw(), Parser::readList(), ReadTable(), t_conv::register_(), RT_continuum(), RT_DestProb(), RT_line_escape(), RT_recom_effic(), RT_tau_init(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesPseudoCont(), search_limit(), PresMode::set(), Energy::set(), SetLimits(), setProperties(), t_prt_matrix::setSpecies(), size_distr(), solveions(), spectral_to_chemical(), spline_cubic_set(), Split(), StandardEnergyUnit(), StandardFluxUnit(), state_do(), StoutCollRate(), StuffComment(), t_ADfA::t_ADfA(), DepthTable::tabval(), TempInterp(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), ValidateMesh(), vary_input(), wr_block(), XERBLA(), xerror_(), y0b01(), Yfunc(), t_abund::zero(), and zoneDensity().

#define EXIT_SUCCESS   ES_SUCCESS
#define fixit (   a)
Value:
do { \
static Fixit fixit_s(__func__,__FILE__,__LINE__, (a)); \
} while (0)
#define __func__
Definition: cpu.h:236

Definition at line 416 of file cddefines.h.

Referenced by AbundChange(), atmdat_CHIANTI_readin(), ChargTranSumHeat(), clean_up(), ContCreatePointers(), CoolEvaluate(), create_isotopologues(), database_readin(), diatomics::diatomics(), DynaCreateArrays(), FndLineHt(), ForbiddenAuls(), GetAveVelocity(), GetDensity(), GetHelikeCollisionStrength(), GetHlikeCollisionStrength(), gridXspec(), diatomics::H2_CollidRateEvalAll(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), diatomics::H2_X_sink_and_source(), HeatSum(), HeCSTableInterp(), HomogeneousSource(), diatomics::init(), init_struc(), IonHydro(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_satellite(), lgNetEdenSrcSmall(), lines(), lines_helium(), lines_hydro(), t_mole_global::make_species(), mole_check_reverse_reactions(), mole_create_react(), mole_generate_isotopologue_reactions(), diatomics::mole_H2_form(), mole_h2_grain_form(), mole_h_reactions(), mole_partition_function(), mole_solve(), OpacityAddTotal(), OpacityCreateAll(), outline_base(), ParseCosmology(), ParseDatabaseH2(), ParseDont(), PressureChange(), pressureZone(), PresTotCurrent(), PrtZone(), punchFITS_PrimaryHeader(), radius_next(), read_data(), Recomb_Seaton59(), renorm_solution(), RT_continuum(), RT_iso_integrate_RRC(), RT_line_all(), RT_line_escape(), RT_tau_init(), SaveLineIntensity(), SaveNewContinuum(), SecIoniz(), set_fractionation(), setXtraRatesO1(), diatomics::SolveExcitedElectronicLevels(), state_get_put(), states_nelemfill(), t_isoCTRL::zero(), and zoneDensity().

#define float   PLEASE_USE_REALNUM_NOT_FLOAT

Definition at line 129 of file cddefines.h.

#define fopen   PLEASE_USE_open_data_NOT_fopen

Definition at line 135 of file cddefines.h.

Referenced by sys_fopen().

#define isnan   MyIsnan
#define lgBOUNDSCHECKVAL   false

Definition at line 173 of file cddefines.h.

#define MALLOC (   exp)    (MyMalloc(exp, __FILE__, __LINE__))
#define MALLOC_AVX (   exp)    (MyMalloc_avx(exp, __FILE__, __LINE__))

Definition at line 559 of file cddefines.h.

Referenced by rfield_opac_malloc().

#define MAX2 (   a,
 
)    max(a,b)

MAX2 takes two arguments, returns the larger of the two

Definition at line 828 of file cddefines.h.

Referenced by abund_starburst(), AbundancesPrt(), AgeCheck(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_STOUT_readin(), atom_level2(), 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(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), da(), dBase_solve(), DebyeDeriv(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), DrvCaseBHS(), DTRSM(), DynaStartZone(), EdenChange(), ElectronFractions(), 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_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(), HyperfineCreate(), hypho(), init_struc(), InitBinAugerData(), InitCoreload(), InterpolateModel(), ion_photo(), ion_recomb(), ion_trim(), ion_trim2(), IonHydro(), iso_allocate(), iso_continuum_lower(), iso_cool(), iso_level(), iso_rad_rec_cooling_extra(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_radrecomb_from_cross_section(), iso_recomb_check(), iso_recomb_malloc(), iso_update_num_levels(), iter_end_check(), IterRestart(), lgCheckMonitors(), lgCoolHeatCheckConverge(), lgNucleiConserved(), limitedDensityScaling(), lincom(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_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(), ParseDatabaseISO(), ParseGrid(), ParseIterations(), ParsePrint(), ParseRangeOption(), ParseSave(), ParseSet(), ParseStop(), ParseTrace(), pltcon(), pltmap(), pltopc(), pltr(), 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(), pseudo_cont::sumBand(), species_bands::sumBand(), tauff(), TryDoubleStep(), TwoPhotonSetup(), uderiv(), UpdatePot(), UpdatePot1(), Yan_H2_CS(), and ZoneStart().

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

MAX3 takes 3 arguments, returns the largest of the 3

Definition at line 833 of file cddefines.h.

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

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

MAX4 takes 4 arguments, returns the largest of the 4

Definition at line 838 of file cddefines.h.

Referenced by sinpar().

#define MESSAGE_ASSERT (   msg,
  exp 
)    ASSERT( (msg) ? (exp) : false )

Definition at line 645 of file cddefines.h.

#define MIN2 (   a,
 
)    min(a,b)

MIN2 takes two arguments, returns the smaller of the two

Definition at line 807 of file cddefines.h.

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(), CoolSave(), CS_l_mixing_PS64(), CS_l_mixing_PS64_expI(), da(), dBase_solve(), dense_parametric_wind(), DGETF2(), DGETRF(), DynaStartZone(), ElectronFractions(), esc_CRDcore(), esc_PRD_1side(), 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(), ipLineEnergy(), iso_assign_quantum_numbers(), iso_collapsed_update(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_put_recomb_error(), iso_radiative_recomb(), iso_radrecomb_from_cross_section(), iso_satellite_update(), iso_update_rates(), lgCheckMonitors(), limitedDensityScaling(), lines_hydro(), map_do(), mole_get_equilibrium_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(), ParseStop(), partx(), pltcon(), pltmap(), pltopc(), pltr(), 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(), SaveHeat(), SaveLineData(), SecIoniz(), set_xIntensity(), SetLimits(), SetLimitsSub(), setstp(), setXtraRatesO1(), shieldFederman(), simplx(), spldrv_safe(), splint_safe(), subopt(), sumcon(), uderiv(), writeCloudyDetails(), xinvrs(), and ZoneStart().

#define MIN3 (   a,
  b,
 
)    (min(min(a,b),c))

MIN3 takes 3 arguments, returns the smallest of the 3

Definition at line 812 of file cddefines.h.

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

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

MIN4 takes 4 arguments, returns the smallest of the 4

Definition at line 817 of file cddefines.h.

Referenced by radius_first().

#define POW2   pow2

POW2 takes 1 argument, and squares it

Definition at line 983 of file cddefines.h.

Referenced by abund_starburst(), collision_strength_VF01(), ColStrGBar(), ContSetIntensity(), CS_l_mixing_PS64(), CS_l_mixing_S62(), dist(), DoFSMixing(), DrvCaseBHS(), 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_vs_coll_str(), HydroEinstA(), HydroOscilStr(), HydroRecCool(), hypho(), diatomics::init(), InitSimPostparse(), iso_assign_quantum_numbers(), iso_cool(), iso_create(), iso_get_collision_strength_collapsed_to_collapsed_fast(), iso_rad_rec_cooling_approx(), iso_rad_rec_cooling_extra(), iso_state_lifetime(), lgCheckMonitors(), lgConserveEnergy(), 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().

#define POW3   pow3
#define POW4   pow4

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

Definition at line 997 of file cddefines.h.

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

#define PrintEfmt (   F,
 
)    F, V
create string with val and format, to print with %s,

much faster than above, totally native on non-MS systems

Parameters
*fmt
val

Definition at line 1364 of file cddefines.h.

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

#define puts (   STR)    Using_puts_before_cdEXIT_is_no_longer_needed

Definition at line 487 of file cddefines.h.

#define STATIC   static

Definition at line 118 of file cddefines.h.

#define STATIC_ASSERT (   x)    ((void)StaticAssertFailed< (x) == true >())

Typedef Documentation

typedef float realnum

Definition at line 124 of file cddefines.h.

typedef float sys_float

Definition at line 127 of file cddefines.h.

Enumeration Type Documentation

anonymous enum
Enumerator
CHARS_SPECIES 

Definition at line 323 of file cddefines.h.

anonymous enum
Enumerator
CHARS_ISOTOPE_SYM 

Definition at line 324 of file cddefines.h.

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_USER_INTERRUPT 
ES_TERMINATION_REQUEST 
ES_ILLEGAL_INSTRUCTION 
ES_FP_EXCEPTION 
ES_SEGFAULT 
ES_BUS_ERROR 
ES_UNKNOWN_SIGNAL 
ES_UNKNOWN_EXCEPTION 
ES_TOP 

Definition at line 142 of file cddefines.h.

Function Documentation

double AnuUnit ( realnum  energy)

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

Definition at line 197 of file service.cpp.

References t_save::chConSavEnr, DEBUG_ENTRY, Energy::get(), t_save::ipConPun, and save.

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

Here is the call graph for this function:

NORETURN void BadRead ( void  )

BadRead tried to read internal data and failed

Definition at line 1082 of file service.cpp.

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

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

Here is the call graph for this function:

void broken ( void  )

broken set flag saying that the code is broken

Definition at line 1163 of file service.cpp.

References broke, DEBUG_ENTRY, and t_broke::lgBroke.

Referenced by ion_solver(), and PresTotCurrent().

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

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

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

Definition at line 264 of file service.cpp.

References DEBUG_ENTRY, and toupper().

Referenced by lgCheckMonitors(), optimize_func(), and PrtFinal().

Here is the call graph for this function:

void caps ( char *  chCard)

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

Parameters
chCard- line image as string of characters

Definition at line 304 of file service.cpp.

References DEBUG_ENTRY, and toupper().

Referenced by atmdat_STOUT_readin(), cdColm(), cdIonFrac(), cdRead(), cdTemp(), LinSv::chALabSet(), t_input::echo(), t_LineSave::findline(), lgCheckMonitors(), LinSv::makeBlend(), Parser::newlineProcess(), ParseAbundances(), ParseNorm(), ParseTable(), and PrtFinal().

Here is the call graph for this function:

void cdPrepareExit ( exit_type  )

prepare termination of the code, but do not terminate yet

Definition at line 132 of file cdinit.cpp.

References cdInput(), cdOutput(), CloseSaveFiles(), cpu, fprintf(), grid, t_cpu::i(), ioQQQ, t_grid::lgGrid, t_cpu_i::lgMPISingleRankMode(), t_grid::pnunit, and SaveGrid().

Referenced by cdMain().

Here is the call graph for this function:

void CodeReview ( void  )

CodeReview - placed next to code that needs to be checked

Definition at line 1189 of file service.cpp.

References broke, DEBUG_ENTRY, and t_broke::lgCheckit.

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

csphot returns photoionization cross section from opacity stage using std pointers

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

Definition at line 1764 of file service.cpp.

References DEBUG_ENTRY, opac, and t_opac::OpacStack.

Referenced by OpacityAddTotal().

int dbg_printf ( int  debug,
const char *  fmt,
  ... 
)

dbg_printf is a debug print routine that was provided by Peter Teuben, as a component from his NEMO package. It offers run-time specification of the level of debugging

Definition at line 1249 of file service.cpp.

References DEBUG_ENTRY, t_trace::debug_level, ioQQQ, and trace.

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

dprintf – version of fprintf which prepends DEBUG

Definition at line 1198 of file service.cpp.

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:

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

Definition at line 1226 of file service.cpp.

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

Here is the call graph for this function:

double dsexp ( double  x)
double exp10 ( double  x)
inline

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

Definition at line 1383 of file cddefines.h.

References BIGDOUBLE, and pow2().

Referenced by AbundancesTable(), atmdat_HS_caseB(), Badnell_rec_init(), cdIonFrac(), cdRead(), cdTemp(), CHIANTI_Upsilon(), ColStrGBar(), conorm(), ContCreatePointers(), ContSetIntensity(), CoolEvaluate(), CoStarInitialize(), CoStarListModels(), da(), dense_fabden(), dgaunt(), dgaunt_check(), DrivePump(), DrvCaseBHS(), DrvEscP(), 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(), HydroRecCool(), HyperfineCS(), hypho(), diatomics::init(), 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(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseCaseB(), ParseCExtra(), ParseCMB(), ParseCommands(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCovering(), ParseCylinder(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDistance(), ParseDrive(), ParseEden(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseHDEN(), ParseHExtra(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNeutrons(), ParseOptimize(), ParsePhi(), ParsePowerlawContinuum(), ParsePrint(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseStop(), ParseTable(), ParseTauMin(), ParseTurbulence(), pltmap(), 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(), WavlenErrorGet(), wr_exp10d(), wr_exp10f(), and xinvrs().

Here is the call graph for this function:

sys_float exp10 ( sys_float  x)
inline

Definition at line 1418 of file cddefines.h.

References exp10f().

Here is the call graph for this function:

sys_float exp10f ( sys_float  x)
inline

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

Definition at line 1401 of file cddefines.h.

References BIGFLOAT, and pow2().

Referenced by exp10().

Here is the call graph for this function:

double FFmtRead ( const char *  chCard,
long int *  ipnt,
long int  last,
bool *  lgEOL 
)
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

Definition at line 1172 of file service.cpp.

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

Referenced by Fixit::Fixit().

Here is the call graph for this function:

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

checks whether a number is within bounds

Definition at line 931 of file cddefines.h.

References ASSERT, fp_equal(), and isnan.

Referenced by DynaStartZone().

Here is the call graph for this function:

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

Definition at line 943 of file cddefines.h.

References ASSERT, fp_equal(), and isnan.

Here is the call graph for this function:

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

Definition at line 955 of file cddefines.h.

References ASSERT, fp_equal_tol(), and isnan.

Here is the call graph for this function:

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

Definition at line 967 of file cddefines.h.

References ASSERT, fp_equal_tol(), and isnan.

Here is the call graph for this function:

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

checks whether two FP numbers are "equal" (differ no more than n epsilon)

Definition at line 858 of file cddefines.h.

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

Referenced by abund_starburst(), atmdat_HS_caseB(), t_gaunt::brems_cool(), ChargTranEval(), LinSv::checkEmergent(), t_mesh::CheckMesh(), conorm(), phymir_state< X, Y, NP, NSTR >::continue_from_state(), ConvBase(), ConvEdenIoniz(), ConvInitSolution(), ConvTempEdenIoniz(), CoolEvaluate(), CoolHyperfine(), CoStarInitialize(), dBase_solve(), eden_sum(), EdenChange(), eeBremsSpectrum(), ffun1(), t_PredCont::find(), FindIndex(), t_LineSave::findline(), fp_bound(), GammaBn(), GrainCharge(), GrainChargeTemp(), GrainDrive(), diatomics::H2_LevelPops(), diatomics::H2_X_coll_rate_evaluate(), HeatSum(), Hydcs123(), InterpolateModel(), ion_recom_calculate(), iso_collide(), iso_level(), iso_rad_rec_cooling_discrete(), iso_radiative_recomb(), iso_renorm(), lgCheckMonitors(), lgValidBinFile(), MeanMassOfElement(), mie_cs_size_distr(), diatomics::mole_H2_LTE(), mole_h_reactions(), NewChargeData(), OpacityAddTotal(), optimize_subplex(), t_gaunt::p_gauntff_vec(), t_gaunt::p_read_table(), t_mesh::p_ReadResolution(), t_gaunt::p_setup_brems(), ParseGrid(), PrtFinal(), radius_first(), RauchInitialize(), RT_DestProb(), SanityCheckBegin(), SaveDo(), SearchModel(), t_mesh::setResolutionScaleFactor(), diatomics::SolveSomeGroundElectronicLevels(), StarburstInitialize(), state_do(), t_physconst::t_physconst(), and tfidle().

Here is the call graph for this function:

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

Definition at line 885 of file cddefines.h.

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

Here is the call graph for this function:

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

Definition at line 919 of file cddefines.h.

References ASSERT, isnan, and max().

Here is the call graph for this function:

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

overloads to allow interception of output

Definition at line 1217 of file service.cpp.

References Output::fptr().

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), addComment(), LinSv::addComponent(), 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(), AulTTError(), Badnell_rec_init(), badprt(), BadRead(), t_warnings::bangin(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), t_warnings::caunin(), cdCautions(), cdClock(), cdColm(), cdDrive(), cdErrors(), cdExecTime(), cdGetLineList(), cdH2_colden(), cdInit(), cdIonFrac(), cdLine_ip(), cdMain(), cdMemory(), cdNotes(), cdPrepareExit(), cdPrintCommands(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTemp(), cdWarnings(), ChargTranPun(), ChargTranSumHeat(), check_data(), pseudo_cont::check_index_fatal(), species_bands::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(), collectSkipTrans(), collision_strength_VF01(), CollisSuppres(), Parser::CommandError(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvCrossSect2CollStr(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolEvaluate(), CoolHeatError(), CoolHyperfine(), coolpr(), CoolSave(), CoolSum(), CoStarCompile(), CoStarInitialize(), CoStarListModels(), CS_l_mixing(), database_readin(), DatabasePrintReference(), dBase_solve(), dBaseAbund(), dgaunt(), dgaunt_check(), dmpary(), do_dump_state(), do_restore_state(), doData(), DoFSMixing(), doHeader(), doop(), Parser::doSetVar(), dprintf(), Drive_cdLine(), DrivePump(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DumpAtmosphere(), DumpLine(), DynaEndZone(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaPunchTimeDep(), DynaSave(), DynaStartZone(), e1(), e1_scaled(), e2(), t_input::echo(), Parser::echo(), eden_sum(), EdenError(), ElectronFractions(), ellpk(), t_debug::enter(), Parser::Error(), escmase(), expn(), factorial(), fc2_scl(), Fe26cs123(), Parser::FFmtRead(), 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(), GetBins(), Parser::getFirstChunk(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), getLevelsGeneric(), Parser::getLineID(), GetLineRec(), GetModel(), GetNextLine(), Parser::getNumberCheckAlwaysLogLim(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), getSpecies(), GetStandardHeLines(), Parser::getSymbol(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), grid_do(), GridCompile(), 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_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), Parser::help(), highen(), HomogeneousSource(), t_ADfA::hpfit(), hv(), Hydcs123(), HydroEinstA(), HydroLevel(), HydroRecCool(), HyperfineCreate(), hypho(), IncidentContinuumHere(), load_balance::init(), diatomics::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitGridASCII(), InitGridBin(), InitSimPostparse(), input_readvector(), InterpolateGridCoStar(), 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_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(), Kurucz79Compile(), t_debug::leave(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgConserveEnergy(), lgConvTemp(), lgCoolNetConverge(), lgElemsConserved(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgOptimize_do(), lgReactBalance(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgStatesConserved(), lgValidModel(), LimitSh(), lindst(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_iron_Ka(), lines_table(), LineStackCreate(), bands_file::load(), LoadIsotopes(), LinSv::makeBlend(), map_do(), maybeNumber(), mc_escape(), t_mean::MeanIon(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_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(), MyMalloc_base(), Ne10cs123(), newreact(), newspecies(), newton_step(), Parser::NoNumb(), t_warnings::notein(), opacity_more_memory(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreateReilMan(), setCollRate::operator()(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), optimize_func(), optimize_phymir(), 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(), parse_reaction(), parse_save_average(), parse_save_line(), Parse_Save_Line_RT(), parse_species_label(), parse_udfa(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFail(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecies(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PlanckIntegral(), plot(), plot_sparsity(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), PressureChange(), PresTotCurrent(), bad_assert::print(), print_delimiter(), print_emline_fine(), iter_track::print_history(), PrintCenterLine(), t_cpu_i::printDataPath(), PrintE71(), PrintE82(), PrintE93(), Parser::PrintLine(), PrintLineDataHeader(), PrintRates(), PrintRatio(), PrintShortZero(), PrintSpectrum(), prme(), process_output(), LinSv::prt(), t_physconst::prt_constants(), prt_constants(), prt_line_err(), prt_line_inlist(), prt_LineLabels(), prt_smooth_predictions(), prt_trans_opc_debug(), 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(), 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(), read_whole_line(), t_input::readarray(), ReadAugerData(), 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(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), Save1Line(), Save1LineData(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveAllSpeciesLabelsLevels(), SaveDo(), saveFITSfile(), SaveGaunts(), SaveGrid(), SaveHeat(), SaveLineData(), SaveLineIntensity(), SaveLineStuff(), SaveNewContinuum(), SaveResults(), SaveSpecial(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesHeader(), SaveSpeciesLines(), SaveSpeciesOne(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScaleAllDensities(), ScanProbDistr(), search_limit(), SecIoniz(), Energy::set(), set_xIntensity(), 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(), state_do(), state_get_put(), states_nelemfill(), stepDensity(), StoutCollRate(), StuffComment(), pseudo_cont::sumBand(), species_bands::sumBand(), SumDensities(), t_ADfA::t_ADfA(), t_physconst::t_physconst(), t_version::t_version(), DepthTable::tabval(), TempChange(), TempInterp(), test_expn(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), UpdatePot(), UpdateUTAs(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), ValidateGrid(), ValidateMesh(), vary_input(), t_warnings::warnin(), WernerCompile(), WMBASICCompile(), WriteASCIIData(), WriteASCIIHead(), XERBLA(), xerror_(), y0b01(), Yfunc(), zero(), t_abund::zero(), zoneDensity(), and ZoneStart().

Here is the call graph for this function:

double fudge ( long int  ipnt)

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

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

Definition at line 567 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, EXIT_FAILURE, fprintf(), t_fudgec::fudgea, fudgec, ioQQQ, t_fudgec::lgFudgeUsed, and t_fudgec::nfudge.

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

Here is the call graph for this function:

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

Definition at line 1117 of file cddefines.h.

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

Definition at line 1121 of file cddefines.h.

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

Definition at line 1125 of file cddefines.h.

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

Definition at line 1129 of file cddefines.h.

int GetQuote ( char *  chLabel,
char *  chCard,
char *  chCardRaw,
bool  lgABORT 
)
GetQuote get any name between double quotes off command line

return string as chLabel, is null terminated returns zero for success, 1 for did not find double quotes

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

Definition at line 599 of file service.cpp.

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

Referenced by cdRead().

Here is the call graph for this function:

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

Definition at line 1101 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

void invalidate_array ( sys_float p,
size_t  size 
)
inline

Definition at line 1106 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

long int ipow ( long  ,
long   
)
ipow
Returns
m^n

Definition at line 754 of file service.cpp.

References DEBUG_ENTRY, and is_odd().

Here is the call graph for this function:

bool is_odd ( int  j)
inline

checks whether argument is odd

Definition at line 757 of file cddefines.h.

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

bool is_odd ( long  j)
inline

Definition at line 758 of file cddefines.h.

long max ( int  a,
long  b 
)
inline

Definition at line 821 of file cddefines.h.

Referenced by flex_arr< double >::alloc(), atmdat_CHIANTI_readin(), bhintegrand(), bhintegrand_log(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), dawson(), 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_tol(), t_gaunt::gauntff(), GetProbDistr_LowLimit(), GrainCharge(), GrainMakeDiffuse(), GrnStdDpth(), GrnVryDpth(), IncidentContinuumHere(), InitBinAugerData(), phymir_state< X, Y, NP, NSTR >::initial_run(), ion_trim_init(), iso_collide(), iso_cool(), iso_level(), iso_satellite_update(), lines_general(), main(), t_mean::MeanInc(), t_mean::MeanIon(), 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(), iter_track::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_clear1(), iter_track_basic< T >::p_clear1(), 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(), ParseGrid(), ParseInterp(), ParseStop(), PrettyTransmission(), qage_(), qagie_(), qagpe_(), qagse_(), qawce_(), qawfe_(), qawoe_(), qawse_(), qelg_(), qheat_init(), qk15_(), qk15i_(), qk15w_(), qk21_(), qk31_(), qk41_(), qk51_(), qk61_(), qng_(), flex_arr< double >::realloc(), rec6j(), multi_geom< d, MEM_LAYOUT_VAL >::reserve(), ritoa(), RT_DestProb(), RT_line_all_escape(), RT_line_fine_opacity(), search_limit(), t_rfield::setTrimming(), sinpar(), SixJFull(), flex_arr< double >::size(), sjs(), t_mean::t_mean(), TempInterp(), TempInterp2(), UpdatePot(), UpdatePot1(), phymir_state< X, Y, NP, NSTR >::xmin(), y0b(), y0b01(), Yfunc(), and ZoneStart().

long max ( long  a,
int  b 
)
inline

Definition at line 822 of file cddefines.h.

double max ( sys_float  a,
double  b 
)
inline

Definition at line 823 of file cddefines.h.

double max ( double  a,
sys_float  b 
)
inline

Definition at line 824 of file cddefines.h.

long min ( int  a,
long  b 
)
inline

Definition at line 766 of file cddefines.h.

Referenced by t_gaunt::brems_cool(), t_gaunt::brems_rt(), chi2_func(), conorm(), ConvEdenIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolEvaluate(), CS_l_mixing_PS64_expI(), dawson(), iter_track::deriv(), dqagpe_(), dqawce_(), dqk15_(), dqk15i_(), dqk15w_(), dqk21_(), dqk31_(), dqk41_(), dqk51_(), dqk61_(), dqng_(), eeBremsSpectrum(), FFmtRead(), find_arr(), fp_equal(), t_gaunt::gauntff(), GrainTemperature(), load_balance::init(), phymir_state< X, Y, NP, NSTR >::initial_run(), ld01_fun(), lines_general(), 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(), iter_track_basic< T >::p_clear1(), phymir_state< X, Y, NP, NSTR >::p_evaluate_hyperblock(), t_gaunt::p_gauntff_vec_sub(), t_gaunt::p_setup_brems(), phymir_state< X, Y, NP, NSTR >::p_setup_next_hyperblock(), pah1_fun(), ParseCommands(), PrintCenterLine(), PrintRates(), PrtFinal(), qagpe_(), qawce_(), qheat_init(), qk15_(), qk15i_(), qk15w_(), qk21_(), qk31_(), qk41_(), qk51_(), qk61_(), qng_(), 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(), iter_track::zero_fit(), and ZoneStart().

long min ( long  a,
int  b 
)
inline

Definition at line 767 of file cddefines.h.

double min ( sys_float  a,
double  b 
)
inline

Definition at line 768 of file cddefines.h.

double min ( double  a,
sys_float  b 
)
inline

Definition at line 769 of file cddefines.h.

void MyAssert ( const char *  file,
int  line,
const char *  comment 
)
MyAssert a version of assert that fails gracefully
Parameters
*file
line

Definition at line 177 of file service.cpp.

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

Referenced by cdMain().

Here is the call graph for this function:

double MyGaussRand ( double  PctUncertainty)

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

Parameters
PctUncertainty

Definition at line 1845 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and RandGauss().

Referenced by iso_error_generation().

Here is the call graph for this function:

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

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

Parameters
sizeuse same type as library function malloc
file
line

Definition at line 1739 of file service.cpp.

References ASSERT, and MyMalloc_base().

Here is the call graph for this function:

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

MyMalloc_avx - same as MyMalloc, but returned memory is aligned on AVX / AVX512 size boundary

Definition at line 1750 of file service.cpp.

References ASSERT, CD_ALIGN, and MyMalloc_base().

Here is the call graph for this function:

long nint ( double  x)
inline
long nMatch ( const char *  chKey,
const char *  chCard 
)

nMatch determine whether match to a keyword occurs on command line, return value is 0 if no match, and position of match within string if hit

Parameters
*chKey
*chCard

Definition at line 537 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and strstr_s().

Referenced by atmdat_CHIANTI_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), cdRead(), t_input::echo(), mie_read_mix(), mie_read_rfi(), mie_read_szd(), Parser::nMatch1(), ParseAbundances(), ParseGrain(), ParseTable(), PrtFinal(), StandardEnergyUnit(), StandardFluxUnit(), and vary_input().

Here is the call graph for this function:

NORETURN void OUT_OF_RANGE ( const char *  str)
inline
double plankf ( long int  ip)

plankf evaluate Planck function for any cell at current electron temperature

Parameters
ip

Definition at line 1869 of file service.cpp.

References t_mesh::anu(), t_rfield::ContBoltz, DEBUG_ENTRY, POW2, and rfield.

Referenced by SaveDo().

Here is the call graph for this function:

double pow ( double  x,
int  i 
)
inline

Definition at line 782 of file cddefines.h.

References powi().

Referenced by AgeCheck(), atmdat_STOUT_readin(), 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(), 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(), ParseRatio(), t_ADfA::phfit(), 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:

double pow ( double  x,
long  i 
)
inline

Definition at line 786 of file cddefines.h.

References powi().

Here is the call graph for this function:

sys_float pow ( sys_float  x,
int  i 
)
inline

Definition at line 790 of file cddefines.h.

References powi().

Here is the call graph for this function:

sys_float pow ( sys_float  x,
long  i 
)
inline

Definition at line 794 of file cddefines.h.

References powi().

Here is the call graph for this function:

double pow ( sys_float  x,
double  y 
)
inline

Definition at line 798 of file cddefines.h.

References pow().

Here is the call graph for this function:

double pow ( double  x,
sys_float  y 
)
inline

Definition at line 802 of file cddefines.h.

References pow().

Here is the call graph for this function:

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

Definition at line 999 of file cddefines.h.

Referenced by atmdat_STOUT_readin(), he_1trans(), and iso_state_lifetime().

double powi ( double  ,
long  int 
)
double powpq ( double  x,
int  p,
int  q 
)
void PrintE71 ( FILE *  ,
double   
)

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

Definition at line 969 of file service.cpp.

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

Referenced by PrtFinal().

Here is the call graph for this function:

void PrintE82 ( FILE *  ,
double   
)

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

Definition at line 920 of file service.cpp.

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

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

Here is the call graph for this function:

void PrintE93 ( FILE *  ,
double   
)

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

Definition at line 1019 of file service.cpp.

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:

double RandGauss ( double  xMean,
double  s 
)
normal random variate generator 
Parameters
xMeanmean value
sstandard deviation s

Definition at line 1805 of file service.cpp.

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

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

Here is the call graph for this function:

char* read_whole_line ( char *  chLine,
int  nChar,
FILE *  ioIN 
)

read_whole_line safe version of fgets - read a line, return null if cannot read line or if input line is too long

Parameters
char*chLine - previously allocated string where the line image will be stored
intnChar size of chLine, we will return NULL if input line is longer than this
FILE*ioIN a previously opened file handle, will read from from here

Definition at line 72 of file service.cpp.

References called, DEBUG_ENTRY, fprintf(), ioQQQ, lgAbort, and t_called::lgTalk.

Referenced by atmdat_LAMDA_readin(), atmdat_STOUT_readin(), Badnell_rec_init(), cdGetLineList(), cdMain(), ContBandsCreate(), CoStarInitialize(), database_readin(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), GetNextLine(), GetStandardHeLines(), diatomics::H2_CollidRateRead(), diatomics::H2_Read_hminus_distribution(), diatomics::H2_Read_LTE_cooling_per_H2(), diatomics::H2_ReadDissocEnergies(), diatomics::H2_ReadDissprob(), diatomics::H2_ReadEnergies(), diatomics::H2_ReadTransprob(), HeCollidSetup(), HelikeTransProbSetup(), HyperfineCreate(), t_yield::init_yield(), iso_recomb_setup(), lgReadAtmosphereHead(), bands_file::load(), LoadIsotopes(), mie_next_line(), t_mesh::p_ReadResolution(), ParseAbundances(), ParseDrive(), ParseInit(), ParseTable(), RauchInitialize(), read_data_line(), read_Helike_cross_sections(), read_level2_lines(), read_mewe_gbar(), diatomics::Read_Mol_Diss_cross_sections(), read_SH98_He1_cross_sections(), read_UTA_lines(), ReadCollisionRateTable(), ReadTable(), StarburstInitialize(), validate_magic_number_1arg(), and validate_magic_number_3arg().

Here is the call graph for this function:

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

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

Definition at line 1015 of file cddefines.h.

References isnan, and sign3().

Referenced by ContRate(), ConvEdenIoniz(), ConvFail(), ConvTempEdenIoniz(), CoolSave(), DrivePump(), eden_sum(), EdenError(), get_error_ratio(), GetFracPop(), GrainCharge(), GrainRateDr(), diatomics::H2_Calc_Average_Rates(), diatomics::H2_Cooling(), diatomics::H2_Level_low_matrix(), diatomics::H2_LevelPops(), iso_departure_coefficients(), lines(), lines_general(), lines_grains(), lines_molecules(), mie_step(), iter_track::next_val(), PrintSpectrum(), PrtFinal(), radius_first(), radius_next(), RT_diffuse(), RT_line_pumping(), safe_div(), SanityCheckBegin(), SaveDo(), SaveHeat(), and diatomics::SolveSomeGroundElectronicLevels().

Here is the call graph for this function:

sys_float safe_div ( sys_float  x,
sys_float  y 
)
inline

Definition at line 1048 of file cddefines.h.

References safe_div().

Here is the call graph for this function:

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

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

Definition at line 1056 of file cddefines.h.

References isnan, and sign3().

Here is the call graph for this function:

double safe_div ( double  x,
double  y 
)
inline

Definition at line 1089 of file cddefines.h.

References safe_div().

Here is the call graph for this function:

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

Definition at line 1932 of file service.cpp.

Referenced by CloudyPrintReference(), and DatabasePrintReference().

sys_float SDIV ( sys_float  x)
inline

SDIV safe division - div by SDIV(x) - if abs val of arg >SMALLFLOAT, returns arg, if < SMALLFLOAT, returns SMALLFLOAT - with negative arg return is +SMALLFLOAT so sign changes

Definition at line 1006 of file cddefines.h.

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(), RT_stark(), SaveDo(), SaveLineData(), SecIoniz(), shieldFederman(), diatomics::SolveExcitedElectronicLevels(), and diatomics::SolveSomeGroundElectronicLevels().

double SDIV ( double  x)
inline

Definition at line 1008 of file cddefines.h.

References SMALLFLOAT.

sys_float sexp ( sys_float  x)
double sexp ( double  x)

Definition at line 1114 of file service.cpp.

References DEBUG_ENTRY, and SEXP_LIMIT.

void ShowMe ( void  )
template<class T >
T sign ( x,
y 
)
inline
FP sign transfer (fortran sign function) - sign of y times abs value of x 
Parameters
x
y

Definition at line 846 of file cddefines.h.

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

template<class T >
int sign3 ( x)
inline

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

Definition at line 854 of file cddefines.h.

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

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

Definition at line 812 of file service.cpp.

References strnlen().

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

Here is the call graph for this function:

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

Definition at line 825 of file service.cpp.

References DEBUG_ENTRY.

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

spsort netlib routine to sort array returning sorted indices

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

Definition at line 1318 of file service.cpp.

References DEBUG_ENTRY.

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

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

Definition at line 1330 of file cddefines.h.

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

Definition at line 1320 of file cddefines.h.

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

Definition at line 131 of file cddefines.h.

References fopen.

Referenced by check_mult_path(), and open_data().

void TestCode ( void  )

TestCode set flag saying that test code is in place

Definition at line 1153 of file service.cpp.

References DEBUG_ENTRY, and lgTestCodeCalled.

char tolower ( char  c)
inline

Definition at line 734 of file cddefines.h.

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

unsigned char tolower ( unsigned char  c)
inline

Definition at line 738 of file cddefines.h.

References tolower().

Here is the call graph for this function:

char TorF ( bool  l)
inline
NORETURN void TotalInsanity ( void  )

TotalInsanity general error handler for something that cannot happen, exits

Definition at line 1067 of file service.cpp.

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

Referenced by AbundancesPrt(), multi_arr< StoutColls, 2 >::alloc(), atmdat_CHIANTI_readin(), atmdat_LAMDA_readin(), atmdat_readin(), atmdat_STOUT_readin(), avg_shield(), Badnell_rec_init(), t_gaunt::brems_cool(), t_gaunt::brems_opac(), t_gaunt::brems_rt(), cdInit(), cdMain(), cdRead(), CHIANTI_Upsilon(), t_ADfA::coll_ion_wrapper(), CollisSuppres(), conorm(), ContSetIntensity(), ConvInitSolution(), ConvIterCheck(), ConvTempEdenIoniz(), CoolEvaluate(), CoolSave(), cross_section(), CS_PercivalRichards78(), database_readin(), dawson(), dBase_solve(), dBaseUpdateCollCoeffs(), DebyeDeriv(), DynaPunchTimeDep(), DynaSave(), EdenChange(), fc2(), FFmtRead(), multi_geom< d, MEM_LAYOUT_VAL >::finalize(), FindIndex(), t_LineSave::findline(), ForbiddenAuls(), ForcePass(), GetHelikeCollisionStrength(), getIntenTypeStr(), t_cpu_i::getPathList(), Parser::GetQuote(), GetQuote(), GetStandardHeLines(), GrainChargeTemp(), GrainMakeDiffuse(), GravitationalPressure(), GridGatherInCloudy(), GrnStdDpth(), H21_cm_pops(), diatomics::H2_LevelPops(), diatomics::H2_Read_LTE_cooling_per_H2(), HaardtMadauInterpolate(), he_1trans(), helike_quantum_defect(), diatomics::init(), t_yield::init_yield(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), irsl2ind(), iso_assign_quantum_numbers(), iso_collapsed_Aul_update(), iso_create(), iso_cross_section(), iso_get_collision_strength_collapsed_to_collapsed_fast(), iso_get_collision_strength_collapsed_to_resolved(), iso_get_collision_strength_resolved(), iso_get_total_num_levels(), iso_radrecomb_from_cross_section(), iter_end_check(), IterEnd(), lgCheckMonitors(), lgInputComment(), lgOptimize_do(), lines(), t_mean::MeanIon(), 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()(), phymir_state< X, Y, NP, NSTR >::p_barrier(), phymir_state< X, Y, NP, NSTR >::p_execute_job(), t_gaunt::p_setup_brems(), pah2_fun(), pah3_fun(), ParseBlackbody(), ParseCosmology(), ParseCrashDo(), ParseDatabaseH2(), ParseDatabaseISO(), ParseGrain(), ParseMonitorResults(), ParseTable(), PrintSpectrum(), PrtColumns(), PrtComment(), PrtFinal(), PrtMeanIon(), radius_first(), radius_next(), RauchInitialize(), read_SH98_He1_cross_sections(), read_UTA_lines(), ReadBadnellAIData(), rfield_opac_malloc(), RT_continuum(), RT_continuum_shield_fcn_point(), RT_OTS_ChkSum(), save_average(), SaveDo(), SaveFilesInit(), SaveSpecies(), SaveSpeciesPseudoCont(), sg(), StarburstInitialize(), state_get_put(), states_nelemfill(), Integrator< Integrand, Method >::sum(), VecIntegrator< Integrand, Method >::sum(), SumDensities(), tbl_fun(), tfidle(), TlustyInterpolate(), TotalInsanityAsStub(), vary_input(), zoneDensity(), and ZoneStart().

Here is the call graph for this function:

template<class T >
T TotalInsanityAsStub ( )

Definition at line 499 of file cddefines.h.

References TotalInsanity(), and ZeroNum.

Here is the call graph for this function:

char toupper ( char  c)
inline
unsigned char toupper ( unsigned char  c)
inline

Definition at line 747 of file cddefines.h.

References toupper().

Here is the call graph for this function:

void uncaps ( char *  chCard)

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

Parameters
chCard- line image as string of characters

Definition at line 287 of file service.cpp.

References DEBUG_ENTRY, and tolower().

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

Here is the call graph for this function:

Variable Documentation

const double DEPTH_OFFSET = 1.e-30

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

Definition at line 321 of file cddefines.h.

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

const double DSEXP_LIMIT = 680.

this is -ln of smallest number dsexp can handle

Definition at line 1370 of file cddefines.h.

Referenced by dsexp().

const int FILENAME_PATH_LENGTH = 200

FILENAME_PATH_LENGTH is the size of the string that holds the path. The longest string that can be held is one less than this, due to the end end of string sentinel in C. Increase this is a larger string is needed to hold the path on your system

Definition at line 293 of file cddefines.h.

const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2
double fnzone
const int INPUT_LINE_LENGTH = 2000
FILE* ioMAP

Definition at line 9 of file cdinit.cpp.

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

FILE* ioPrnErr

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

Definition at line 9 of file cddefines.cpp.

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

FILE* ioQQQ

Definition at line 7 of file cddefines.cpp.

Referenced by AbortErrorMessage(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), t_PredCont::add(), LinSv::addComponent(), AGN_Hemis(), AtlasCompile(), atmdat_3body(), atmdat_CHIANTI_readin(), atmdat_dielrec_fe(), atmdat_LAMDA_readin(), atmdat_outer_shell(), atmdat_readin(), atmdat_STOUT_readin(), AtmospheresAvail(), AulTTError(), Badnell_rec_init(), badprt(), BadRead(), t_warnings::bangin(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), t_warnings::caunin(), cdClock(), cdColm(), cdDrive(), cdExecTime(), cdH2_colden(), cdInit(), cdIonFrac(), cdLine_ip(), cdMain(), cdMemory(), cdOutput(), cdPrepareExit(), cdRead(), cdSPEC(), cdSPEC2(), cdTemp(), ChargTranPun(), ChargTranSumHeat(), check_data(), pseudo_cont::check_index_fatal(), species_bands::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(), collectSkipTrans(), collision_strength_VF01(), CollisSuppres(), Parser::CommandError(), conorm(), 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(), dgaunt(), dgaunt_check(), dmpary(), do_dump_state(), do_restore_state(), DoFSMixing(), doop(), Parser::doSetVar(), Drive_cdLine(), DrivePump(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DumpCoolStack(), DumpHeatStack(), DumpLine(), DynaEndZone(), DynaIonize(), DynaIterEnd(), DynaIterStart(), DynaNewStep(), DynaPrtZone(), DynaStartZone(), e1(), e1_scaled(), e2(), Parser::echo(), eden_sum(), EdenError(), ElectronFractions(), ellpk(), Parser::Error(), escmase(), expn(), factorial(), fc2_scl(), Fe26cs123(), Parser::FFmtRead(), 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(), GetBins(), Parser::getFirstChunk(), GetFracPop(), GetHelikeCollisionStrength(), band_cont::getInten(), getLevelsGeneric(), Parser::getLineID(), GetLineRec(), GetModel(), GetNextLine(), Parser::getNumberCheckAlwaysLogLim(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), Parser::getPairs(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), getSpecies(), GetStandardHeLines(), Parser::getSymbol(), diatomics::GetXColden(), GrainCharge(), GrainChargeTemp(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainsInit(), GrainTemperature(), GravitationalPressure(), grid_do(), GridCompile(), 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_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatSum(), HeCollidSetup(), HelikeTransProbSetup(), highen(), HomogeneousSource(), t_ADfA::hpfit(), hv(), Hydcs123(), HydroEinstA(), HydroLevel(), HydroRecCool(), HyperfineCreate(), IncidentContinuumHere(), load_balance::init(), diatomics::init(), t_mole_global::init(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitGridASCII(), InitGridBin(), InitSimPostparse(), input_readvector(), InterpolateGridCoStar(), 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_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(), Kurucz79Compile(), lfactorial(), lgCheckMonitors(), lgCompileAtmosphere(), lgConserveEnergy(), lgConvTemp(), lgCoolNetConverge(), lgElemsConserved(), lgNetEdenSrcSmall(), lgNucleiConserved(), lgOptimize_do(), lgReadAtmosphereHead(), lgReadAtmosphereTail(), lgStatesConserved(), lgValidModel(), LimitSh(), lindst(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_iron_Ka(), lines_table(), LineStackCreate(), bands_file::load(), LoadIsotopes(), main(), LinSv::makeBlend(), map_do(), maybeNumber(), mc_escape(), t_mean::MeanIon(), mie_auxiliary(), mie_auxiliary2(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_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(), MyMalloc_base(), Ne10cs123(), newreact(), newspecies(), newton_step(), Parser::NoNumb(), t_warnings::notein(), opacity_more_memory(), OpacityAddTotal(), OpacityCreateAll(), OpacityCreateReilMan(), setCollRate::operator()(), Atom_LevelN::operator()(), FunctLAMDA::operator()(), 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_reaction(), parse_save_average(), parse_save_line(), Parse_Save_Line_RT(), parse_species_label(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAperture(), ParseBackgrd(), ParseBlackbody(), ParseBremsstrahlung(), ParseChemistry(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosm(), ParseCosmicRays(), ParseCosmology(), ParseCovering(), ParseCrashDo(), ParseDarkMatter(), ParseDatabase(), ParseDatabaseH2(), ParseDatabaseISO(), ParseDielectronic(), ParseDiffuse(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseEnergy(), ParseExtinguish(), ParseF_nu(), ParseFail(), ParseFill(), ParseFluc(), ParseForceTemperature(), ParseGlobule(), ParseGrain(), ParseGravity(), ParseGrid(), ParseHDEN(), ParseHeLike(), ParseHelp(), ParseHExtra(), ParseHydrogen(), ParseIlluminate(), ParseInit(), ParseInitCount(), ParseIntensity(), ParseInterp(), ParseIonPar(), ParseLaser(), ParseLuminosity(), ParseMagnet(), ParseMap(), ParseMetal(), ParseMonitorResults(), ParseNorm(), ParseNumber(), ParseOptimize(), ParsePGrains(), ParsePhi(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePrtLineSum(), ParseQH(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSave(), ParseSet(), ParseSpecies(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTolerance(), ParseTrace(), ParseTurbulence(), PlanckIntegral(), plot(), pltcon(), pltmap(), pltopc(), pltr(), PntForLine(), PressureChange(), PresTotCurrent(), bad_assert::print(), print_delimiter(), print_emline_fine(), iter_track::print_history(), iter_track::print_status(), t_cpu_i::printDataPath(), PrintRates(), PrintRatio(), PrintSpectrum(), prme(), process_output(), prt_constants(), 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(), read_whole_line(), t_input::readarray(), ReadAugerData(), 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(), SanityCheck(), SanityCheckBegin(), SanityCheckGaunt(), save_average(), save_line(), Save_Line_RT(), save_opacity(), SaveDo(), saveFITSfile(), SaveHeat(), SaveLineData(), SaveLineStuff(), SaveSpecies(), SaveSpeciesBands(), SaveSpeciesOptDep(), SaveSpeciesPseudoCont(), ScaleAllDensities(), ScanProbDistr(), search_limit(), SecIoniz(), Energy::set(), set_xIntensity(), 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(), state_do(), state_get_put(), states_nelemfill(), stepDensity(), StoutCollRate(), StuffComment(), pseudo_cont::sumBand(), species_bands::sumBand(), SumDensities(), t_ADfA::t_ADfA(), t_cpu_i::t_cpu_i(), t_version::t_version(), DepthTable::tabval(), TempChange(), TempInterp(), test_expn(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), trim_levels(), uderiv(), ufunct(), UpdatePot(), UpdateUTAs(), validate_magic_number_1arg(), validate_magic_number_3arg(), t_mesh::ValidateEdges(), ValidateGrid(), ValidateMesh(), vary_input(), t_warnings::warnin(), WernerCompile(), WMBASICCompile(), XERBLA(), xerror_(), y0b01(), Yfunc(), zero(), t_abund::zero(), zoneDensity(), and ZoneStart().

FILE* ioStdin
const int ipALUMINIUM = 12

Definition at line 360 of file cddefines.h.

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

const int ipARGON = 17
const int ipBERYLLIUM = 3

Definition at line 351 of file cddefines.h.

Referenced by PrtZone().

const int ipBORON = 4

Definition at line 352 of file cddefines.h.

Referenced by PrtZone().

const int ipCALCIUM = 19

Definition at line 367 of file cddefines.h.

Referenced by chkCaHeps(), cross_section(), ion_photo(), lines(), and read_Helike_cross_sections().

const int ipCARBON = 5
const int ipCHLORINE = 16

Definition at line 364 of file cddefines.h.

Referenced by ChargTranEval(), and lines().

const int ipCHROMIUM = 23

Definition at line 371 of file cddefines.h.

const int ipCOBALT = 26

Definition at line 374 of file cddefines.h.

const int ipCOPPER = 28

Definition at line 376 of file cddefines.h.

const int ipCRD = -1
const int ipCRDW = 2
const int ipFLUORINE = 8

Definition at line 356 of file cddefines.h.

const int ipHELIUM = 1

Definition at line 349 of file cddefines.h.

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_energy(), helike_quantum_defect(), HelikeTransProbSetup(), ColliderList::init(), t_yield::init_yield(), InitCoreload(), InitDefaultsPreparse(), InitSimPostparse(), ion_recom_calculate(), ion_trim(), ion_trim2(), ion_wrapper(), IonHelium(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_update(), iso_continuum_lower(), iso_create(), iso_level(), iso_put_recomb_error(), iso_radiative_recomb(), iso_set_ion_rates(), iso_zero(), lgCheckMonitors(), 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(), ParsePrint(), ParseSave(), PrintRates(), PrtAllTau(), PrtComment(), PrtFinal(), PrtHeader(), PrtMeanIon(), PrtZone(), radius_increment(), radius_next(), read_Helike_cross_sections(), RT_OTS(), RT_OTS_PrtRate(), RT_tau_init(), SanityCheckBegin(), save_opacity(), SaveDo(), SecIoniz(), t_mesh::ValidateEdges(), and t_secondaries::zero().

const int ipHYDROGEN = 0

these are indices for some elements, on the C scale

Definition at line 348 of file cddefines.h.

Referenced by AbundancesPrt(), AbundancesSet(), AbundChange(), AGN_Hemis(), t_secondaries::alloc(), Badnell_rec_init(), t_gaunt::brems_sum_ions(), diatomics::CalcPhotoionizationRate(), cdColm(), cdIonFrac(), 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(), find_solution(), 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(), t_ADfA::h_coll_str(), he_1trans(), HeatSum(), helike_quantum_defect(), highen(), HlikeCSInterp(), HomogeneousSource(), Hydcs123(), ColliderList::init(), diatomics::init(), init_struc(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), 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_get_collision_strength_collapsed_to_collapsed_fast(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_setRedisFun(), iso_suprathermal(), iso_update_rates(), iso_zero(), iter_end_check(), IterRestart(), IterStart(), lgCheckMonitors(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_molecules(), logPressureState(), t_mole_global::make_species(), map_do(), t_mean::MeanInc(), mie_read_form(), mole_effects(), diatomics::mole_H2_form(), mole_h2_grain_form(), mole_h_fixup(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_solve(), newspecies(), OpacityAddTotal(), OpacityCreateAll(), pah1_fun(), ParseAbundances(), ParseCommands(), ParseDatabaseISO(), ParseDLaw(), ParseElement(), ParseFluc(), ParseGlobule(), ParseHDEN(), ParsePrint(), ParseSave(), pltopc(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtAllTau(), PrtColumns(), PrtComment(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtMeanIon(), PrtZone(), radius_first(), radius_increment(), radius_next(), read_Helike_cross_sections(), RT_continuum(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_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(), setXtraRatesCa2(), setXtraRatesFe2(), setXtraRatesO1(), state_get_put(), states_nelemfill(), SumDensities(), tfidle(), total_molecule_elems(), t_mesh::ValidateEdges(), t_secondaries::zero(), t_dense::zero(), and zoneDensity().

const int ipIRON = 25
const int ipKRYPTON = 35

Definition at line 378 of file cddefines.h.

Referenced by ElectronFractions().

const int ipLITHIUM = 2
const int ipLY_A = -2
const int ipMAGNESIUM = 11
const int ipMANGANESE = 24

Definition at line 372 of file cddefines.h.

Referenced by ChargTranEval().

const int ipNEON = 9
const int ipNICKEL = 27

Definition at line 375 of file cddefines.h.

Referenced by ChargTranEval().

const int ipNITROGEN = 6
const int ipOXYGEN = 7
const int ipPHOSPHORUS = 14

Definition at line 362 of file cddefines.h.

Referenced by ChargTranEval().

const int ipPOTASSIUM = 18

Definition at line 366 of file cddefines.h.

Referenced by ChargTranEval(), and OpacityCreateAll().

const int ipPRD = 1

with the above, the total radiative rec per ion is iso.RadRecomb[ipISO][nelem][n][ipRecRad]* iso.RadRecomb[ipISO][nelem][n][ipRecNetEsc]*dense.eden;

Definition at line 339 of file cddefines.h.

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

const int ipRecEsc = 2
const int ipRecNetEsc = 1
const int ipRecRad = 0
const int ipSCANDIUM = 20

Definition at line 368 of file cddefines.h.

const int ipSILICON = 13

Definition at line 361 of file cddefines.h.

Referenced by ChargTranEval(), InitCoreload(), InitDefaultsPreparse(), lines(), and SaveDo().

const int ipSODIUM = 10

Definition at line 358 of file cddefines.h.

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

const int ipSULPHUR = 15

Definition at line 363 of file cddefines.h.

Referenced by ChargTranEval(), InitCoreload(), InitDefaultsPreparse(), lines(), and SaveDo().

const int ipTITANIUM = 21

Definition at line 369 of file cddefines.h.

Referenced by ChargTranEval().

const int ipVANADIUM = 22

Definition at line 370 of file cddefines.h.

const int ipZINC = 29

Definition at line 377 of file cddefines.h.

Referenced by helike_energy().

long int iteration
bool lgAbort
bool lgPrnErr

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

Definition at line 13 of file cddefines.cpp.

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

bool lgTestCodeCalled

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

Definition at line 11 of file cddefines.cpp.

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

bool lgTestCodeEnabled

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

Definition at line 12 of file cddefines.cpp.

Referenced by ParseSet(), and zero().

const int LIMELM = 30

This is the number of elements included in the code, is used to set lengths of many vectors

Definition at line 307 of file cddefines.h.

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundChange(), t_secondaries::alloc(), t_ionbal::alloc(), t_mole_local::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(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), chIonLbl(), t_ADfA::coll_ion_wrapper(), collectSkipTrans(), ContCreatePointers(), ContSetIntensity(), ConvBase(), ConvInitSolution(), ConvIterCheck(), CoolDima(), CoolEvaluate(), CoolHyperfine(), CoolSave(), CoolZero(), database_readin(), dBase_solve(), dBaseAbund(), DumpHeatStack(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaSaveLast(), DynaStartZone(), eden_sum(), ElectronFractions(), fill_array(), t_gaunt::gauntff(), get_total_abundance_ions(), Parser::GetElem(), GetStandardHeLines(), 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(), InitCoreload(), 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_quantum_numbers(), iso_charge_transfer_update(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_put_error(), iso_rad_rec_cooling_discrete(), iso_radiative_recomb(), iso_recomb_malloc(), iso_recomb_setup(), iso_satellite(), iso_suprathermal(), iso_update_rates(), iso_zero(), IterRestart(), IterStart(), lgNetEdenSrcSmall(), lines(), lines_continuum(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), t_mole_global::make_species(), MakeHCTData(), map_do(), t_mean::MeanInc(), mie_read_form(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_write_form(), mie_write_opc(), mole_eval_dynamic_balance(), mole_eval_sources(), mole_make_groups(), my_Integrand_VF01_E< P >::my_Integrand_VF01_E(), nelem_symbol_to_index(), NewChargeData(), newisotope(), OpacityAdd1Element(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), GrainVar::p_clear0(), GrainVar::p_clear1(), t_gaunt::p_gauntff_vec_sub(), t_gaunt::p_read_table(), t_gaunt::p_setup_brems(), ParseAbundances(), ParseCompile(), ParseDatabaseISO(), ParseDrive(), ParseElement(), ParseMetal(), ParsePrint(), ParseSave(), ParseSet(), parsespect(), PresTotCurrent(), prt_smooth_predictions(), PrtColumns(), PrtComment(), PrtLinePres(), PrtMeanIon(), prtmet(), PrtZone(), radius_increment(), radius_next(), 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(), SetIsotopeFractions(), spectral_to_chemical(), state_get_put(), SumDensities(), t_dense::t_dense(), t_mean::t_mean(), t_yield::t_yield(), tfidle(), total_molecule_elems(), UpdatePot1(), UpdateRecomZ0(), UpdateUTAs(), t_secondaries::zero(), t_thermal::zero(), t_ionbal::zero(), t_dense::zero(), t_abund::zero(), t_atmdat::zero(), t_mole_global::zero(), t_isoCTRL::zero(), and t_mole_local::zero().

const double MAX_DENSITY = 1.e24

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

Definition at line 318 of file cddefines.h.

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

const int NCHLAB = 10
const int NHYDRO_MAX_LEVEL = 401

following is real limit to how many levels can be computed for model hydrogen atom - this has the one extra included, so at most iso.numLevels_max[ipH_LIKE] can be NHYDRO_MAX_LEVEL-1 and vectors should be dim NHYDRO_MAX_LEVEL

Definition at line 315 of file cddefines.h.

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().

const int NISO = 2

the number of iso sequences now in the code

Definition at line 310 of file cddefines.h.

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(), InitCoreload(), 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_ionize_recombine(), iso_level(), iso_multiplet_opacities(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_radiative_recomb(), iso_recomb_auxiliary_free(), iso_recomb_malloc(), iso_recomb_setup(), iso_satellite(), iso_satellite_update(), iso_suprathermal(), iso_update_rates(), iso_zero(), IterRestart(), IterStart(), lgTrivialSolution(), lines(), lines_continuum(), OpacityAdd1Element(), OpacityAddTotal(), ParseElement(), PresTotCurrent(), PrintRates(), PrtComment(), PrtLinePres(), prtmet(), PrtZone(), radius_increment(), 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(), spectral_to_chemical(), state_get_put(), t_dynamics::zero(), and t_isoCTRL::zero().

long int nzone

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

Definition at line 14 of file cddefines.cpp.

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(), 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(), GrainCharge(), 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(), lgConserveEnergy(), lgElemsConserved(), lgNetEdenSrcSmall(), lgStatesConserved(), lindst(), lines_continuum(), lines_hydro(), map_do(), mole_effects(), mole_h_rate_diagnostics(), mole_h_reactions(), mole_rk_bigchange(), mole_solve(), MyAssert(), NewChargeData(), OpacityAddTotal(), pltcon(), PressureChange(), PresTotCurrent(), PrintRates(), prt_smooth_predictions(), PrtComment(), PrtFinal(), PrtLineSum(), PrtZone(), qheat(), radius_first(), radius_increment(), radius_next(), 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().

const double SEXP_LIMIT = 84.

this is -ln of smallest number sexp can handle

Definition at line 1368 of file cddefines.h.

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

const double ZeroNum

this is the number zero, used to trick clever compilers when dividing by it to crash program there is a routine called zero - this name cannot overlap definition is in cddefines.cpp

Definition at line 13 of file cdinit.cpp.

Referenced by ParseCrashDo(), and TotalInsanityAsStub().