Analysis Software
Documentation for sPHENIX simulation software
|
Go to the source code of this file.
Classes | |
struct | event_kinematics_cut |
struct | lepton_cut |
struct | gamma_cut |
struct | hadron_cut |
Functions | |
int | dvcs_plot () |
float | get_angle_separation (float e_phi, float e_theta, float g_phi, float g_theta) |
void | hist_to_png (TH2F *h, TString saveTitle) |
void | add_to_array (char *type, TString pngName, TString title, event_kinematics_cut ev_c=ev_standard_cut, lepton_cut l_c=l_standard_cut, gamma_cut g_c=g_standard_cut, hadron_cut h_c=h_standard_cut) |
void | BinLog (TH2F *h) |
Variables | |
const event_kinematics_cut | ev_standard_cut = {0,1000,0,100,0,100,0} |
const lepton_cut | l_standard_cut = {-999,999,-999,999,-999,999} |
const hadron_cut | h_standard_cut = {-999,999,-999,999,-999,999} |
const gamma_cut | g_standard_cut = {-999,999,-999,999,-999,999} |
TH2F ** | h2array |
event_kinematics_cut * | ev_cutarray |
lepton_cut * | l_cutarray |
gamma_cut * | g_cutarray |
hadron_cut * | h_cutarray |
TString * | pngNames |
int | index =0 |
int | arraySize |
int | nEvents |
const int | nbins =80 |
TH2F * | h2_x_Q2_base = new TH2F("x_Q2","",nbins,-4,0,nbins,0,2) |
TH2F * | h2_lepton_base = new TH2F("lepton_mom_eta","",nbins,-4,4,nbins,0,30) |
TH2F * | h2_gamma_base = new TH2F("gamma_mom_eta","",nbins,-4,4,nbins,0,30) |
TH2F * | h2_hadron_base = new TH2F("hadron_mom_eta","",nbins,-1,20,nbins,0,300) |
TH2F * | h2_hadron_scatter_base = new TH2F("scatter","",nbins,0,1.5,nbins,0,0.006) |
TH2F * | h2_electron_photon_angle_base = new TH2F("angle_separation","",nbins,0,3.2,nbins,0,1) |
TH2F * | h2_nils_plot = new TH2F("nils_plot","",nbins,0,9,nbins,0,360) |
void add_to_array | ( | char * | type, |
TString | pngName, | ||
TString | title, | ||
event_kinematics_cut | ev_c = ev_standard_cut , |
||
lepton_cut | l_c = l_standard_cut , |
||
gamma_cut | g_c = g_standard_cut , |
||
hadron_cut | h_c = h_standard_cut |
||
) |
Definition at line 427 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 427 of file dvcs_plot.C
References arraySize, BinLog(), h2_electron_photon_angle_base, h2_gamma_base, h2_hadron_base, h2_hadron_scatter_base, h2_lepton_base, h2_nils_plot, h2_x_Q2_base, h2array, index, and pngNames.
Referenced by dvcs_plot().
void BinLog | ( | TH2F * | h | ) |
Definition at line 482 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 482 of file dvcs_plot.C
References bins, i, and width.
Referenced by add_to_array().
int dvcs_plot | ( | ) |
Definition at line 86 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 86 of file dvcs_plot.C
References add_to_array(), arraySize, Enable::CEMC, RawTowerDefs::EEMC, energy, eta, f, RawTowerDefs::FEMC, get_angle_separation(), h2array, hist_to_png(), i, lepton_cut::max_eta, gamma_cut::max_eta, hadron_cut::max_eta, lepton_cut::max_mom, gamma_cut::max_mom, hadron_cut::max_mom, event_kinematics_cut::max_Q2, event_kinematics_cut::max_t, lepton_cut::max_theta, gamma_cut::max_theta, hadron_cut::max_theta, event_kinematics_cut::max_y, event_kinematics_cut::min_angle_separation, lepton_cut::min_eta, gamma_cut::min_eta, hadron_cut::min_eta, lepton_cut::min_mom, gamma_cut::min_mom, hadron_cut::min_mom, event_kinematics_cut::min_Q2, event_kinematics_cut::min_t, lepton_cut::min_theta, gamma_cut::min_theta, hadron_cut::min_theta, event_kinematics_cut::min_y, n, nEvents, ActsTests::PropagationDatasets::phi, train_ambiguity_solver::pid, pngNames, t, Acts::UnitConstants::T, ActsTests::PropagationDatasets::theta, ambiguity_solver_full_chain::x, and y.
float get_angle_separation | ( | float | e_phi, |
float | e_theta, | ||
float | g_phi, | ||
float | g_theta | ||
) |
Definition at line 355 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 355 of file dvcs_plot.C
Referenced by dvcs_plot().
void hist_to_png | ( | TH2F * | h, |
TString | saveTitle | ||
) |
Definition at line 375 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 375 of file dvcs_plot.C
Referenced by dvcs_plot(), jpsi_particle_plot(), and printHists().
int arraySize |
Definition at line 58 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 58 of file dvcs_plot.C
Referenced by add_to_array(), and dvcs_plot().
event_kinematics_cut* ev_cutarray |
Definition at line 52 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 52 of file dvcs_plot.C
const event_kinematics_cut ev_standard_cut = {0,1000,0,100,0,100,0} |
Definition at line 44 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 44 of file dvcs_plot.C
gamma_cut* g_cutarray |
Definition at line 54 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 54 of file dvcs_plot.C
const gamma_cut g_standard_cut = {-999,999,-999,999,-999,999} |
Definition at line 47 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 47 of file dvcs_plot.C
TH2F* h2_electron_photon_angle_base = new TH2F("angle_separation","",nbins,0,3.2,nbins,0,1) |
Definition at line 73 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 73 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_gamma_base = new TH2F("gamma_mom_eta","",nbins,-4,4,nbins,0,30) |
Definition at line 70 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 70 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_hadron_base = new TH2F("hadron_mom_eta","",nbins,-1,20,nbins,0,300) |
Definition at line 71 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 71 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_hadron_scatter_base = new TH2F("scatter","",nbins,0,1.5,nbins,0,0.006) |
Definition at line 72 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 72 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_lepton_base = new TH2F("lepton_mom_eta","",nbins,-4,4,nbins,0,30) |
Definition at line 69 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 69 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_nils_plot = new TH2F("nils_plot","",nbins,0,9,nbins,0,360) |
Definition at line 74 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 74 of file dvcs_plot.C
Referenced by add_to_array().
TH2F* h2_x_Q2_base = new TH2F("x_Q2","",nbins,-4,0,nbins,0,2) |
Definition at line 68 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 68 of file dvcs_plot.C
Referenced by add_to_array().
TH2F** h2array |
Definition at line 51 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 51 of file dvcs_plot.C
Referenced by add_to_array(), and dvcs_plot().
hadron_cut* h_cutarray |
Definition at line 55 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 55 of file dvcs_plot.C
const hadron_cut h_standard_cut = {-999,999,-999,999,-999,999} |
Definition at line 46 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 46 of file dvcs_plot.C
int index =0 |
Definition at line 57 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 57 of file dvcs_plot.C
Referenced by MultiArray< TVector3 >::Add(), add_to_array(), TrkrClusterContainerv4::addClusterSpecifyKey(), ActsExamples::HoughTransformSeeder::addMeasurements(), ParticleFlowElementContainer::AddParticleFlowElement(), nanoflann::KNNResultSet< DistanceType, IndexType, CountType >::addPoint(), JetRecoEval::all_truth_hits(), JetRecoEval::all_truth_particles(), JetTruthEval::all_truth_particles(), JetRecoEval::all_truth_showers(), approx(), Acts::TrackSelector::EtaBinnedConfig::binIndex(), Acts::Test::BOOST_AUTO_TEST_CASE(), Fatras::Test::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), Acts::IntegrationTest::BOOST_DATA_TEST_CASE(), ActsFatras::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), caen_correction::caen_correction(), noiPadDimSet::calc_pads(), Calibrator::calibrate(), DecayFinder::checkIfCorrectGeant4Particle(), DecayFinder::checkIfCorrectHepMCParticle(), ActsExamples::TrackFindingAlgorithm::computeSharedHits(), PHG4EPDDetector::construct_block(), TpcSpaceChargeReconstructionHelper::copy_histogram(), oncsSub_idtpcfeev2::crc16(), oncsSub_idinttv0::crc16(), Acts::VolumeMaterialMapper::createExtraHits(), ActsExamples::HoughTransformSeeder::createLayerHoughHist(), genfit::MeasurementFactory< measurement_T >::createMany(), groot::CreateZigzags(), DbFormEntry::DbFormEntry(), Packet_idll1v1::decode(), Packet_iddigitizerv2::decode(), oncsSub_idgl1v0::decode(), TowerInfoDefs::decode_emcal(), TowerInfoContainer::decode_emcal(), TowerInfoDefs::decode_epd(), TowerInfoContainer::decode_epd(), Packet_iddigitizerv3::decode_FEM(), TowerInfoDefs::decode_hcal(), TowerInfoContainer::decode_hcal(), decode_idmiznhc(), TowerInfoContainerv1::decode_key(), TowerInfoContainerv2::decode_key(), TowerInfoContainerv3::decode_key(), TowerInfoContainer::decode_mbd(), TowerInfoDefs::decode_mbd(), oncsSub_iddreamv0::decode_payload(), TowerInfoDefs::decode_smd(), TowerInfoDefs::decode_zdc(), TowerInfoContainer::decode_zdc(), AZigzag::DetermineCommonMode(), TPCMap::digest_map(), TpcMap::digest_map(), oncsSub_iddigitizerv1::digitizer_decode(), do_peak_finder(), Fun4AllOutputManager::DoNotWriteEvent(), EMCalTowerRingStudy(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Encode(), ActsExamples::SeedingAlgorithm::execute(), ActsExamples::HoughTransformSeeder::execute(), Acts::Experimental::DetectorVolumesCollection::extract(), Acts::Experimental::IndexedDetectorVolumeExtractor::extract(), detail::fillChargeMatrix(), FillEnergy(), Acts::SeedFilter< external_spacepoint_t >::filterSeeds_2SpFixed(), TrkrClusterContainerv4::findCluster(), findFramePacketIndex(), Acts::BinnedSPGroupIterator< external_spacepoint_t >::findNotEmptyBin(), Acts::findParticleData(), ActsExamples::findSpacePointForIndex(), Fun4All_FillChargesMap_300evts_MDC2(), Fun4All_FillDCMap(), MultiArray< TVector3 >::Get(), TpcDistortionCorrection::get_corrected_position(), JetRecoEval::get_energy_contribution(), PHG4CellDefs::MVTXBinning::get_index(), Jetv2::get_property(), PHG4EICMvtxDetector::get_stave(), PHG4MvtxDetector::get_stave(), TowerInfoContainerv1::get_tower_at_key(), TowerInfoContainerv2::get_tower_at_key(), TowerInfoContainerv3::get_tower_at_key(), JetTruthEval::get_truth_jet(), TowerInfov3::get_waveform_value(), TrkrClusterContainerv4::getClusters(), ActsExamples::HoughTransformSeeder::getComboIndices(), Acts::InterpolatedBFieldMap< grid_t >::getFieldCell(), A_Event::getFrameValue(), getHistoryEntry(), getHistorySourceIndex(), getHistoryStage(), getHistoryStatus(), TrigFTF_GNN_TrackingFilter< external_spacepoint_t >::getLayerType(), Acts::MaterialMapper< G >::getMaterialCell(), testing::internal::UnitTestImpl::GetMutableTestCase(), testing::TestCase::GetMutableTestInfo(), MultiArray< TVector3 >::GetPtr(), MakeSourceLinks::getSourceLinks(), testing::internal::UnitTestImpl::GetTestCase(), testing::TestCase::GetTestInfo(), testing::TestPartResultArray::GetTestPartResult(), OnlMonDBodbc::GetVar(), KFPVEfficiencies::Inc(), KFPartEfficiencies::Inc(), KFPVEfficiencies::IncReco(), KFPartEfficiencies::IncReco(), fm_partition::init_filling_buckets(), ratio_cut_partition::init_filling_buckets(), InttVertexMapv1::insert(), BbcVertexMapv1::insert(), MbdVertexMapv1::insert(), GlobalVertexMapv1::insert(), SvtxTrackMap_v1::insert(), SvtxTrackMap_v2::insert(), sPHElectronPairContainerv1::insert(), SvtxVertexMap_v1::insert(), DecayFinderContainer_v1::insert(), KFParticle_Container::insert(), JetMapv1::insert(), PHHepMCGenEventMap::insert_active_event(), PHHepMCGenEventMap::insert_background_event(), Acts::detail::Grid< external_spacepoint_t >::interpolate(), oncsSub_idinttv0::intt_decode(), ActsExamples::invertIndexMultimap(), Packet_starscaler::iValue(), oncsSub_idfnalmwpc::iValue(), oncsSub_idfnalmwpcv2::iValue(), oncsSub_idinttv0::iValue(), oncsSub_idmvtxv3::iValue(), fast_eta2y::Jacobian(), nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::KDTreeEigenMatrixAdaptor(), ActsExamples::SeedingFTFAlgorithm::LayerNumbering(), KFParticleSIMD::Load(), Packet_starscaler::lValue(), oncsSub_idmvtxv3::lValue(), main(), Acts::IntegrationTest::makeFieldMap(), makehist(), makeTestSimhits(), Acts::mapMaterialPoints(), ActsExamples::AmbiguityResolutionML::mapTrackHits(), genfit::MeanExcEnergy_get(), OnlineAnalysis(), trento::FastExp< T >::operator()(), Acts::ObjectMultiIntersection< object_t, representation_t >::operator[](), cl::vector< ::size_t, N >::operator[](), PHG4GDMLWriteParamvol::ParametersWrite(), PHG4TpcPadPlaneReadout::populate_tbins(), gbl::GblTrajectory::prepare(), testing::internal::PrintCharsAsStringTo(), TpcSimpleClusterizer::process_event(), TpcClusterizer::process_event(), MvtxCombinedRawDataDecoder::process_event(), PhotonJet::process_event(), PHTpcResiduals::processTrack(), ActsExamples::prototrackToSeed(), pyinom(), nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::query(), fast_eta2y::rapidity(), intt_pool::rawValue(), ActsExamples::RootSimHitReader::read(), ActsExamples::CsvMeasurementReader::read(), PHPythia6::ReadConfig(), ReadHis(), ReadHis2(), ReadHis3(), ActsExamples::EDM4hepUtil::readSimHit(), TrkrClusterContainerv4::removeCluster(), DynamicNearestNeighbours::RemovePoint(), DecayFinder::searchHepMCRecord(), nanoflann::KDTreeSingleIndexAdaptor< Distance, DatasetAdaptor, DIM, IndexType >::searchLevel(), KFParticleTopoReconstructor::SelectParticleCandidates(), MultiArray< TVector3 >::Set(), PseudoJet::set_cluster_hist_index(), Jetv2::set_property(), SvtxTrackSeed_v1::set_silicon_seed_index(), SvtxTrackSeed_v2::set_silicon_seed_index(), SvtxTrackSeed_v1::set_tpc_seed_index(), SvtxTrackSeed_v2::set_tpc_seed_index(), PseudoJet::set_user_index(), TowerInfov3::set_waveform_value(), KFPEmcCluster::SetCovariance(), Acts::detail::Grid< external_spacepoint_t >::setExteriorBins(), KFPEmcCluster::SetParameter(), KFPEmcCluster::SetTracks(), KFPTrackVector::SetTracks(), Acts::solenoidFieldMap(), PHActsInitialVertexFinder::sortTracks(), Acts::detail_vmt::VectorMultiTrajectoryBase::statistics(), Acts::Test::MultiTrajectoryTestsCommon< factory_t >::testTrackStateProxyCrossTalk(), Acts::Test::MultiTrajectoryTestsCommon< factory_t >::testTrackStateProxyStorage(), Acts::Test::MultiTrajectoryTestsCommon< factory_t >::testTrackStateReassignment(), oncsSub_idtpcfeev2::tpc_decode(), oncsSub_idtpcfeev3::tpc_decode(), tpc_pool::tpc_decode(), Fun4AllServer::unregisterSubsystemsNow(), ActsAlignment::Alignment< fitter_t >::updateAlignmentParameters(), Fun4AllServer::UpdateEventSelector(), A_Event::updateFramelist(), MicromegasHotChannelMapData::write(), Fun4AllEventOutStream::WriteEvent(), Acts::xyzCoordinateCheck(), and nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::~KDTreeEigenMatrixAdaptor().
lepton_cut* l_cutarray |
Definition at line 53 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 53 of file dvcs_plot.C
const lepton_cut l_standard_cut = {-999,999,-999,999,-999,999} |
Definition at line 45 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 45 of file dvcs_plot.C
const int nbins =80 |
Definition at line 67 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 67 of file dvcs_plot.C
Referenced by TilingExtent::_determine_rapidity_extent(), calo_towers(), ChargeMapReader::CanInterpolateAt(), ccbb(), centrality_newplotbg_newsupp(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), crossterms(), fakee_invmass(), SvtxEvaluator::fillOutputNtuples(), fit(), fit_vs_directcount(), generateTruthIbfGainMap(), GetZProjection(), instantiate(), jpsi_particle_plot(), loop_tree(), make_fmod_calibrations(), newplotbg_dAu_vscent_2022(), newplotbg_newsupp(), newplotbg_newsupp_2021(), newplotbg_newsupp_2022(), newplotbg_newsupp_2022_60pct(), newplotbg_vscent_2022(), Plot_FastTrack_Efficiency(), Plot_Hit_Count(), Plot_SVTX_Efficiency(), plotembed_vscent(), plotpirej(), plotTimes(), PHG4BlockCellReco::process_event(), Acts::Experimental::ProtoBinning::ProtoBinning(), ActsExamples::Options::readMagneticField(), ChargeMapReader::ReadSourceAdc(), rebin_TH1D(), ChargeMapReader::RegenerateDensity(), Acts::solenoidFieldMap(), TEST_CASE(), track2cluster_plot(), while(), write(), write_recals_to_text(), and writeTimeOrderedDistortions().
int nEvents |
Definition at line 62 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 62 of file dvcs_plot.C
Referenced by analyzeClusterEtIso(), analyzeTree(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), clus_dst_simple_superfastcalib(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), dvcs_plot(), Fun(), Fun4All_Ana(), Fun4All_BHG(), Fun4All_CaloProduction_PreQM23(), Fun4All_CaloTreeGen(), Fun4All_Condor(), Fun4All_EICAnalysis_DIS(), Fun4All_EICAnalysis_DISReco(), Fun4All_EICAnalysis_DVCS(), Fun4All_EICAnalysis_Exclusive(), Fun4All_EICAnalysis_Leptoquarks(), Fun4All_EICAnalysis_Quarkonia(), Fun4All_EICAnalysis_TrackEval(), Fun4All_EMCalBadTowerID(), Fun4All_EMCalLikelihood(), Fun4All_FillChargesMap_300evts_MDC2(), Fun4All_FillDCMap(), Fun4All_G4_block(), Fun4All_G4_Calos(), Fun4All_G4_Clusters(), Fun4All_G4_EICDetector_LQ(), Fun4All_G4_EICDetector_LQ_analysis(), Fun4All_G4_EICDetector_LQ_analysis_nf(), Fun4All_G4_EICDetector_LQ_reference(), Fun4All_G4_EICDetector_RICH(), Fun4All_G4_EICIR(), Fun4All_G4_fsPHENIX_FastSim(), Fun4All_G4_fsPHENIX_pi0(), Fun4All_G4_IonGun(), Fun4All_G4_LeadBrick(), Fun4All_G4_Prototype2(), Fun4All_G4_Prototype3(), Fun4All_G4_Prototype4(), Fun4All_G4_sPHENIX(), Fun4All_G4_sPHENIX_AnaGenFit(), Fun4All_G4_sPHENIX_photonjet(), Fun4All_G4_sPHENIX_photons(), Fun4All_G4_sPHENIX_truthphotonjet(), Fun4All_G4_TPC(), Fun4All_G4_W(), Fun4All_HCALAnalysis(), Fun4All_hijbkg(), Fun4All_Intt_Combiner(), Fun4All_MBDTreeGen(), Fun4All_MCEventGen(), Fun4All_PRDF(), Fun4All_Pythia6(), Fun4All_quickHijing_Prod(), Fun4All_RICHReco(), Fun4All_RunCorrelatorJetTree(), Fun4All_RunCorrelatorQAModules(), Fun4All_RunLambdaJetHunter(), Fun4All_single_particle(), Fun4All_TestBeam(), Fun4All_TestBeam_Ana(), Fun4All_TestBeam_ExampleAnalysisModule(), Fun4All_TestBeam_HCAL_SampleFrac(), Fun4All_TestBeam_HCAL_ShowerCalib(), Fun4All_TestBeam_HCAL_TowerCalib(), Fun4All_TestBeam_ShowerCalib(), Fun4All_TestBeam_TPC(), Fun4All_testEtIso_Hijing(), Fun4All_testEtIso_Pythia(), Fun4All_testingGround(), Fun4AllRolloverFileOutStream::Fun4AllRolloverFileOutStream(), generate_ep_dis(), generator(), hcal_toweridmacro(), Jin_BJet(), main(), processGeometry(), Jetscape::JetScape::ReadGeneralParametersFromXML(), Run(), Run_BbcCheck(), RunBDiJetModule(), KFParticleTopoReconstructor::SaveInputParticles(), srundst_mdc2_clustest(), toweridmacro(), track2cluster_plot(), and Wrapper().
TString* pngNames |
Definition at line 56 of file dvcs_plot.C.
View newest version in sPHENIX GitHub at line 56 of file dvcs_plot.C
Referenced by add_to_array(), and dvcs_plot().