LArSoft
v09_90_00
Liquid Argon Software toolkit - https://larsoft.org/
|
#include "OpFastScintillation.hh"
Classes | |
struct | Dims |
struct | OpticalDetector |
Public Member Functions | |
OpFastScintillation (const G4String &processName="Scintillation", G4ProcessType type=fElectromagnetic) | |
~OpFastScintillation () | |
virtual G4bool | IsApplicable (const G4ParticleDefinition &aParticleType) |
G4double | GetMeanFreePath (const G4Track &aTrack, G4double, G4ForceCondition *) |
G4double | GetMeanLifeTime (const G4Track &aTrack, G4ForceCondition *) |
virtual G4VParticleChange * | PostStepDoIt (const G4Track &aTrack, const G4Step &aStep) |
virtual G4VParticleChange * | AtRestDoIt (const G4Track &aTrack, const G4Step &aStep) |
void | SetTrackSecondariesFirst (const G4bool state) |
void | SetFiniteRiseTime (const G4bool state) |
G4bool | GetTrackSecondariesFirst () const |
G4bool | GetFiniteRiseTime () const |
void | SetScintillationYieldFactor (const G4double yieldfactor) |
G4double | GetScintillationYieldFactor () const |
void | SetScintillationExcitationRatio (const G4double excitationratio) |
G4double | GetScintillationExcitationRatio () const |
G4PhysicsTable * | GetFastIntegralTable () const |
G4PhysicsTable * | GetSlowIntegralTable () const |
void | AddSaturation (G4EmSaturation *sat) |
void | RemoveSaturation () |
G4EmSaturation * | GetSaturation () const |
void | SetScintillationByParticleType (const G4bool) |
G4bool | GetScintillationByParticleType () const |
void | DumpPhysicsTable () const |
void | getVUVTimes (std::vector< double > &arrivalTimes, const double distance_in_cm, const size_t angle_bin) |
void | generateParam (const size_t index, const size_t angle_bin) |
void | getVISTimes (std::vector< double > &arrivalTimes, const TVector3 &ScintPoint, const TVector3 &OpDetPoint) |
void | detectedDirectHits (std::map< size_t, int > &DetectedNum, const double Num, geo::Point_t const &ScintPoint) const |
void | detectedReflecHits (std::map< size_t, int > &ReflDetectedNum, const double Num, geo::Point_t const &ScintPoint) const |
Protected Member Functions | |
void | BuildThePhysicsTable () |
bool | RecordPhotonsProduced (const G4Step &aStep, double N) |
Protected Attributes | |
std::unique_ptr< G4PhysicsTable > | theSlowIntegralTable |
std::unique_ptr< G4PhysicsTable > | theFastIntegralTable |
G4bool | fTrackSecondariesFirst |
G4bool | fFiniteRiseTime |
G4double | YieldFactor |
G4double | ExcitationRatio |
G4bool | scintillationByParticleType |
Private Member Functions | |
bool | usesSemiAnalyticModel () const |
Returns whether the semi-analytic visibility parametrization is being used. More... | |
int | VUVHits (const double Nphotons_created, geo::Point_t const &ScintPoint, OpticalDetector const &opDet) const |
int | VISHits (geo::Point_t const &ScintPoint, OpticalDetector const &opDet, const double cathode_hits_rec, const std::array< double, 3 > hotspot) const |
G4double | single_exp (const G4double t, const G4double tau2) const |
G4double | bi_exp (const G4double t, const G4double tau1, const G4double tau2) const |
G4double | scint_time (const G4Step &aStep, G4double ScintillationTime, G4double ScintillationRiseTime) const |
void | propagationTime (std::vector< double > &arrival_time_dist, G4ThreeVector x0, const size_t OpChannel, bool Reflected=false) |
G4double | sample_time (const G4double tau1, const G4double tau2) const |
double | reemission_energy () const |
void | average_position (G4Step const &aStep, double *xzyPos) const |
double | Rectangle_SolidAngle (const double a, const double b, const double d) const |
double | Rectangle_SolidAngle (Dims const &o, const std::array< double, 3 > v) const |
double | Disk_SolidAngle (const double d, const double h, const double b) const |
double | Omega_Dome_Model (const double distance, const double theta) const |
G4double | Gaisser_Hillas (const double x, const double *par) const |
void | ProcessStep (const G4Step &step) |
bool | isOpDetInSameTPC (geo::Point_t const &ScintPoint, geo::Point_t const &OpDetPoint) const |
bool | isScintInActiveVolume (geo::Point_t const &ScintPoint) |
double | interpolate (const std::vector< double > &xData, const std::vector< double > &yData, double x, bool extrapolate, size_t i=0) const |
void | interpolate3 (std::array< double, 3 > &inter, const std::vector< double > &xData, const std::vector< double > &yData1, const std::vector< double > &yData2, const std::vector< double > &yData3, double x, bool extrapolate) const |
Static Private Member Functions | |
static std::vector< geo::BoxBoundedGeo > | extractActiveVolumes (geo::GeometryCore const &geom) |
Private Attributes | |
std::map< double, double > | tpbemission |
std::unique_ptr< CLHEP::RandGeneral > | fTPBEm |
G4EmSaturation * | emSaturation |
phot::MappedFunctions_t | ParPropTimeTF1 |
phot::MappedT0s_t | ReflT0s |
double | fstep_size |
double | fmin_d |
double | fmax_d |
double | fvuv_vgroup_mean |
double | fvuv_vgroup_max |
double | finflexion_point_distance |
double | fangle_bin_timing_vuv |
std::vector< std::vector< double > > | fparameters [7] |
std::vector< std::vector< TF1 > > | VUV_timing |
std::vector< std::vector< double > > | VUV_max |
std::vector< std::vector< double > > | VUV_min |
double | fvis_vmean |
double | fangle_bin_timing_vis |
std::vector< double > | fdistances_refl |
std::vector< double > | fradial_distances_refl |
std::vector< std::vector< std::vector< double > > > | fcut_off_pars |
std::vector< std::vector< std::vector< double > > > | ftau_pars |
double | fdelta_angulo_vuv |
bool | fIsFlatPDCorr |
std::vector< std::vector< double > > | fGHvuvpars_flat |
std::vector< double > | fborder_corr_angulo_flat |
std::vector< std::vector< double > > | fborder_corr_flat |
bool | fIsDomePDCorr |
std::vector< std::vector< double > > | fGHvuvpars_dome |
std::vector< double > | fborder_corr_angulo_dome |
std::vector< std::vector< double > > | fborder_corr_dome |
bool | fStoreReflected |
double | fdelta_angulo_vis |
std::vector< double > | fvis_distances_x_flat |
std::vector< double > | fvis_distances_r_flat |
std::vector< std::vector< std::vector< double > > > | fvispars_flat |
std::vector< double > | fvis_distances_x_dome |
std::vector< double > | fvis_distances_r_dome |
std::vector< std::vector< std::vector< double > > > | fvispars_dome |
double | fplane_depth |
double | fcathode_zdimension |
double | fcathode_ydimension |
geo::Point_t | fcathode_centre |
std::vector< geo::BoxBoundedGeo > const | fActiveVolumes |
double | fradius |
Dims | fcathode_plane |
int | fL_abs_vuv |
std::vector< geo::Point_t > | fOpDetCenter |
std::vector< int > | fOpDetType |
std::vector< double > | fOpDetLength |
std::vector< double > | fOpDetHeight |
bool const | bPropagate |
Whether propagation of photons is enabled. More... | |
phot::PhotonVisibilityService const *const | fPVS |
Photon visibility service instance. More... | |
bool const | fUseNhitsModel = false |
Whether the semi-analytic model is being used for photon visibility. More... | |
bool const | fOnlyActiveVolume = false |
Whether photon propagation is performed only from active volumes. More... | |
bool const | fOnlyOneCryostat = false |
bool const | fOpaqueCathode = false |
Whether the cathodes are fully opaque; currently hard coded "no". More... | |
Definition at line 130 of file OpFastScintillation.hh.
larg4::OpFastScintillation::OpFastScintillation | ( | const G4String & | processName = "Scintillation" , |
G4ProcessType | type = fElectromagnetic |
||
) |
Definition at line 180 of file OpFastScintillation.cxx.
References util::abs(), bPropagate, BuildThePhysicsTable(), art::errors::Configuration, util::counter(), emSaturation, util::enumerate(), ExcitationRatio, extractActiveVolumes(), fActiveVolumes, fangle_bin_timing_vis, fangle_bin_timing_vuv, fborder_corr_angulo_dome, fborder_corr_angulo_flat, fborder_corr_dome, fborder_corr_flat, fcathode_centre, fcathode_plane, fcathode_ydimension, fcathode_zdimension, fcut_off_pars, fdelta_angulo_vis, fdelta_angulo_vuv, fdistances_refl, fFiniteRiseTime, fGHvuvpars_dome, fGHvuvpars_flat, finflexion_point_distance, fIsDomePDCorr, fIsFlatPDCorr, fL_abs_vuv, fmax_d, fmin_d, fOnlyActiveVolume, fOnlyOneCryostat, fOpDetCenter, fOpDetHeight, fOpDetLength, fOpDetType, fparameters, fplane_depth, fPVS, fradial_distances_refl, fradius, fstep_size, fStoreReflected, ftau_pars, fTPBEm, fTrackSecondariesFirst, fUseNhitsModel, fvis_distances_r_dome, fvis_distances_r_flat, fvis_distances_x_dome, fvis_distances_x_flat, fvis_vmean, fvispars_dome, fvispars_flat, fvuv_vgroup_max, fvuv_vgroup_mean, geo::TPCGeo::GetCathodeCenter(), geo::OpDetGeo::GetCenter(), larg4::OpFastScintillation::Dims::h, geo::OpDetGeo::Height(), phot::PhotonVisibilityService::IncludePropTime(), interpolate(), geo::OpDetGeo::isBar(), geo::OpDetGeo::Length(), phot::PhotonVisibilityService::LoadGHDome(), phot::PhotonVisibilityService::LoadGHFlat(), phot::PhotonVisibilityService::LoadTimingsForVISPar(), phot::PhotonVisibilityService::LoadTimingsForVUVPar(), phot::PhotonVisibilityService::LoadVisParsDome(), phot::PhotonVisibilityService::LoadVisParsFlat(), phot::PhotonVisibilityService::LoadVisSemiAnalyticProperties(), phot::PhotonVisibilityService::LoadVUVSemiAnalyticProperties(), geo::GeometryCore::Ncryostats(), phot::PhotonVisibilityService::NOpChannels(), geo::GeometryCore::OpDetGeoFromOpDet(), detinfo::LArProperties::ScintByParticleType(), scintillationByParticleType, geo::OpDetGeo::Shape(), phot::PhotonVisibilityService::StoreReflected(), tpbemission, geo::GeometryCore::TPC(), phot::PhotonVisibilityService::UseNhitsModel(), usesSemiAnalyticModel(), lar::dump::vector(), VUV_max, VUV_min, VUV_timing, larg4::OpFastScintillation::Dims::w, and YieldFactor.
larg4::OpFastScintillation::~OpFastScintillation | ( | ) |
Definition at line 386 of file OpFastScintillation.cxx.
References theFastIntegralTable, and theSlowIntegralTable.
|
inline |
Definition at line 215 of file OpFastScintillation.hh.
|
virtual |
Definition at line 399 of file OpFastScintillation.cxx.
References PostStepDoIt().
|
private |
|
private |
Definition at line 1833 of file OpFastScintillation.cxx.
Referenced by sample_time().
|
protected |
Definition at line 853 of file OpFastScintillation.cxx.
References theFastIntegralTable, and theSlowIntegralTable.
Referenced by OpFastScintillation().
void larg4::OpFastScintillation::detectedDirectHits | ( | std::map< size_t, int > & | DetectedNum, |
const double | Num, | ||
geo::Point_t const & | ScintPoint | ||
) | const |
Definition at line 1478 of file OpFastScintillation.cxx.
References util::counter(), fOpDetCenter, fOpDetHeight, fOpDetLength, fOpDetType, fPVS, isOpDetInSameTPC(), phot::PhotonVisibilityService::NOpChannels(), and VUVHits().
Referenced by RecordPhotonsProduced().
void larg4::OpFastScintillation::detectedReflecHits | ( | std::map< size_t, int > & | ReflDetectedNum, |
const double | Num, | ||
geo::Point_t const & | ScintPoint | ||
) | const |
Definition at line 1500 of file OpFastScintillation.cxx.
References util::abs(), util::counter(), fborder_corr_angulo_flat, fborder_corr_flat, fcathode_centre, fcathode_plane, fGHvuvpars_flat, fIsFlatPDCorr, fL_abs_vuv, fOpDetCenter, fOpDetHeight, fOpDetLength, fOpDetType, fplane_depth, fPVS, Gaisser_Hillas(), interpolate(), isOpDetInSameTPC(), phot::PhotonVisibilityService::NOpChannels(), util::pi(), r, Rectangle_SolidAngle(), and VISHits().
Referenced by RecordPhotonsProduced().
|
private |
Definition at line 1990 of file OpFastScintillation.cxx.
References d, e, larg4::isApproximatelyEqual(), larg4::isApproximatelyZero(), larg4::isDefinitelyGreaterThan(), larg4::isDefinitelyLessThan(), and util::pi().
Referenced by VISHits(), and VUVHits().
|
inline |
Definition at line 516 of file OpFastScintillation.hh.
|
staticprivate |
Definition at line 2149 of file OpFastScintillation.cxx.
References geo::BoxBoundedGeo::ExtendToInclude(), geo::GeometryCore::Iterate(), and geo::GeometryCore::Ncryostats().
Referenced by OpFastScintillation().
|
private |
Definition at line 1841 of file OpFastScintillation.cxx.
Referenced by detectedReflecHits(), and VUVHits().
void larg4::OpFastScintillation::generateParam | ( | const size_t | index, |
const size_t | angle_bin | ||
) |
Definition at line 1229 of file OpFastScintillation.cxx.
References finflexion_point_distance, larg4::finter_d(), fmin_d, fparameters, fstep_size, fvuv_vgroup_max, fvuv_vgroup_mean, interpolate(), interpolate3(), larg4::model_close(), larg4::model_far(), VUV_max, VUV_min, and VUV_timing.
Referenced by getVUVTimes().
|
inline |
Definition at line 511 of file OpFastScintillation.hh.
|
inline |
Definition at line 481 of file OpFastScintillation.hh.
G4double larg4::OpFastScintillation::GetMeanFreePath | ( | const G4Track & | aTrack, |
G4double | , | ||
G4ForceCondition * | condition | ||
) |
Definition at line 978 of file OpFastScintillation.cxx.
G4double larg4::OpFastScintillation::GetMeanLifeTime | ( | const G4Track & | aTrack, |
G4ForceCondition * | condition | ||
) |
Definition at line 986 of file OpFastScintillation.cxx.
|
inline |
Definition at line 221 of file OpFastScintillation.hh.
|
inline |
Definition at line 228 of file OpFastScintillation.hh.
|
inline |
Definition at line 501 of file OpFastScintillation.hh.
|
inline |
Definition at line 491 of file OpFastScintillation.hh.
|
inline |
Definition at line 506 of file OpFastScintillation.hh.
|
inline |
Definition at line 476 of file OpFastScintillation.hh.
void larg4::OpFastScintillation::getVISTimes | ( | std::vector< double > & | arrivalTimes, |
const TVector3 & | ScintPoint, | ||
const TVector3 & | OpDetPoint | ||
) |
Definition at line 1354 of file OpFastScintillation.cxx.
References util::abs(), util::counter(), fangle_bin_timing_vis, larg4::fast_acos(), fcathode_centre, fcut_off_pars, fdistances_refl, fmin_d, fplane_depth, fradial_distances_refl, fstep_size, ftau_pars, fvis_vmean, fvuv_vgroup_max, getVUVTimes(), interpolate(), util::pi(), r, util::size(), VUV_min, and x.
Referenced by propagationTime().
void larg4::OpFastScintillation::getVUVTimes | ( | std::vector< double > & | arrivalTimes, |
const double | distance_in_cm, | ||
const size_t | angle_bin | ||
) |
Definition at line 1329 of file OpFastScintillation.cxx.
References fmin_d, fstep_size, fvuv_vgroup_mean, generateParam(), VUV_max, VUV_min, and VUV_timing.
Referenced by getVISTimes(), and propagationTime().
|
private |
Definition at line 1911 of file OpFastScintillation.cxx.
References util::size().
Referenced by detectedReflecHits(), generateParam(), getVISTimes(), OpFastScintillation(), VISHits(), and VUVHits().
|
private |
Definition at line 1939 of file OpFastScintillation.cxx.
References util::size().
Referenced by generateParam().
|
inlinevirtual |
Definition at line 458 of file OpFastScintillation.hh.
|
private |
Definition at line 1809 of file OpFastScintillation.cxx.
References util::abs().
Referenced by detectedDirectHits(), detectedReflecHits(), and RecordPhotonsProduced().
|
private |
Definition at line 1822 of file OpFastScintillation.cxx.
References fActiveVolumes.
Referenced by RecordPhotonsProduced().
|
private |
Definition at line 2118 of file OpFastScintillation.cxx.
References fradius, and util::pi().
Referenced by VISHits(), and VUVHits().
|
virtual |
Definition at line 409 of file OpFastScintillation.cxx.
References larg4::IonizationAndScintillation::Instance(), larg4::IonizationAndScintillation::NumberScintillationPhotons(), RecordPhotonsProduced(), and larg4::IonizationAndScintillation::Reset().
Referenced by AtRestDoIt().
|
private |
Definition at line 505 of file OpFastScintillation.cxx.
References larg4::OpDetPhotonTable::AddEnergyDeposit(), larg4::ParticleListAction::GetCurrentOrigTrackID(), larg4::ParticleListAction::GetCurrentTrackID(), and larg4::OpDetPhotonTable::Instance().
Referenced by RecordPhotonsProduced().
|
private |
Definition at line 1009 of file OpFastScintillation.cxx.
References util::abs(), fangle_bin_timing_vuv, larg4::fast_acos(), fOpDetCenter, fPVS, getVISTimes(), getVUVTimes(), phot::PhotonVisibilityService::IncludeParPropTime(), phot::PhotonVisibilityService::IncludePropTime(), ParPropTimeTF1, util::pi(), and geo::vect::toTVector3().
Referenced by RecordPhotonsProduced().
|
protected |
Definition at line 529 of file OpFastScintillation.cxx.
References larg4::OpDetPhotonTable::AddLitePhoton(), larg4::OpDetPhotonTable::AddOpDetBacktrackerRecord(), larg4::OpDetPhotonTable::AddPhoton(), sim::OpDetBacktrackerRecord::AddScintillationPhotons(), average_position(), bPropagate, util::counter(), detectedDirectHits(), detectedReflecHits(), emSaturation, sim::OnePhoton::Energy, ExcitationRatio, fFiniteRiseTime, sim::LArG4Parameters::FillSimEnergyDeposits(), fOnlyActiveVolume, fOpaqueCathode, fOpDetCenter, fPVS, phot::PhotonVisibilityService::GetAllVisibilities(), larg4::ParticleListAction::GetCurrentTrackID(), phot::PhotonVisibilityService::GetReflT0s(), phot::PhotonVisibilityService::GetTimingTF1(), phot::PhotonVisibilityService::IncludeParPropTime(), sim::OnePhoton::InitialPosition, larg4::IonizationAndScintillation::Instance(), larg4::OpDetPhotonTable::Instance(), isOpDetInSameTPC(), isScintInActiveVolume(), sim::OnePhoton::MotherTrackID, phot::PhotonVisibilityService::NOpChannels(), ParPropTimeTF1, ProcessStep(), propagationTime(), reemission_energy(), ReflT0s, scint_time(), scintillationByParticleType, sim::OnePhoton::SetInSD, phot::PhotonVisibilityService::StoreReflected(), phot::PhotonVisibilityService::StoreReflT0(), theFastIntegralTable, theSlowIntegralTable, sim::OnePhoton::Time, sim::LArG4Parameters::UseLitePhotons(), usesSemiAnalyticModel(), and larg4::IonizationAndScintillation::VisibleEnergyDeposit().
Referenced by PostStepDoIt().
|
private |
Definition at line 2051 of file OpFastScintillation.cxx.
References d, and larg4::fast_acos().
Referenced by detectedReflecHits(), Rectangle_SolidAngle(), VISHits(), and VUVHits().
|
private |
Definition at line 2063 of file OpFastScintillation.cxx.
References larg4::OpFastScintillation::Dims::h, larg4::isApproximatelyZero(), larg4::isDefinitelyGreaterThan(), Rectangle_SolidAngle(), and larg4::OpFastScintillation::Dims::w.
|
private |
Definition at line 1074 of file OpFastScintillation.cxx.
References fTPBEm, and tpbemission.
Referenced by RecordPhotonsProduced().
|
inline |
Definition at line 218 of file OpFastScintillation.hh.
Referenced by SetScintillationByParticleType().
|
private |
Definition at line 1054 of file OpFastScintillation.cxx.
References bi_exp(), d, and single_exp().
Referenced by scint_time().
|
private |
Definition at line 992 of file OpFastScintillation.cxx.
References sample_time().
Referenced by RecordPhotonsProduced().
|
inline |
Definition at line 471 of file OpFastScintillation.hh.
void larg4::OpFastScintillation::SetScintillationByParticleType | ( | const G4bool | scintType | ) |
Definition at line 966 of file OpFastScintillation.cxx.
References emSaturation, RemoveSaturation(), and scintillationByParticleType.
|
inline |
Definition at line 496 of file OpFastScintillation.hh.
|
inline |
Definition at line 486 of file OpFastScintillation.hh.
|
inline |
Definition at line 466 of file OpFastScintillation.hh.
|
private |
Definition at line 1828 of file OpFastScintillation.cxx.
Referenced by sample_time().
|
private |
Returns whether the semi-analytic visibility parametrization is being used.
Definition at line 1472 of file OpFastScintillation.cxx.
References fUseNhitsModel.
Referenced by OpFastScintillation(), and RecordPhotonsProduced().
|
private |
Definition at line 1681 of file OpFastScintillation.cxx.
References util::abs(), d, Disk_SolidAngle(), larg4::dist(), larg4::fast_acos(), fcathode_centre, fdelta_angulo_vis, geo::vect::fillCoords(), fIsDomePDCorr, fIsFlatPDCorr, fplane_depth, fradius, fvis_distances_r_dome, fvis_distances_r_flat, fvis_distances_x_dome, fvis_distances_x_flat, fvispars_dome, fvispars_flat, larg4::OpFastScintillation::OpticalDetector::h, interpolate(), Omega_Dome_Model(), larg4::OpFastScintillation::OpticalDetector::OpDetPoint, util::pi(), r, Rectangle_SolidAngle(), util::size(), larg4::OpFastScintillation::OpticalDetector::type, and larg4::OpFastScintillation::OpticalDetector::w.
Referenced by detectedReflecHits().
|
private |
Definition at line 1578 of file OpFastScintillation.cxx.
References util::abs(), d, Disk_SolidAngle(), larg4::dist(), larg4::fast_acos(), fborder_corr_angulo_dome, fborder_corr_angulo_flat, fborder_corr_dome, fborder_corr_flat, fcathode_centre, fdelta_angulo_vuv, fGHvuvpars_dome, fGHvuvpars_flat, geo::vect::fillCoords(), fIsDomePDCorr, fIsFlatPDCorr, fL_abs_vuv, fradius, Gaisser_Hillas(), larg4::OpFastScintillation::OpticalDetector::h, interpolate(), Omega_Dome_Model(), larg4::OpFastScintillation::OpticalDetector::OpDetPoint, util::pi(), r, Rectangle_SolidAngle(), larg4::OpFastScintillation::OpticalDetector::type, and larg4::OpFastScintillation::OpticalDetector::w.
Referenced by detectedDirectHits().
|
private |
Whether propagation of photons is enabled.
Definition at line 412 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and RecordPhotonsProduced().
|
private |
Definition at line 325 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), RecordPhotonsProduced(), and SetScintillationByParticleType().
|
protected |
Definition at line 278 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and RecordPhotonsProduced().
|
private |
Definition at line 397 of file OpFastScintillation.hh.
Referenced by isScintInActiveVolume(), and OpFastScintillation().
|
private |
Definition at line 348 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and propagationTime().
|
private |
Definition at line 378 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VUVHits().
|
private |
Definition at line 373 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), OpFastScintillation(), and VUVHits().
|
private |
Definition at line 379 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VUVHits().
|
private |
Definition at line 374 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), OpFastScintillation(), and VUVHits().
|
private |
Definition at line 396 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), getVISTimes(), OpFastScintillation(), VISHits(), and VUVHits().
|
private |
Definition at line 402 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), and OpFastScintillation().
|
private |
Definition at line 395 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Definition at line 395 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Definition at line 351 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 384 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 369 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VUVHits().
|
private |
Definition at line 349 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
protected |
Definition at line 274 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and RecordPhotonsProduced().
|
private |
Definition at line 377 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VUVHits().
|
private |
Definition at line 372 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), OpFastScintillation(), and VUVHits().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by generateParam(), and OpFastScintillation().
|
private |
Definition at line 376 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), VISHits(), and VUVHits().
|
private |
Definition at line 371 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), OpFastScintillation(), VISHits(), and VUVHits().
|
private |
Definition at line 403 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), OpFastScintillation(), and VUVHits().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by generateParam(), getVISTimes(), getVUVTimes(), and OpFastScintillation().
|
private |
Whether photon propagation is performed only from active volumes.
Definition at line 420 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and RecordPhotonsProduced().
|
private |
Allows running even if light on cryostats C:1
and higher is not supported. Currently hard coded "no"
Definition at line 423 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Whether the cathodes are fully opaque; currently hard coded "no".
Definition at line 425 of file OpFastScintillation.hh.
Referenced by RecordPhotonsProduced().
|
private |
Definition at line 404 of file OpFastScintillation.hh.
Referenced by detectedDirectHits(), detectedReflecHits(), OpFastScintillation(), propagationTime(), and RecordPhotonsProduced().
|
private |
Definition at line 407 of file OpFastScintillation.hh.
Referenced by detectedDirectHits(), detectedReflecHits(), and OpFastScintillation().
|
private |
Definition at line 406 of file OpFastScintillation.hh.
Referenced by detectedDirectHits(), detectedReflecHits(), and OpFastScintillation().
|
private |
Definition at line 405 of file OpFastScintillation.hh.
Referenced by detectedDirectHits(), detectedReflecHits(), and OpFastScintillation().
|
private |
Definition at line 340 of file OpFastScintillation.hh.
Referenced by generateParam(), and OpFastScintillation().
|
private |
Definition at line 395 of file OpFastScintillation.hh.
Referenced by detectedReflecHits(), getVISTimes(), OpFastScintillation(), and VISHits().
|
private |
Photon visibility service instance.
Definition at line 415 of file OpFastScintillation.hh.
Referenced by detectedDirectHits(), detectedReflecHits(), OpFastScintillation(), propagationTime(), and RecordPhotonsProduced().
|
private |
Definition at line 350 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 401 of file OpFastScintillation.hh.
Referenced by Omega_Dome_Model(), OpFastScintillation(), VISHits(), and VUVHits().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by generateParam(), getVISTimes(), getVUVTimes(), and OpFastScintillation().
|
private |
Definition at line 382 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Definition at line 352 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 321 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and reemission_energy().
|
protected |
Definition at line 273 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().
|
private |
Whether the semi-analytic model is being used for photon visibility.
Definition at line 418 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and usesSemiAnalyticModel().
|
private |
Definition at line 391 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 387 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 390 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 386 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 348 of file OpFastScintillation.hh.
Referenced by getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 392 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 388 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and VISHits().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by generateParam(), getVISTimes(), and OpFastScintillation().
|
private |
Definition at line 338 of file OpFastScintillation.hh.
Referenced by generateParam(), getVUVTimes(), and OpFastScintillation().
|
private |
Definition at line 327 of file OpFastScintillation.hh.
Referenced by propagationTime(), and RecordPhotonsProduced().
|
private |
Definition at line 328 of file OpFastScintillation.hh.
Referenced by RecordPhotonsProduced().
|
protected |
Definition at line 280 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), RecordPhotonsProduced(), and SetScintillationByParticleType().
|
protected |
Definition at line 271 of file OpFastScintillation.hh.
Referenced by BuildThePhysicsTable(), RecordPhotonsProduced(), and ~OpFastScintillation().
|
protected |
Definition at line 270 of file OpFastScintillation.hh.
Referenced by BuildThePhysicsTable(), RecordPhotonsProduced(), and ~OpFastScintillation().
|
private |
Definition at line 320 of file OpFastScintillation.hh.
Referenced by OpFastScintillation(), and reemission_energy().
|
private |
Definition at line 344 of file OpFastScintillation.hh.
Referenced by generateParam(), getVUVTimes(), and OpFastScintillation().
|
private |
Definition at line 345 of file OpFastScintillation.hh.
Referenced by generateParam(), getVISTimes(), getVUVTimes(), and OpFastScintillation().
|
private |
Definition at line 342 of file OpFastScintillation.hh.
Referenced by generateParam(), getVUVTimes(), and OpFastScintillation().
|
protected |
Definition at line 276 of file OpFastScintillation.hh.
Referenced by OpFastScintillation().