Analysis Software
Documentation for sPHENIX simulation software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
EMCalTowerRingStudy.C File Reference
#include <iostream>
#include <string>
#include <vector>
#include <TFile.h>
#include <TTree.h>
#include <TAxis.h>
#include <TChain.h>
+ Include dependency graph for EMCalTowerRingStudy.C:

Go to the source code of this file.

Functions

double delta_phi (double phi1, double phi2)
 
double phi_in_range (double phi)
 
bool tower_in_square (float calo_eta, float calo_phi, float eta, float phi, int N)
 
bool tower_in_ring (float calo_eta, float calo_phi, float eta, float phi, int N)
 
void EMCalTowerRingStudy ()
 

Variables

Int_t event
 
Float_t eta
 
Float_t phi
 
Float_t e
 
Float_t pt
 
Float_t vx
 
Float_t vy
 
Float_t vz
 
vector< int > id
 
int nTow_in
 
vector< float > eta_in
 
vector< float > phi_in
 
vector< float > e_in
 
vector< int > ieta_in
 
vector< int > iphi_in
 
int nTow_out
 
vector< float > eta_out
 
vector< float > phi_out
 
vector< float > e_out
 
vector< int > ieta_out
 
vector< int > iphi_out
 
int nTow_emc
 
vector< float > eta_emc
 
vector< float > phi_emc
 
vector< float > e_emc
 
vector< int > ieta_emc
 
vector< int > iphi_emc
 
TTree * fChain
 
Int_t fCurrent
 pointer to the analyzed TTree or TChain
 
const int ncal = 3
 current Tree number in a TChain
 
string cal_name [] = { "iHCal", "oHCal", "EMCal" }
 
string cal_tag [] = { "_in", "_out", "_emc" }
 
TString inFileName = "HCalJetPhiShift_10k.root"
 
int n_pt_bins [ncal] = {80,100,100}
 
double pt_bin_lo [ncal] = {0.,0.,0.}
 
double pt_bin_hi [ncal] = {4.,50.,20.}
 
double eta_max [ncal] = {1.1,1.1,1.152}
 
int n_eta_bins [ncal] = {24,24,96}
 
int n_phi_bins [ncal] = {64,64,256}
 
int * nTowers [ncal] = {&nTow_in, &nTow_out, &nTow_emc}
 
vector< float > * calo_eta [ncal] = {&eta_in, &eta_out, &eta_emc}
 
vector< float > * calo_phi [ncal] = {&phi_in, &phi_out, &phi_emc}
 
vector< float > * calo_e [ncal] = {&phi_in, &phi_out, &e_emc}
 
vector< int > * calo_ieta [ncal] = {&ieta_in, &ieta_out, &ieta_emc}
 
vector< int > * calo_iphi [ncal] = {&iphi_in, &iphi_out, &iphi_emc}
 
const int i_cal = 2
 
const int ref_cal = 2
 

Function Documentation

double delta_phi ( double  phi1,
double  phi2 
)

Definition at line 63 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 63 of file EMCalTowerRingStudy.C

Referenced by cluster_resolution(), dR(), event_topology_reco(), ExploreTTrees(), RawClusterBuilderTopo::get_adjacent_towers_by_ID(), likelihood(), likelihood_topology(), PHTpcCentralMembraneMatcher::process_event(), PHTpcDeltaZCorrection::process_track(), TpcDirectLaserReconstruction::process_track(), TpcSpaceChargeReconstruction::process_track(), tower_in_ring(), and TrackCaloDist().

+ Here is the caller graph for this function:

void EMCalTowerRingStudy ( )

Definition at line 110 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 110 of file EMCalTowerRingStudy.C

References Acts::Test::at, cal_tag, calo_e, calo_eta, calo_ieta, calo_iphi, calo_phi, double(), Acts::UnitConstants::e, eta, event, f, fChain, add_histos::histos, i, i_cal, index, configureMap::inFileName, j, ncal, nTowers, writeMapConfig::outFileName, ActsTests::PropagationDatasets::phi, Acts::Test::pos, physmon_track_finding_ttbar::pt, ref_cal, tower_in_ring(), Acts::UnitConstants::us, vx, vy, and vz.

+ Here is the call graph for this function:

double phi_in_range ( double  phi)

Definition at line 70 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 70 of file EMCalTowerRingStudy.C

References ActsTests::PropagationDatasets::phi.

Referenced by ExploreTTrees(), and tower_in_ring().

+ Here is the caller graph for this function:

bool tower_in_ring ( float  calo_eta,
float  calo_phi,
float  eta,
float  phi,
int  N 
)

Definition at line 87 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 87 of file EMCalTowerRingStudy.C

References delta_phi(), double(), and phi_in_range().

Referenced by EMCalTowerRingStudy().

+ Here is the call graph for this function:

+ Here is the caller graph for this function:

bool tower_in_square ( float  calo_eta,
float  calo_phi,
float  eta,
float  phi,
int  N 
)

Definition at line 76 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 76 of file EMCalTowerRingStudy.C

Variable Documentation

string cal_name[] = { "iHCal", "oHCal", "EMCal" }

Definition at line 46 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 46 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

string cal_tag[] = { "_in", "_out", "_emc" }

Definition at line 47 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 47 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<float>* calo_e[ncal] = {&phi_in, &phi_out, &e_emc}

Definition at line 59 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 59 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<float>* calo_eta[ncal] = {&eta_in, &eta_out, &eta_emc}

Definition at line 57 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 57 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<int>* calo_ieta[ncal] = {&ieta_in, &ieta_out, &ieta_emc}

Definition at line 60 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 60 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<int>* calo_iphi[ncal] = {&iphi_in, &iphi_out, &iphi_emc}

Definition at line 61 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 61 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<float>* calo_phi[ncal] = {&phi_in, &phi_out, &phi_emc}

Definition at line 58 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 58 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<float> e_emc

Definition at line 37 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 37 of file EMCalTowerRingStudy.C

vector<float> e_in

Definition at line 25 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 25 of file EMCalTowerRingStudy.C

vector<float> e_out

Definition at line 31 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 31 of file EMCalTowerRingStudy.C

Float_t eta

Definition at line 13 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 13 of file EMCalTowerRingStudy.C

Referenced by __example_6.f__(), __example_7.f__(), __example_8.f__(), LazyTiling9Alt::_initialise_tiles(), LazyTiling9::_initialise_tiles(), LazyTiling25::_initialise_tiles(), AddFlowToParent(), myAnalysis::analyze(), STrackCutStudy::Analyze(), AnalyzeResiduals(), analyzeSignal(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_DATA_TEST_CASE(), PHTruthSiliconAssociation::buildTrackSeed(), PHTruthTrackSeeding::buildTrackSeed(), Fluid::calcTotals(), CalculateSigmaDca(), cemcReco::calculateTSP(), ccbb(), DecayFinder::checkIfCorrectGeant4Particle(), trento::Event::compute_reduced_thickness(), ConstructGeometry(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), create_pythia_dummy(), EMCalLikelihood::do_ganging(), Martini::DoEnergyLoss(), ColoredHadronization::DoHadronization(), HybridHadronization::DoHadronization(), DrawEcal_BlockCalibration(), dvcs_plot(), eic_sphenix_test_smearing(), eic_unsmeared_eta_p(), eicsmear_check_calorimeter(), eicsmear_check_tracking(), EMCalTowerRingStudy(), JetMultSub::EstimateRho(), EMCalCalib::eval_photon_proj(), EMCalAna::eval_trk_proj(), QAG4SimulationCalorimeterSum::eval_trk_proj(), ActsExamples::TrackParameterSelector::execute(), ActsExamples::ParticleSelector::execute(), ActsExamples::TruthSeedSelector::execute(), ActsExamples::PropagationAlgorithm::execute(), ExploreTTrees(), f2pyth(), fast_eta2y::fast_eta2y(), ffdeu(), ActsExamples::EffPlotTool::fill(), ActsExamples::TrackSummaryPlotTool::fill(), ActsExamples::DuplicationPlotTool::fill(), ActsExamples::FakeRatePlotTool::fill(), ActsExamples::ResPlotTool::fill(), JetEvaluator::fillOutputNtuples(), JetEnergies::fillOutputNtuples(), TrkrNtuplizer::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), find_matching_jet(), ElectronID::findMCmatch(), LeptoquarksReco::FindMinDeltaRCandidate(), fjetResol(), flowAfterburner(), Jetscape::FluidDynamics::FluidDynamics(), fullMaterial(), Fun4All_G4_Prototype3(), Fun4All_G4_Prototype4(), Fun4All_G4_TPC(), GenHadron::GenHadron(), PHG4Utils::get_eta(), PHG4InputFilter::get_eta(), RawTowerGeomv1::get_eta(), RawTowerGeomv4::get_eta(), RawTowerGeomv2::get_eta(), RawTowerGeomv3::get_eta(), PHG4Utils::get_etaphi(), TowerJetInput::get_input(), TruthJetInput::get_input(), Jetscape::EvolutionHistory::get_tz(), TrackProjectionTools::getCluster(), Fluid::getCMFvariables(), getenergyhlle_(), getEta(), KFParticleBaseSIMD::GetEta(), Acts::TrigFTF_GNN_Layer< external_spacepoint_t >::getEtaBin(), GetEvalHisto(), CLVisc::GetHydroInfo(), Hydroinfo_MUSIC::getHydroValues(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::getLifetimeSignOfTrack(), DVMPHelper::GetParticleReco(), ParticleReader::getParticles(), DVMPHelper::GetParticleTruth(), GetQAHisto(), GetResolution(), hijfst_(), Hit::Hit(), TowerBackgroundv1::identify(), STrackCutStudy::InitTuples(), DISKinematicsReco::InsertCandidateFromCluster(), TrackProjectorPid::is_in_RICH(), Jet_reso(), Jet_reso_Iso(), RandomConeAna::jets_to_pseudojets(), likelihood(), Jetscape::PartonShower::load_edge_info_handler(), CaloCalibEmc_Pi0::Loop(), CaloCalibEmc_Pi0::Loop_for_eta_slices(), lucell(), MachineLearning_CSV(), main(), PHActsTrackProjection::makeCaloSurfacePtrs(), makeV1_BUP2020(), MaterialHistograms::MaterialHistograms(), momentumDistributions(), Acts::ObjectSorterT< Vector3 >::operator()(), ActsExamples::ParametricParticleGenerator::operator()(), Acts::DistanceSorterT< T >::operator()(), SecondaryVertexFinder::outputTrackDetails(), Plot_FastTrack_Efficiency(), Plot_Hit_Count(), plotbg(), plotembed_vscent(), plotpirej(), Jetscape::SurfaceFinder::PrepareASurfaceCell(), printHits(), PHSiliconTruthTrackSeeding::Process(), HFFastSim::process_D02PiK(), PHG4InputFilter::process_event(), PHG4ParticleGenerator::process_event(), PHG4ParticleGeneratorD0::process_event(), JetProbeMaker::process_event(), TrackingPerformanceCheck::process_event(), RecoInfoExport::process_event(), PHHepMCParticleSelectorDecayProductChain::process_event(), RawTowerCalibration::process_event(), G4TowerNtuple::process_event(), G4CellNtuple::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), PHG4SimpleEventGenerator::process_event(), Quarkonia2LeptonsMC::process_event(), SubtractTowers::process_event(), SubtractTowersCS::process_event(), TowerTiming::process_event(), RawTowerDigitizer::process_event(), RetowerCEMC::process_event(), HFMLTriggerHepMCTrigger::process_event(), DirectPhotonPythia::process_event(), DetermineTowerBackground::process_event(), TPCDataStreamEmulator::process_event(), PJTranslator::process_event(), UEvsEtaCentrality::process_event(), PHGenFitTrackProjection::process_event(), hijbkg_upc::process_event(), TPCMLDataInterface::process_event(), singlePhotonClusterAna::process_event(), pi0ClusterAna::process_event(), caloTreeGen::process_event(), ElectronID::process_event(), pythiaEMCalAna::process_event(), MyJetAnalysis::process_event(), cemcReco::process_event(), RawTowerCombiner::process_event(), sPHAnalysis::process_event_hepmc(), sPHAnalysis::process_event_pythiaupsilon(), sPHAnalysis::process_event_test(), sPHAnalysis::process_event_upsilons(), CaloWaveFormSim::process_g4hits(), HFFastSim::process_Lc2pPiK(), KshortReconstruction::projectTrackToCylinder(), pycell(), pyresd(), pyxtot(), RandomHit(), VtxRegressor::regress(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::JetInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::FlowInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ClustInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::TrkInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::CstInfo::Rest(), PHFlowJetMaker::run_particle_flow(), CaloTriggerInfov1::set_best2_EMCal_4x4_eta(), CaloTriggerInfov1::set_best_EMCal_2x2_eta(), CaloTriggerInfov1::set_best_EMCal_4x4_eta(), CaloTriggerInfov1::set_best_FullCalo_0p2x0p2_eta(), CaloTriggerInfov1::set_best_FullCalo_0p4x0p4_eta(), CaloTriggerInfov1::set_best_FullCalo_0p6x0p6_eta(), CaloTriggerInfov1::set_best_FullCalo_0p8x0p8_eta(), CaloTriggerInfov1::set_best_FullCalo_1p0x1p0_eta(), PHG4Reco::set_rapidity_coverage(), PHSartreParticleTrigger::SetAbsEtaHigh(), PHPy8ParticleTrigger::SetAbsEtaHigh(), PHPy6ParticleTrigger::SetAbsEtaHigh(), PHSartreParticleTrigger::SetAbsEtaLow(), PHPy8ParticleTrigger::SetAbsEtaLow(), PHPy6ParticleTrigger::SetAbsEtaLow(), PHSartreParticleTrigger::SetEtaHigh(), PHPy8ParticleTrigger::SetEtaHigh(), PHPy6ParticleTrigger::SetEtaHigh(), PHSartreParticleTrigger::SetEtaLow(), PHPy8ParticleTrigger::SetEtaLow(), PHPy6ParticleTrigger::SetEtaLow(), Proto3ShowerCalib::Eval_Cluster::setfmods(), IC::setIC(), ICGubser::setIC(), ICGlauber::setIC(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::JetInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::CstInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::FlowInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ClustInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::TrkInfo::SetInfo(), PHG4Utils::SetPseudoRapidityCoverage(), TEST(), TrackCaloDist(), TrackParametrization(), Acts::TrigFTF_GNN_Layer< external_spacepoint_t >::TrigFTF_GNN_Layer(), TreeMaker::UseFastJet(), Acts::BinningData::value(), Acts::MeasurementSelector::VariableCut(), ActsEvaluator::visitTrackStates(), VtxRegressor::VtxRegressor(), pythiaEMCalAna::withinAcceptance(), ActsExamples::RootTrajectorySummaryWriter::writeT(), and ActsExamples::RootMaterialTrackWriter::writeT().

vector<float> eta_emc

Definition at line 35 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 35 of file EMCalTowerRingStudy.C

vector<float> eta_in

Definition at line 23 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 23 of file EMCalTowerRingStudy.C

double eta_max[ncal] = {1.1,1.1,1.152}

Definition at line 52 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 52 of file EMCalTowerRingStudy.C

vector<float> eta_out

Definition at line 29 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 29 of file EMCalTowerRingStudy.C

Int_t event

Definition at line 12 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 12 of file EMCalTowerRingStudy.C

TTree* fChain

Definition at line 41 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 41 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

Int_t fCurrent

pointer to the analyzed TTree or TChain

Definition at line 42 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 42 of file EMCalTowerRingStudy.C

const int i_cal = 2

Definition at line 104 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 104 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

vector<int> ieta_emc

Definition at line 38 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 38 of file EMCalTowerRingStudy.C

vector<int> ieta_in

Definition at line 26 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 26 of file EMCalTowerRingStudy.C

vector<int> ieta_out

Definition at line 32 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 32 of file EMCalTowerRingStudy.C

TString inFileName = "HCalJetPhiShift_10k.root"

Definition at line 48 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 48 of file EMCalTowerRingStudy.C

vector<int> iphi_emc

Definition at line 39 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 39 of file EMCalTowerRingStudy.C

vector<int> iphi_in

Definition at line 27 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 27 of file EMCalTowerRingStudy.C

vector<int> iphi_out

Definition at line 33 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 33 of file EMCalTowerRingStudy.C

int n_eta_bins[ncal] = {24,24,96}

Definition at line 53 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 53 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

int n_phi_bins[ncal] = {64,64,256}

Definition at line 54 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 54 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

int n_pt_bins[ncal] = {80,100,100}

Definition at line 49 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 49 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

const int ncal = 3

current Tree number in a TChain

Definition at line 45 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 45 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy(), and ExploreTTrees().

int nTow_emc

Definition at line 34 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 34 of file EMCalTowerRingStudy.C

int nTow_in

Definition at line 22 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 22 of file EMCalTowerRingStudy.C

int nTow_out

Definition at line 28 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 28 of file EMCalTowerRingStudy.C

int* nTowers[ncal] = {&nTow_in, &nTow_out, &nTow_emc}

Definition at line 56 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 56 of file EMCalTowerRingStudy.C

vector<float> phi_emc

Definition at line 36 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 36 of file EMCalTowerRingStudy.C

vector<float> phi_in

Definition at line 24 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 24 of file EMCalTowerRingStudy.C

Referenced by SepdMon::process_event(), and PseudoJet::set_cached_rap_phi().

vector<float> phi_out

Definition at line 30 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 30 of file EMCalTowerRingStudy.C

double pt_bin_hi[ncal] = {4.,50.,20.}

Definition at line 51 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 51 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

double pt_bin_lo[ncal] = {0.,0.,0.}

Definition at line 50 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 50 of file EMCalTowerRingStudy.C

Referenced by ExploreTTrees().

const int ref_cal = 2

Definition at line 108 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 108 of file EMCalTowerRingStudy.C

Referenced by EMCalTowerRingStudy().

Float_t vx

Definition at line 17 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 17 of file EMCalTowerRingStudy.C

Referenced by STrackCutStudy::Analyze(), Fluid::calcTotals(), SetupDualRICHAnalyzer::calculate_emission_angle(), FluidcellStatistic::calculate_hypersurface_3volume(), HydroinfoH5::clean_hydro_event(), create_pythia_dummy(), Matter::DoEnergyLoss(), AdSCFT::DoEnergyLoss(), Martini::DoEnergyLoss(), HybridHadronization::DoHadronization(), EMCalTowerRingStudy(), ExploreTTrees(), psTOFTimezeroEval::fillOutputNtuples(), SvtxEvaluatorHaiwang::fillOutputNtuples(), TrkrNtuplizer::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), Fun4All_G4_EICIR(), sPHElectronPairv1::get_phiv(), getenergyhlle_(), HydroinfoH5::getHydroinfo(), HydroinfoH5::getHydroinfoOnlattice(), Hydroinfo_MUSIC::getHydroValues(), ClusterIso::getTowerEta(), getvalueshlle_(), GraphShiftScaling(), STrackCutStudy::InitTuples(), Hydro::ISformal(), PHG4Utils::line_and_rectangle_intersect(), main(), Fluid::outputGnuplot(), psTOFTimezeroEval::printOutputInfo(), SvtxEvaluatorHaiwang::printOutputInfo(), TrkrNtuplizer::printOutputInfo(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), MomentumEvaluator::process_event(), RawClusterBuilderTemplate::process_event(), PHG4BlockCellReco::process_event(), QAG4SimulationVertex::process_event(), Pi0MassAnalysis::process_event(), CaloCalibEmc_Pi0::process_event(), pyhistfu(), pypdpo(), Hydroinfo_MUSIC::readHydroData(), HydroinfoH5::readHydroinfoBuffered_total(), HydroinfoH5::readHydroinfoH5(), HydroinfoH5::readHydroinfoSingleframe(), PHSimpleVertexFinder::removeOutlierTrackPairs(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::Reset(), IC::setIC(), ICGubser::setIC(), ICGlauber::setIC(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::SetInfo(), Hydro::setNSvalues(), Hydro::source_step(), and Hydro::visc_source_step().

Float_t vy

Definition at line 18 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 18 of file EMCalTowerRingStudy.C

Referenced by STrackCutStudy::Analyze(), Fluid::calcTotals(), SetupDualRICHAnalyzer::calculate_emission_angle(), FluidcellStatistic::calculate_hypersurface_3volume(), HydroinfoH5::clean_hydro_event(), create_pythia_dummy(), Matter::DoEnergyLoss(), AdSCFT::DoEnergyLoss(), Martini::DoEnergyLoss(), HybridHadronization::DoHadronization(), EMCalTowerRingStudy(), ExploreTTrees(), psTOFTimezeroEval::fillOutputNtuples(), SvtxEvaluatorHaiwang::fillOutputNtuples(), TrkrNtuplizer::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), Fun4All_G4_EICIR(), sPHElectronPairv1::get_phiv(), getenergyhlle_(), HydroinfoH5::getHydroinfo(), HydroinfoH5::getHydroinfoOnlattice(), Hydroinfo_MUSIC::getHydroValues(), ClusterIso::getTowerEta(), getvalueshlle_(), GraphShiftScaling(), STrackCutStudy::InitTuples(), Hydro::ISformal(), PHG4Utils::line_and_rectangle_intersect(), main(), Fluid::outputGnuplot(), psTOFTimezeroEval::printOutputInfo(), SvtxEvaluatorHaiwang::printOutputInfo(), TrkrNtuplizer::printOutputInfo(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), MomentumEvaluator::process_event(), RawClusterBuilderTemplate::process_event(), QAG4SimulationVertex::process_event(), Pi0MassAnalysis::process_event(), CaloCalibEmc_Pi0::process_event(), Hydroinfo_MUSIC::readHydroData(), HydroinfoH5::readHydroinfoBuffered_total(), HydroinfoH5::readHydroinfoH5(), HydroinfoH5::readHydroinfoSingleframe(), PHSimpleVertexFinder::removeOutlierTrackPairs(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::Reset(), ICGubser::setIC(), IC::setIC(), ICGlauber::setIC(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::SetInfo(), Hydro::setNSvalues(), Hydro::source_step(), and Hydro::visc_source_step().

Float_t vz

Definition at line 19 of file EMCalTowerRingStudy.C.

View newest version in sPHENIX GitHub at line 19 of file EMCalTowerRingStudy.C

Referenced by STrackCutStudy::Analyze(), Fluid::calcTotals(), SetupDualRICHAnalyzer::calculate_emission_angle(), InttVertexFinder::calculateZvertex(), create_pythia_dummy(), Matter::DoEnergyLoss(), AdSCFT::DoEnergyLoss(), Martini::DoEnergyLoss(), HybridHadronization::DoHadronization(), EMCalTowerRingStudy(), Acts::estimateTrackParamsFromSeed(), ExploreTTrees(), psTOFTimezeroEval::fillOutputNtuples(), SvtxEvaluatorHaiwang::fillOutputNtuples(), TrkrNtuplizer::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), Fun4All_G4_EICIR(), sPHElectronPairv1::get_phiv(), Fluid::getCMFvariables(), getenergyhlle_(), Hydroinfo_MUSIC::getHydroValues(), ClusterIso::getTowerEta(), getvalueshlle_(), STrackCutStudy::InitTuples(), Hydro::ISformal(), main(), Fluid::outputGnuplot(), psTOFTimezeroEval::printOutputInfo(), SvtxEvaluatorHaiwang::printOutputInfo(), TrkrNtuplizer::printOutputInfo(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), CaloRecoUtility::ProbCorrsZVertex(), MomentumEvaluator::process_event(), RawClusterZVertexRecorrect::process_event(), RawClusterBuilderTemplate::process_event(), PHG4CylinderCellReco::process_event(), QAG4SimulationVertex::process_event(), Pi0MassAnalysis::process_event(), CaloCalibEmc_Pi0::process_event(), Hydroinfo_MUSIC::readHydroData(), PHSimpleVertexFinder::removeOutlierTrackPairs(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::Reset(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::Reset(), ICGubser::setIC(), IC::setIC(), ICGlauber::setIC(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::ParInfo::SetInfo(), SColdQcdCorrelatorAnalysis::SCorrelatorUtilities::RecoInfo::SetInfo(), Hydro::setNSvalues(), Hydro::source(), Hydro::source_step(), transformCV(), and Hydro::visc_source_step().