/home66/gary/public_html/cloudy/c10_branch/source/h2.h File Reference

Go to the source code of this file.

Data Structures

struct  t_h2

Defines

#define N_H2_ELEC   7

Functions

void H2_Create (void)
void H2_ContPoint (void)
double H2_DR (void)
void H2_Init (void)
void H2_init_coreload (void)
double H2_Accel (void)
void H2_RT_OTS (void)
double H2_RadPress (void)
void H2_LinesAdd (void)
void H2_Reset (void)
double H2_InterEnergy (void)
void H2_Colden (const char *chLabel)
void H2_Cooling (const char *chString)
void H2_Punch_line_data (FILE *ioPUN, bool lgDoAll)
void H2_PunchLineStuff (FILE *io, realnum xLimit, long index)
void H2_RT_diffuse (void)
void H2_RTMake (void)
void H2_RT_tau_inc (void)
void H2_Zero (void)
void H2_Prt_Zone (void)
void H2_LineZero (void)
void H2_RT_tau_reset (void)
void H2_LevelPops (void)
void H2_PunchDo (FILE *io, char chJOB[], const char chTime[], long int ipPun)
void H2_Prt_line_tau (void)
void H2_ParseSave (Parser &p, char *chHeader)
double H2_itrzn (void)
void H2_Prt_column_density (FILE *ioMEAN)

Variables

bool lgH2_READ_DATA
EXTERN struct t_h2 h2

Define Documentation

#define N_H2_ELEC   7

this is the number of electronic levels

Definition at line 9 of file h2.h.

Referenced by H2_Init(), H2_init_coreload(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_Zero(), and ParseAtomH2().


Function Documentation

double H2_Accel ( void   ) 

radiative acceleration due to H2 called in rt_line_driving

Definition at line 364 of file mole_h2.cpp.

References ASSERT, DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, and t_h2::nVib_hi.

Referenced by RT_line_driving().

void H2_Colden ( const char *  chLabel  ) 

H2_Colden maintain H2 column densities within X

Parameters:
*chLabel 

Definition at line 3545 of file mole_h2.cpp.

References cdEXIT, DEBUG_ENTRY, t_radius::drad_x_fillfac, h2, H2_populations, H2_populations_LTE, t_hmi::H2_total, H2_X_colden, H2_X_colden_LTE, hmi, ioQQQ, t_h2::Jlowest, t_h2::lgH2ON, t_h2::nRot_hi, t_h2::nVib_hi, and radius.

Referenced by molcol().

void H2_ContPoint ( void   ) 

set the ipCont struc element for the H2 molecule, called by ContCreatePointers

Definition at line 305 of file mole_h2.cpp.

References ASSERT, DEBUG_ENTRY, h2, H2Lines, ipFineCont(), ipLineEnergy(), t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, and WAVNRYD.

Referenced by ContCreatePointers().

Here is the call graph for this function:

void H2_Cooling ( const char *  chString  ) 
void H2_Create ( void   ) 

create H2 molecules, called by ContCreatePointers

Todo:
1 add this as a Lya excitation process

Definition at line 81 of file mole_h2_create.cpp.

References abscf(), AddState2Stack(), multi_arr< T, d, ALLOC, lgBC >::alloc(), ASSERT, BIGFLOAT, cdEXIT, t_hmi::chGrainFormPump, multi_arr< T, d, ALLOC, lgBC >::clone(), CollRateFit, DEBUG_ENER, DEBUG_ENTRY, EH2_eval(), EN1EV, ENERGY_H2_STAR, energy_off, energy_wn, ERG1CM, GetGF(), h2, H2_Boltzmann, H2_col_rate_in, H2_col_rate_out, H2_coll_dissoc_rate_coef, H2_coll_dissoc_rate_coef_H2, H2_CollidRateRead(), H2_CollRate, H2_disske, H2_DissocEnergies, H2_dissprob, H2_energies, H2_ipPhoto, H2_ipX_ener_sort, H2_lgOrtho, H2_nRot_add_ortho_para, H2_old_populations, H2_populations, H2_populations_LTE, H2_rad_rate_in, H2_rad_rate_out, H2_Read_hminus_distribution(), H2_ReadDissprob(), H2_ReadEnergies(), H2_ReadTransprob(), H2_SaveLine, H2_stat, H2_TOP, H2_vib_dist(), H2_X_colden, H2_X_colden_LTE, H2_X_coll_rate, H2_X_formation, H2_X_grain_formation_distribution, H2_X_Hmin_back, H2_X_hminus_formation_distribution, H2_X_rate_from_elec_excited, H2_X_rate_to_elec_excited, H2_X_sink, H2_X_source, H2Lines, hmi, HPLANCK, ioQQQ, ipCRDW, ipElec_H2_energy_sort, ipEnergySort, ipoint(), ipRot_H2_energy_sort, ipVib_H2_energy_sort, is_odd(), t_h2::Jlowest, lgH2_line_exists, t_mole::lgH2_NOISE, lgH2_READ_DATA, t_h2::lgH2ON, LIMELM, MALLOC, MAX2, mole, t_mole::n_h2_elec_states, N_X_COLLIDER, t_h2::nElecLevelOutput, nEner_H2_ground, nH2_energies, t_mole::nH2_TRACE, t_mole::nH2_trace_full, nLevels_per_elec, t_h2::nRot_hi, nTE_HMINUS, t_h2::nVib_hi, nXLevelsMatrix, opac, PI, PI4, pops_per_vib, pow(), POW2, pow3(), RandGauss(), RefIndex(), multi_arr< T, d, ALLOC, lgBC >::reserve(), sexp(), SMALLFLOAT, spsort(), T1CM, t_opac::taumin, TotalInsanity(), VIB_COLLID, WAVNRYD, t_mole::xMeanNoise, t_mole::xSTDNoise, and multi_arr< T, d, ALLOC, lgBC >::zero().

Referenced by ContCreatePointers().

Here is the call graph for this function:

double H2_DR ( void   ) 

H2_DR choose next zone thickness based on H2 big molecule

Definition at line 3598 of file mole_h2.cpp.

References BIGFLOAT.

Referenced by radius_next().

void H2_Init ( void   ) 

H2_Init - called by cdInit to init H2

Definition at line 445 of file mole_h2_etc.cpp.

References DEBUG_ENTRY, h2, mole, N_H2_ELEC, t_mole::n_h2_elec_states, and t_h2::nCallH2_this_zone.

Referenced by zero().

void H2_init_coreload ( void   ) 

H2_init_coreload one time initialization

Definition at line 373 of file mole_h2_etc.cpp.

References chH2ColliderLabels, DEBUG_ENTRY, h2, t_h2::Jlowest, N_H2_ELEC, t_h2::nRot_hi, and t_h2::nVib_hi.

Referenced by InitCoreload().

double H2_InterEnergy ( void   ) 

internal energy of H2 called in PresTotCurrent

Referenced by PresTotCurrent().

double H2_itrzn ( void   ) 

H2_itrzn - average number of H2 pop evaluations per zone

Definition at line 292 of file mole_h2.cpp.

References h2, t_h2::lgH2ON, nH2_pops, and nH2_zone.

Referenced by PrtFinal().

void H2_LevelPops ( void   ) 

do level populations for H2, called by iso_solve

Todo:
2 - put H2Lines in outward beams in RT_diffuse
Todo:
2 put supra thermal excitation into excitation of electronic bands

Definition at line 1385 of file mole_h2.cpp.

References ASSERT, t_hmi::Average_A, t_hmi::Average_collH2_deexcit, t_hmi::Average_collH2_excit, t_hmi::Average_collH2g_dissoc, t_hmi::Average_collH2s_dissoc, t_hmi::Average_collH_deexcit, t_hmi::Average_collH_excit, t_conv::chConvIoniz, t_rfield::ConInterOut, conv, ConvFail(), t_thermal::ctot, DEBUG_ENTRY, dense, t_dense::eden, t_conv::EdenErrorAllowed, ENERGY_H2_STAR, energy_wn, EVRYD, exp_disoc, t_rfield::flux, fnzone, fp_equal(), FRAC, t_dense::gas_phase, h2, t_hmi::H2_BigH2_H2g_av, t_hmi::H2_BigH2_H2s_av, H2_Boltzmann, t_hmi::H2_chem_BigH2_H2g, t_hmi::H2_chem_BigH2_H2s, H2_col_rate_in, H2_col_rate_out, H2_coll_dissoc_rate_coef_H2, H2_CollidRateEvalAll(), H2_CollRate, H2_Cooling(), H2_den_g, H2_den_s, H2_DISS_ALLISON_DALGARNO, H2_dissprob, H2_energies, t_hmi::H2_frac_abund_set, H2_gs_rates(), t_hmi::H2_H2g_to_H2s_rate_BigH2, t_hmi::H2_H2g_to_H2s_rate_TH85, H2_ipX_ener_sort, H2_Level_low_matrix(), H2_lgOrtho, H2_old_populations, t_hmi::H2_photodissoc_BigH2_H2g, t_hmi::H2_photodissoc_BigH2_H2s, t_hmi::H2_photodissoc_TH85, H2_populations, H2_populations_LTE, H2_rad_rate_in, H2_rad_rate_out, t_hmi::H2_rate_destroy, H2_renorm_chemistry, t_hmi::H2_Solomon_dissoc_rate_BigH2_H2g, t_hmi::H2_Solomon_dissoc_rate_BigH2_H2s, t_hmi::H2_Solomon_dissoc_rate_TH85_H2g, t_hmi::H2_Solomon_dissoc_rate_used_H2g, H2_Solomon_rate(), H2_stat, H2_sum_excit_elec_den, t_mole::H2_to_H_limit, t_hmi::H2_total, t_hmi::H2_total_BigH2, t_hmi::H2_tripletdissoc_H2g, t_hmi::H2_tripletdissoc_H2s, H2_X_coll_rate, H2_X_coll_rate_evaluate(), H2_X_rate_from_elec_excited, H2_X_rate_to_elec_excited, H2_X_sink, H2_X_source, H2_zero_pops_too_low(), t_hmi::H2g_BigH2, t_hmi::H2g_LTE_bigH2, H2Lines, t_hmi::H2s_BigH2, t_hmi::H2s_LTE_bigH2, t_conv::HeatCoolRelErrorAllowed, t_hmi::HeatH2Dexc_BigH2, hmi, t_hmi::Hmolec, t_thermal::htot, INT32_MAX, ioQQQ, ipHYDROGEN, ipMH2g, ipMH2s, ipoint(), ipRot_H2_energy_sort, ipVib_H2_energy_sort, iteration, t_h2::Jlowest, lgAbort, t_hmi::lgBigH2_evaluated, t_conv::lgConvPops, lgH2_line_exists, t_mole::lgH2_LTE, t_h2::lgH2ON, t_rfield::lgInducProcess, t_hmi::lgLeidenCRHack, t_conv::lgSearch, t_thermal::lgTemperatureConstant, t_trace::lgTr_H2_Mole, t_trace::lgTrace, LIM_H2_POP_LOOP, loop_h2_pops, MAX2, mole, mole_H2_form(), mole_H2_LTE(), t_mole::n_h2_elec_states, nCallH2_this_iteration, t_h2::nCallH2_this_zone, nH2_pops, t_mole::nH2_TRACE, t_mole::nH2_trace_final, t_mole::nH2_trace_full, t_mole::nH2_trace_iterations, nH2_zone, nLevels_per_elec, t_h2::nRot_hi, t_trace::nTrConvg, t_h2::nVib_hi, nXLevelsMatrix, nzone, nzone_nlevel_set, t_h2::ortho_density, t_rfield::outlin, t_rfield::outlin_noplot, t_h2::para_density, phycon, pops_per_elec, pops_per_vib, pow(), PRT_POPS, multi_arr< T, d, ALLOC, lgBC >::ptr(), t_hmi::rate_grain_h2_J1_to_J0, t_hmi::rate_grain_h2_op_conserve, rfield, SAHA, SDIV(), secondaries, SMALLFLOAT, t_phycon::te, t_phycon::te32, thermal, TorF(), TotalInsanity(), trace, WAVNRYD, and t_secondaries::x12tot.

Referenced by IonHydro(), and SaveLineData().

Here is the call graph for this function:

void H2_LinesAdd ( void   ) 

add in explicit lines from the large H2 molecule, called by lines_molecules

Definition at line 54 of file mole_h2_io.cpp.

References DEBUG_ENTRY, t_radius::dVeffAper, h2, H2_SaveLine, H2Lines, t_LineSave::ipass, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, lindst(), LineSave, t_h2::nElecLevelOutput, t_h2::nRot_hi, t_h2::nVib_hi, PutLine(), and radius.

Referenced by lines_molecules().

Here is the call graph for this function:

void H2_LineZero ( void   ) 

initialize optical depths in H2, called from RT_tau_init

Definition at line 757 of file mole_h2.cpp.

References DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, and t_h2::nVib_hi.

Referenced by RT_tau_init().

void H2_ParseSave ( Parser p,
char *  chHeader 
)

H2_ParseSave parse the save h2 command

Definition at line 149 of file mole_h2_io.cpp.

References cdEXIT, chH2ColliderLabels, chN_X_COLLIDER, t_save::chSave, DEBUG_ENTRY, Parser::getNumberDefault(), Parser::getNumberDefaultNegImplLog(), h2, ioQQQ, N_X_COLLIDER, t_h2::nElecLevelOutput, Parser::nMatch(), t_save::nsave, t_save::punarg, save, and thresh_punline_h2.

Referenced by ParseSave().

Here is the call graph for this function:

void H2_Prt_column_density ( FILE *  ioMEAN  ) 

H2_Prt_column_density print H2 info into zone results, called from prtzone for each printed zone

Parameters:
*ioMEAN this is stream used for io, is stdout when called by final, is save unit when save output generated

Definition at line 421 of file mole_h2_io.cpp.

References t_colden::colden, colden, DEBUG_ENTRY, h2, t_hmi::H2_total, H2_X_colden, hmi, ipCOL_H2g, ipCOL_H2s, t_h2::lgH2ON, t_h2::nCallH2_this_zone, t_h2::ortho_colden, t_h2::para_colden, pops_per_vib, PrintEfmt, and SDIV().

Referenced by PrtColumns().

Here is the call graph for this function:

void H2_Prt_line_tau ( void   ) 

print line optical depths, called from premet in response to print line optical depths command

Definition at line 1184 of file mole_h2_io.cpp.

References DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, and prme().

Referenced by prtmet().

Here is the call graph for this function:

void H2_Prt_Zone ( void   ) 

H2_Prt_Zone print H2 info into zone results, called from prtzone for each printed zone

Definition at line 387 of file mole_h2_io.cpp.

References DEBUG_ENTRY, h2, H2_populations, t_hmi::H2_total, hmi, ioQQQ, t_h2::lgH2ON, t_h2::nCallH2_this_zone, t_h2::ortho_density, t_h2::para_density, pops_per_vib, PrintEfmt, and SDIV().

Referenced by PrtZone().

Here is the call graph for this function:

void H2_Punch_line_data ( FILE *  ioPUN,
bool  lgDoAll 
)

save H2 line data

Parameters:
ioPUN io unit for save
lgDoAll save all levels if true, only subset if false

Todo:
1 add logic to deduce cs

Definition at line 1059 of file mole_h2_io.cpp.

References cdEXIT, DEBUG_ENTRY, h2, H2Lines, ioQQQ, t_h2::Jlowest, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, and Save1LineData().

Referenced by SaveLineData().

Here is the call graph for this function:

void H2_PunchDo ( FILE *  io,
char  chJOB[],
const char  chTime[],
long int  ipPun 
)

save some properties of the large H2 molecule

Parameters:
io 
chJOB[] 
chTime[] 
ipPun 

Definition at line 1254 of file mole_h2_io.cpp.

References ASSERT, t_hmi::assoc_detach, t_hmi::assoc_detach_backwards_exct, t_hmi::assoc_detach_backwards_grnd, multi_arr< T, d, ALLOC, lgBC >::begin(), t_hmi::bh2dis, t_hmi::bh2h22hh2, t_hmi::bh2h2p, chlgPara, chMolBranch(), co, t_colden::colden, colden, t_colden::coldenH2_ov_vel, t_radius::Conv2PrtInten, t_hmi::CR_reac_H2g, t_hmi::CR_reac_H2s, t_secondaries::csupra, t_thermal::ctot, DEBUG_ENTRY, dense, t_radius::depth_mid_zone, t_hmi::eh3_h2h, energy_wn, t_rfield::extin_mag_V_point, FRAC, t_dense::gas_phase, gv, h2, t_hmi::H2_BigH2_H2g_av, t_hmi::H2_BigH2_H2s_av, t_co::H2_C_CH_H, t_co::H2_CH2_CH3_H, t_co::H2_CH2P_CH3P_H, t_co::H2_CH3_CH4_H, t_co::H2_CH4P_CH5P_H, t_co::H2_CH_CH2_H, t_hmi::H2_chem_BigH2_H2g, t_hmi::H2_chem_BigH2_H2s, t_co::H2_CHP_CH2P_H, t_co::H2_ClP_HClP_H, t_co::H2_CN_HCN_H, t_co::H2_CNP_HCNP_H, H2_col_rate_in, H2_col_rate_out, H2_CollRate, t_co::H2_COP_HCOP_H, t_co::H2_CP_CHP_H, t_co::H2_CSP_HCSP_H, t_co::H2_H2OP_H3OP_H, t_co::H2_HClP_H2ClP_H, t_co::H2_HCNP_HCNHP_H, H2_ipX_ener_sort, H2_lgOrtho, t_co::H2_N_NH_H, t_co::H2_NH2_NH3_H, t_co::H2_NH2P_NH3P_H, t_co::H2_NH3P_NH4P_H, t_co::H2_NH_NH2_H, t_co::H2_NHP_N_H3P, t_co::H2_NHP_NH2P_H, t_co::H2_NP_NHP_H, t_co::H2_O_OH_H, t_co::H2_OH_H2O_H, t_co::H2_OHP_H2OP_H, H2_old_populations, t_co::H2_OP_OHP_H, t_hmi::H2_photodissoc_used_H2g, t_hmi::H2_photodissoc_used_H2s, H2_populations, H2_populations_LTE, H2_rad_rate_in, H2_rad_rate_out, t_hmi::H2_rate_create, t_hmi::H2_rate_destroy, H2_renorm_chemistry, H2_SaveLine, t_co::H2_SiOP_SiOHP_H, t_hmi::H2_Solomon_dissoc_rate_BD96_H2g, t_hmi::H2_Solomon_dissoc_rate_BD96_H2s, t_hmi::H2_Solomon_dissoc_rate_BigH2_H2g, t_hmi::H2_Solomon_dissoc_rate_BigH2_H2s, t_hmi::H2_Solomon_dissoc_rate_ELWERT_H2g, t_hmi::H2_Solomon_dissoc_rate_TH85_H2g, t_hmi::H2_Solomon_dissoc_rate_TH85_H2s, t_hmi::H2_Solomon_dissoc_rate_used_H2g, t_hmi::H2_Solomon_dissoc_rate_used_H2s, t_hmi::H2_Solomon_elec_decay_H2g, t_hmi::H2_Solomon_elec_decay_H2s, t_co::H2_SP_HSP_H, H2_stat, t_hmi::H2_total, t_hmi::H2_total_BigH2, H2_X_colden, H2_X_colden_LTE, t_hmi::H2g_BigH2, t_hmi::h2ge2h, t_hmi::h2h22hh2, t_hmi::h2hph3p, H2Lines, t_co::H2P_C2_C2P_H2, t_co::H2P_CH2_CH2P_H2, t_co::H2P_CH4_CH3P_H2, t_co::H2P_CH4_CH4P_H2, t_co::H2P_CH_CHP_H2, t_co::H2P_CN_CNP_H2, t_co::H2P_CO_COP_H2, t_co::H2P_H2O_H2OP_H2, t_co::H2P_HCN_HCNP_H2, t_co::H2P_NH2_NH2P_H2, t_co::H2P_NH3_NH3P_H2, t_co::H2P_NH_NHP_H2, t_co::H2P_NO_NOP_H2, t_co::H2P_O2_O2P_H2, t_co::H2P_OH_OHP_H2, t_hmi::h2ph3p, t_hmi::h2phmh2h, t_hmi::H2s_BigH2, t_co::H2s_C_CH_H, t_co::H2s_CH2_CH3_H, t_co::H2s_CH3_CH4_H, t_co::H2s_CH_CH2_H, t_co::H2s_CP_CHP_H, t_co::H2s_O_OH_H, t_co::H2s_OH_H2O_H, t_co::H2s_OP_OHP_H, t_hmi::h2s_sp_decay, t_hmi::h2se2h, t_hmi::h2sh, t_hmi::h2sh2g, t_hmi::h2sh2sh2g2h, t_hmi::h2sh2sh2s2h, t_hmi::h32h2, t_co::H3P_C_CHP_H2, t_co::H3P_CH2_CH3P_H2, t_co::H3P_CH3_CH4P_H2, t_co::H3P_CH4_CH5P_H2, t_co::H3P_CH_CH2P_H2, t_co::H3P_Cl_HClP_H2, t_co::H3P_CN_HCNP_H2, t_co::H3P_CO_HCOP_H2, t_co::H3P_CS_HCSP_H2, t_co::H3P_H2O_H3OP_H2, t_co::H3P_HCl_H2ClP_H2, t_co::H3P_HCN_HCNHP_H2, t_co::H3P_NH2_NH3P_H2, t_co::H3P_NH3_NH4P_H2, t_co::H3P_NH_NH2P_H2, t_co::H3P_NO2_NOP_OH_H2, t_co::H3P_NO_HNOP_H2, t_co::H3P_O_OHP_H2, t_co::H3P_OH_H2OP_H2, t_co::H3P_S_HSP_H2, t_co::H3P_SiH_SiH2P_H2, t_co::H3P_SiO_SiOHP_H2, t_hmi::h3petc, t_hmi::h3ph2hp, t_hmi::h3ph2p, t_hmi::h3phm2h2, t_hmi::h3phmh2hh, t_co::H_CH2_CH_H2, t_co::H_CH3_CH2_H2, t_co::H_CH3P_CH2P_H2, t_co::H_CH4P_CH3P_H2, t_co::H_CH5P_CH4P_H2, t_co::H_CH_C_H2, t_co::H_CHP_CP_H2, t_co::H_HSP_SP_H2, t_co::H_OH_O_H2, t_hmi::HeatH2Dexc_BigH2, t_hmi::HeatH2Dexc_TH85, t_hmi::HeatH2Dish_BigH2, t_hmi::HeatH2Dish_TH85, t_hmi::hehph2h3phe, t_hmi::heph2heh2p, hmi, t_co::Hminus_H3OP_H2O_H2, t_co::Hminus_H3OP_OH_H2_H, t_co::Hminus_HCOP_CO_H2, t_co::Hminus_NH4P_NH3_H2, t_hmi::Hmolec, t_co::HP_CH2_CHP_H2, t_co::HP_CH4_CH3P_H2, t_co::HP_HNO_NOP_H2, t_co::HP_HS_SP_H2, t_co::HP_SiH_SiP_H2, t_thermal::htot, hyperfine, ipCOL_H2g, ipCOL_H2s, ipHELIUM, ipHYDROGEN, ipMH, ipMH2g, ipMH2p, ipMH2s, ipMH3p, ipMHeHp, ipMHm, ipMHp, t_LineSave::ipNormWavL, ipRot_H2_energy_sort, ipVib_H2_energy_sort, t_h2::Jlowest, t_hmi::lgBigH2_evaluated, lgH2_line_exists, t_h2::lgH2ON, LineSave, LineSv, MAX2, MIN2, mole, t_mole::n_h2_elec_states, N_X_COLLIDER, t_h2::nCallH2_this_zone, t_h2::nElecLevelOutput, nLevels_per_elec, t_h2::nRot_hi, NSOL, t_LineSave::nsum, t_h2::nVib_hi, t_h2::ortho_colden, t_h2::ortho_density, t_h2::para_colden, t_h2::para_density, phycon, pops_per_elec, prt_wl(), t_save::punarg, t_hmi::radasc, radius, GrainVar::rate_h2_form_grains_used_total, rfield, t_hmi::rh2dis, t_hmi::rh2h2p, t_hmi::rheph2hpheh, save, t_LineSave::ScaleNormLine, SDIV(), secondaries, SMALLFLOAT, spsort(), t_tag_LineSv::SumLine, T1CM, t_phycon::te, thermal, thresh_punline_h2, t_hyperfine::Tspin21cm, t_hmi::UV_Cont_rel2_Draine_DB96_depth, t_hmi::UV_Cont_rel2_Habing_spec_depth, t_hmi::UV_Cont_rel2_Habing_TH85_depth, wl, and t_dense::xIonDense.

Referenced by SaveDo().

Here is the call graph for this function:

void H2_PunchLineStuff ( FILE *  io,
realnum  xLimit,
long  index 
)

include H2 lines in punched optical depths, etc, called from SaveLineStuff

Parameters:
io 
xLimit 
index 

Definition at line 1130 of file mole_h2_io.cpp.

References t_dense::AtomicWeight, DEBUG_ENTRY, dense, GetDopplerWidth(), h2, H2Lines, ipHYDROGEN, t_h2::Jlowest, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, and Save1Line().

Referenced by SaveLineStuff().

Here is the call graph for this function:

double H2_RadPress ( void   ) 
void H2_Reset ( void   ) 

H2_Reset called to reset variables that are needed after an iteration

Definition at line 460 of file mole_h2_etc.cpp.

References DEBUG_ENTRY, fnzone, h2, H2_SaveLine, ioQQQ, iteration, iterationAsEval, mole, nCallH2_this_iteration, nH2_pops, t_mole::nH2_TRACE, nH2_zone, nzone_nlevel_set, nzoneAsEval, t_h2::renorm_max, and t_h2::renorm_min.

Referenced by IterRestart().

void H2_RT_diffuse ( void   ) 

do emission from H2 - called from RT_diffuse

Definition at line 532 of file mole_h2.cpp.

References DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, t_h2::nCallH2_this_zone, t_h2::nRot_hi, and t_h2::nVib_hi.

Referenced by RT_diffuse().

void H2_RT_OTS ( void   ) 

H2_RT_OTS - add H2 ots fields

Definition at line 3604 of file mole_h2.cpp.

References DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, t_h2::nCallH2_this_zone, t_h2::nRot_hi, t_h2::nVib_hi, and RT_OTS_AddLine().

Referenced by RT_OTS().

Here is the call graph for this function:

void H2_RT_tau_inc ( void   ) 

increment optical depth for the H2 molecule, called from RT_tau_inc

Definition at line 691 of file mole_h2.cpp.

References ASSERT, t_dense::AtomicWeight, DEBUG_ENTRY, dense, GetDopplerWidth(), h2, H2_renorm_chemistry, H2Lines, ipHYDROGEN, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, MAX2, MIN2, mole, t_mole::n_h2_elec_states, nCallH2_this_iteration, t_h2::nRot_hi, t_h2::nVib_hi, nzone, t_h2::renorm_max, t_h2::renorm_min, and RT_line_one_tauinc().

Referenced by RT_tau_inc().

Here is the call graph for this function:

void H2_RT_tau_reset ( void   ) 

the large H2 molecule, called from RT_tau_reset

Definition at line 812 of file mole_h2.cpp.

References DEBUG_ENTRY, h2, H2Lines, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, and RT_line_one_tau_reset().

Referenced by RT_tau_reset().

Here is the call graph for this function:

void H2_RTMake ( void   ) 

do RT for H2 lines

Definition at line 585 of file mole_h2.cpp.

References ASSERT, t_dense::AtomicWeight, DEBUG_ENTRY, dense, GetDopplerWidth(), h2, H2Lines, ioQQQ, ipHYDROGEN, t_h2::Jlowest, lgH2_line_exists, t_h2::lgH2ON, mole, t_mole::n_h2_elec_states, t_h2::nRot_hi, t_h2::nVib_hi, RT_line_one(), and SDIV().

Referenced by IonHydro(), and RT_line_all().

Here is the call graph for this function:

void H2_Zero ( void   ) 

Variable Documentation

EXTERN struct t_h2 h2

flag saying whether molecular data have been read in yet

Definition at line 54 of file cdinit.cpp.

Referenced by H2_Create(), H2_Zero(), and ParseAtomH2().

 All Data Structures Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Defines

Generated on 15 Nov 2012 for cloudy by  doxygen 1.6.1