/home66/gary/public_html/cloudy/c08_branch/source/cddefines.h File Reference

#include <stdio.h>
#include <stdlib.h>
#include <math.h>
#include <assert.h>
#include <string.h>
#include <float.h>
#include <limits.h>
#include <time.h>
#include <signal.h>
#include <string>
#include <sstream>
#include <vector>
#include <valarray>
#include <complex>
#include <map>
#include <memory>
#include <stdexcept>
#include "cpu.h"
#include "container_classes.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.

Namespaces

namespace  std

Data Structures

class  Singleton< T >
class  cloudy_exit
class  bad_signal
class  bad_assert
class  bad_mpi
class  t_debug
class  debugtrace< lgTrace >
class  auto_vec< T >
struct  auto_vec< T >::auto_vec_ref< U >
struct  t_emission
struct  t_species
struct  t_CollRatesArray
struct  t_CollSplinesArray
struct  t_collision
struct  t_quantumState
struct  t_transition

Defines

#define EXTERN   extern
#define STATIC   static
#define float   PLEASE_USE_REALNUM_NOT_FLOAT
#define cdEXIT(FAIL)   throw cloudy_exit( __func__, __FILE__, __LINE__, FAIL )
#define puts(STR)   Using_puts_before_cdEXIT_is_no_longer_needed
#define DEBUG
#define PARALLEL_MODE   false
#define MALLOC(exp)   (MyMalloc(exp,__FILE__, __LINE__))
#define CALLOC   MyCalloc
#define REALLOC   MyRealloc
#define ASSERT(exp)
#define isnan   MyIsnan
#define DEBUG_ENTRY(funcname)   debugtrace<false> DEBUG_ENTRY( funcname )
#define MIN2   min
#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   max
#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(X)   (pow2(X)*pow2(X))
#define HMRATE(a, b, c)   hmrate4(a,b,c,phycon.te)

Typedefs

typedef float realnum
typedef float sys_float
typedef t_transition transition
typedef t_quantumState quantumState
typedef t_emission emission
typedef t_collision collision
typedef t_species species
typedef t_CollRatesArray CollRateCoeffArray
typedef t_CollSplinesArray CollSplinesArray

Enumerations

enum  collider {
  ipELECTRON, ipPROTON, ipHE_PLUS, ipALPHA,
  ipNCOLLIDER
}
enum  split_mode { SPM_RELAX, SPM_KEEP_EMPTY, SPM_STRICT }

Functions

double fudge (long int ipnt)
void broken (void)
void fixit (void)
void CodeReview (void)
void TestCode (void)
void * MyMalloc (size_t size, const char *file, int line)
void * MyCalloc (size_t num, size_t size)
void * MyRealloc (void *p, size_t size)
void MyAssert (const char *file, int line)
NORETURN void cdExit (int iexit)
void ShowMe (void)
NORETURN void TotalInsanity (void)
NORETURN void BadRead (void)
NORETURN void BadOpen (void)
NORETURN void NoNumb (char *chCard)
int dbg_printf (int debug, const char *fmt,...)
int dprintf (FILE *fp, const char *format,...)
char * read_whole_line (char *chLine, int nChar, FILE *ioIN)
NORETURN void OUT_OF_RANGE (const char *str)
char 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)
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)
template<class T>
pow2 (T a)
template<class T>
pow3 (T a)
sys_float SDIV (sys_float x)
double SDIV (double x)
sys_float safe_div (sys_float x, sys_float y)
double safe_div (double x, double y)
double hmrate4 (double a, double b, double c, double te)
template<class T>
void invalidate_array (T *p, size_t size)
void invalidate_array (double *p, size_t size)
void invalidate_array (sys_float *p, size_t size)
 INSTANTIATE_MULTI_ARR (quantumState, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL)
 INSTANTIATE_MULTI_ARR (transition, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL)
void Split (const string &str, const string &sep, vector< string > &lst, split_mode mode)
bool FindAndReplace (string &str, const string &substr, const string &newstr)
bool FindAndErase (string &str, const string &substr)
double csphot (long int inu, long int ithr, long int iofset)
double RandGauss (double xMean, double s)
double MyGaussRand (double PctUncertainty)
double AnuUnit (realnum energy)
void cap4 (char *chCAP, char *chLab)
void uncaps (char *chCard)
void caps (char *chCard)
double e2 (double t)
double ee1 (double x)
double ee1_safe (double x)
double FFmtRead (const char *chCard, long int *ipnt, long int last, bool *lgEOL)
long nMatch (const char *chKey, const char *chCard)
long int GetElem (char *chCARD_CAPS)
int GetQuote (char *chLabel, char *chCard, bool lgABORT)
double powi (double, long int)
long int ipow (long, long)
void PrintE82 (FILE *, double)
void PrintE71 (FILE *, double)
void PrintE93 (FILE *, double)
char * PrintEfmt (const char *fmt, double val)
sys_float sexp (sys_float x)
double sexp (double x)
double dsexp (double x)
double plankf (long int ip)
double qg32 (double, double, double(*)(double))
void spsort (realnum x[], long int n, long int iperm[], int kflag, int *ier)
double vfun (double damp, double x)

Variables

EXTERN FILE * ioQQQ
EXTERN FILE * ioStdin
FILE * ioMAP
EXTERN FILE * ioPrnErr
EXTERN bool lgAbort
EXTERN bool lgTestCodeCalled
EXTERN bool lgTestCodeEnabled
EXTERN bool lgPrnErr
EXTERN long int nzone
EXTERN double fnzone
EXTERN long int iteration
EXTERN long int nSimThisCoreload
const double ZeroNum
const int FILENAME_PATH_LENGTH = 200
const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2
const int INPUT_LINE_LENGTH = 200
const int LIMELM = 30
const int NISO = 2
const int NHYDRO_MAX_LEVEL = 401
const int N_H_MOLEC = 8
const double DEPTH_OFFSET = 1.e-30
const int ipRecEsc = 2
const int ipRecNetEsc = 1
const int ipRecRad = 0
const int ipPRD = 1
const int ipCRD = -1
const int ipCRDW = 2
const int ipLY_A = -2
const int ipDEST_K2 = 1
const int ipDEST_INCOM = 2
const int ipDEST_SIMPL = 3
const int ipH1s = 0
const int ipH2s = 1
const int ipH2p = 2
const int ipH3s = 3
const int ipH3p = 4
const int ipH3d = 5
const int ipH4s = 6
const int ipH4p = 7
const int ipH4d = 8
const int ipH4f = 9
const int ipH5s = 10
const int ipH5p = 11
const int ipH5d = 12
const int ipH5f = 13
const int ipH5g = 14
const int ipH6s = 15
const int ipHe1s1S = 0
const int ipHe2s3S = 1
const int ipHe2s1S = 2
const int ipHe2p3P0 = 3
const int ipHe2p3P1 = 4
const int ipHe2p3P2 = 5
const int ipHe2p1P = 6
const int ipHe3s3S = 7
const int ipHe3s1S = 8
const int ipHe3p3P = 9
const int ipHe3d3D = 10
const int ipHe3d1D = 11
const int ipHe3p1P = 12
const int ipHe4s3S = 13
const int ipHe4s1S = 14
const int ipHe4p3P = 15
const int ipHe4d3D = 16
const int ipHe4d1D = 17
const int ipHe4f3F = 18
const int ipHe4f1F = 19
const int ipHe4p1P = 20
const int ipH_LIKE = 0
const int ipHE_LIKE = 1
const int ipLI_LIKE = 2
const int ipBE_LIKE = 3
const int ipB_LIKE = 4
const int ipC_LIKE = 5
const int ipN_LIKE = 6
const int ipO_LIKE = 7
const int ipF_LIKE = 8
const int ipHYDROGEN = 0
const int ipHELIUM = 1
const int ipLITHIUM = 2
const int ipBERYLLIUM = 3
const int ipBORON = 4
const int ipCARBON = 5
const int ipNITROGEN = 6
const int ipOXYGEN = 7
const int ipFLUORINE = 8
const int ipNEON = 9
const int ipSODIUM = 10
const int ipMAGNESIUM = 11
const int ipALUMINIUM = 12
const int ipSILICON = 13
const int ipPHOSPHORUS = 14
const int ipSULPHUR = 15
const int ipCHLORINE = 16
const int ipARGON = 17
const int ipPOTASSIUM = 18
const int ipCALCIUM = 19
const int ipSCANDIUM = 20
const int ipTITANIUM = 21
const int ipVANADIUM = 22
const int ipCHROMIUM = 23
const int ipMANGANESE = 24
const int ipIRON = 25
const int ipCOBALT = 26
const int ipNICKEL = 27
const int ipCOPPER = 28
const int ipZINC = 29
const double SEXP_LIMIT = 84.


Define Documentation

#define ASSERT ( exp   ) 

Value:

do { \
                                if (!(exp)) \
                                { \
                                        if( cpu.lgAssertAbort() ) \
                                                abort();          \
                                        else \
                                                throw bad_assert(__FILE__,__LINE__); \
                                } \
                        } while( 0 )
a cloudy version of the assert macro that can be recovered from

Definition at line 606 of file cddefines.h.

Referenced by abscf(), addComment(), addKeyword_num(), addKeyword_txt(), AddLine2Stack(), AddState2Stack(), AgeCheck(), flex_arr< float >::alloc(), multi_arr< float, 3 >::alloc(), AssertFeIIDep(), atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atmdat_Chianti_readin(), atmdat_lamda_readin(), atmol_popsolve(), atom_level2(), atom_level3(), atom_levelN(), atom_pop2(), atom_pop3(), AtomCSInterp(), t_fe2ovr_la::atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), bh(), bh_log(), bhg(), bhG(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), cdDLine(), cdEmis_ip(), cdH2_Line(), cdLine(), cdLine_ip(), cdSPEC2(), ChargTranSumHeat(), ChckFill(), Chianti_Upsilon(), chIonLbl(), chLineLbl(), CO_create_react(), CO_findrk(), CO_Init(), CO_update_species_cache(), collision_strength_VF01(), ColStrGBar(), conorm(), cont_gaunt_calc(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvRate2CS(), CoolAdd(), CoolEvaluate(), coolpr(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_PercivalRichards78(), CS_VS80(), da(), DebyeDeriv(), dftori(), DoBeckert_etal(), DoFSMixing(), DoSatelliteLines(), DoSutherland(), DumpLine(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaSaveLast(), DynaStartZone(), eden_sum(), ee1_safe(), EH2_eval(), emergent_line(), emit_frac(), esc_CRDcore(), esc_CRDwing(), esc_PRD(), esc_PRD_1side(), escmase(), F21(), F21_mx(), F21i(), F21i_log(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), FeII_OTS(), FeIICollRatesBoltzmann(), FeIIPun1Depart(), FeIIPunPop(), FeIISumBand(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), multi_geom< d, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL >::finalize(), FindIndex(), fndstr(), ForbiddenAuls(), fp_equal(), fp_equal_tol(), FreeFreeGaunt(), fsff(), GammaBn(), GammaBnPL(), GammaK(), GetFracPop(), GetGF(), GetModel(), GetProbDistr_LowLimit(), getrf_wrapper(), getrs_wrapper(), gett2(), gett2o3(), GrainCharge(), GrainDrift(), GrainElecEmis1(), GrainElecRecomb1(), GrainMakeDiffuse(), GrainScreen(), GrainsInit(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GridCompile(), GridGatherAfterCloudy(), gridXspec(), GrnStdDpth(), GrnVryDpth(), H2_Accel(), H2_CollidRateEvalAll(), H2_CollidRateRead(), H2_ContPoint(), H2_Create(), H2_Level_low_matrix(), H2_RadPress(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_RT_tau_inc(), H2_X_coll_rate_evaluate(), t_ADfA::h_coll_str(), H_cross_section(), H_photo_cs_lin(), H_photo_cs_log10(), t_ADfA::H_rad_rec(), HCTIon(), HCTRecom(), he_1trans(), He_cross_section(), HeCSInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), highen(), Hion_coll_ioniz_ratecoef(), hmole(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), hydro_transprob(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroCSInterp(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HydroRenorm(), HydroT2Low(), HyperfineCreate(), HyperfineCS(), Hypergeometric2F1(), init_eps(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitGridCoStar(), InitIndexArrays(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), flex_arr< float >::invalidate(), multi_arr< float, 3 >::invalidate(), ion_collis(), ion_photo(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonCSInterp(), IonIron(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipShells(), iso_allocate(), iso_cascade(), iso_collapsed_Aul_update(), iso_collapsed_bnl_set(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_continuum_lower(), iso_cool(), iso_create(), iso_dielec_recomb_rate(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_RRCoef_Te(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), IterEnd(), IterRestart(), L_mix_integrand_VF01(), LeidenCollRate(), lgCheckAsserts(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConvPres(), lgIonizConverg(), lgMolecAver(), lgValidModel(), linadd(), lindst(), LineConvRate2CS(), lines_general(), lines_hydro(), linint(), LinterpTable(), LinterpVector(), log10_fsff(), log10_prodxx(), log_integral(), MeanIonRadius(), MeanIonVolume(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_read_rfi(), mie_write_form(), mole_H2_LTE(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), Nemala_Start(), newelement(), NewGrainBin(), newreaction(), newspecies(), nMatch(), OccupationNumberLine(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), optimize_func(), outline(), ParseAssertResults(), ParseAtomISO(), ParseCosmicRays(), ParseCrashDo(), ParseFluc(), ParseGrid(), ParsePunch(), ParseTable(), PE_init(), t_ADfA::phfit(), PntForLine(), PressureRadiationLine(), PrtAllTau(), PrtComment(), PrtFinal(), PrtLinePres(), PrtMeanIon(), PrtZone(), punch_average(), punch_line(), punch_opacity(), PunchFilesInit(), punchFITS_EnergyHeader(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), PunchNewContinuum(), PunchSpecial(), PutCS(), PutHetCol(), PutLine(), qheat(), qheat_init(), radius_first(), radius_increment(), read_hm05(), ReadAugerData(), flex_arr< float >::realloc(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), RefIndex(), flex_arr< float >::reserve(), multi_geom< d, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL >::reserve(), resetBltin(), ReturnGrainBins(), rfield_opac_malloc(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_line_one(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_PrtRate(), RT_recom_effic(), RT_tau_init(), RTesc_lya(), S62_Therm_ave_coll_str(), ScanProbDistr(), scqdri(), search_limit(), SetLimits(), SetNChrgStates(), size_distr(), Spec_cont(), spline_cubic_set(), sprt_wl(), StarburstInitialize(), StarkCollTransProb_VF01(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), tbl_fun(), TempInterp(), TempInterp2(), TryDoubleStep(), uderiv(), ufunct(), UpdatePot(), UpdatePot1(), WavlenErrorGet(), writeCloudyDetails(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yfunc(), flex_arr< float >::zero(), multi_arr< float, 3 >::zero(), and ZoneStart().

#define CALLOC   MyCalloc

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

Definition at line 534 of file cddefines.h.

Referenced by CoolPunch(), F21(), F21_mx(), H_photo_cs_log10(), HeatPunch(), InitGridCoStar(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), and ParseTable().

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

Definition at line 451 of file cddefines.h.

Referenced by abund_starburst(), AbundancesTable(), AnuUnit(), atmdat_Chianti_readin(), atmdat_dielrec_fe(), atmdat_HS_caseB(), atmdat_lamda_readin(), atmdat_readin(), atmol_popsolve(), atom_level3(), atom_pop5(), AtomSeqBeryllium(), aver(), Badnell_rec_init(), BadOpen(), BadRead(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bhG(), bhG_mx(), C6cs123(), Ca20cs123(), cdClock(), cdDrive(), cdExecTime(), cdGetLineList(), cdRead(), cdSPEC(), CheckVal(), chi2_func(), ChkUnits(), cnewton(), CO_Colden(), CO_PopsEmisCool(), CO_zero(), conorm(), ContBandsCreate(), ConvEdenIoniz(), ConvFail(), ConvTempEdenIoniz(), CoolNitr(), coolpr(), CoStarInterpolate(), dense_fabden(), dense_tabden(), dgaunt(), do_dump_state(), do_restore_state(), Drive_cdLine(), DrvCaseBHS(), DrvHyas(), DynaPresChngFactor(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), factorial(), Fe26cs123(), Fe4Lev12(), FeII_Colden(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIILevelPops(), FeIIPunData(), ffun1(), fill(), FillGFF(), find_arr(), FindIndex(), fsff(), fudge(), gauss_legendre(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetQuote(), GetStandardHeLines(), GrainCharge(), GrainMakeDiffuse(), grid_do(), gridXspec(), H2_CollidRateEvalAll(), H2_CollidRateRead(), H2_He_coll_init(), H2_Level_low_matrix(), H2_ParsePunch(), H2_Punch_line_data(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), HeCollidSetup(), HelikeTransProbSetup(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), HydroEinstA(), HydroRecCool(), HyperfineCreate(), hypho(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateRectGrid(), inv_ufunct(), IonCarbo(), ipoint(), iso_update_num_levels(), lfactorial(), lgCheckAsserts(), lgConvPres(), ligbar(), LimitSh(), main(), MakeDeriv(), makelist(), makeplist(), mie_auxiliary(), mie_cs(), mie_cs_size_distr(), mie_next_line(), mie_read_double(), mie_read_long(), mie_read_mix(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_repair(), mie_write_opc(), molcol(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), Nemala_Start(), NewGrainBin(), newreact(), newspecies(), NoNumb(), oi_level_pops(), OpacityCreateReilMan(), open_data(), optimize_func(), optimize_phymir(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseState(), ParseStop(), ParseTable(), ParseTLaw(), pltr(), PntForLine(), PrtComment(), PrtElem(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punchFITS_SpectraData(), punchFITSfile(), PunchLineStuff(), PunResults1Line(), qintr(), t_ADfA::rad_rec(), RauchInitializeSub(), rd_continue(), read_continuum_mesh(), read_hm05(), ReadAugerData(), ReadTable(), RT_DestProb(), RT_line_one(), RT_line_static(), RT_recom_effic(), SanityCheck(), search_limit(), SetLimits(), size_distr(), solveions(), spline_cubic_set(), Split(), state_do(), StuffComment(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), TeBrent(), TempInterp(), TotalInsanity(), totlin(), uderiv(), ufunct(), XERBLA(), y0b01(), and Yfunc().

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

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

Definition at line 698 of file cddefines.h.

Referenced by abscf(), abund_starburst(), AbundancesPrt(), AbundancesSet(), AbundancesTable(), AbundancesZero(), addComment(), addentry(), addKeyword_num(), addKeyword_txt(), AddLine2Stack(), AddState2Stack(), advection_set_detault(), AgeCheck(), AGN_He1_CS(), AGN_Hemis(), AngerJ(), anomal(), AnuUnit(), AssertFeIIDep(), AtlasCompile(), AtlasInterpolate(), atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atmdat_3body(), atmdat_Chianti_readin(), atmdat_dielrec_fe(), atmdat_DielSupres(), atmdat_HS_caseB(), atmdat_lamda_readin(), atmdat_outer_shell(), atmdat_readin(), atmol_popsolve(), AtmospheresAvail(), atom_level2(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop2(), atom_pop3(), atom_pop5(), AtomCSInterp(), t_fe2ovr_la::atoms_fe2ovr(), AtomSeqBeryllium(), AtomSeqBoron(), aver(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), BadOpen(), badprt(), BadRead(), BadStart(), bangin(), bessel_i0(), bessel_i0_scaled(), bessel_i1(), bessel_i1_scaled(), bessel_j0(), bessel_j1(), bessel_jn(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), bh(), bh_log(), bhg(), bhG(), bhg_log(), bhG_mx(), bhGm(), bhGm_mx(), bhGp(), bhGp_mx(), bhintegrand(), bhintegrand_log(), bigk(), blkdata1(), broken(), Bruggeman(), C6cs123(), Ca20cs123(), calcc(), cap4(), caps(), caunin(), cdasum(), cdaxpy(), cdB21cm(), cdCautions(), cdClock(), cdClosePunchFiles(), cdColm(), cdcopy(), cdDepth_depth(), cdDLine(), cdDrive(), cdEmis(), cdEmis_ip(), cdErrors(), cdExecTime(), cdgamma(), cdGetLineList(), cdH2_Line(), cdInit(), cdInp(), cdIonFrac(), cdLine(), cdLine_ip(), cdLineListPunch(), cdNoExec(), cdNotes(), cdNwcns(), cdOutp(), cdPressure_depth(), cdPressure_last(), cdPrtWL(), cdRead(), cdReasonGeo(), cdSPEC(), cdSPEC2(), cdSurprises(), cdTalk(), cdTemp(), cdTimescales(), cdWarnings(), ChargTranEval(), ChargTranPun(), ChargTranSumHeat(), ChckFill(), CheckVal(), ChemImportance(), chi2_func(), Chianti_Upsilon(), chIonLbl(), chkCaHeps(), ChkUnits(), chLineLbl(), ClosePunchFiles(), cmshft(), cnewton(), CO_Colden(), CO_create_react(), CO_dissoc_rate(), CO_drive(), CO_findrate(), CO_findrate_s(), CO_findrk(), CO_Init(), co_lnu_c_o_lnu(), CO_OTS(), CO_PopsEmisCool(), CO_punch_mol(), CO_sink_rate(), CO_solve(), CO_source_rate(), CO_step(), CO_update_rks(), CO_update_species_cache(), CO_zero(), CodeReview(), t_ADfA::coll_ion(), collision_strength_VF01(), CollisionJunk(), CollisionZero(), ColStrGBar(), con_pump_op(), cone2(), conorm(), conpmp(), conrec(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContRate(), ContSetIntensity(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvIterCheck(), ConvPresTempEdenIoniz(), ConvRate2CS(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolChro(), CoolCoba(), CoolDima(), CoolEvaluate(), CoolFluo(), CoolHeatError(), CoolIron(), CoolMagn(), CoolMang(), CoolNeon(), CoolNick(), CoolNitr(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolPunch(), CoolScan(), CoolSili(), CoolSodi(), CoolSulf(), CoolSum(), CoolTita(), CoolVana(), CoolZero(), CoolZinc(), CoStarCompile(), CoStarInterpolate(), CoStarListModels(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_PercivalRichards78(), CS_ThermAve_PR78(), csphot(), csscal(), d3_np_fs(), da(), database_prep(), database_readin(), dbg_printf(), DebyeDeriv(), dense_fabden(), dense_tabden(), dftori(), dgaunt(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), dist(), DLASWP(), dmpary(), do_dump_state(), do_restore_state(), DoFSMixing(), DoSatelliteLines(), dprintf(), Drive_cdLine(), DrvCaseBHS(), DrvContPump(), DrvEscP(), DrvHyas(), DSCAL(), dsexp(), DSWAP(), DTRSM(), DumpLine(), DynaCreateArrays(), DynaEndIter(), DynaEndZone(), DynaFlux(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaPunch(), DynaPunchTimeDep(), DynaSaveLast(), DynaStartZone(), DynaZero(), e2(), eden_sum(), ee1(), ee1_safe(), eina(), ellpk(), emergent_line(), emislines_fillredis(), emit_frac(), EmLineJunk(), EmLineZero(), endFindLevLine(), esc_CRDcore(), esc_CRDwing(), esc_CRDwing_1side(), esc_PRD(), esc_PRD_1side(), esca0k2(), esccon(), escConE2(), escmase(), evalf(), exp1(), expn(), extend(), extin(), F21(), F21_mx(), F21i(), F21i_log(), factorial(), Fe11Lev5(), Fe13Lev5(), fe14cs(), Fe26cs123(), Fe2_cooling(), t_fe2ovr_la::fe2par(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), Fe_10_11_13_cs(), FeII_Colden(), FeII_LineZero(), FeII_OTS(), FeII_RT_Make(), FeII_RT_Out(), FeII_RT_tau_reset(), FeII_RT_TauInc(), FeIIAccel(), FeIIAddLines(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIICreate(), FeIIFillLow16(), FeIIIntenZero(), FeIILevelPops(), FeIILyaPump(), FeIIOvrLap(), FeIIPoint(), FeIIPrint(), FeIIPun1Depart(), FeIIPunchColden(), FeIIPunchLevels(), FeIIPunchLines(), FeIIPunchLineStuff(), FeIIPunchOpticalDepth(), FeIIPunData(), FeIIPunDepart(), FeIIPunPop(), FeIIRadPress(), FeIIReset(), FeIISumBand(), FeIIZero(), FFmtRead(), ffun(), ffun1(), fiddle(), fill(), FillExtraLymanLine(), FillGFF(), FillJ(), find_arr(), findelement(), FindHCoStar(), FindIndex(), FindNeg(), findspecies(), FindTempChangeFactor(), FindVCoStar(), fixit(), FndLineHt(), fndneg(), fndstr(), ForbiddenAuls(), FreeGrid(), freehash(), fsff(), fstats(), fudge(), GammaBn(), GammaBnPL(), GammaK(), GammaPrt(), GammaPrtRate(), GammaPrtShells(), gauss_init(), gauss_legendre(), gbar0(), gbar1(), getAtNo(), getbin(), GetElem(), GetFracPop(), GetGF(), GetLineRec(), GetMaxhLine(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), GetStandardHeLines(), gett2(), gett2o3(), GrainCharge(), GrainChargeTemp(), GrainChrgTransferRates(), GrainCollHeating(), GrainDrift(), GrainDrive(), GrainElecEmis1(), GrainElecRecomb1(), GrainIonColl(), GrainMakeDiffuse(), GrainRateDr(), GrainRestartIter(), GrainScreen(), GrainsInit(), GrainStartIter(), GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), GrainZero(), grid_do(), GridCompile(), GridGatherAfterCloudy(), GridGatherInCloudy(), GridInterpolate(), gridXspec(), grn_abs(), GrnStdDpth(), GrnVryDpth(), H2_Accel(), H2_Colden(), H2_CollidRateEvalAll(), H2_CollidRateEvalOne(), H2_CollidRateRead(), H2_ContPoint(), H2_Cooling(), H2_Create(), H2_gs_rates(), H2_He_coll(), H2_He_coll_init(), H2_Init(), H2_init_coreload(), H2_Level_low_matrix(), H2_LevelPops(), H2_LinesAdd(), H2_LineZero(), H2_ParsePunch(), H2_Prt_column_density(), H2_Prt_line_tau(), H2_Prt_Zone(), H2_Punch_line_data(), H2_PunchDo(), H2_PunchLineStuff(), H2_RadPress(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_Reset(), H2_RT_diffuse(), H2_RT_OTS(), H2_RT_tau_inc(), H2_RT_tau_reset(), H2_RTMake(), H2_Solomon_rate(), H2_X_coll_rate_evaluate(), H2_Zero(), H2_zero_pops_too_low(), 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(), hashfunction(), HCoolRatio(), HCSAR_interp(), HCTIon(), HCTRecom(), He2cs123(), he_1trans(), HeatPunch(), HeatSum(), HeatZero(), HeCollidSetup(), HeCSInterp(), helike_energy(), helike_quantum_defect(), helike_transprob(), HelikeTransProbSetup(), highen(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), hmiopc(), hmirat(), hmole(), hmole_init(), hmole_reactions(), hmole_step(), hmrate(), t_ADfA::hpfit(), hri(), hri_log10(), hrii(), hrii_log(), hv(), Hydcs123(), hydro_transprob(), hydro_vs_coll_str(), hydro_vs_deexcit(), hydro_vs_ioniz(), HydroCSInterp(), HydroEinstA(), HydroLevel(), HydroOscilStr(), HydroRecCool(), HydroRenorm(), HydroT2Low(), HyperfineCreate(), HyperfineCS(), hypho(), IDAMAX(), ILAENV(), init_eps(), t_fe2ovr_la::init_pointers(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitCoreloadPostparse(), InitDefaultsPreparse(), InitEmissivities(), InitEnthalpy(), initFindLevLine(), InitGrid(), InitGridCoStar(), InitIndexArrays(), InitSimPostparse(), input_init(), input_readarray(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_collis(), ion_photo(), ion_recom_calculate(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), ion_zero(), IonAlumi(), IonArgon(), IonBeryl(), IonBoron(), IonCalci(), IonCarbo(), IonChlor(), IonChrom(), IonCobal(), IonCoppe(), IonCSInterp(), IonFluor(), IonHelium(), IonIron(), IonLithi(), IonMagne(), IonManga(), IonNeon(), IonNicke(), IonNitro(), IonOxyge(), IonPhosi(), IonPotas(), IonScand(), IonSilic(), IonSodiu(), IonSulph(), IonTitan(), IonVanad(), IonZinc(), ipContEnergy(), ipFindLevLine(), ipFineCont(), ipLineEnergy(), ipoint(), ipow(), ipShells(), isactive(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_Aul_update(), iso_collapsed_bnl_print(), iso_collapsed_bnl_set(), iso_collapsed_lifetimes_update(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_dielec_recomb_rate(), iso_error_generation(), iso_get_total_num_levels(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_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_RRCoef_Te(), iso_satellite(), iso_satellite_update(), iso_solve(), iso_state_lifetime(), iso_suprathermal(), iso_update_num_levels(), iso_zero(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), JIndex(), Kurucz79Compile(), Kurucz79Interpolate(), L_mix_integrand_VF01(), lagrange(), LeidenCollRate(), lfactorial(), lgCheckAsserts(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConvPres(), lgConvTemp(), lgCoolHeatCheckConverge(), lgCoolNetConverge(), lgFileReadable(), lgInputComment(), lgIonizConverg(), lgMolecAver(), lgOptimize_do(), lgTauGood(), lgValidAsciiFile(), lgValidBinFile(), lgValidModel(), ligbar(), LimitSh(), linadd(), lindst(), LineConvRate2CS(), lines(), lines_continuum(), lines_general(), lines_grains(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_molecules(), lines_setup(), lines_table(), linfit(), linint(), LinterpTable(), LinterpVector(), log10_fsff(), log_integral(), lookup_key(), LSAME(), Magnetic_evaluate(), Magnetic_init(), Magnetic_reinit(), main(), MakeCS(), MakeDeriv(), MakeHCTData(), makelist(), makeplist(), map_do(), maxchain(), MeanInc(), MeanIonRadius(), MeanIonVolume(), MeanZero(), mie_auxiliary(), mie_calc_ial(), mie_cs(), mie_cs_size_distr(), mie_find_slope(), mie_integrate(), mie_next_data(), mie_next_line(), mie_read_double(), mie_read_form(), mie_read_long(), mie_read_mix(), mie_read_opc(), mie_read_realnum(), mie_read_rfi(), mie_read_szd(), mie_read_word(), mie_repair(), mie_write_form(), mie_write_opc(), MihalasCompile(), MihalasInterpolate(), molcol(), mole_H2_form(), mole_H2_LTE(), MyAssert(), MyCalloc(), MyGaussRand(), MyMalloc(), MyRealloc(), Ne10cs123(), Nemala_Start(), NewChargeData(), newelement(), NewGrainBin(), newhash(), newpt(), newreact(), newspecies(), nMatch(), noneq_offset(), NoNumb(), notein(), OccupationNumberLine(), ofit(), oi3Pcs(), oi_level_pops(), Opacity_iso_photo_cs(), opacity_more_memory(), OpacityAdd1Element(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), OpacityAddTotal(), OpacityCreate1Element(), OpacityCreateAll(), OpacityCreatePowerLaw(), OpacityCreateReilMan(), OpacityValenceRescale(), OpacityZero(), OpacityZeroOld(), open_data(), opfun(), optimize_func(), optimize_phymir(), optimize_subplex(), order(), outline(), outsum(), pah1_fun(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCaseB(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTrace(), partx(), PE_init(), t_ADfA::phfit(), phygrm(), pintr(), PlanckIntegral(), plankf(), plot(), pltcon(), pltmap(), pltopc(), pltr(), pnegopc(), PntForLine(), powi(), PressureChange(), PressureRadiationLine(), PresTotCurrent(), PrintE71(), PrintE82(), PrintE93(), PrintEfmt(), prme(), prt_constants(), prt_LineLabels(), prt_smooth_predictions(), prt_wl(), PrtAllTau(), PrtColumns(), PrtComment(), PrtContinuum(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLinePres(), PrtLineSum(), PrtMeanIon(), prtmet(), PrtZone(), ptrcer(), Punch1LineData(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punch_opacity(), PunchDo(), PunchFilesInit(), punchFITS_EnergyData(), punchFITS_EnergyHeader(), punchFITS_GenericData(), punchFITS_GenericHeader(), punchFITS_ParamData(), punchFITS_ParamHeader(), punchFITS_PrimaryHeader(), punchFITS_SpectraData(), punchFITS_SpectraHeader(), punchFITSfile(), PunchGaunts(), PunchLineData(), PunchLineStuff(), PunchSpecial(), PunFeII(), PunLineIntensity(), punResults(), PunResults1Line(), PutCS(), PutExtra(), PutHetCol(), PutLine(), qg32(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_first(), radius_increment(), radius_next(), RandGauss(), RauchCompile(), RauchInitializeSub(), RauchInterpolateHCa(), RauchInterpolateHelium(), RauchInterpolateHNi(), RauchInterpolateHpHe(), RauchInterpolateHydr(), RauchInterpolatePG1159(), rayleh(), rd_continue(), read_continuum_mesh(), read_hm05(), read_whole_line(), ReadAugerData(), ReadTable(), RebinAtmosphere(), RebinFind(), RebinQHeatResults(), RebinSingleCell(), t_ADfA::rec_lines(), RefIndex(), ReturnGrainBins(), rfield_opac_malloc(), ritoa(), ritodf(), RT_continuum_shield_fcn(), RT_DestHummer(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_AddCont(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_OTS_Update(), RT_OTS_Zero(), RT_recom_effic(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), RTesc_lya_1side(), S2cs(), S62_Therm_ave_coll_str(), SanityCheck(), SanityCheckBegin(), ScanProbDistr(), scqdri(), search_limit(), SearchModel(), SetLimits(), SetLimitsSub(), SetNChrgStates(), setstp(), sexp(), ShowMe(), simplx(), sinpar(), size_distr(), solveions(), sortd(), Spec_cont(), spldrv_safe(), spline_cubic_set(), spline_cubic_val(), splint_safe(), Split(), sprt_wl(), spsort(), StarburstCompile(), StarburstInitialize(), StarkCollTransProb_VF01(), start(), state_do(), state_get_put(), StateJunk(), states_nelemfill(), states_popfill(), states_propprint(), StateZero(), Stognienko(), StuffComment(), subopt(), sumcon(), t_ADfA::t_ADfA(), t_cpu::t_cpu(), t_fe2ovr_la::t_fe2ovr_la(), t_fe2ovr_la::tau_inc(), tauff(), tbl_fun(), TeBrent(), TempChange(), TempInterp(), TempInterp2(), TestCode(), TexcLine(), tfidle(), th85rate(), Therm_ave_coll_str_int_PR78(), Therm_ave_coll_str_int_VF01(), ThetaNu(), timestep_next(), TlustyCompile(), TlustyInterpolate(), TotalInsanity(), totlin(), TransitionJunk(), TransitionZero(), TryDoubleStep(), uderiv(), ufunct(), uncaps(), UpdatePot(), UpdatePot1(), UpdatePot2(), UpdateRecomZ0(), ValidateGrid(), vary_input(), velset(), vib_evap(), warnin(), WavlenErrorGet(), wcnint(), WernerCompile(), WernerInterpolate(), WMBASICCompile(), WMBASICInterpolate(), wr_continue(), XERBLA(), xinvrs(), xmap(), y0b(), y0b01(), y0psa(), y1psa(), y2pa(), y2s(), Yan_H2_CS(), Yfunc(), zero(), t_fe2ovr_la::zero_opacity(), ZeroContin(), ZoneEnd(), and ZoneStart().

#define EXTERN   extern

define EXTERN as nothing before including cddefines.h to allocate global data

Definition at line 56 of file cddefines.h.

#define float   PLEASE_USE_REALNUM_NOT_FLOAT

Definition at line 74 of file cddefines.h.

#define HMRATE ( a,
b,
 )     hmrate4(a,b,c,phycon.te)

Definition at line 935 of file cddefines.h.

Referenced by IonCarbo().

#define isnan   MyIsnan

Definition at line 633 of file cddefines.h.

Referenced by atmdat_Chianti_readin(), atmdat_lamda_readin(), CO_findrk(), CO_update_species_cache(), fp_equal(), fp_equal_tol(), IterRestart(), LeidenCollRate(), ParseCrashDo(), and safe_div().

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

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

Definition at line 525 of file cddefines.h.

Referenced by addentry(), AGN_Hemis(), atmdat_Chianti_readin(), atmdat_lamda_readin(), atmdat_readin(), atmol_popsolve(), AtomSeqBoron(), cdGetLineList(), cdSPEC(), cdSPEC2(), Chianti_Upsilon(), CO_Colden(), CO_create_react(), CO_Init(), CO_PopsEmisCool(), CO_zero(), ContBandsCreate(), ConvEdenIoniz(), CoolIron(), CoolNitr(), CoolSili(), CoolSulf(), database_readin(), DebyeDeriv(), DynaCreateArrays(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), Fe7Lev8(), FeIIBandsCreate(), FeIIContCreate(), FeIICreate(), FillGFF(), gauss_legendre(), GetStandardHeLines(), GrainDrift(), GrainMakeDiffuse(), GrainsInit(), GridGatherInCloudy(), gridXspec(), H2_He_coll_init(), H2_Level_low_matrix(), HelikeTransProbSetup(), hmole_step(), HyperfineCreate(), hypho(), initFindLevLine(), InitGrid(), InterpolateGridCoStar(), InterpolateModelCoStar(), InterpolateRectGrid(), ion_solver(), iso_cascade(), iso_recomb_malloc(), iso_solve(), IterStart(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lines_helium(), main(), MeanZero(), mie_calc_ial(), mie_integrate(), mie_read_mix(), mie_read_rfi(), mie_read_szd(), mie_write_opc(), Nemala_Start(), newelement(), NewGrainBin(), newhash(), newreact(), newreaction(), newspecies(), OpacityCreateAll(), ParseAssertResults(), ParseCrashDo(), ParseDynaTime(), ParseInterp(), ParsePunch(), pltcon(), pltopc(), PressureChange(), PrtLineSum(), punch_average(), punchFITS_GenericData(), PunchNewContinuum(), qheat(), qheat_init(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), ReadAugerData(), RebinAtmosphere(), RebinQHeatResults(), rfield_opac_malloc(), RT_diffuse(), RT_OTS_Update(), sinpar(), spline_cubic_set(), StarburstInitialize(), ValidateGrid(), and zero().

#define MAX2   max

MAX2 takes two arguments, returns the larger of the two

Definition at line 744 of file cddefines.h.

Referenced by abund_starburst(), AgeCheck(), AssertFeIIDep(), atmdat_Chianti_readin(), atmdat_DielSupres(), atmdat_lamda_readin(), atmdat_readin(), atom_level3(), atom_pop5(), t_fe2ovr_la::atoms_fe2ovr(), Badnell_rec_init(), badprt(), bhintegrand_log(), C6cs123(), Ca20cs123(), cdColm(), cdTimescales(), ChargTranSumHeat(), chkCaHeps(), collision_strength_VF01(), ColStrGBar(), ContRate(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolAdd(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolIron(), CoolMagn(), CoolNick(), CoolOxyg(), CoolPota(), CoolPunch(), CoolSili(), CoolSodi(), CoolSulf(), CoStarListModels(), cross_section(), da(), DebyeDeriv(), DGEMM(), DGER(), DGETF2(), DGETRF(), DGETRS(), DoBeckert_etal(), DoSutherland(), DrvCaseBHS(), DTRSM(), DynaPresChngFactor(), DynaStartZone(), F2_1(), fe14cs(), Fe26cs123(), Fe2_cooling(), Fe7Lev8(), Fe_10_11_13_cs(), FeIICollRatesBoltzmann(), FeIILyaPump(), ffun1(), find_arr(), fstats(), GammaBn(), GammaBnPL(), GammaK(), GetModel(), GetPotValues(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainCharge(), GrainChrgTransferRates(), GrainCollHeating(), GrainElecRecomb1(), GrainRateDr(), H21_cm_pops(), h21_t_lt_10(), H21cm_proton(), H2_CollidRateEvalAll(), H2_CollidRateEvalOne(), H2_gs_rates(), H2_RT_tau_inc(), H_cross_section(), H_photo_cs_log10(), HCTIon(), HCTRecom(), he_1trans(), HeCSInterp(), helike_radrecomb_from_cross_section(), HighestIonStage(), Hion_coll_ioniz_ratecoef(), hlike_radrecomb_from_cross_section(), hmole_reactions(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), Hydcs123(), hydro_vs_coll_str(), HydroEinstA(), HydroLevel(), HydroT2Low(), Hypergeometric2F1(), hypho(), ion_photo(), ion_recomb(), IonIron(), IonMagne(), IonOxyge(), iso_allocate(), iso_collapsed_bnl_set(), iso_recomb_check(), iso_recomb_malloc(), iso_satellite_update(), iso_update_num_levels(), lgCheckAsserts(), lgCoolHeatCheckConverge(), lgIonizConverg(), lindst(), lines_continuum(), lines_grains(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_molecules(), MeanIonRadius(), MeanIonVolume(), MeanZero(), mie_cs(), mie_find_slope(), mie_integrate(), mie_read_mix(), mie_repair(), mie_write_opc(), molcol(), Ne10cs123(), Opacity_iso_photo_cs(), OpacityAdd1Element(), OpacityAdd1SubshellInduc(), OpacityCreate1Element(), optimize_func(), optimize_phymir(), pah1_fun(), ParseAtomISO(), ParseGrid(), ParsePrint(), ParsePunch(), ParseRangeOption(), ParseStop(), ParseTrace(), pltcon(), pltmap(), pltopc(), pltr(), PressureChange(), PrtAllTau(), PrtColumns(), PrtHeader(), punch_colden(), punch_line(), punch_opacity(), PunchDo(), PunchNewContinuum(), qheat(), qheat_init(), qintr(), radius_next(), rayleh(), RebinQHeatResults(), RT_diffuse(), RT_line_one(), RT_line_one_tau_reset(), RT_line_static(), RT_LineWidth(), RT_OTS(), RT_OTS_Update(), RT_recom_effic(), RTesc_lya(), RTesc_lya_1side(), S2cs(), ScanProbDistr(), search_limit(), SetLimits(), setstp(), sinpar(), spldrv_safe(), splint_safe(), tauff(), timestep_next(), TryDoubleStep(), uderiv(), vary_input(), xNI_coll_stren(), y0b01(), 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 749 of file cddefines.h.

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

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

MAX2 takes 4 arguments, returns the largest of the 4

Definition at line 754 of file cddefines.h.

Referenced by iso_collapsed_bnl_set(), and sinpar().

#define MIN2   min

MIN2 takes two arguments, returns the smaller of the two

Definition at line 723 of file cddefines.h.

Referenced by abund_starburst(), AgeCheck(), atmdat_3body(), atmdat_DielSupres(), C6cs123(), Ca20cs123(), ChargTranSumHeat(), chi2_func(), ContRate(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolAlum(), CoolArgo(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolFluo(), CoolMagn(), CoolNick(), CoolOxyg(), CoolPhos(), CoolPota(), coolpr(), CoolSili(), CoolSodi(), CoolSulf(), CS_l_mixing_PS64(), da(), dense_fabden(), DGETF2(), DGETRF(), DoBeckert_etal(), DoSutherland(), esc_CRDcore(), esc_CRDwing(), esc_PRD_1side(), fe14cs(), Fe26cs123(), Fe_10_11_13_cs(), FeIIPunData(), ffun1(), FillJ(), find_arr(), fstats(), GammaBn(), GammaBnPL(), GammaK(), GammaPrt(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GrainScreen(), GrainTemperature(), h21_t_ge_10(), H21cm_electron(), H21cm_proton(), H2_He_coll(), H2_RT_tau_inc(), HCTIon(), HCTRecom(), helike_radrecomb_from_cross_section(), Hion_coll_ioniz_ratecoef(), hlike_radrecomb_from_cross_section(), Hydcs123(), HydroEinstA(), Hypergeometric2F1(), hypho(), ILAENV(), ion_collis(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), IonIron(), IonOxyge(), ipLineEnergy(), ipoint(), iso_collapsed_bnl_set(), iso_continuum_lower(), lgCheckAsserts(), mie_auxiliary(), mie_integrate(), mie_read_mix(), mie_read_rfi(), mie_write_opc(), Ne10cs123(), oi3Pcs(), OpacityAdd1Subshell(), OpacityAdd1SubshellInduc(), optimize_func(), pah1_fun(), ParseBlackbody(), ParseCosmicRays(), ParseRangeOption(), ParseSet(), ParseStop(), partx(), PlanckIntegral(), pltcon(), pltmap(), pltopc(), pltr(), PressureChange(), PressureRadiationLine(), prt_smooth_predictions(), PrtLinePres(), PrtMeanIon(), PunchNewContinuum(), qheat(), qheat_init(), qintr(), radius_first(), radius_next(), RebinQHeatResults(), RebinSingleCell(), RT_continuum_shield_fcn(), RT_DestProb(), RT_line_one(), RT_line_one_tau_reset(), RT_line_one_tauinc(), RT_line_static(), RT_LineWidth(), RT_recom_effic(), RTesc_lya(), RTesc_lya_1side(), S2cs(), SetLimits(), setstp(), simplx(), spldrv_safe(), splint_safe(), subopt(), sumcon(), TeBrent(), timestep_next(), uderiv(), vary_input(), writeCloudyDetails(), xinvrs(), xNI_coll_stren(), and ZoneStart().

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

MIN3 takes 3 arguments, returns the smallest of the 3

Definition at line 728 of file cddefines.h.

Referenced by iso_continuum_lower(), pltmap(), and RT_line_static().

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

MIN2 takes 4 arguments, returns the smallest of the 4

Definition at line 733 of file cddefines.h.

Referenced by iso_collapsed_bnl_set(), and radius_first().

#define PARALLEL_MODE   false

as the code is developed this should become part of the design for future true parallel processing. This flag should be false if it is not necessary for a given instance of a routine to keep separate memory. This is the case in a serial machine, or an MPI run where there are n instances of the code running on n processors. This should be true if an instance of a routine must have its own unique memory, so that other instances of the routine, which may be running in parallel on another processor, does not share the same memory.

Definition at line 515 of file cddefines.h.

Referenced by ion_solver().

#define POW2   pow2

POW2 takes 1 argument, and squares it

Definition at line 840 of file cddefines.h.

Referenced by abund_starburst(), anomal(), AssertFeIIDep(), Bruggeman(), chi2_func(), cnewton(), collision_strength_VF01(), ColStrGBar(), CoolAlum(), CoolEvaluate(), CoolMagn(), cross_section(), CS_l_mixing_PS64(), CS_l_mixing_S62(), CS_PercivalRichards78(), DebyeDeriv(), dense_fabden(), dist(), DoFSMixing(), DoSutherland(), DrvCaseBHS(), DynaIonize(), DynaNewStep(), DynaPrtZone(), eina(), FeIICollRatesBoltzmann(), FillExtraLymanLine(), FreeFreeGaunt(), fstats(), GammaBnPL(), gauss_legendre(), gbar0(), gbar1(), GetGF(), GetProbDistr_HighLimit(), gett2(), gett2o3(), GrainDrift(), GrainMakeDiffuse(), GrainScreen(), H2_CollidRateEvalAll(), H2_CollidRateEvalOne(), H2_vib_dist(), t_ADfA::H_rad_rec(), helike_energy(), helike_transprob(), hmole_reactions(), t_ADfA::hpfit(), t_ADfA::hpfit_rel(), hydro_vs_coll_str(), HydroEinstA(), HydroOscilStr(), HydroRecCool(), hypho(), InitSimPostparse(), IonCSInterp(), iso_cool(), iso_create(), iso_state_lifetime(), lgCheckAsserts(), lgCompileAtmosphere(), lgConvPres(), lines_lv1_li_ne(), Magnetic_evaluate(), mie_auxiliary(), mie_cs(), mie_find_slope(), mie_integrate(), mie_read_szd(), ofit(), oi3Pcs(), pah1_fun(), t_ADfA::phfit(), phygrm(), PlanckIntegral(), plankf(), qheat(), radius_first(), rayleh(), RT_continuum_shield_fcn(), RT_DestProb(), RT_line_one(), RTesc_lya_1side(), S62_Therm_ave_coll_str(), sinpar(), size_distr(), StarkCollTransProb_VF01(), Stognienko(), tfidle(), ThetaNu(), uderiv(), UpdatePot2(), velset(), y0b01(), and ZoneStart().

#define POW3   pow3

POW3 takes 1 argument, and cubes it

Definition at line 847 of file cddefines.h.

Referenced by abund_starburst(), collision_strength_VF01(), cross_section(), CS_PercivalRichards78(), DebyeDeriv(), FeIICollRatesBoltzmann(), ffun1(), GetProbDistr_LowLimit(), GrainDrift(), hydro_vs_coll_str(), hydro_vs_deexcit(), HydroOscilStr(), HydroRecCool(), mie_auxiliary(), mie_integrate(), pah1_fun(), ParseAtomISO(), punch_opacity(), RebinAtmosphere(), sinpar(), and y0b01().

#define POW4 (  )     (pow2(X)*pow2(X))

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

Definition at line 854 of file cddefines.h.

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

#define puts ( STR   )     Using_puts_before_cdEXIT_is_no_longer_needed

Definition at line 454 of file cddefines.h.

#define REALLOC   MyRealloc

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

Definition at line 543 of file cddefines.h.

Referenced by ConvEdenIoniz(), extend(), opacity_more_memory(), PressureChange(), and StarburstInitialize().

#define STATIC   static

Definition at line 63 of file cddefines.h.


Typedef Documentation

typedef struct t_collision collision

Definition at line 1091 of file cddefines.h.

typedef struct t_CollRatesArray CollRateCoeffArray

typedef struct t_CollSplinesArray CollSplinesArray

typedef struct t_emission emission

Definition at line 1090 of file cddefines.h.

typedef struct t_quantumState quantumState

Definition at line 1089 of file cddefines.h.

typedef float realnum

Definition at line 69 of file cddefines.h.

typedef struct t_species species

Definition at line 1092 of file cddefines.h.

typedef float sys_float

Definition at line 72 of file cddefines.h.

typedef struct t_transition transition

Definition at line 1088 of file cddefines.h.


Enumeration Type Documentation

enum collider

Enumerator:
ipELECTRON 
ipPROTON 
ipHE_PLUS 
ipALPHA 
ipNCOLLIDER 

Definition at line 218 of file cddefines.h.

enum split_mode

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

Enumerator:
SPM_RELAX 
SPM_KEEP_EMPTY 
SPM_STRICT 

Definition at line 1359 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 168 of file service.cpp.

References cdEXIT, t_punch::chConPunEnr, DEBUG_ENTRY, EVRYD, ioQQQ, t_punch::ipConPun, punch, RYD_INF, RYDLAM, and SPEEDLIGHT.

Referenced by AGN_Hemis(), pun1Line(), punch_opacity(), and PunchNewContinuum().

NORETURN void BadOpen ( void   ) 

BadOpen tried to open data files and failed

Definition at line 990 of file service.cpp.

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

Referenced by main().

Here is the call graph for this function:

NORETURN void BadRead ( void   ) 

BadRead tried to read internal data and failed

Definition at line 976 of file service.cpp.

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

Referenced by H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), 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 1086 of file service.cpp.

References broke, DEBUG_ENTRY, and t_broke::lgBroke.

Referenced by ion_solver(), and IonNitro().

void cap4 ( char *  chCAP,
char *  chLab 
)

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

Parameters:
chCAP output string, cap'd first 4 char of chLab,
chLab with null terminating input string ending with eol

Definition at line 289 of file service.cpp.

References DEBUG_ENTRY.

Referenced by cdDLine(), cdEmis(), cdLine(), GetOptColDen(), lgCheckAsserts(), optimize_func(), ParseDLaw(), ParseInterp(), ParseNorm(), ParseTLaw(), and PrtFinal().

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

References DEBUG_ENTRY.

Referenced by cdColm(), cdEmis(), cdIonFrac(), cdRead(), cdTemp(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), input_readarray(), Nemala_Start(), ParseAbundances(), ParseDynaTime(), ParseElement(), ParseInterp(), PrtFinal(), PrtLineSum(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), and punResults().

NORETURN void cdExit ( int  iexit  ) 

the Cloudy exit handler

Parameters:
iexit,EXIT_FAILURE for failure, EXIT_SUCCESS for success

Definition at line 243 of file cdinit.cpp.

References ClosePunchFiles(), ioQQQ, and lgMPI.

Referenced by main().

Here is the call graph for this function:

void CodeReview ( void   ) 

CodeReview - placed next to code that needs to be checked

Definition at line 1105 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:
inu INU is array index pointing to frequency where opacity is to be evaluated on f not c scale
ithr ITHR is pointer to threshold
iofset IOFSET is offset as defined in opac0

Definition at line 1725 of file service.cpp.

References DEBUG_ENTRY, opac, and t_opac::OpacStack.

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 1136 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 1114 of file service.cpp.

References DEBUG_ENTRY.

Referenced by qheat_init().

double dsexp ( double  x  ) 

dsexp safe exponential function for doubles

Parameters:
x 

Definition at line 1056 of file service.cpp.

References DEBUG_ENTRY.

Referenced by Hion_coll_ioniz_ratecoef(), iso_collide(), and iso_satellite_update().

double e2 ( double  t  ) 

e2 second exponential integral

Parameters:
t optical depth argument

Definition at line 348 of file service.cpp.

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

Referenced by DrvCaseBHS(), MakeHCTData(), and ParseDrive().

Here is the call graph for this function:

double ee1 ( double  x  ) 

ee1 first exponential integral

Parameters:
x optical depth argument, returns e1(tau)

Definition at line 361 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, and ioQQQ.

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

double ee1_safe ( double  x  ) 

this one same as ee1, except is divided by a factor of exp(x), and is only to be used for x>1.

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

Definition at line 405 of file service.cpp.

References ASSERT, and DEBUG_ENTRY.

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

FFmtRead - the free-format number reader

Parameters:
*chCard string giving the line image
*ipnt the index for the character in the string where we shall start
last the number of characters in the string - do not search beyond it
*lgEOL true if hit end of line with no number

Definition at line 430 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and min().

Referenced by abund_starburst(), atmdat_Chianti_readin(), atmdat_lamda_readin(), Badnell_rec_init(), cdGetLineList(), ContBandsCreate(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetStandardHeLines(), H2_ParsePunch(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCollidSetup(), HelikeTransProbSetup(), HyperfineCreate(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCaseB(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseStop(), ParseTable(), ParseTLaw(), ParseTrace(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), read_continuum_mesh(), and read_hm05().

Here is the call graph for this function:

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

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

Definition at line 1381 of file cddefines.h.

References FindAndReplace().

Here is the call graph for this function:

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

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

Definition at line 1369 of file cddefines.h.

Referenced by FindAndErase().

void fixit ( void   ) 

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

Definition at line 1096 of file service.cpp.

References broke, DEBUG_ENTRY, and t_broke::lgFixit.

Referenced by atmdat_Chianti_readin(), atmol_popsolve(), ForbiddenAuls(), grn_abs(), HydroLevel(), IonCSInterp(), iso_collide(), iso_ionize_recombine(), iso_satellite(), iso_zero(), lines_hydro(), newreact(), ParsePunch(), punchFITS_PrimaryHeader(), RT_line_static(), and states_nelemfill().

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

Definition at line 797 of file cddefines.h.

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

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

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

Referenced by abund_starburst(), atom_level3(), ConvBase(), ConvInitSolution(), Fe2_cooling(), FeIICollRatesBoltzmann(), GrainDrive(), H2_X_coll_rate_evaluate(), hmole_reactions(), Hydcs123(), HyperfineCS(), iso_collide(), lgTauGood(), mole_H2_LTE(), optimize_subplex(), RT_DestProb(), state_do(), TeBrent(), and tfidle().

Here is the call graph for this function:

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

Definition at line 827 of file cddefines.h.

References ASSERT, isnan, and max().

Here is the call graph for this function:

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

Definition at line 816 of file cddefines.h.

References ASSERT, isnan, and max().

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:
ipnt integer saying which of the possible numbers on the fudge command to use - 0 would be the first

Definition at line 530 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, t_fudgec::fudgea, fudgec, ioQQQ, t_fudgec::lgFudgeUsed, and t_fudgec::nfudge.

Referenced by Fe7Lev8(), and InitEmissivities().

long int GetElem ( char *  chCARD_CAPS  ) 

GetElem scans line image, finds element. returns atomic number j, on C scale. Returns , -1 if no hit. chCARD_CAPS must have been converted to all CAPS by caps() to work

Parameters:
chCARD_CAPS 

Definition at line 558 of file service.cpp.

References t_elementnames::chElementNameShort, DEBUG_ENTRY, elementnames, LIMELM, and nMatch().

Referenced by ParseAssertResults(), ParseAtomISO(), ParsePrint(), ParsePunch(), ParseSet(), ParseTrace(), and punch_average().

Here is the call graph for this function:

int GetQuote ( char *  chLabel,
char *  chCard,
bool  lgABORT 
)

GetQuote get any name between double quotes off command line return string as chLabel, is null terminated returns zero for success, 1 for did not find double quotes

Parameters:
*chLabel we will generate a label and stuff it here
*chCard local cap'd line, we will blank this out
lgABORT if true then abort if no double quotes found, if false then return null string in this case

Definition at line 584 of file service.cpp.

References cdEXIT, t_input::chOrgCard, DEBUG_ENTRY, input, and ioQQQ.

Referenced by ParseAssertResults(), ParseCompile(), ParseGrain(), ParseInit(), ParseNorm(), ParseOptimize(), ParsePunch(), ParseSet(), ParseState(), ParseStop(), and ParseTable().

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

Definition at line 937 of file cddefines.h.

INSTANTIATE_MULTI_ARR ( transition  ,
MEM_LAYOUT_VAL  ,
lgBOUNDSCHECKVAL   
)

INSTANTIATE_MULTI_ARR ( quantumState  ,
MEM_LAYOUT_VAL  ,
lgBOUNDSCHECKVAL   
)

void invalidate_array ( sys_float p,
size_t  size 
) [inline]

Definition at line 960 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

void invalidate_array ( double *  p,
size_t  size 
) [inline]

Definition at line 955 of file cddefines.h.

References set_NaN().

Here is the call graph for this function:

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

Definition at line 950 of file cddefines.h.

Referenced by flex_arr< float >::invalidate(), and multi_arr< float, 3 >::invalidate().

long int ipow ( long  ,
long   
)

ipow

Returns:
m^n

Definition at line 718 of file service.cpp.

References DEBUG_ENTRY, and is_odd().

Here is the call graph for this function:

bool is_odd ( long  j  )  [inline]

Definition at line 708 of file cddefines.h.

bool is_odd ( int  j  )  [inline]

checks whether argument is odd

Definition at line 707 of file cddefines.h.

Referenced by expn(), fsff(), ipow(), ParsePunch(), and powi().

double max ( double  a,
sys_float  b 
) [inline]

Definition at line 740 of file cddefines.h.

double max ( sys_float  a,
double  b 
) [inline]

Definition at line 739 of file cddefines.h.

long max ( long  a,
int  b 
) [inline]

Definition at line 738 of file cddefines.h.

long max ( int  a,
long  b 
) [inline]

Definition at line 737 of file cddefines.h.

Referenced by flex_arr< float >::alloc(), e2(), fp_equal(), fp_equal_tol(), GrnStdDpth(), InitBinAugerData(), iso_satellite_update(), maxchain(), flex_arr< float >::realloc(), multi_geom< d, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL >::reserve(), flex_arr< float >::size(), TempInterp(), TempInterp2(), UpdatePot1(), and Yfunc().

double min ( double  a,
sys_float  b 
) [inline]

Definition at line 719 of file cddefines.h.

double min ( sys_float  a,
double  b 
) [inline]

Definition at line 718 of file cddefines.h.

long min ( long  a,
int  b 
) [inline]

Definition at line 717 of file cddefines.h.

long min ( int  a,
long  b 
) [inline]

Definition at line 716 of file cddefines.h.

Referenced by FFmtRead(), fp_equal(), TempInterp(), TempInterp2(), UpdatePot1(), and Yfunc().

void MyAssert ( const char *  file,
int  line 
)

MyAssert a version of assert that fails gracefully

Parameters:
*file 
line 

Definition at line 149 of file service.cpp.

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

Referenced by main().

Here is the call graph for this function:

void* MyCalloc ( size_t  num,
size_t  size 
)

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

Parameters:
num use same type as library function CALLOC
size 

Definition at line 1652 of file service.cpp.

References ASSERT, cdEXIT, DEBUG_ENTRY, and ioQQQ.

double MyGaussRand ( double  PctUncertainty  ) 

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

Parameters:
PctUncertainty 

Definition at line 1806 of file service.cpp.

References ASSERT, DEBUG_ENTRY, and RandGauss().

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:
size use same type as library function malloc
file 
line 

Definition at line 1571 of file service.cpp.

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

Here is the call graph for this function:

void* MyRealloc ( void *  p,
size_t  size 
)

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

Parameters:
num use same type as library function REALLOC
size 

Definition at line 1690 of file service.cpp.

References ASSERT, cdEXIT, DEBUG_ENTRY, and ioQQQ.

long nint ( double  x  )  [inline]

nint rounds to the nearest long int

Definition at line 712 of file cddefines.h.

Referenced by GrainCharge(), InitEmissivities(), mie_write_form(), ParseSet(), t_ADfA::phfit(), sinpar(), and size_distr().

long nMatch ( const char *  chKey,
const char *  chCard 
)

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

Parameters:
*chKey 
*chCard 

Definition at line 500 of file service.cpp.

References ASSERT, and DEBUG_ENTRY.

Referenced by abund_starburst(), Badnell_rec_init(), cdRead(), ChkUnits(), GetElem(), GetOptTemp(), H2_ParsePunch(), mie_read_mix(), mie_read_rfi(), mie_read_szd(), Nemala_Start(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCaseB(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInit(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTrace(), PrtFinal(), punch_average(), Punch_Line_RT(), and punResults().

NORETURN void NoNumb ( char *  chCard  ) 

NoNumb general error handler for no numbers on input line

Parameters:
*chCard 

Definition at line 1004 of file service.cpp.

References cdEXIT, DEBUG_ENTRY, and ioQQQ.

Referenced by ParseAssertResults(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseConstant(), ParseCosmicRays(), ParseDynaTime(), ParseDynaWind(), ParseExtinguish(), ParseF_nu(), ParseIonPar(), ParseMagnet(), ParseNorm(), ParsePrint(), ParsePunch(), ParseSet(), ParseStop(), punch_average(), and punch_colden().

NORETURN void OUT_OF_RANGE ( const char *  str  )  [inline]

Definition at line 621 of file cddefines.h.

References cpu, and t_cpu::lgAssertAbort().

Referenced by flex_arr< float >::at(), multi_arr< float, 3 >::at(), const_n_pointer< T, 1, C_TYPE, true >::operator[](), const_n_pointer< T, 1, ARPA_TYPE, true >::operator[](), const_n_pointer< T, N, C_TYPE, true >::operator[](), const_n_pointer< T, N, ARPA_TYPE, true >::operator[](), n_pointer< T, 1, C_TYPE, true >::operator[](), n_pointer< T, 1, ARPA_TYPE, true >::operator[](), n_pointer< T, N, C_TYPE, true >::operator[](), n_pointer< T, N, ARPA_TYPE, true >::operator[](), flex_arr< float >::p_index(), basic_pntr< T, d, ALLOC, lgBC >::p_index_checked(), and multi_arr< float, 3 >::p_iterator_bc().

Here is the call graph for this function:

double plankf ( long int  ip  ) 

plankf evaluate Planck function for any cell at current electron temperature

Parameters:
ip 

Definition at line 1831 of file service.cpp.

References t_rfield::anu, t_rfield::ContBoltz, DEBUG_ENTRY, FR1RYD, POW2, and rfield.

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

Definition at line 842 of file cddefines.h.

Referenced by ASINH(), C6cs123(), Ca20cs123(), Fe26cs123(), hrii(), Hydcs123(), linfit(), log10_prodxx(), Ne10cs123(), and y1psa().

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

Definition at line 849 of file cddefines.h.

Referenced by elec_esc_length(), H_Einstein_A_lin(), H_Einstein_A_log10(), y1psa(), and y2pa().

double powi ( double  ,
long  int 
)

powi raise x to integer power

Definition at line 683 of file service.cpp.

References DEBUG_ENTRY, and is_odd().

Referenced by add_mx(), atmdat_DielSupres(), bhg(), bhG(), DebyeDeriv(), expn(), F21i_log(), FeIILyaPump(), fsff(), GrainCharge(), t_ADfA::H_rad_rec(), Hion_coll_ioniz_ratecoef(), hrii(), hrii_log(), hydro_vs_coll_str(), hydro_vs_deexcit(), HydroRecCool(), InitEmissivities(), ParseBackgrd(), rayleh(), size_distr(), and unmxify().

Here is the call graph for this function:

void PrintE71 ( FILE *  ,
double   
)

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

Definition at line 867 of file service.cpp.

References DEBUG_ENTRY.

void PrintE82 ( FILE *  ,
double   
)

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

Definition at line 821 of file service.cpp.

References DEBUG_ENTRY.

Referenced by optimize_func(), PrtAllTau(), and PrtHeader().

void PrintE93 ( FILE *  ,
double   
)

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

Definition at line 914 of file service.cpp.

References DEBUG_ENTRY.

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

char* PrintEfmt ( const char *  fmt,
double  val 
)

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

Parameters:
*fmt 
val 

Definition at line 768 of file service.cpp.

References DEBUG_ENTRY.

Referenced by aver(), GammaPrt(), GetModel(), H2_Prt_column_density(), H2_Prt_Zone(), HydroLevel(), prme(), PrtAllTau(), PrtHeader(), PrtHydroTrace1(), PrtZone(), and Punch1LineData().

double qg32 ( double  ,
double  ,
double(*)(double)   
)

32 point gaussian quadrature integration

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

Definition at line 1158 of file service.cpp.

References DEBUG_ENTRY.

Referenced by AngerJ(), collision_strength_VF01(), conpmp(), cont_gaunt_calc(), CS_l_mixing_S62(), CS_l_mixing_VF01(), CS_ThermAve_PR78(), CS_VS80(), DrvContPump(), esccon(), helike_radrecomb_from_cross_section(), hlike_radrecomb_from_cross_section(), and Recomb_Seaton59().

double RandGauss ( double  xMean,
double  s 
)

normal random variate generator

Parameters:
xMean mean value
s standard deviation s

Definition at line 1766 of file service.cpp.

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

Referenced by ion_recomb(), 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
int nChar 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 70 of file service.cpp.

References called, DEBUG_ENTRY, ioQQQ, lgAbort, and t_called::lgTalk.

Referenced by atmdat_Chianti_readin(), atmdat_lamda_readin(), Badnell_rec_init(), cdGetLineList(), ContBandsCreate(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), GetNextLine(), GetStandardHeLines(), H2_CollidRateRead(), H2_He_coll_init(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCollidSetup(), HelikeTransProbSetup(), HyperfineCreate(), t_yield::init_yield(), lgCompileAtmosphereCoStar(), main(), mie_next_line(), Nemala_Start(), ParseDrive(), ParseInit(), ptrcer(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), ReadTable(), and StarburstInitialize().

double safe_div ( double  x,
double  y 
) [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, or when evaluating 0/0

Definition at line 901 of file cddefines.h.

References isnan, and sign3().

Here is the call graph for this function:

sys_float safe_div ( sys_float  x,
sys_float  y 
) [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, or when evaluating 0/0

Definition at line 870 of file cddefines.h.

References isnan, and sign3().

Here is the call graph for this function:

double SDIV ( double  x  )  [inline]

Definition at line 863 of file cddefines.h.

References SMALLFLOAT.

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

References SMALLFLOAT.

Referenced by t_fe2ovr_la::atoms_fe2ovr(), cdTemp(), ChemImportance(), ConvEdenIoniz(), ConvInitSolution(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolOxyg(), DynaPunchTimeDep(), Fe2_cooling(), FeIILevelPops(), FeIIPunPop(), GammaPrt(), GrainDrive(), H21_cm_pops(), H2_CollidRateEvalAll(), H2_gs_rates(), H2_Level_low_matrix(), H2_LevelPops(), H2_Prt_column_density(), H2_Prt_Zone(), H2_PunchDo(), H2_X_coll_rate_evaluate(), hmole(), hmole_reactions(), HydroT2Low(), ion_solver(), ion_trim(), IonSilic(), iso_level(), IterEnd(), lgCheckAsserts(), lgConvEden(), lgCoolHeatCheckConverge(), lines_continuum(), lines_grains(), OccupationNumberLine(), ParseTable(), PrtZone(), radius_increment(), radius_next(), RT_continuum_shield_fcn(), RT_line_all(), RT_line_one_tauinc(), RT_line_static(), and timestep_next().

double sexp ( double  x  ) 

Definition at line 1036 of file service.cpp.

References DEBUG_ENTRY, and SEXP_LIMIT.

sys_float sexp ( sys_float  x  ) 

sexp safe exponential function

Definition at line 1017 of file service.cpp.

Referenced by atmdat_dielrec_fe(), atmol_popsolve(), atom_level2(), atom_levelN(), atom_pop5(), Badnell_DR_rate_eval(), ChargTranEval(), ColStrGBar(), con_pump_op(), CoolEvaluate(), CoolIron(), CoolOxyg(), dense_fabden(), e2(), extin(), ffun1(), H21_cm_pops(), H21cm_electron(), H2_CollidRateEvalAll(), H2_CollidRateEvalOne(), H2_vib_dist(), H2_X_coll_rate_evaluate(), HCTRecom(), hmole_reactions(), iso_collide(), IterEnd(), lines_lv1_na_ar(), mole_H2_LTE(), opfun(), ParseAgn(), ParseDrive(), RT_continuum_shield_fcn(), RT_line_one(), velset(), vfun(), and vib_evap().

void ShowMe ( void   ) 

print comment asking to show output to me

Definition at line 232 of file service.cpp.

References t_hmi::BiggestH2, cdCautions(), cdPrintCommands(), cdWarnings(), conv, t_hextra::cryden, DEBUG_ENTRY, hextra, hmi, input, Singleton< T >::Inst(), ioQQQ, t_warnings::ncaun, t_input::nSaveIni, t_conv::nTeFail, t_warnings::nwarn, and warnings.

Referenced by atom_level3(), aver(), BadOpen(), BadRead(), cnewton(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvTempEdenIoniz(), coolpr(), escmase(), Fe4Lev12(), fill(), FindIndex(), GrainCharge(), H2_ReadTransprob(), ipoint(), lgCheckAsserts(), lgConvPres(), ligbar(), mie_auxiliary(), mie_cs_size_distr(), mie_read_mix(), mie_read_rfi(), mie_repair(), MyAssert(), PrtComment(), RauchInitializeSub(), RT_line_static(), size_distr(), and TotalInsanity().

Here is the call graph for this function:

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

Referenced by bessel_jn(), bessel_yn(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), DynaPresChngFactor(), qheat_init(), setstp(), TeBrent(), and xinvrs().

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

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

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

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

Definition at line 102 of file service.cpp.

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

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

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
n number of values in x
iperm[] permutation output array
kflag flag saying what to do - 1 sorts into increasing order, not changing
kflag the original routine
*ier error condition, should be 0

Definition at line 1223 of file service.cpp.

References DEBUG_ENTRY.

Referenced by atmdat_Chianti_readin().

void TestCode ( void   ) 

TestCode set flag saying that test code is in place

Definition at line 1075 of file service.cpp.

References DEBUG_ENTRY, and lgTestCodeCalled.

char TorF ( bool  l  )  [inline]

Definition at line 703 of file cddefines.h.

Referenced by ConvEdenIoniz(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), GrainCharge(), GrainChargeTemp(), InitSimPostparse(), lgConvPres(), lgCoolNetConverge(), MyAssert(), Nemala_Start(), qheat(), and RT_OTS_PrtRate().

NORETURN void TotalInsanity ( void   ) 

TotalInsanity general error handler for something that cannot happen, exits

Definition at line 959 of file service.cpp.

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

Referenced by multi_arr< float, 3 >::alloc(), atmdat_Chianti_readin(), atmdat_lamda_readin(), atmdat_readin(), atom_level3(), atom_levelN(), AtomCSInterp(), Badnell_rec_init(), cdInit(), cdLine(), cdRead(), Chianti_Upsilon(), collision_strength_VF01(), ConvInitSolution(), ConvIterCheck(), ConvTempEdenIoniz(), CoolEvaluate(), CoolIron(), CoolNitr(), CoolSili(), CoolSulf(), CS_PercivalRichards78(), DebyeDeriv(), dense_fabden(), DynaPunch(), DynaPunchTimeDep(), Fe7Lev8(), Fe_10_11_13_cs(), multi_geom< d, MEM_LAYOUT_VAL, lgBOUNDSCHECKVAL >::finalize(), ForbiddenAuls(), getAtNo(), GridGatherAfterCloudy(), GridGatherInCloudy(), GrnStdDpth(), he_1trans(), helike_quantum_defect(), hmole_reactions(), t_yield::init_yield(), InterpolateModel(), IonCSInterp(), iso_collapsed_Aul_update(), iso_collapsed_bnl_set(), iso_collide(), iso_create(), iso_get_total_num_levels(), iso_level(), iso_radrecomb_from_cross_section(), lgCheckAsserts(), lgConvPres(), lgInputComment(), lines_setup(), Nemala_Start(), Opacity_iso_photo_cs(), open_data(), ParseAssertResults(), ParseAtomFeII(), ParseAtomISO(), ParseGrain(), ParseOptimize(), ParsePunch(), ParseSet(), ParseTable(), PresTotCurrent(), prme(), PrtColumns(), PrtComment(), punch_average(), read_hm05(), rfield_opac_malloc(), RT_continuum_shield_fcn(), RT_OTS_ChkSum(), sprt_wl(), state_get_put(), tbl_fun(), tfidle(), timestep_next(), and TlustyInterpolate().

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

References DEBUG_ENTRY.

Referenced by atmdat_Chianti_readin(), and atmdat_lamda_readin().

double vfun ( double  damp,
double  x 
) [inline]

Definition at line 1540 of file cddefines.h.

References sexp().

Referenced by con_pump_op(), and opfun().

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

Referenced by ParseSet().

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

const int FILENAME_PATH_LENGTH_2 = FILENAME_PATH_LENGTH*2

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

Definition at line 183 of file cddefines.h.

Referenced by atmdat_Chianti_readin(), atmdat_lamda_readin(), atmdat_readin(), cdGetLineList(), ContBandsCreate(), FeIIBandsCreate(), FeIICreate(), GetNextLine(), H2_CollidRateRead(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), t_yield::init_yield(), mie_next_line(), mie_read_mix(), mie_read_opc(), mie_read_rfi(), mie_read_szd(), mie_write_form(), mie_write_opc(), Nemala_Start(), ParseCompile(), ParseGrain(), ParseInit(), ParseTable(), punch_average(), punch_opacity(), and ReadAugerData().

EXTERN double fnzone

this is nzone + conv.nPres2Ioniz/100 in ConvBase

Definition at line 153 of file cddefines.h.

Referenced by cloudy(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvIoniz(), ConvPresTempEdenIoniz(), CoolEvaluate(), dense_fabden(), GammaPrt(), GammaPrtShells(), GetFracPop(), GrainCharge(), H2_LevelPops(), H2_Reset(), hmole(), hmole_reactions(), ion_trim(), IonSilic(), MyAssert(), PunchSpecial(), radius_increment(), RT_line_all(), RT_line_static(), RT_OTS(), and RT_OTS_PrtRate().

const int INPUT_LINE_LENGTH = 200

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

Definition at line 188 of file cddefines.h.

Referenced by abund_starburst(), AgeCheck(), Badnell_rec_init(), BadStart(), cdEmis(), cdGetLineList(), cdIonFrac(), cdLine(), cdRead(), cdTemp(), ContBandsCreate(), ConvEdenIoniz(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), FeIIBandsCreate(), FillGFF(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetStandardHeLines(), grid_do(), H2_He_coll_init(), H2_ParsePunch(), H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), HeCollidSetup(), HelikeTransProbSetup(), HyperfineCreate(), lgCheckAsserts(), lgCompileAtmosphereCoStar(), main(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCaseB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTrace(), prt_smooth_predictions(), PrtComment(), PrtLineSum(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), PunLineIntensity(), punResults(), RauchInitializeSub(), read_continuum_mesh(), ReadTable(), StarburstInitialize(), state_get_put(), and writeCloudyDetails().

FILE* ioMAP

Definition at line 10 of file cdinit.cpp.

Referenced by ParseMap(), and ParsePunch().

EXTERN FILE* ioPrnErr

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

Definition at line 131 of file cddefines.h.

Referenced by cdInit().

EXTERN FILE* ioQQQ

ioQQQ is the file hand to the output file itself, ioQQQ is set to stdout by default in cdInit, and is reset to anything else by calling cdOutp

Definition at line 123 of file cddefines.h.

Referenced by abund_starburst(), AbundancesPrt(), AbundancesTable(), AnuUnit(), AtlasCompile(), atmdat_2phot_rate(), atmdat_Chianti_readin(), atmdat_dielrec_fe(), atmdat_lamda_readin(), atmdat_outer_shell(), atmdat_readin(), atmol_popsolve(), AtmospheresAvail(), atom_level3(), atom_levelN(), atom_oi_calc(), atom_pop5(), AtomSeqBeryllium(), aver(), Badnell_rec_init(), BadOpen(), badprt(), BadRead(), bangin(), bessel_k0(), bessel_k0_scaled(), bessel_k1(), bessel_k1_scaled(), bessel_y0(), bessel_y1(), bessel_yn(), C6cs123(), Ca20cs123(), caunin(), cdClock(), cdCO_colden(), cdColm(), cdDrive(), cdExecTime(), cdExit(), cdGetLineList(), cdInit(), cdIonFrac(), cdLine(), cdOutp(), cdRead(), cdSPEC(), cdTemp(), ChckFill(), CheckVal(), chi2_func(), ChkUnits(), chMolBranch(), ClosePunchFiles(), cloudy(), CO_Colden(), CO_drive(), CO_PopsEmisCool(), CO_zero(), conorm(), ContBandsCreate(), ContCreateMesh(), ContCreatePointers(), ContNegative(), ContSetIntensity(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolEvaluate(), coolpr(), CoStarCompile(), CoStarListModels(), dbg_printf(), dense_fabden(), dense_tabden(), dgaunt(), dmpary(), do_dump_state(), do_restore_state(), DoFSMixing(), DrvCaseBHS(), DrvEscP(), DrvHyas(), DumpLine(), DynaEndIter(), DynaEndZone(), DynaIonize(), DynaPresChngFactor(), DynaPrtZone(), DynaStartZone(), ee1(), ellpk(), endFindLevLine(), escmase(), expn(), F2_1(), factorial(), Fe26cs123(), Fe2_cooling(), Fe4Lev12(), Fe7Lev8(), FeII_Colden(), FeII_RT_Make(), FeIIBandsCreate(), FeIICollRatesBoltzmann(), FeIIContCreate(), FeIILevelPops(), FeIIPunData(), ffun(), ffun1(), fill(), FillExtraLymanLine(), FillGFF(), FillJ(), FreeFreeGaunt(), fudge(), GammaPrtShells(), GetLineRec(), GetModel(), GetNextLine(), GetOptColDen(), GetOptLineInt(), GetOptTemp(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), GetQuote(), GetStandardHeLines(), GrainChargeTemp(), GrainDrive(), GrainMakeDiffuse(), GrainsInit(), grid_do(), GridCompile(), gridXspec(), H2_CollidRateEvalAll(), H2_CollidRateEvalOne(), H2_CollidRateRead(), H2_Create(), H2_He_coll(), H2_Level_low_matrix(), H2_LevelPops(), H2_ParsePunch(), H2_Prt_Zone(), H2_ReadTransprob(), H2_Reset(), H2_X_coll_rate_evaluate(), H_Einstein_A_lin(), H_Einstein_A_log10(), H_photo_cs_lin(), H_photo_cs_log10(), HCSAR_interp(), He2cs123(), he_1trans(), HeCollidSetup(), HeCSInterp(), HelikeTransProbSetup(), hmole(), hmole_reactions(), t_ADfA::hpfit(), hv(), Hydcs123(), HydroEinstA(), HydroLevel(), HydroRecCool(), HydroT2Low(), HyperfineCreate(), t_yield::init_yield(), InitEmissivities(), InitGrid(), InitSimPostparse(), input_readarray(), InterpolateGff(), InterpolateGridCoStar(), InterpolateModel(), InterpolateModelCoStar(), InterpolateRectGrid(), inv_ufunct(), ion_recombAGN(), ion_solver(), ion_trim(), IonAlumi(), IonBeryl(), IonBoron(), IonCarbo(), IonHelium(), IonIron(), IonMagne(), IonNeon(), IonNitro(), IonOxyge(), IonSilic(), IonSodiu(), ipContEnergy(), ipFindLevLine(), ipLineEnergy(), ipoint(), iso_collapsed_bnl_print(), iso_collide(), iso_continuum_lower(), iso_level(), iso_photo(), iso_prt_pops(), iso_recomb_setup(), iso_update_num_levels(), iter_end_check(), IterEnd(), IterRestart(), IterStart(), Kurucz79Compile(), lfactorial(), lgCheckAsserts(), lgCompileAtmosphere(), lgCompileAtmosphereCoStar(), lgConvPres(), lgCoolNetConverge(), ligbar(), LimitSh(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_lv1_k_zn(), lines_lv1_li_ne(), lines_lv1_na_ar(), lines_setup(), lines_table(), main(), MakeDeriv(), makelist(), makeplist(), mie_write_opc(), MihalasCompile(), MyAssert(), MyCalloc(), MyMalloc(), MyRealloc(), Ne10cs123(), Nemala_Start(), NewGrainBin(), NoNumb(), notein(), oi_level_pops(), opacity_more_memory(), OpacityCreateAll(), OpacityCreateReilMan(), open_data(), optimize_func(), optimize_phymir(), ParseAbsMag(), ParseAbundances(), ParseAge(), ParseAgn(), ParseAssertResults(), ParseAtomCO(), ParseAtomFeII(), ParseAtomH2(), ParseAtomISO(), ParseBackgrd(), ParseBlackbody(), ParseCMB(), ParseCommands(), ParseCompile(), ParseConstant(), ParseCoronal(), ParseCosmicRays(), ParseCrashDo(), ParseDLaw(), ParseDont(), ParseDrive(), ParseDynaTime(), ParseDynaWind(), ParseElement(), ParseExtinguish(), ParseF_nu(), ParseFluc(), ParseGlobule(), ParseGrain(), ParseGrid(), ParseHDEN(), ParseInit(), ParseInterp(), ParseIonPar(), ParseMagnet(), ParseMap(), ParseMetal(), ParseNorm(), ParseOptimize(), ParsePlot(), ParsePlotRangeContin(), ParsePlotRangeOption(), ParsePowerlawContinuum(), ParsePrint(), ParsePunch(), ParseRadius(), ParseRangeOption(), ParseRatio(), ParseSet(), ParseSphere(), ParseState(), ParseStop(), ParseTable(), ParseTest(), ParseTLaw(), ParseTrace(), pltcon(), pltmap(), pltopc(), pltr(), PntForLine(), PressureChange(), PresTotCurrent(), t_cpu::printDataPath(), prme(), prt_constants(), PrtAllTau(), PrtComment(), PrtElem(), PrtFinal(), PrtHeader(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtLineSum(), PrtMeanIon(), prtmet(), prtPunOpacSummary(), PrtZone(), ptrcer(), punch_average(), punch_colden(), punch_line(), Punch_Line_RT(), punchFITS_SpectraData(), punchFITSfile(), PunchLineData(), PunchLineStuff(), PunResults1Line(), qheat(), qheat_init(), qintr(), t_ADfA::rad_rec(), radius_increment(), radius_next(), RauchCompile(), RauchInitializeSub(), read_continuum_mesh(), read_hm05(), read_whole_line(), ReadAugerData(), ReadTable(), RebinQHeatResults(), RT_DestProb(), RT_line_all(), RT_line_one(), RT_line_one_tau_reset(), RT_line_static(), RT_OTS(), RT_OTS_AddLine(), RT_OTS_ChkSum(), RT_OTS_PrtRate(), RT_recom_effic(), RT_tau_inc(), RT_tau_reset(), RTesc_lya_1side(), SanityCheck(), SanityCheckBegin(), ScanProbDistr(), SetLimits(), ShowMe(), spline_cubic_set(), Split(), StarburstCompile(), StarburstInitialize(), state_do(), state_get_put(), t_ADfA::t_ADfA(), t_fe2ovr_la::t_fe2ovr_la(), t_version::t_version(), TeBrent(), TempChange(), TempInterp(), tfidle(), timestep_next(), TlustyCompile(), TotalInsanity(), totlin(), uderiv(), ufunct(), vary_input(), warnin(), WernerCompile(), WMBASICCompile(), wr_continue(), and XERBLA().

EXTERN FILE* ioStdin

Definition at line 125 of file cddefines.h.

Referenced by cdInit(), cdInp(), dgaunt(), DrvCaseBHS(), DrvEscP(), DrvHyas(), main(), ParseDrive(), and ptrcer().

const int ipALUMINIUM = 12

Definition at line 333 of file cddefines.h.

Referenced by AbundancesZero(), CoolAlum(), getAtNo(), and IonAlumi().

const int ipARGON = 17

Definition at line 338 of file cddefines.h.

Referenced by AbundancesZero(), CoolArgo(), ForbiddenAuls(), getAtNo(), and IonArgon().

const int ipB_LIKE = 4

Definition at line 314 of file cddefines.h.

const int ipBE_LIKE = 3

Definition at line 313 of file cddefines.h.

const int ipBERYLLIUM = 3

Definition at line 324 of file cddefines.h.

Referenced by AbundancesZero(), and IonBeryl().

const int ipBORON = 4

Definition at line 325 of file cddefines.h.

Referenced by AbundancesZero(), and IonBoron().

const int ipC_LIKE = 5

Definition at line 315 of file cddefines.h.

const int ipCALCIUM = 19

Definition at line 340 of file cddefines.h.

Referenced by AbundancesZero(), CoolCalc(), getAtNo(), IonCalci(), and lines_lv1_k_zn().

const int ipCARBON = 5

Definition at line 326 of file cddefines.h.

Referenced by AbundancesZero(), CO_drive(), CO_Init(), co_lnu_c_o_lnu(), ContRate(), CoolCarb(), cross_section(), getAtNo(), GrainRateDr(), hydro_vs_coll_str(), InitCoreload(), ion_solver(), IonCarbo(), IonIron(), IonMagne(), lgMolecAver(), lines_lv1_li_ne(), pah1_fun(), ParsePunch(), and radius_next().

const int ipCHLORINE = 16

Definition at line 337 of file cddefines.h.

Referenced by AbundancesZero(), CO_Init(), CoolChlo(), getAtNo(), and IonChlor().

const int ipCHROMIUM = 23

Definition at line 344 of file cddefines.h.

Referenced by AbundancesZero(), CoolChro(), getAtNo(), and IonChrom().

const int ipCOBALT = 26

Definition at line 347 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), and IonCobal().

const int ipCOPPER = 28

Definition at line 349 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), and IonCoppe().

const int ipCRD = -1

Definition at line 245 of file cddefines.h.

Referenced by FeIIZero(), ParseAtomFeII(), ParseAtomISO(), RT_continuum_shield_fcn(), and RT_line_static().

const int ipCRDW = 2

Definition at line 247 of file cddefines.h.

Referenced by FeIIZero(), iso_satellite(), ParseAtomFeII(), ParseAtomISO(), RT_continuum_shield_fcn(), and RT_line_static().

const int ipDEST_INCOM = 2

Definition at line 253 of file cddefines.h.

Referenced by RT_DestProb(), and RT_line_static().

const int ipDEST_K2 = 1

Definition at line 251 of file cddefines.h.

Referenced by RT_DestProb(), and RT_line_static().

const int ipDEST_SIMPL = 3

Definition at line 255 of file cddefines.h.

Referenced by RT_DestProb().

const int ipF_LIKE = 8

Definition at line 318 of file cddefines.h.

const int ipFLUORINE = 8

Definition at line 329 of file cddefines.h.

Referenced by AbundancesZero(), and IonFluor().

const int ipH1s = 0

some levels for hydrogenic species

Definition at line 259 of file cddefines.h.

Referenced by atom_oi_calc(), t_fe2ovr_la::atoms_fe2ovr(), cdTemp(), ChargTranSumHeat(), ContRate(), CoolCalc(), CoolEvaluate(), CS_l_mixing_PS64(), Fe2_cooling(), FeIILyaPump(), GammaBnPL(), GrainTemperature(), H21_cm_pops(), H_cross_section(), HydroLevel(), HydroT2Low(), ion_recomb(), IonHelium(), iso_ionize_recombine(), iso_photo(), IterRestart(), lines_general(), lines_hydro(), lines_lv1_k_zn(), PrtAllTau(), PrtComment(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtZone(), punch_opacity(), PunchSpecial(), RT_DestProb(), RT_OTS(), RTesc_lya(), and SanityCheckBegin().

const int ipH2p = 2

Definition at line 261 of file cddefines.h.

Referenced by cdTemp(), CoolCalc(), Fe2_cooling(), FeIILyaPump(), GrainTemperature(), H21_cm_pops(), HydroCSInterp(), HydroT2Low(), iso_suprathermal(), lines_continuum(), lines_general(), lines_hydro(), lines_lv1_k_zn(), PrtAllTau(), PrtHydroTrace1(), PunchSpecial(), RT_DestProb(), RT_OTS(), RTesc_lya(), and SanityCheckBegin().

const int ipH2s = 1

Definition at line 260 of file cddefines.h.

Referenced by ContRate(), ConvIterCheck(), GrainRateDr(), HydroCSInterp(), HydroLevel(), HydroRenorm(), HydroT2Low(), lines_continuum(), lines_general(), lines_hydro(), PrtAllTau(), PrtHydroTrace1(), and PunchSpecial().

const int ipH3d = 5

Definition at line 264 of file cddefines.h.

Referenced by lines_continuum().

const int ipH3p = 4

Definition at line 263 of file cddefines.h.

Referenced by atom_oi_calc(), ConvIterCheck(), lines_continuum(), lines_hydro(), and PrtAllTau().

const int ipH3s = 3

Definition at line 262 of file cddefines.h.

Referenced by lines_continuum(), lines_hydro(), and PrtAllTau().

const int ipH4d = 8

Definition at line 267 of file cddefines.h.

Referenced by lines_general().

const int ipH4f = 9

Definition at line 268 of file cddefines.h.

const int ipH4p = 7

Definition at line 266 of file cddefines.h.

Referenced by lines_general(), lines_hydro(), and PrtAllTau().

const int ipH4s = 6

Definition at line 265 of file cddefines.h.

Referenced by lines_general(), lines_hydro(), and PrtAllTau().

const int ipH5d = 12

Definition at line 271 of file cddefines.h.

const int ipH5f = 13

Definition at line 272 of file cddefines.h.

const int ipH5g = 14

Definition at line 273 of file cddefines.h.

const int ipH5p = 11

Definition at line 270 of file cddefines.h.

Referenced by lines_hydro(), and PrtAllTau().

const int ipH5s = 10

Definition at line 269 of file cddefines.h.

const int ipH6s = 15

Definition at line 274 of file cddefines.h.

const int ipH_LIKE = 0

these are array indices for isoelectronic sequences, same as element but used for array addressing to make context totally clear

Definition at line 310 of file cddefines.h.

Referenced by atmdat_2phot_rate(), atmdat_2phot_shapefunction(), atom_oi_calc(), t_fe2ovr_la::atoms_fe2ovr(), cdTemp(), ChargTranSumHeat(), chkCaHeps(), collision_strength_VF01(), ContRate(), ConvBase(), ConvIterCheck(), ConvTempEdenIoniz(), CoolCalc(), CoolEvaluate(), CS_l_mixing_PS64(), CS_l_mixing_VF01(), CS_PercivalRichards78(), DynaZero(), Fe2_cooling(), FeIILyaPump(), FillExtraLymanLine(), GammaBnPL(), GrainRateDr(), GrainTemperature(), H21_cm_pops(), t_ADfA::h_coll_str(), H_cross_section(), hlike_radrecomb_from_cross_section(), hydro_transprob(), HydroCSInterp(), HydroLevel(), HydroRecCool(), HydroRenorm(), HydroT2Low(), InitCoreload(), InitDefaultsPreparse(), ion_recomb(), ion_solver(), IonHelium(), IonMagne(), IonOxyge(), iso_allocate(), iso_assign_quantum_numbers(), iso_cascade(), iso_collapsed_Aul_update(), iso_collapsed_bnl_print(), iso_collapsed_bnl_set(), iso_collide(), iso_create(), iso_get_total_num_levels(), iso_ionize_recombine(), iso_level(), iso_prt_pops(), iso_radrecomb_from_cross_section(), iso_solve(), iso_suprathermal(), iso_zero(), IterRestart(), IterStart(), lgCheckAsserts(), lines(), lines_continuum(), lines_general(), lines_hydro(), lines_lv1_k_zn(), Opacity_iso_photo_cs(), OpacityCreateAll(), ParseAssertResults(), ParseAtomISO(), ParseCompile(), ParseDont(), ParsePrint(), ParseTest(), ParseTrace(), PrtAllTau(), PrtComment(), PrtHydroTrace1(), PrtHydroTrace1a(), prtmet(), PrtZone(), punch_opacity(), PunchLineStuff(), PunchSpecial(), radius_first(), radius_increment(), RT_DestProb(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), SanityCheckBegin(), state_get_put(), and zero().

const int ipHe1s1S = 0

some levels for he-like species

Definition at line 279 of file cddefines.h.

Referenced by cross_section(), ForbiddenAuls(), he_1trans(), HeCollidSetup(), helike_quantum_defect(), HelikeTransProbSetup(), ion_recomb(), IonCSInterp(), iso_dielec_recomb_rate(), and PrtZone().

const int ipHe2p1P = 6

Definition at line 287 of file cddefines.h.

Referenced by ForbiddenAuls(), he_1trans(), and PrtZone().

const int ipHe2p3P0 = 3

Definition at line 284 of file cddefines.h.

Referenced by AGN_He1_CS(), AtomCSInterp(), ForbiddenAuls(), he_1trans(), IonCSInterp(), iso_prt_pops(), and PrtZone().

const int ipHe2p3P1 = 4

Definition at line 285 of file cddefines.h.

Referenced by AGN_He1_CS(), AtomCSInterp(), he_1trans(), IonCSInterp(), iso_prt_pops(), and PrtZone().

const int ipHe2p3P2 = 5

Definition at line 286 of file cddefines.h.

Referenced by AGN_He1_CS(), AtomCSInterp(), ConvIterCheck(), ForbiddenAuls(), he_1trans(), IonCSInterp(), iso_prt_pops(), and PrtZone().

const int ipHe2s1S = 2

Definition at line 283 of file cddefines.h.

Referenced by he_1trans(), IonCSInterp(), and PrtZone().

const int ipHe2s3S = 1

Definition at line 282 of file cddefines.h.

Referenced by AGN_He1_CS(), ConvIterCheck(), ForbiddenAuls(), he_1trans(), HeCollidSetup(), IonCSInterp(), lines_helium(), PrtZone(), and RT_diffuse().

const int ipHe3d1D = 11

Definition at line 294 of file cddefines.h.

Referenced by AGN_He1_CS(), and PrtZone().

const int ipHe3d3D = 10

Definition at line 293 of file cddefines.h.

Referenced by AGN_He1_CS(), and PrtZone().

const int ipHe3p1P = 12

Definition at line 295 of file cddefines.h.

Referenced by PrtZone().

const int ipHe3p3P = 9

Definition at line 292 of file cddefines.h.

Referenced by AGN_He1_CS(), and PrtZone().

const int ipHe3s1S = 8

Definition at line 291 of file cddefines.h.

Referenced by PrtZone().

const int ipHe3s3S = 7

Definition at line 290 of file cddefines.h.

Referenced by AGN_He1_CS(), ForbiddenAuls(), he_1trans(), and PrtZone().

const int ipHe4d1D = 17

Definition at line 302 of file cddefines.h.

const int ipHe4d3D = 16

Definition at line 301 of file cddefines.h.

const int ipHe4f1F = 19

Definition at line 304 of file cddefines.h.

const int ipHe4f3F = 18

Definition at line 303 of file cddefines.h.

const int ipHe4p1P = 20

Definition at line 305 of file cddefines.h.

const int ipHe4p3P = 15

Definition at line 300 of file cddefines.h.

const int ipHe4s1S = 14

Definition at line 299 of file cddefines.h.

const int ipHe4s3S = 13

Definition at line 298 of file cddefines.h.

Referenced by he_1trans().

const int ipHE_LIKE = 1

Definition at line 311 of file cddefines.h.

Referenced by atmdat_2phot_rate(), atmdat_2phot_shapefunction(), AtomCSInterp(), Badnell_rec_init(), collision_strength_VF01(), ConvIterCheck(), cross_section(), CS_PercivalRichards78(), DoFSMixing(), DoSatelliteLines(), ForbiddenAuls(), he_1trans(), He_cross_section(), HeCollidSetup(), HeCSInterp(), helike_energy(), helike_quantum_defect(), helike_radrecomb_from_cross_section(), helike_transprob(), hmole_reactions(), InitCoreload(), ion_recomb(), IonCSInterp(), IonHelium(), iso_collapsed_Aul_update(), iso_collapsed_bnl_print(), iso_collapsed_bnl_set(), iso_collide(), iso_create(), iso_dielec_recomb_rate(), iso_get_total_num_levels(), iso_ionize_recombine(), iso_level(), iso_prt_pops(), iso_radrecomb_from_cross_section(), iso_satellite(), iso_satellite_update(), iso_state_lifetime(), lgCheckAsserts(), lines(), lines_helium(), Opacity_iso_photo_cs(), OpacityCreateAll(), ParseAssertResults(), ParseAtomISO(), ParseCompile(), ParseDont(), ParsePrint(), ParseTrace(), PrtAllTau(), PrtZone(), punch_opacity(), and RT_diffuse().

const int ipHELIUM = 1

Definition at line 322 of file cddefines.h.

Referenced by AbundancesSet(), AbundancesZero(), AGN_Hemis(), AtomCSInterp(), Badnell_rec_init(), ChargeTransferUpdate(), ChargTranEval(), ChargTranSumHeat(), CO_Init(), CoolCarb(), CoolOxyg(), cross_section(), FillExtraLymanLine(), ForbiddenAuls(), getAtNo(), GetStandardHeLines(), GrainDrift(), H2_X_coll_rate_evaluate(), he_1trans(), He_cross_section(), HeCollidSetup(), HeCSInterp(), helike_energy(), helike_quantum_defect(), HelikeTransProbSetup(), hmole_reactions(), t_yield::init_yield(), InitCoreload(), ion_recomb(), ion_trim(), IonCSInterp(), IonHelium(), iso_assign_quantum_numbers(), iso_collapsed_bnl_set(), iso_collide(), iso_continuum_lower(), iso_ionize_recombine(), iso_level(), iso_solve(), lgCheckAsserts(), lines(), lines_helium(), lines_lv1_li_ne(), lines_molecules(), ParseAssertResults(), ParsePrint(), ParsePunch(), PrtAllTau(), PrtComment(), PrtMeanIon(), PrtZone(), punch_opacity(), PunchDo(), radius_next(), and RT_OTS().

const int ipHYDROGEN = 0

these are indices for some elements, on the C scale

Definition at line 321 of file cddefines.h.

Referenced by AbundancesPrt(), AbundancesSet(), AbundancesZero(), AGN_Hemis(), atom_oi_calc(), t_fe2ovr_la::atoms_fe2ovr(), cdColm(), cdIonFrac(), cdTemp(), ChargeTransferUpdate(), ChargTranSumHeat(), chkCaHeps(), CO_drive(), CO_Init(), ContRate(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolCalc(), CoolCarb(), CoolChlo(), CoolEvaluate(), CoolIron(), CoolNick(), CoolOxyg(), CoolSili(), CoolSulf(), crnurate(), DynaCreateArrays(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaPunch(), DynaPunchTimeDep(), DynaSaveLast(), DynaStartZone(), eden_sum(), Fe2_cooling(), FeIILyaPump(), getAtNo(), GrainChargeTemp(), GrainDrift(), GrainDrive(), GrainMakeDiffuse(), GrainRateDr(), GrainTemperature(), GrainUpdateRadius1(), GrnStdDpth(), GrnVryDpth(), H21_cm_pops(), H2_LevelPops(), H2_X_coll_rate_evaluate(), t_ADfA::h_coll_str(), he_1trans(), helike_quantum_defect(), hmole(), hmole_step(), Hydcs123(), HydroCSInterp(), HydroLevel(), HydroRenorm(), HydroT2Low(), t_yield::init_yield(), InitBinAugerData(), InitCoreload(), InitDefaultsPreparse(), InitSimPostparse(), ion_recom_calculate(), ion_recomb(), ion_solver(), ion_trim(), IonMagne(), IonOxyge(), IonSilic(), iso_collapsed_bnl_set(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_ionize_recombine(), iso_level(), iso_solve(), iso_suprathermal(), IterRestart(), lgCheckAsserts(), lgConvPres(), lgMolecAver(), lines_continuum(), lines_general(), lines_hydro(), lines_lv1_li_ne(), lines_molecules(), MeanInc(), mie_read_form(), newspecies(), OpacityAddTotal(), pah1_fun(), ParseAtomISO(), ParseDLaw(), ParseFluc(), ParseGlobule(), ParseHDEN(), ParsePrint(), ParsePunch(), PressureChange(), PresTotCurrent(), prt_smooth_predictions(), PrtAllTau(), PrtColumns(), PrtComment(), PrtHydroTrace1(), PrtHydroTrace1a(), PrtMeanIon(), PrtZone(), punch_opacity(), PunchDo(), PunchLineData(), PunchSpecial(), radius_first(), radius_next(), RT_DestProb(), RT_OTS(), and zero().

const int ipIRON = 25

Definition at line 346 of file cddefines.h.

Referenced by AbundancesZero(), atmdat_readin(), t_fe2ovr_la::atoms_fe2ovr(), Badnell_DR_rate_eval(), Badnell_RR_rate_eval(), CO_drive(), CO_Init(), CoolIron(), Fe11Lev5(), Fe13Lev5(), Fe2_cooling(), Fe3Lev14(), Fe4Lev12(), FeII_RT_Out(), FeIILevelPops(), FeIILyaPump(), FeIIPunPop(), FeIISumBand(), getAtNo(), InitCoreload(), IonIron(), and lines_lv1_k_zn().

const int ipLI_LIKE = 2

Definition at line 312 of file cddefines.h.

const int ipLITHIUM = 2

Definition at line 323 of file cddefines.h.

Referenced by AbundancesZero(), ChargeTransferUpdate(), CO_drive(), eden_sum(), ion_recombAGN(), and IonLithi().

const int ipLY_A = -2

Definition at line 249 of file cddefines.h.

Referenced by ParseAtomISO(), RT_continuum_shield_fcn(), RT_line_one(), and RT_line_static().

const int ipMAGNESIUM = 11

Definition at line 332 of file cddefines.h.

Referenced by AbundancesZero(), CO_drive(), CO_Init(), CoolMagn(), getAtNo(), InitCoreload(), and IonMagne().

const int ipMANGANESE = 24

Definition at line 345 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), and IonManga().

const int ipN_LIKE = 6

Definition at line 316 of file cddefines.h.

const int ipNEON = 9

Definition at line 330 of file cddefines.h.

Referenced by AbundancesZero(), CoolNeon(), ForbiddenAuls(), getAtNo(), InitCoreload(), and IonNeon().

const int ipNICKEL = 27

Definition at line 348 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), and IonNicke().

const int ipNITROGEN = 6

Definition at line 327 of file cddefines.h.

Referenced by AbundancesZero(), CO_Init(), CoolNitr(), getAtNo(), InitCoreload(), IonNitro(), and lines_lv1_li_ne().

const int ipO_LIKE = 7

Definition at line 317 of file cddefines.h.

const int ipOXYGEN = 7

Definition at line 328 of file cddefines.h.

Referenced by AbundancesZero(), atom_oi_calc(), ChargeTransferUpdate(), ChargTranEval(), CO_drive(), CO_Init(), co_lnu_c_o_lnu(), ConvInitSolution(), CoolOxyg(), getAtNo(), HeCSInterp(), hmole(), InitCoreload(), InitDefaultsPreparse(), IonOxyge(), iter_end_check(), lines_lv1_li_ne(), ParsePunch(), and ParseSet().

const int ipPHOSPHORUS = 14

Definition at line 335 of file cddefines.h.

Referenced by AbundancesZero(), CoolPhos(), getAtNo(), and IonPhosi().

const int ipPOTASSIUM = 18

Definition at line 339 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), and IonPotas().

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

Referenced by emislines_fillredis(), ParseAtomFeII(), ParseAtomISO(), RT_continuum_shield_fcn(), and RT_line_static().

const int ipRecEsc = 2

Definition at line 232 of file cddefines.h.

Referenced by iso_zero(), lines_continuum(), RT_diffuse(), and RT_OTS().

const int ipRecNetEsc = 1

Definition at line 234 of file cddefines.h.

Referenced by iso_ionize_recombine(), and iso_zero().

const int ipRecRad = 0

Definition at line 236 of file cddefines.h.

Referenced by HydroRecCool(), iso_ionize_recombine(), iso_radiative_recomb(), iso_radiative_recomb_effective(), iso_zero(), lines_continuum(), and RT_OTS().

const int ipSCANDIUM = 20

Definition at line 341 of file cddefines.h.

Referenced by AbundancesZero(), CoolScan(), getAtNo(), and IonScand().

const int ipSILICON = 13

Definition at line 334 of file cddefines.h.

Referenced by AbundancesZero(), CO_drive(), CO_Init(), getAtNo(), InitCoreload(), IonIron(), IonMagne(), IonSilic(), and lines_lv1_na_ar().

const int ipSODIUM = 10

Definition at line 331 of file cddefines.h.

Referenced by AbundancesZero(), CoolSodi(), getAtNo(), and IonSodiu().

const int ipSULPHUR = 15

Definition at line 336 of file cddefines.h.

Referenced by AbundancesZero(), CO_drive(), CO_Init(), CoolSulf(), getAtNo(), InitCoreload(), IonIron(), IonMagne(), IonSulph(), lines_lv1_na_ar(), and ParseSet().

const int ipTITANIUM = 21

Definition at line 342 of file cddefines.h.

Referenced by AbundancesZero(), CoolTita(), getAtNo(), and IonTitan().

const int ipVANADIUM = 22

Definition at line 343 of file cddefines.h.

Referenced by AbundancesZero(), CoolVana(), getAtNo(), and IonVanad().

const int ipZINC = 29

Definition at line 350 of file cddefines.h.

Referenced by AbundancesZero(), getAtNo(), helike_energy(), and IonZinc().

EXTERN long int iteration

the iteration counter, set and incremented in routine cloudy, ==1 during first iteration, 2 during second, etc

Definition at line 157 of file cddefines.h.

Referenced by cloudy(), CO_drive(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIterCheck(), ConvPresTempEdenIoniz(), CoolEvaluate(), DynaEndIter(), DynaIonize(), DynaStartZone(), emergent_line(), esc_CRDcore(), esc_CRDwing(), esc_PRD(), Fe2_cooling(), FeIILyaPump(), H2_Level_low_matrix(), H2_Reset(), hmole(), hmole_reactions(), IterEnd(), IterRestart(), lgCheckAsserts(), lgMolecAver(), lines(), main(), MyAssert(), PresTotCurrent(), PrtComment(), PrtHydroTrace1(), PunchSpecial(), radius_first(), radius_next(), RT_line_one_tau_reset(), RT_line_static(), RT_LineWidth(), RT_OTS_AddLine(), RT_recom_effic(), RT_tau_reset(), state_get_put(), vib_evap(), zero(), and ZoneStart().

EXTERN bool lgAbort

this set true when abort sequence is initiated - serious meltdown is happening

Definition at line 134 of file cddefines.h.

Referenced by cdDrive(), cdNwcns(), cloudy(), ConvEdenIoniz(), ConvFail(), ConvInitSolution(), ConvIoniz(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolHeatError(), GridGatherAfterCloudy(), H2_LevelPops(), ion_trim(), IterRestart(), lgCoolNetConverge(), main(), open_data(), PresTotCurrent(), prt_smooth_predictions(), PrtComment(), PrtFinal(), punch_line(), radius_increment(), read_whole_line(), RT_diffuse(), RT_line_static(), TempChange(), and zero().

EXTERN bool lgPrnErr

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

Definition at line 146 of file cddefines.h.

Referenced by cdInit(), and ParsePrint().

EXTERN bool lgTestCodeCalled

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

Definition at line 138 of file cddefines.h.

Referenced by PrtComment(), and TestCode().

EXTERN bool lgTestCodeEnabled

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

Definition at line 142 of file cddefines.h.

Referenced by ParseSet().

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

Referenced by abund_starburst(), AbundancesPrt(), AbundancesSet(), atmdat_3body(), atmdat_DielSupres(), atmdat_readin(), atmol_popsolve(), Badnell_DR_rate_eval(), Badnell_rec_init(), Badnell_RR_rate_eval(), cdColm(), cdIonFrac(), cdTemp(), ChargeTransferUpdate(), ChargTranEval(), ChargTranSumHeat(), chIonLbl(), CO_drive(), CO_Init(), collision_strength_VF01(), ContCreatePointers(), ConvBase(), ConvInitSolution(), ConvIterCheck(), CoolEvaluate(), DynaIonize(), eden_sum(), GammaBnPL(), GetElem(), GetStandardHeLines(), GrainZero(), HeatPunch(), HeatSum(), HeCollidSetup(), helike_quantum_defect(), HelikeTransProbSetup(), highen(), hmole_reactions(), Hydcs123(), HydroLevel(), HydroT2Low(), InitCoreload(), InitDefaultsPreparse(), InitSimPostparse(), ion_collis(), ion_photo(), ion_recomb(), ion_recombAGN(), ion_solver(), ion_trim(), IonCSInterp(), IonIron(), iso_collide(), iso_continuum_lower(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_level(), iso_photo(), iso_put_error(), iso_radiative_recomb(), iso_recomb_malloc(), iso_recomb_setup(), iso_solve(), iso_suprathermal(), IterStart(), lgIonizConverg(), lines(), lines_general(), lines_helium(), lines_hydro(), lines_setup(), MeanInc(), MeanZero(), mie_read_opc(), mie_write_opc(), newspecies(), OpacityAdd1Element(), OpacityAddTotal(), OpacityCreateAll(), ParseAbundances(), ParseAtomISO(), ParseCompile(), ParseDrive(), ParseElement(), ParseMetal(), ParsePrint(), ParsePunch(), PressureChange(), PresTotCurrent(), PrtColumns(), PrtLinePres(), PrtMeanIon(), prtmet(), PrtZone(), PunchDo(), PunchLineData(), radius_increment(), radius_next(), rfield_opac_malloc(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), RTesc_lya(), SanityCheckBegin(), state_get_put(), tfidle(), th85rate_co(), and zero().

const int N_H_MOLEC = 8

number of hydrogen species in hmole

Definition at line 203 of file cddefines.h.

Referenced by atmdat_readin(), ConvBase(), DynaIonize(), eden_sum(), hmole(), hmole_step(), and PrtZone().

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

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

const int NISO = 2

the number of iso sequences now in the code

Definition at line 195 of file cddefines.h.

Referenced by ConvBase(), ConvIterCheck(), CoolDima(), CoolEvaluate(), DynaZero(), FindNeg(), HeatSum(), HeCollidSetup(), InitCoreload(), InitDefaultsPreparse(), ion_collis(), ion_photo(), ion_recomb(), ion_solver(), ion_trim(), iso_collide(), iso_collisional_ionization(), iso_cool(), iso_create(), iso_ionize_recombine(), iso_photo(), iso_prt_pops(), iso_put_error(), iso_radiative_recomb(), iso_recomb_auxiliary_free(), iso_recomb_malloc(), iso_recomb_setup(), iso_solve(), iso_suprathermal(), IterStart(), OpacityAdd1Element(), ParseElement(), PresTotCurrent(), PrtComment(), PrtLinePres(), prtmet(), PrtZone(), PunchLineStuff(), radius_increment(), RT_diffuse(), RT_line_all(), RT_line_driving(), RT_OTS(), RT_stark(), RT_tau_inc(), RT_tau_init(), RT_tau_reset(), state_get_put(), and zero().

EXTERN long int nSimThisCoreload

number of simulations done with this coreload - 1 for first sim

Definition at line 160 of file cddefines.h.

Referenced by cdDrive(), InitCoreload(), and ParsePunch().

EXTERN long int nzone

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

Definition at line 150 of file cddefines.h.

Referenced by AgeCheck(), AGN_Hemis(), t_fe2ovr_la::atoms_fe2ovr(), cdDepth_depth(), cdnZone(), cdPressure_depth(), cloudy(), ConvBase(), ConvEdenIoniz(), ConvFail(), ConvPresTempEdenIoniz(), ConvTempEdenIoniz(), CoolDima(), CoolEvaluate(), dmpary(), DynaIonize(), DynaNewStep(), DynaPresChngFactor(), DynaPrtZone(), DynaSaveLast(), escmase(), Fe2_cooling(), GetProbDistr_HighLimit(), GetProbDistr_LowLimit(), gett2(), gett2o3(), GrainDrive(), GrainUpdateRadius2(), H2_Level_low_matrix(), H2_LevelPops(), H2_RT_tau_inc(), hmole(), hmole_reactions(), ion_trim(), IonHelium(), IonMagne(), IonNitro(), IonOxyge(), IonSilic(), iter_end_check(), lgCheckAsserts(), lgConvPres(), lgMolecAver(), lines_continuum(), lines_hydro(), main(), MakeDeriv(), map_do(), MyAssert(), PressureChange(), PresTotCurrent(), PrtComment(), PrtFinal(), PrtLineSum(), PrtZone(), punch_line(), PunLineIntensity(), PutHetCol(), radius_next(), RT_DestProb(), RT_diffuse(), RT_line_one(), RT_line_static(), RT_OTS(), RT_OTS_Update(), RT_stark(), and ZoneStart().

const double SEXP_LIMIT = 84.

this is -ln of smallest number sexp can handle

Definition at line 1500 of file cddefines.h.

Referenced by 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 14 of file cdinit.cpp.

Referenced by ParseCrashDo().


Generated on Mon Feb 16 12:03:49 2009 for cloudy by  doxygen 1.4.7