#include <iostream>
#include <ctime>
#include <sstream>
#include <cmath>
#include <cstdlib>
#include <set>
#include <string>
#include "GENIE/Framework/Numerical/RandomGen.h"
#include "GENIE/Tools/Flux/GNuMIFlux.h"
#include "GENIE/Tools/Flux/GSimpleNtpFlux.h"
#include "GENIE/Framework/Utils/UnitUtils.h"
#include "GENIE/Framework/Utils/AppInit.h"
#include "TSystem.h"
#include "TStopwatch.h"
#include "TLorentzVector.h"
#include "TNtuple.h"
#include "TFile.h"
#include "TRandom3.h"
Go to the source code of this file.
Classes | |
struct | complex |
Functions | |
void | dsinit_ () |
void | wimpinit_ () |
void | nusetup_ () |
void | pygive_ (char *, size_t) |
void | nuoscinit_ () |
void | modpyt_ () |
void | genevt_ (unsigned int *channel, unsigned int *nev) |
void | weinit_ () |
double | astxt2mjd_ (char *) |
void | nupropsu_ () |
double | pyr_ (int *) |
unsigned int | nutype (unsigned int u) |
int | signum (double d) |
double | zamp (complex z) |
double | zarg (complex z) |
int | get_pdg (unsigned wimpevent_nui) |
Variables | |
const bool | COMMAND_LINE_INPUT = false |
const double | PI = M_PI |
const double | NOVA_AZIMUTH = 332.066111 |
const unsigned | nFluxEntries = 100000 |
const double | enumin = 1.0 |
const double | T_MAX = 5.0e5 |
const double | T_MIN = 0 |
const double | X_MAX = 16000 |
const double | X_MIN = -16000 |
const double | Y_MAX = -9200 |
const double | Y_MIN = -9200 |
const double | Z_MAX = 72000 |
const double | Z_MIN = -48000 |
const unsigned int | ANN_CHAN = 11 |
const unsigned int | N_ANN = 1e7 |
const double | CM_ENERGY = 100 |
const double | THETA_12 = 33.58 * PI / 180.0 |
const double | THETA_13 = 9.12 * PI / 180.0 |
const double | THETA_23 = 40.40 * PI / 180.0 |
const double | DELTA_CP = 0 |
const double | DM2_21 = 7.58e-5 |
const double | DM2_31 = 2.35e-5 |
const bool | WIMPANN_OUTP = false |
const bool | USE_EARTH_ANN = false |
const bool | WIMPANN_SUM = false |
const std::string | FILE_S = "wimpann_sun.out" |
const std::string | FILE_E = "wimpann_earth.out" |
const std::string | FILE_INFO = "wimpann.info" |
const std::string | FILE_SUM_S = "wimpann_sun.sum" |
const std::string | FILE_SUM_E = "wimpann_earth.sum" |
const double | WELAT = 48.4171297 |
const double | WELONG = -92.7890442 |
const unsigned int | WETF = 2 |
const unsigned int | WE_INT = 3 |
const unsigned int | WE_MED = 1 |
struct { | |
double enumax | |
bool output | |
bool earth | |
double mwimp | |
} | neutrino_ |
struct { | |
complex nusc [700000][3] | |
double nusr [700000][3] | |
double nuer [700000] | |
unsigned int nusi [700000][7] | |
unsigned int nuei [700000][4] | |
unsigned int nnus | |
unsigned int nnue | |
unsigned int nuunierr | |
} | nus_ |
struct { | |
int kf1 [14] | |
int kf2 [14] | |
int ach | |
int achmax | |
} | annich_ |
struct { | |
double th12 | |
double th13 | |
double th23 | |
double delta | |
double dm212 | |
double dm312 | |
} | nuosc_ |
struct { | |
unsigned int seed | |
unsigned int nevfiles | |
unsigned int nannperfile | |
unsigned int fileno | |
} | wimppara_ |
struct { | |
double welat | |
double welong | |
double wet1 | |
double wet2 | |
double mjd1 | |
double mjd2 | |
unsigned int wemed | |
unsigned int weint | |
unsigned int wetf | |
unsigned int wesunacc | |
unsigned int weradec | |
unsigned int weseed | |
char wefile [128] | |
char wesumdir [128] | |
char d1txt [26] | |
char d2txt [26] | |
} | wesim_ |
struct { | |
complex nustate [3] | |
double enu | |
double lang | |
double le | |
double ledet | |
double langdet | |
double hang | |
double he | |
double tev | |
double dfluxnu | |
double dfluxvert | |
double dfluxdet | |
double nuang | |
double dist | |
double nuaz | |
double laz | |
double haz | |
double lazdet | |
double sunnadir | |
double mjd | |
double mjdfr | |
double sunra | |
double sundec | |
double sunaz | |
double sunel | |
double nura | |
double nudec | |
double nuel | |
double lepra | |
double lepdec | |
double lepaz | |
double lepel | |
double hadra | |
double haddec | |
double hadaz | |
double hadel | |
double dpsun [3] | |
double lst | |
int nut | |
int nui | |
int iev | |
int lcv | |
} | weevent_ |
double astxt2mjd_ | ( | char * | ) |
Referenced by get_wimpevent_info().
void dsinit_ | ( | ) |
Referenced by setup_wimpann().
|
inline |
Definition at line 135 of file runWimpSim.h.
Referenced by main().
void nusetup_ | ( | ) |
Referenced by setup_wimpann().
Definition at line 122 of file runWimpSim.h.
Referenced by GetCommandLineArgs(), readNtuple::Loop(), main(), ParseFluxHst(), and genie::AlvarezRusoCOHPiPXSec::XSec().
double pyr_ | ( | int * | ) |
|
inline |
void wimpinit_ | ( | ) |
Referenced by setup_wimpann().
|
inline |
Definition at line 130 of file runWimpSim.h.
References complex::i, complex::r, and std::sqrt().
Referenced by main().
|
inline |
Definition at line 131 of file runWimpSim.h.
References std::atan(), complex::i, PI, complex::r, and signum().
Referenced by main().
int ach |
Definition at line 94 of file runWimpSim.h.
int achmax |
Definition at line 94 of file runWimpSim.h.
const unsigned int ANN_CHAN = 11 |
Definition at line 43 of file runWimpSim.h.
Referenced by get_wimpann_info().
struct { ... } annich_ |
const double CM_ENERGY = 100 |
Definition at line 45 of file runWimpSim.h.
Referenced by get_wimpann_info().
const bool COMMAND_LINE_INPUT = false |
Definition at line 24 of file runWimpSim.h.
char d1txt[26] |
Definition at line 108 of file runWimpSim.h.
char d2txt[26] |
Definition at line 108 of file runWimpSim.h.
double delta |
Definition at line 98 of file runWimpSim.h.
Referenced by osc::_PMNS_DMP< T >::_PMNS_DMP(), genie::BYPDF::AllPDFs(), BicountEllipse_dCP(), genie::utils::nuclear::BindEnergy(), BiprobEllipse_dCP(), genie::NievesQELCCPXSec::CompareNievesTensors(), rsim::PulseShaper::CreateTrace(), ana::CVNVetoOverlapWindowCut(), genie::mueloss::BetheBlochModel::dE_dx(), calib::BetheBlochAnalytic::dEdx(), calib::BetheBlochAnalytic::Delta(), align::SplitTracks::DemingRegFit(), demoFitContours(), genie::mueloss::gsl::PetrukhinShestakovIntegrand::DoEval(), ana::DrawLineArrow(), FCCorrectSlice(), fcn(), fcn2Var(), FCTutorial2020(), calib::EnergyStandardCandles::FillMichelRecoInfo(), trk::KalmanTrack::FilterOnly(), trk::KalmanTrack::FilterTracker(), art::flattenCollections(), genie::utils::hadxs::InelasticPionNucleonXSec(), isCloseEnough(), joint_fit_2017_make_fc_slice(), joint_fit_2018_contours(), joint_fit_2019_contours(), jointsensitivity(), genie::NievesQELCCPXSec::LmunuAnumu(), LOverEPlot(), LZ4_renormDictT(), LZ4HC_Insert(), LZ4HC_InsertAndGetWiderMatch(), monoprob(), calib::BetheBlochAnalytic::MPV(), plot_contprof(), plot_joint_fit_2020_contours(), PlotSignificanceVsYear_FixDelta(), evg::MCTruthToDk2NuHackItr::pretty_darn_close(), genie::INukeDeltaPropg::ProcessEventRecord(), vf::VertexFinder::produce(), ana::TrivialCrossSectionAnalysis::RelativeUncertainty(), trk::KalmanTrack::SegmentFinder(), sensitivity2018(), sensitivity2020(), sensitivity_plot(), osc::OscCalcGeneral::SetdCP(), osc::analytic::_OscCalc< T >::SetdCP(), osc::PMNS_Sterile::SetDelta(), ana::SigmaDelta::SetFitVars(), osc::OscCalcSterile::SetRho(), ana::SigmaDelta::SigmaPenalty(), osc::_PMNS< T >::SortEigenvalues(), TheoryEllipse_dCP(), ana::ToEigenSterile(), ana::TrivialCrossSectionAnalysis::TotalErrors(), genie::utils::hadxs::TotalPionNucleonXSec(), UpdateStats(), and genie::NievesSimoVacasMECPXSec2016::XSec().
const double DELTA_CP = 0 |
Definition at line 49 of file runWimpSim.h.
Referenced by get_wimpann_info().
double dfluxdet |
Definition at line 113 of file runWimpSim.h.
double dfluxnu |
Definition at line 113 of file runWimpSim.h.
double dfluxvert |
Definition at line 113 of file runWimpSim.h.
double dist |
Definition at line 113 of file runWimpSim.h.
Referenced by remid::ReMIdTrain::analyze(), slicer::S4DParamCalc::analyze(), nnbar::ShowerMuonCoincidence::analyze(), upmuana::UpMuRecoAna::analyze(), upmuana::UpMuAnalysis::analyze(), me::MEFinder::BestSlcMatch(), trk::KalmanGeoHelper::CalcMissFrac(), supernova::sliceAna::CalculatePCorr(), geo::LiveGeometry::CellsToEdgeInMC(), geo::ClampRayToDetectorVolume(), geo::ClosestApproach(), remid::ReMIdTrain::ContainedEvent(), trk::KalmanTrackAna::Containment(), DedxComp(), DedxCompBirk(), DedxGamma(), rb::Track::DistanceFromEnd(), rb::Track::DistanceFromStart(), slid::DeconvolveAlg::DistanceToCore(), jmshower::EID::EID(), lem::EventSummary::EventSummary(), novaddt::MichelETrigger::filter(), genie::flux::GFluxBlender::GetFlavorMixer(), upmuana::UpMuAnalysis::getLLR(), upmuana::UpMuRecoAna::getLLR(), calib::IBetheBloch::GetMPVGraph(), shadow::NOVASLocate::GetObjectPosition(), ndreco::NDRecoFxs::getProngDedx(), ndreco::NDRecoFxs::getProngProximity(), tdslicer::TDSlicer::GetPtInfo(), ndreco::NDRecoFxs::getTrackDedx(), ndreco::NDRecoFxs::getTrackProximity(), ndreco::NDRecoFxs::getTrackScatt(), slid::DeconvolveAlg::GetWeights(), genie::INukeHadroData2018::IntBounce(), genie::INukeHadroData::IntBounce(), genie::geometry::FidCylinder::InterceptUncapped(), me::MEFinder::IsTrkME(), make_angle_plot(), make_UU_plot(), fuzz::FuzzyKMeanAlg::MakeAngles(), nerd::NERDProng::MakeCluster(), calib::IBetheBloch::MPV(), cosrej::MakeNueCosRej::MuonParentByDist(), PionDedxComp(), slid::ParticleIDAlg::PlaneRadius(), slicer::PointManager::PreparekDistInfo(), evgen::GFlavorOsc::Probability(), photrans::PhotonTransport::produce(), cheat::MCCheater::produce(), tdslicer::TDSlicer::produce(), ProtonDedxComp(), ProtonDedxCompBirk(), slid::ParticleIDAlg::Radius(), trk::CosmicTrackUtilities::RangeMomentum(), hough::MultiHough2P::RefinePeak(), genie::flux::GSimpleNtpEntry::Reset(), screen_dist_to_track(), screen_to_activecell(), screen_to_activetrack(), screen_to_activevertex(), hough::MultiHoughT::Scrub(), earms::ElasticArmsHS::Scrub(), vdt::VertexDT::Scrub(), fuzz::FuzzyKVertex::Scrub(), novaddt::utils::DetectorUtils::SetAttenuationParameters(), genie::flux::GFluxBlender::SetBaselineDist(), jmshower::JMShower::SetHitDist(), upmuana::LlrUpmu::setLLR(), jmshower::EID::SetSh1DistToEdge(), ana::ContainmentSyst::Shift(), simb::MCTrajectory::TotalLength(), rb::Prong::TotalLength(), rb::Track::TotalLength(), numue::NumuEAna::TotalLengthInDetector(), cheat::RecoCheckAna::TotalLengthInDetector(), trk::KalmanTrackAna::TotalLengthInDetector(), genie::geometry::GeomVolSelectorRockBox::TrimSegment(), genie::geometry::GeomVolSelectorFiducial::TrimSegment(), trk::KalmanTrackMerge::ViewMergeTracks(), and jmshower::JMShower::~JMShower().
double dm212 |
Definition at line 98 of file runWimpSim.h.
const double DM2_21 = 7.58e-5 |
Definition at line 50 of file runWimpSim.h.
Referenced by get_wimpann_info().
const double DM2_31 = 2.35e-5 |
Definition at line 51 of file runWimpSim.h.
Referenced by get_wimpann_info().
double dm312 |
Definition at line 98 of file runWimpSim.h.
double dpsun[3] |
Definition at line 113 of file runWimpSim.h.
bool earth |
Definition at line 83 of file runWimpSim.h.
double enu |
Definition at line 113 of file runWimpSim.h.
Referenced by calc_enuwgt(), genie::flux::GNuMIFluxPassThroughInfo::CalcEnuWgt(), genie::SKKinematicsGenerator::CalculateKin_AtharSingleKaon(), genie::SKKinematicsGenerator::ComputeMaxXSec(), fabserrX(), main(), genie::flux::GDk2NuFlux::ScanForMaxWeight(), genie::flux::GNuMIFlux::ScanForMaxWeight(), test_gnumi(), genie::flux::GDk2NuFluxXMLHelper::~GDk2NuFluxXMLHelper(), and genie::flux::GNuMIFluxPassThroughInfo::~GNuMIFluxPassThroughInfo().
double enumax |
Definition at line 82 of file runWimpSim.h.
const double enumin = 1.0 |
Definition at line 36 of file runWimpSim.h.
Referenced by gnumi2simple(), main(), and make_simple_grid().
const std::string FILE_E = "wimpann_earth.out" |
Definition at line 56 of file runWimpSim.h.
Referenced by get_wimpann_info().
const std::string FILE_INFO = "wimpann.info" |
Definition at line 57 of file runWimpSim.h.
Referenced by get_wimpann_info().
const std::string FILE_S = "wimpann_sun.out" |
Definition at line 55 of file runWimpSim.h.
Referenced by get_wimpann_info().
const std::string FILE_SUM_E = "wimpann_earth.sum" |
Definition at line 59 of file runWimpSim.h.
Referenced by get_wimpann_info().
const std::string FILE_SUM_S = "wimpann_sun.sum" |
Definition at line 58 of file runWimpSim.h.
Referenced by get_wimpann_info().
unsigned int fileno |
Definition at line 102 of file runWimpSim.h.
Referenced by lem::CreateOnDemandMapping(), lem::MMapFileAtAddress(), and ana::Progress::SetProgress().
double hadaz |
Definition at line 113 of file runWimpSim.h.
double haddec |
Definition at line 113 of file runWimpSim.h.
double hadel |
Definition at line 113 of file runWimpSim.h.
double hadra |
Definition at line 113 of file runWimpSim.h.
double hang |
Definition at line 113 of file runWimpSim.h.
double haz |
Definition at line 113 of file runWimpSim.h.
double he |
Definition at line 113 of file runWimpSim.h.
Referenced by ana::ExPIDPlot(), ExPIDPlot(), plot(), and reco_minus_true_panels().
int iev |
Definition at line 118 of file runWimpSim.h.
Referenced by ConvertToGHad(), ConvertToGHepMock(), ConvertToGINuke(), ConvertToGRooTracker(), ConvertToGST(), ConvertToGTracker(), ConvertToGXML(), main(), genie::PythiaHadronization::MultiplicityProb(), run_evgen_test(), and RunCherryPicker().
int kf1[14] |
Definition at line 94 of file runWimpSim.h.
int kf2[14] |
Definition at line 94 of file runWimpSim.h.
Referenced by genie::NievesQELCCPXSec::ruLinRelX().
double lang |
Definition at line 113 of file runWimpSim.h.
double langdet |
Definition at line 113 of file runWimpSim.h.
double laz |
Definition at line 113 of file runWimpSim.h.
double lazdet |
Definition at line 113 of file runWimpSim.h.
int lcv |
Definition at line 118 of file runWimpSim.h.
double le |
Definition at line 113 of file runWimpSim.h.
double ledet |
Definition at line 113 of file runWimpSim.h.
double lepaz |
Definition at line 113 of file runWimpSim.h.
double lepdec |
Definition at line 113 of file runWimpSim.h.
double lepel |
Definition at line 113 of file runWimpSim.h.
double lepra |
Definition at line 113 of file runWimpSim.h.
double lst |
Definition at line 113 of file runWimpSim.h.
Referenced by DrawDeltaChiSqrWithContours(), GetContours(), and GetNFiles().
double mjd |
Definition at line 113 of file runWimpSim.h.
Referenced by main().
double mjd1 |
Definition at line 106 of file runWimpSim.h.
double mjd2 |
Definition at line 106 of file runWimpSim.h.
double mjdfr |
Definition at line 113 of file runWimpSim.h.
double mwimp |
Definition at line 84 of file runWimpSim.h.
Referenced by main().
const unsigned int N_ANN = 1e7 |
Definition at line 44 of file runWimpSim.h.
Referenced by get_wimpann_info().
unsigned int nannperfile |
Definition at line 102 of file runWimpSim.h.
struct { ... } neutrino_ |
Referenced by main().
unsigned int nevfiles |
Definition at line 102 of file runWimpSim.h.
const unsigned nFluxEntries = 100000 |
Definition at line 34 of file runWimpSim.h.
Referenced by main().
unsigned int nnue |
Definition at line 90 of file runWimpSim.h.
Referenced by BinByBinTemplateFit(), and genie::flux::GAstroFlux::Index().
unsigned int nnus |
Definition at line 90 of file runWimpSim.h.
const double NOVA_AZIMUTH = 332.066111 |
Definition at line 30 of file runWimpSim.h.
Referenced by main().
double nuang |
Definition at line 113 of file runWimpSim.h.
double nuaz |
Definition at line 113 of file runWimpSim.h.
double nudec |
Definition at line 113 of file runWimpSim.h.
unsigned int nuei[700000][4] |
Definition at line 90 of file runWimpSim.h.
double nuel |
Definition at line 113 of file runWimpSim.h.
double nuer[700000] |
Definition at line 89 of file runWimpSim.h.
int nui |
Definition at line 118 of file runWimpSim.h.
Referenced by chi2().
struct { ... } nuosc_ |
Referenced by get_wimpann_info().
double nura |
Definition at line 113 of file runWimpSim.h.
struct { ... } nus_ |
Referenced by main().
complex nusc[700000][3] |
Definition at line 88 of file runWimpSim.h.
unsigned int nusi[700000][7] |
Definition at line 90 of file runWimpSim.h.
double nusr[700000][3] |
Definition at line 89 of file runWimpSim.h.
complex nustate[3] |
Definition at line 112 of file runWimpSim.h.
int nut |
Definition at line 118 of file runWimpSim.h.
Referenced by main().
unsigned int nuunierr |
Definition at line 90 of file runWimpSim.h.
bool output |
Definition at line 83 of file runWimpSim.h.
const double PI = M_PI |
Definition at line 25 of file runWimpSim.h.
unsigned int seed |
Definition at line 102 of file runWimpSim.h.
Referenced by ana::FitInAnaBinsBkgdEstimator::Background(), ana::NumuCC2p2hBkgdEstimator::Background(), art::RandomNumberGenerator::defaultEngineKind(), ana::IFitter::ExpandSeeds(), fill_exps(), ana::StanFitter::Fit(), ana::IFitter::FitHelper(), ana::MinuitFitter::FitHelperSeeded(), CLHEP::MixMaxRng::flat(), futureSig_reach_singlePOTcombo_syst(), g4n::G4Gen::G4Gen(), ana::Spectrum::GetEigenStan(), genie::RandomGen::GetSeed(), ana::GetSystShiftsMultiverse(), ana::MichelTaggingSyst2020::Hash(), ana::MichelTaggingSyst2018::Hash(), ana::Hash(), MakeFakeData(), ana::Prod4DQFailCheckBase::VectorHash::operator()(), std::hash< Eigen::ArrayXd >::operator()(), ana::GradientDescent::Package(), dt::DiscreteTracker::RecoOneTrack(), ana::RefineSeeds(), RunFitter(), genie::RandomGen::SetSeed(), simple_FC_validation(), and ana::StanFitter::TestGradients().
double sunaz |
Definition at line 113 of file runWimpSim.h.
double sundec |
Definition at line 113 of file runWimpSim.h.
double sunel |
Definition at line 113 of file runWimpSim.h.
double sunnadir |
Definition at line 113 of file runWimpSim.h.
double sunra |
Definition at line 113 of file runWimpSim.h.
const double T_MAX = 5.0e5 |
Definition at line 37 of file runWimpSim.h.
const double T_MIN = 0 |
Definition at line 37 of file runWimpSim.h.
double tev |
Definition at line 113 of file runWimpSim.h.
double th12 |
Definition at line 98 of file runWimpSim.h.
Referenced by osc::_PMNS_DMP< T >::_PMNS_DMP(), osc::OscCalcCPT::GetTh12(), osc::_OscParameters< double >::operator==(), osc::_PMNS_DMP< T >::P(), osc::OscCalcGeneral::SetDmsq32(), osc::_PMNSOpt< T >::SetMix(), osc::OscCalcPMNS_CPT::SetTh12(), osc::OscCalcGeneral::SetTh12(), osc::OscCalcPMNS_NSI::SetTh12(), osc::_OscCalcPMNS< T >::SetTh12(), osc::_OscCalcPMNSOpt< T >::SetTh12(), osc::OscCalc::SetTh12(), osc::_OscCalcDMP< T >::SetTh12(), osc::OscCalcPMNSOptEigen::SetTh12(), and osc::analytic::_OscCalc< T >::SetTh12().
double th13 |
Definition at line 98 of file runWimpSim.h.
Referenced by osc::_PMNS_DMP< T >::_PMNS_DMP(), demoFitContours(), FCTutorial2020(), osc::OscCalcCPT::GetTh13(), joint_fit_2018_contours(), joint_fit_2019_contours(), osc::_OscParameters< double >::operator==(), osc::_PMNS_DMP< T >::P(), plot_joint_fit_2020_contours(), osc::OscCalcGeneral::SetDmsq32(), osc::_PMNSOpt< T >::SetMix(), osc::OscCalcPMNS_CPT::SetTh13(), osc::OscCalcGeneral::SetTh13(), osc::_OscCalcPMNS< T >::SetTh13(), osc::OscCalcPMNS_NSI::SetTh13(), osc::_OscCalcPMNSOpt< T >::SetTh13(), osc::OscCalc::SetTh13(), osc::_OscCalcDMP< T >::SetTh13(), osc::OscCalcPMNSOptEigen::SetTh13(), and osc::analytic::_OscCalc< T >::SetTh13().
double th23 |
Definition at line 98 of file runWimpSim.h.
Referenced by osc::_PMNS_DMP< T >::_PMNS_DMP(), demoFitContours(), DrawSurface(), fake_future_data(), FCTutorial2020(), osc::OscCalcCPT::GetTh23(), goodness_of_fit(), joint_fit_2018_contours(), joint_fit_2019_contours(), joint_fit_future_bestfit_univ(), joint_fit_future_contour_univ(), jointsensitivity(), nuebar_signif(), osc::_OscParameters< double >::operator==(), osc::_PMNS_DMP< T >::P(), plot_joint_fit_2020_contours(), Plotting_DataAndPrediction(), sensitivity2018(), sensitivity2020(), osc::OscCalcGeneral::SetDmsq32(), osc::_PMNSOpt< T >::SetMix(), osc::OscCalcPMNS_CPT::SetTh23(), osc::OscCalcGeneral::SetTh23(), osc::_OscCalcPMNS< T >::SetTh23(), osc::OscCalcPMNS_NSI::SetTh23(), osc::_OscCalcPMNSOpt< T >::SetTh23(), osc::OscCalc::SetTh23(), osc::_OscCalcDMP< T >::SetTh23(), osc::OscCalcPMNSOptEigen::SetTh23(), and osc::analytic::_OscCalc< T >::SetTh23().
const double THETA_12 = 33.58 * PI / 180.0 |
Definition at line 46 of file runWimpSim.h.
Referenced by get_wimpann_info().
const double THETA_13 = 9.12 * PI / 180.0 |
Definition at line 47 of file runWimpSim.h.
Referenced by get_wimpann_info().
const double THETA_23 = 40.40 * PI / 180.0 |
Definition at line 48 of file runWimpSim.h.
Referenced by get_wimpann_info().
const bool USE_EARTH_ANN = false |
Definition at line 53 of file runWimpSim.h.
Referenced by get_wimpann_info().
const unsigned int WE_INT = 3 |
Definition at line 65 of file runWimpSim.h.
Referenced by get_wimpevent_info().
const unsigned int WE_MED = 1 |
Definition at line 66 of file runWimpSim.h.
Referenced by get_wimpevent_info().
struct { ... } weevent_ |
Referenced by main().
char wefile[128] |
Definition at line 108 of file runWimpSim.h.
unsigned int weint |
Definition at line 107 of file runWimpSim.h.
const double WELAT = 48.4171297 |
Definition at line 62 of file runWimpSim.h.
Referenced by get_wimpevent_info().
double welat |
Definition at line 106 of file runWimpSim.h.
const double WELONG = -92.7890442 |
Definition at line 63 of file runWimpSim.h.
Referenced by get_wimpevent_info().
double welong |
Definition at line 106 of file runWimpSim.h.
unsigned int wemed |
Definition at line 107 of file runWimpSim.h.
unsigned int weradec |
Definition at line 107 of file runWimpSim.h.
unsigned int weseed |
Definition at line 107 of file runWimpSim.h.
struct { ... } wesim_ |
Referenced by get_wimpevent_info().
char wesumdir[128] |
Definition at line 108 of file runWimpSim.h.
unsigned int wesunacc |
Definition at line 107 of file runWimpSim.h.
double wet1 |
Definition at line 106 of file runWimpSim.h.
double wet2 |
Definition at line 106 of file runWimpSim.h.
const unsigned int WETF = 2 |
Definition at line 64 of file runWimpSim.h.
Referenced by get_wimpevent_info().
unsigned int wetf |
Definition at line 107 of file runWimpSim.h.
const bool WIMPANN_OUTP = false |
Definition at line 52 of file runWimpSim.h.
Referenced by get_wimpann_info().
const bool WIMPANN_SUM = false |
Definition at line 54 of file runWimpSim.h.
Referenced by get_wimpann_info().
struct { ... } wimppara_ |
Referenced by get_wimpann_info(), get_wimpevent_info(), and main().
const double X_MAX = 16000 |
Definition at line 38 of file runWimpSim.h.
Referenced by main().
const double X_MIN = -16000 |
Definition at line 38 of file runWimpSim.h.
Referenced by main().
const double Y_MAX = -9200 |
Definition at line 39 of file runWimpSim.h.
Referenced by main().
const double Y_MIN = -9200 |
Definition at line 39 of file runWimpSim.h.
Referenced by main().
const double Z_MAX = 72000 |
Definition at line 40 of file runWimpSim.h.
Referenced by main().
const double Z_MIN = -48000 |
Definition at line 40 of file runWimpSim.h.
Referenced by main().