grains.cpp File Reference

#include "cddefines.h"
#include "physconst.h"
#include "rfield.h"
#include "hmi.h"
#include "trace.h"
#include "conv.h"
#include "ionbal.h"
#include "thermal.h"
#include "phycon.h"
#include "doppvel.h"
#include "taulines.h"
#include "mole.h"
#include "heavy.h"
#include "thirdparty.h"
#include "dense.h"
#include "ipoint.h"
#include "elementnames.h"
#include "grainvar.h"
#include "grains.h"

Include dependency graph for grains.cpp:

Go to the source code of this file.

Defines

#define FREE_CHECK(PTR)   { ASSERT( PTR != NULL ); free( PTR ); PTR = NULL; }
#define FREE_SAFE(PTR)   { if( PTR != NULL ) free( PTR ); PTR = NULL; }
#define POT2CHRG(X)   ((X)*EVRYD/ELEM_CHARGE*gv.bin[nd]->Capacity - 1.)
#define CHRG2POT(X)   (((X)+1.)*ELEM_CHARGE/EVRYD/gv.bin[nd]->Capacity)
#define ONE_ELEC   (ELEM_CHARGE/EVRYD/gv.bin[nd]->Capacity)
#define EPSP(Z_0, Z)   ( ((Z) <= (Z_0)) ? 0. : (((Z) >= (Z_0)+1) ? 1. : (double)((Z)-(Z_0))) )

Functions

STATIC void InitEmissivities (void)
STATIC double PlanckIntegral (double, long, long)
STATIC void NewChargeData (long)
STATIC double GrnStdDpth (long)
STATIC void GrainChargeTemp (void)
STATIC void GrainCharge (long, double *)
STATIC double GrainElecRecomb1 (long, long, double *, double *)
STATIC double GrainElecEmis1 (long, long, double *, double *, double *, double *, double *)
STATIC void GrainScreen (long, long, long, double *, double *)
STATIC double ThetaNu (double)
STATIC void UpdatePot (long, long, long, double[], double[])
STATIC void GetFracPop (long, long, double[], double[], long *)
STATIC void UpdatePot1 (long, long, long, long)
STATIC void UpdatePot2 (long, long)
STATIC long HighestIonStage (void)
STATIC void UpdateRecomZ0 (long, long, bool)
STATIC void GetPotValues (long, long, double *, double *, double *, double *, double *, bool)
STATIC void GrainIonColl (long, long, long, long, const double[], const double[], long *, float *, float *)
STATIC void GrainChrgTransferRates (long)
STATIC void GrainUpdateRadius1 (void)
STATIC void GrainUpdateRadius2 (bool)
STATIC void GrainTemperature (long, float *, double *, double *, double *)
STATIC void GrainCollHeating (long, float *, float *)
STATIC double GrnVryDpth (long)
void GrainZero (void)
void GrainStartIter (void)
void GrainRestartIter (void)
void SetNChrgStates (long nChrg)
long NewGrainBin (void)
void ReturnGrainBins (void)
void GrainsInit (void)
STATIC double PlanckIntegral (double tdust, long int nd, long int ip)
STATIC double GrnStdDpth (long int nd)
void GrainDrive (void)
STATIC void GrainCharge (long int nd, double *ThermRatio)
STATIC void GrainIonColl (long int nd, long int nz, long int nelem, long int ion, const double phi_s_up[], const double phi_s_dn[], long *Z0, float *ChEn, float *ChemEn)
STATIC void GrainTemperature (long int nd, float *dccool, double *hcon, double *hots, double *hla)
void PE_init (long nd, long nz, long i, double *cs1, double *cs2, double *cs_tot, double *cool1, double *cool2, double *ehat1, double *ehat2)
STATIC void GrainCollHeating (long int nd, float *dcheat, float *dccool)
void GrainDrift (void)
STATIC double GrnVryDpth (long int nd)

Variables

static const int INCL_TUNNEL = true
static const int NO_TUNNEL = false
static const int ALL_STAGES = true
static long int nCalledGrainDrive
static const long NTOP = NDEMS/5
static const double THERMCONST = PI4*ELECTRON_MASS*POW2(BOLTZMANN)/POW3(HPLANCK)
static const double STICK_ELEC = 0.5
static const double STICK_ION = 1.0
static const double MEAN_PATH = 1.e-7
static const double TOLER = CONSERV_TOL/10.
static const long BRACKET_MAX = 50L
static const int NCHU = NCHS/3
static const long CT_LOOP_MAX = 25L
static const long T_LOOP_MAX = 50L
static double HEAT_TOLER = DBL_MAX
static double HEAT_TOLER_BIN = DBL_MAX
static double CHRG_TOLER = DBL_MAX
static bool lgGvInitialized = false
static const double AC0 = 3.e-9
static const double AC1G = 4.e-8
static const double AC2G = 7.e-8


Define Documentation

#define CHRG2POT (  )     (((X)+1.)*ELEM_CHARGE/EVRYD/gv.bin[nd]->Capacity)

Definition at line 34 of file grains.cpp.

Referenced by GetPotValues(), GrainCharge(), GrainDrive(), and GrainsInit().

#define EPSP ( Z_0,
 )     ( ((Z) <= (Z_0)) ? 0. : (((Z) >= (Z_0)+1) ? 1. : (double)((Z)-(Z_0))) )

Definition at line 38 of file grains.cpp.

Referenced by GrainElecRecomb1().

#define FREE_CHECK ( PTR   )     { ASSERT( PTR != NULL ); free( PTR ); PTR = NULL; }

#define FREE_SAFE ( PTR   )     { if( PTR != NULL ) free( PTR ); PTR = NULL; }

#define ONE_ELEC   (ELEM_CHARGE/EVRYD/gv.bin[nd]->Capacity)

Definition at line 35 of file grains.cpp.

Referenced by GetPotValues(), and GrainsInit().

#define POT2CHRG (  )     ((X)*EVRYD/ELEM_CHARGE*gv.bin[nd]->Capacity - 1.)

Definition at line 33 of file grains.cpp.

Referenced by GrainsInit().


Function Documentation

STATIC void GetFracPop ( long  nd,
long  Zlo,
double  rate_up[],
double  rate_dn[],
long *  newZlo 
)

Definition at line 2642 of file grains.cpp.

References ASSERT, t_gv::bin, cdEXIT(), GrainBin::chDstLab, GrainBin::chrg, DEBUG_ENTRY, DEBUG_EXIT, fnzone, ChargeBin::FracPop, gv, ioQQQ, GrainBin::LowestZg, MAX2, t_gv::nBin, GrainBin::nChrg, NCHU, ShowMe(), x1, and x2.

Referenced by GrainCharge().

Here is the call graph for this function:

STATIC void GetPotValues ( long  nd,
long  Zg,
double *  ThresInf,
double *  ThresInfVal,
double *  ThresSurf,
double *  ThresSurfVal,
double *  PotSurf,
bool  lgUseTunnelCorr 
)

STATIC void GrainCharge ( long int  nd,
double *  ThermRatio 
)

STATIC void GrainCharge ( long  ,
double *   
)

Referenced by GrainChargeTemp().

STATIC void GrainChargeTemp ( void   ) 

Todo:
2 this algorithm might be more efficient with Brent

Todo:
2 should collisional heating/cooling be included here?

Todo:
2 use something like log(ThermRatio) + log(delta) ????

Todo:
2 this algorithm might be more efficient with Brent

Definition at line 1406 of file grains.cpp.

References ASSERT, GrainBin::AveDustZ, t_conv::BadConvIoniz, t_gv::bin, t_conv::chConvIoniz, GrainBin::chDstLab, t_elementnames::chElementSym, GrainBin::ChemEn, GrainBin::ChemEnH2, GrainBin::chrg, CHRG_TOLER, GrainBin::cnv_GR_pCM3, GrainBin::cnv_H_pCM3, conv, ConvFail(), t_thermal::ctot, DEBUG_ENTRY, DEBUG_EXIT, dense, t_gv::dHeatdT, GrainBin::dstems, GrainBin::dstpot, GrainBin::dstslp2, t_gv::dsttmp, ChargeBin::DustZ, t_dense::eden, elementnames, fnzone, ChargeBin::FracPop, fudge(), t_dense::gas_phase, t_gv::GasCoolColl, t_gv::GasHeatNet, GrainBin::GasHeatPhotoEl, t_gv::GasHeatPhotoEl, t_gv::GasHeatTherm, GRAIN_TMAX, GRAIN_TMIN, GrainCharge(), GrainChrgTransferRates(), t_gv::GrainChTrRate, GrainBin::GrainGasCool, GrainBin::GrainHeat, t_gv::GrainHeatChem, GrainBin::GrainHeatColl, t_gv::GrainHeatCollSum, t_gv::GrainHeatDif, t_gv::GrainHeatInc, t_gv::GrainHeatLya, t_gv::GrainHeatSum, GrainTemperature(), GrainUpdateRadius1(), GrainUpdateRadius2(), t_gv::GrnRecomTe, gv, HEAT_TOLER, HEAT_TOLER_BIN, t_gv::HighestIon, HighestIonStage(), ionbal, t_dense::IonHigh, t_dense::IonLow, ioQQQ, ipHYDROGEN, lgAbort, t_conv::lgConvIoniz, t_trace::lgDustBug, t_dense::lgElmtOn, t_ionbal::lgGrainIonRecom, GrainBin::lgPAHsInIonizedRegion, t_conv::lgSearch, GrainBin::lgTdustConverged, t_trace::lgTrace, LIMELM, MAT_PAH, MAT_PAH2, GrainBin::matType, t_gv::nBin, GrainBin::nChrg, NDEMS, NewChargeData(), nzone, t_gv::nzone, phycon, POW2, splint_safe(), T_LOOP_MAX, t_phycon::te, TE1RYD, GrainBin::tedust, thermal, GrainBin::thermionic, ChargeBin::ThresInf, TOLER, TorF(), t_gv::TotalEden, TotalInsanity(), trace, and t_dense::xIonDense.

Referenced by GrainDrive().

Here is the call graph for this function:

STATIC void GrainChrgTransferRates ( long  nd  ) 

STATIC void GrainCollHeating ( long int  nd,
float *  dcheat,
float *  dccool 
)

STATIC void GrainCollHeating ( long  ,
float *  ,
float *   
)

Referenced by GrainTemperature().

void GrainDrift ( void   ) 

void GrainDrive ( void   ) 

GrainDrive main routine to converge grains thermal solution

Definition at line 1243 of file grains.cpp.

References GrainBin::avdft, GrainBin::avDGRatio, GrainBin::avdpot, GrainBin::avdust, GrainBin::AveDustZ, t_gv::bin, GrainBin::BolFlux, GrainBin::ChemEn, GrainBin::ChemEnH2, GrainBin::chrg, CHRG2POT, conv, t_thermal::ctot, t_gv::dclmax, DEBUG_ENTRY, DEBUG_EXIT, dense, t_gv::dphmax, GrainBin::dstpot, GrainBin::DustDftVel, ChargeBin::DustZ, t_dense::eden, t_conv::EdenErrorAllowed, EVRYD, ChargeBin::FracPop, t_dense::gas_phase, t_gv::GasCoolColl, GrainBin::GasHeatPhotoEl, t_gv::GasHeatPhotoEl, GrainChargeTemp(), t_gv::GrainChTrRate, GrainBin::GrainCoolTherm, GrainBin::GrainHeat, t_gv::GrainHeatChem, GrainBin::GrainHeatColl, t_gv::GrainHeatCollSum, t_gv::GrainHeatDif, t_gv::GrainHeatInc, t_gv::GrainHeatLya, t_gv::GrainHeatScaleFactor, t_gv::GrainHeatSum, GrainUpdateRadius1(), GrainUpdateRadius2(), t_gv::GrnElecDonateMax, t_gv::GrnElecHoldMax, gv, t_thermal::heating, hmi, ioQQQ, ipHYDROGEN, t_gv::lgAnyDustVary, t_gv::lgAnyNegCharge, t_gv::lgBakesPAH_heat, t_gv::lgDustOn, GrainBin::lgEverQHeat, t_gv::lgGrainPhysicsOn, GrainBin::lgPAHsInIonizedRegion, t_gv::lgReevaluate, t_conv::lgSearch, GrainBin::lgUseQHeat, LIMELM, t_gv::nBin, nCalledGrainDrive, GrainBin::nChrg, ChargeBin::nfill, t_trace::nTrConvg, nzone, phycon, GrainBin::QHeatFailures, SDIV(), t_phycon::te, GrainBin::tedust, ChargeBin::tedust, GrainBin::TeGrainMax, thermal, GrainBin::thermionic, t_gv::TotalDustHeat, t_gv::TotalEden, trace, and t_hmi::UV_Cont_rel2_Habing_TH85_depth.

Referenced by ConvBase(), and hmole_step().

Here is the call graph for this function:

STATIC double GrainElecEmis1 ( long  nd,
long  nz,
double *  sum1a,
double *  sum1b,
double *  sum1c,
double *  sum2,
double *  sum3 
)

Todo:
2 note that the number of primary electrons is given by yhat, which may not be one, so this is not necessarily consistent

Todo:
2 avAuger depends on grain charge, this should be treated explicitly here

Definition at line 2282 of file grains.cpp.

References ASSERT, t_DoppVel::AveVel, t_gv::bin, GrainBin::chrg, ChargeBin::cs_pdt, DEBUG_ENTRY, DEBUG_EXIT, dense, DoppVel, GrainBin::dstab1, ChargeBin::DustZ, ChargeBin::ESum1a, ChargeBin::ESum1b, ChargeBin::ESum1c, ChargeBin::ESum2, t_rfield::flux, GrainScreen(), gv, GrainBin::IntArea, ChargeBin::ipThresInf, ChargeBin::ipThresInfVal, t_dense::lgElmtOn, LIMELM, MAX2, t_gv::nBin, GrainBin::nChrg, t_rfield::nflux, ChargeBin::RecomZ0, rfield, STICK_ION, t_rfield::SummedCon, ChargeBin::ThermRate, t_dense::xIonDense, and ChargeBin::yhat.

Referenced by GrainCharge(), GrainCollHeating(), and UpdatePot().

Here is the call graph for this function:

STATIC double GrainElecRecomb1 ( long  nd,
long  nz,
double *  sum1,
double *  sum2 
)

STATIC void GrainIonColl ( long int  nd,
long int  nz,
long int  nelem,
long int  ion,
const double  phi_s_up[],
const double  phi_s_dn[],
long *  Z0,
float *  ChEn,
float *  ChemEn 
)

Definition at line 3263 of file grains.cpp.

References t_rfield::anu, t_gv::bin, GrainBin::chrg, DEBUG_ENTRY, DEBUG_EXIT, ChargeBin::DustZ, GetPotValues(), gv, Heavy, t_Heavy::ipHeavy, GrainBin::LowestZg, NO_TUNNEL, and rfield.

Here is the call graph for this function:

STATIC void GrainIonColl ( long  ,
long  ,
long  ,
long  ,
const   double[],
const   double[],
long *  ,
float *  ,
float *   
)

Referenced by UpdateRecomZ0().

void GrainRestartIter ( void   ) 

STATIC void GrainScreen ( long  ion,
long  nd,
long  nz,
double *  eta,
double *  xi 
)

void GrainsInit ( void   ) 

startup routine for grains, called before first calculations, but after parsecommands

Definition at line 508 of file grains.cpp.

References t_rfield::anu, t_gv::anumax, t_gv::anumin, ASSERT, GrainBin::asym, ATOMIC_MASS_UNIT, atoms, GrainBin::atomWeight, GrainBin::AvRadius, GrainBin::AvVol, GrainBin::BandGap, t_gv::bin, cdEXIT(), GrainBin::chDstLab, GrainBin::chrg, CHRG2POT, CHRG_TOLER, GrainBin::cnv_CM3_pGR, GrainBin::cnv_CM3_pH, GrainBin::cnv_GR_pCM3, GrainBin::cnv_H_pCM3, GrainBin::cnv_H_pGR, t_thermal::ConstGrainTemp, conv, ChargeBin::cs_pdt, DEBUG_ENTRY, DEBUG_EXIT, dense, t_gv::dstab, GrainBin::dstab1, GrainBin::dstAbund, GrainBin::dstfactor, t_gv::dstsc, GrainBin::dustp, GrainBin::DustWorkFcn, ChargeBin::DustZ, t_conv::EdenErrorAllowed, GrainBin::elmAbund, t_gv::elmSumAbund, ChargeBin::fac1, ChargeBin::fac2, ChargeBin::FracPop, t_dense::gas_phase, t_gv::GasCoolColl, GetPotValues(), t_gv::GrainEmission, t_gv::GrainHeatCollSum, t_gv::GrainHeatDif, t_gv::GrainHeatInc, t_gv::GrainHeatLya, t_gv::GrainHeatSum, t_gv::GrainMetal, t_gv::GraphiteEmission, t_gv::GrnRecomTe, GrnVryDpth(), gv, HEAT_TOLER, HEAT_TOLER_BIN, t_conv::HeatCoolRelErrorAllowed, t_thermal::heating, INCL_TUNNEL, InitEmissivities(), InitEnthalpy(), GrainBin::IntArea, GrainBin::inv_att_len, ioQQQ, ipHYDROGEN, t_gv::lgAnyDustVary, t_gv::lgAnyNegCharge, t_gv::lgBakes, t_trace::lgDustBug, GrainBin::lgDustFunc, t_gv::lgDustOn, GrainBin::lgQHeat, t_gv::lgQHeatAll, t_gv::lgQHeatOn, GrainBin::lgQHTooWide, t_trace::lgTrace, LIMELM, GrainBin::LowestPot, GrainBin::LowestZg, MALLOC, MAT_PAH, MAT_PAH2, GrainBin::matType, MAX2, MEAN_PATH, t_gv::nBin, GrainBin::nChrg, NCHS, NCHU, NDUST, t_gv::nfill, ChargeBin::nfill, nint(), t_rfield::nupper, t_gv::nzone, ONE_ELEC, POT2CHRG, POW2, POW3, GrainBin::pure_sc1, GrainBin::qtmin, GrainBin::qtmin_zone1, rfield, t_gv::SilicateEmission, STICK_ELEC, GrainBin::StickElecNeg, GrainBin::StickElecPos, ChargeBin::tedust, thermal, TorF(), trace, t_gv::which_zmin, t_rfield::widflx, GrainBin::y1, ChargeBin::yhat, ZMIN_BAKES, ZMIN_CAR, and ZMIN_SIL.

Referenced by OpacityCreateAll().

Here is the call graph for this function:

void GrainStartIter ( void   ) 

STATIC void GrainTemperature ( long int  nd,
float *  dccool,
double *  hcon,
double *  hots,
double *  hla 
)

STATIC void GrainTemperature ( long  ,
float *  ,
double *  ,
double *  ,
double *   
)

Referenced by GrainChargeTemp().

STATIC void GrainUpdateRadius1 ( void   ) 

STATIC void GrainUpdateRadius2 ( bool  lgAnyNegCharge  ) 

void GrainZero ( void   ) 

STATIC double GrnStdDpth ( long int  nd  ) 

STATIC double GrnStdDpth ( long   ) 

Referenced by GrnVryDpth().

STATIC double GrnVryDpth ( long int  nd  ) 

Definition at line 4381 of file grains.cpp.

References ASSERT, t_gv::bin, DEBUG_ENTRY, DEBUG_EXIT, dense, t_dense::gas_phase, GrnStdDpth(), gv, ipHYDROGEN, GrainBin::lgDustFunc, and t_dense::xIonDense.

Here is the call graph for this function:

STATIC double GrnVryDpth ( long   ) 

Referenced by GrainsInit(), and GrainUpdateRadius1().

STATIC long HighestIonStage ( void   ) 

Definition at line 3081 of file grains.cpp.

References DEBUG_ENTRY, DEBUG_EXIT, dense, t_dense::lgElmtOn, LIMELM, MAX2, and t_dense::xIonDense.

Referenced by GrainChargeTemp().

STATIC void InitEmissivities ( void   ) 

STATIC void NewChargeData ( long  nd  ) 

long NewGrainBin ( void   ) 

void PE_init ( long  ,
long  ,
long  ,
double *  ,
double *  ,
double *  ,
double *  ,
double *  ,
double *  ,
double *   
)

helper routine for initializing quantities related to the photo-electric effect

Parameters:
nd 
nz 
i 
*cs1 [out]
*cs2 [out]
*cs_tot [out]
*cool1 [out]
*cool2 [out]
*ehat1 [out]
*ehat2 [out]

Definition at line 3804 of file grains.cpp.

References t_rfield::anu, ASSERT, t_gv::bin, GrainBin::chrg, ChargeBin::cs_pdt, DEBUG_ENTRY, DEBUG_EXIT, GrainBin::dstab1, ChargeBin::DustZ, Ehi, Elo, gv, ChargeBin::ipThresInf, ChargeBin::ipThresInfVal, MAX2, t_gv::nBin, GrainBin::nChrg, t_rfield::nflux, ChargeBin::PotSurf, rfield, ChargeBin::ThresInf, ChargeBin::ThresInfVal, ChargeBin::ThresSurf, ChargeBin::ThresSurfVal, and ChargeBin::yhat.

Referenced by qheat_init(), and UpdatePot1().

STATIC double PlanckIntegral ( double  tdust,
long int  nd,
long int  ip 
)

STATIC double PlanckIntegral ( double  ,
long  ,
long   
)

Referenced by InitEmissivities().

void ReturnGrainBins ( void   ) 

void SetNChrgStates ( long   ) 

this routine is called by ParseSet()

Definition at line 359 of file grains.cpp.

References ASSERT, DEBUG_ENTRY, DEBUG_EXIT, gv, t_gv::nChrgRequested, and NCHU.

Referenced by ParseSet().

STATIC double ThetaNu ( double  nu  ) 

Definition at line 2502 of file grains.cpp.

References DEBUG_ENTRY, DEBUG_EXIT, and POW2.

Referenced by GetPotValues(), and GrainScreen().

STATIC void UpdatePot ( long  nd,
long  Zlo,
long  stride,
double  rate_up[],
double  rate_dn[] 
)

STATIC void UpdatePot1 ( long  nd,
long  nz,
long  Zg,
long  ipStart 
)

STATIC void UpdatePot2 ( long  nd,
long  nz 
)

STATIC void UpdateRecomZ0 ( long  nd,
long  nz,
bool  lgAllIonStages 
)


Variable Documentation

const double AC0 = 3.e-9 [static]

Definition at line 98 of file grains.cpp.

Referenced by GetPotValues().

const double AC1G = 4.e-8 [static]

Definition at line 99 of file grains.cpp.

Referenced by GetPotValues().

const double AC2G = 7.e-8 [static]

Definition at line 100 of file grains.cpp.

Referenced by GetPotValues().

const int ALL_STAGES = true [static]

Definition at line 43 of file grains.cpp.

Referenced by UpdatePot1().

const long BRACKET_MAX = 50L [static]

Definition at line 72 of file grains.cpp.

Referenced by GrainCharge().

double CHRG_TOLER = DBL_MAX [static]

Definition at line 89 of file grains.cpp.

Referenced by GrainChargeTemp(), and GrainsInit().

const long CT_LOOP_MAX = 25L [static]

Definition at line 81 of file grains.cpp.

double HEAT_TOLER = DBL_MAX [static]

Definition at line 87 of file grains.cpp.

Referenced by GrainChargeTemp(), and GrainsInit().

double HEAT_TOLER_BIN = DBL_MAX [static]

Definition at line 88 of file grains.cpp.

Referenced by GrainChargeTemp(), and GrainsInit().

const int INCL_TUNNEL = true [static]

Definition at line 40 of file grains.cpp.

Referenced by GrainsInit(), UpdatePot1(), and UpdateRecomZ0().

bool lgGvInitialized = false [static]

Definition at line 95 of file grains.cpp.

Referenced by NewGrainBin(), and ReturnGrainBins().

const double MEAN_PATH = 1.e-7 [static]

Definition at line 67 of file grains.cpp.

Referenced by GrainsInit().

long int nCalledGrainDrive [static]

Definition at line 48 of file grains.cpp.

Referenced by GrainDrive(), and GrainZero().

const int NCHU = NCHS/3 [static]

Definition at line 76 of file grains.cpp.

Referenced by GetFracPop(), GrainCharge(), GrainsInit(), and SetNChrgStates().

const int NO_TUNNEL = false [static]

Definition at line 41 of file grains.cpp.

Referenced by GrainIonColl(), UpdatePot1(), and UpdateRecomZ0().

const long NTOP = NDEMS/5 [static]

Definition at line 54 of file grains.cpp.

Referenced by InitEmissivities().

const double STICK_ELEC = 0.5 [static]

Definition at line 63 of file grains.cpp.

Referenced by GrainsInit().

const double STICK_ION = 1.0 [static]

const long T_LOOP_MAX = 50L [static]

Definition at line 84 of file grains.cpp.

Referenced by GrainChargeTemp().

const double THERMCONST = PI4*ELECTRON_MASS*POW2(BOLTZMANN)/POW3(HPLANCK) [static]

Definition at line 60 of file grains.cpp.

Referenced by UpdatePot2().

const double TOLER = CONSERV_TOL/10. [static]

Definition at line 71 of file grains.cpp.

Referenced by GrainChargeTemp(), mie_auxiliary(), and search_limit().


Generated for cloudy by doxygen 1.5.9