#include <DataFormats/Candidate/interface/Particle.h>
Public Types | |
typedef int | Charge |
electric charge type | |
typedef math::XYZTLorentzVector | LorentzVector |
Lorentz vector. | |
typedef math::XYZPoint | Point |
point in the space | |
typedef math::PtEtaPhiMLorentzVector | PolarLorentzVector |
Lorentz vector. | |
typedef math::XYZVector | Vector |
point in the space | |
Public Member Functions | |
Vector | boostToCM () const |
boost vector to boost a Lorentz vector to the particle center of mass system | |
int | charge () const |
electric charge | |
double | energy () const |
energy | |
double | et () const |
transverse energy | |
double | eta () const |
momentum pseudorapidity | |
bool | longLived () const |
is long lived? | |
double | mass () const |
mass | |
double | massSqr () const |
mass squared | |
Vector | momentum () const |
spatial momentum vector | |
double | mt () const |
transverse mass | |
double | mtSqr () const |
transverse mass squared | |
double | p () const |
magnitude of momentum vector | |
const LorentzVector & | p4 () const |
four-momentum Lorentz vector | |
Particle (Charge q, const PolarLorentzVector &p4, const Point &vertex=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true) | |
constructor from values | |
Particle (Charge q, const LorentzVector &p4, const Point &vertex=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true) | |
constructor from values | |
Particle () | |
default constructor | |
int | pdgId () const |
PDG identifier. | |
double | phi () const |
momentum azimuthal angle | |
const PolarLorentzVector & | polarP4 () const |
four-momentum Lorentz vector | |
double | pt () const |
transverse momentum | |
double | px () const |
x coordinate of momentum vector | |
double | py () const |
y coordinate of momentum vector | |
double | pz () const |
z coordinate of momentum vector | |
double | rapidity () const |
repidity | |
void | setCharge (Charge q) |
set electric charge | |
void | setLongLived () |
set long lived flag | |
void | setMass (double m) |
set particle mass | |
void | setP4 (const PolarLorentzVector &p4) |
set 4-momentum | |
void | setP4 (const LorentzVector &p4) |
set 4-momentum | |
void | setPdgId (int pdgId) |
void | setPz (double pz) |
void | setStatus (int status) |
set status word | |
void | setThreeCharge (Charge qx3) |
set electric charge | |
void | setVertex (const Point &vertex) |
set vertex | |
int | status () const |
status word | |
double | theta () const |
momentum polar angle | |
int | threeCharge () const |
electric charge | |
const Point & | vertex () const |
vertex position | |
double | vx () const |
x coordinate of vertex position | |
double | vy () const |
y coordinate of vertex position | |
double | vz () const |
z coordinate of vertex position | |
double | y () const |
repidity | |
virtual | ~Particle () |
destructor | |
Static Public Attributes | |
static const unsigned int | longLivedTag = 65536 |
long lived flag | |
Protected Member Functions | |
void | cacheCartesian () const |
set internal cache | |
void | cachePolar () const |
set internal cache | |
void | clearCache () const |
clear internal cache | |
Protected Attributes | |
edm::BoolCache | cacheCartesianFixed_ |
edm::BoolCache | cachePolarFixed_ |
has cache been set? | |
float | eta_ |
float | mass_ |
LorentzVector | p4Cartesian_ |
internal cache for p4 | |
PolarLorentzVector | p4Polar_ |
internal cache for p4 | |
int | pdgId_ |
PDG identifier. | |
float | phi_ |
float | pt_ |
four-momentum Lorentz vector | |
Charge | qx3_ |
electric charge | |
int | status_ |
status word | |
Point | vertex_ |
vertex position |
Definition at line 21 of file Particle.h.
typedef int reco::Particle::Charge |
typedef math::XYZPoint reco::Particle::Point |
reco::Particle::Particle | ( | ) | [inline] |
reco::Particle::Particle | ( | Charge | q, | |
const LorentzVector & | p4, | |||
const Point & | vertex = Point( 0, 0, 0 ) , |
|||
int | pdgId = 0 , |
|||
int | status = 0 , |
|||
bool | integerCharge = true | |||
) | [inline] |
constructor from values
Definition at line 36 of file Particle.h.
References qx3_.
00037 : 00038 qx3_( q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ), 00039 vertex_( vertex ), pdgId_( pdgId ), status_( status ), 00040 cachePolarFixed_( false ), cacheCartesianFixed_( false ) { 00041 if ( integerCharge ) qx3_ *= 3; 00042 }
reco::Particle::Particle | ( | Charge | q, | |
const PolarLorentzVector & | p4, | |||
const Point & | vertex = Point( 0, 0, 0 ) , |
|||
int | pdgId = 0 , |
|||
int | status = 0 , |
|||
bool | integerCharge = true | |||
) | [inline] |
constructor from values
Definition at line 44 of file Particle.h.
References qx3_.
00045 : 00046 qx3_( q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ), 00047 vertex_( vertex ), pdgId_( pdgId ), status_( status ), 00048 cachePolarFixed_( false ), cacheCartesianFixed_( false ) { 00049 if ( integerCharge ) qx3_ *= 3; 00050 }
virtual reco::Particle::~Particle | ( | ) | [inline, virtual] |
Vector reco::Particle::boostToCM | ( | ) | const [inline] |
boost vector to boost a Lorentz vector to the particle center of mass system
Definition at line 69 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
00069 { cacheCartesian(); return p4Cartesian_.BoostToCM(); }
void reco::Particle::cacheCartesian | ( | ) | const [inline, protected] |
set internal cache
Definition at line 186 of file Particle.h.
References cacheCartesianFixed_, cachePolar(), p4Cartesian_, and p4Polar_.
Referenced by boostToCM(), energy(), momentum(), p(), p4(), px(), py(), pz(), setPz(), and theta().
00186 { 00187 if ( cacheCartesianFixed_ ) return; 00188 cachePolar(); 00189 p4Cartesian_ = p4Polar_; 00190 cacheCartesianFixed_ = true; 00191 }
void reco::Particle::cachePolar | ( | ) | const [inline, protected] |
set internal cache
Definition at line 180 of file Particle.h.
References cachePolarFixed_, eta_, mass_, p4Polar_, phi_, and pt_.
Referenced by cacheCartesian(), et(), mt(), mtSqr(), polarP4(), and rapidity().
00180 { 00181 if ( cachePolarFixed_ ) return; 00182 p4Polar_ = PolarLorentzVector( pt_, eta_, phi_, mass_ ); 00183 cachePolarFixed_ = true; 00184 }
int reco::Particle::charge | ( | ) | const [inline] |
electric charge
Definition at line 54 of file Particle.h.
References qx3_.
Referenced by ElectronAnalyzer::analyze(), ZHistogrammer::analyze(), GsfElectronDataAnalyzer::analyze(), TauMVATrainer::analyze(), PFTester::analyze(), ZMassHistogrammer::analyze(), GsfElectronMCAnalyzer::analyze(), TopValidation::analyze(), GsfElectronFakeAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), EgHLTOffEle::charge(), CandCombinerBase< OutputCollection, CandPtr >::combine(), TtDecayChannelSelector::countProngs(), reco::isodeposit::IsoDepositExtractor::deposit(), reco::isodeposit::IsoDepositExtractor::deposits(), PFTauDiscriminants::TrackAngle::doComputation(), PFTauDiscriminants::ChargedOutlierPt::doComputation(), PFTauDiscriminants::PiZeroPt::doComputation(), PFTauDiscriminants::PiZeroAngle::doComputation(), PFTauDiscriminants::ChargedOutlierAngle::doComputation(), PFTauDiscriminants::TrackPt::doComputation(), PFTauDiscriminants::OutlierNCharged::doComputation(), PFTauDiscriminants::NeutralOutlierAngle::doComputation(), PFTauDiscriminants::NeutralOutlierPt::doComputation(), reco::PFTau::dump(), CandIsoDepositProducer::extractTrack(), RecoMuonValidator::MuonME::fill(), pat::GenericParticle::fillInFrom(), reco::PFTauDecayMode::filteredObjectCandidates(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), TopDecaySubset::fromTruncListing(), reco::GsfElectron::GsfElectron(), TtDilepEvtSolutionMaker::HasPositiveCharge(), TtDilepEvtSolutionMaker::LepDiffCharge(), PFTauDiscriminants::PFTauDiscriminantManager::mainTrack(), helpers::MCTruthPairSelector< T >::operator()(), TrackingParticleSelector::operator()(), operator<<(), reco::LeafCandidate::overlap(), reco::PFTauDecayMode::PFTauDecayMode(), NamedCandCombinerBase::preselect(), CandCombinerBase< OutputCollection, CandPtr >::preselect(), JetAnalyzer::PtSpectrumInSideAJet(), RecoTracktoTP::s_qoverp(), TPtoRecoTrack::s_qoverp(), reco::PFCandidate::setTrackRef(), PFRootEventManager::tauBenchmark(), and reco::PFCandidate::translateTypeToPdgId().
00054 { return qx3_ / 3; }
void reco::Particle::clearCache | ( | ) | const [inline, protected] |
clear internal cache
Definition at line 193 of file Particle.h.
References cacheCartesianFixed_, and cachePolarFixed_.
Referenced by setMass().
00193 { 00194 cachePolarFixed_ = false; 00195 cacheCartesianFixed_ = false; 00196 }
double reco::Particle::energy | ( | ) | const [inline] |
energy
Definition at line 73 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), PhotonValidator::analyze(), JetValidation::analyze(), JetToDigiDump::analyze(), PFJetAnalyzer::analyze(), CaloTowerAnalyzer::analyze(), JetAnalyzer::analyze(), HLTBJetDQMSource::analyzeLifetime(), HLTBJetDQMSource::analyzePerformance(), HLTBJetDQMSource::analyzeSoftmuon(), EMEnrichingFilterAlgo::applyBFieldCurv(), ToyJetCorrection::applyCorrection(), reco::PFJet::chargedEmEnergyFraction(), reco::PFJet::chargedHadronEnergyFraction(), reco::PFJet::chargedMuEnergyFraction(), TauElementsOperators::computeConeSize(), JetPlusTrackCorrector::correction(), EgHLTOffEle::energy(), JetMCTagUtils::EnergyRatioFromBHadrons(), JetMCTagUtils::EnergyRatioFromCHadrons(), JetPlots::fill(), CaloJetTester::fillMatchHists(), PFJetTester::fillMatchHists(), PFRootEventManager::fillOutEventWithCaloTowers(), PFRootEventManager::fillOutEventWithPFCandidates(), EMEnrichingFilterAlgo::filterIsoGenPar(), CaloTowersCreationAlgo::finish(), PFJetBenchmark::gettrue(), JetMaker::makeSpecific(), reco::PFJet::neutralEmEnergyFraction(), reco::PFJet::neutralHadronEnergyFraction(), reco::operator<<(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), CaloTowerCreatorForTauHLT::produce(), CaloTowerCandidateCreator::produce(), JetAnalyzer::PtSpectrumInSideAJet(), HardTauAlgorithm::recalculateEnergy(), METAlgo::run(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), PFCandCommonVertexFitterBase::set(), reco::Photon::setVertex(), and reco::SoftLeptonTagInfo::taggingVariables().
00073 { cacheCartesian(); return p4Cartesian_.E(); }
double reco::Particle::et | ( | ) | const [inline] |
transverse energy
Definition at line 75 of file Particle.h.
References cachePolar(), and p4Polar_.
Referenced by CaloSpecificAlgo::addInfo(), PFTester::analyze(), CaloTowerAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), HLTBJetDQMSource::analyzeLifetime(), HLTBJetDQMSource::analyzePerformance(), EgammaObjects::analyzePhotons(), HLTBJetDQMSource::analyzeSoftmuon(), EMEnrichingFilterAlgo::applyBFieldCurv(), TauElementsOperators::computeConeSize(), GlobalFitCorrector::correction(), HardTauCorrector::correction(), egammaisolation::EgammaTrackExtractor::deposit(), HLTTauDQMSource::doL2(), EgHLTOffEle::et(), l1extra::L1EtMissParticle::etMiss(), GenericBenchmark::fill(), JetPlots::fill(), HeavyChHiggsToTauNuSkim::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), myspace::greaterEt(), JetVertexMain::Main(), reco::Jet::nCarrying(), operator<<(), CandOneToManyDeltaRMatcher::produce(), L2TauIsolationSelector::produce(), L2TauRelaxingIsolationSelector::produce(), CaloTowerCreatorForTauHLT::produce(), CaloTowerCandidateCreator::produce(), METAlgo::run(), reco::SoftLeptonTagInfo::taggingVariables(), and VisGenJetTwig::update().
00075 { cachePolar(); return p4Polar_.Et(); }
double reco::Particle::eta | ( | ) | const [inline] |
momentum pseudorapidity
Reimplemented in reco::EcalIsolatedParticleCandidate.
Definition at line 97 of file Particle.h.
References eta_.
Referenced by ZIterativeAlgorithmWithFit::addEvent(), CaloSpecificAlgo::addInfo(), ZHistogrammer::analyze(), ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), JetValidation::analyze(), PhotonValidator::analyze(), MCEfficiencyAnalyzer::analyze(), HLTMuonGenericRate::analyze(), ZToMuMuHistogrammer::analyze(), FlavorJetCorrectionExample::analyze(), JetToDigiDump::analyze(), PFTester::analyze(), HLTMCtruth::analyze(), PartonJetCorrectionExample::analyze(), PFJetAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), PFJetTester::analyze(), CaloJetTester::analyze(), CaloTowerAnalyzer::analyze(), MuonEnergyDepositAnalyzer::analyze(), JetAnalyzer::analyze(), ElectronCalibration::analyze(), TopValidation::analyze(), GsfElectronFakeAnalyzer::analyze(), HLTBJetDQMSource::analyzeLifetime(), HLTBJetDQMSource::analyzePerformance(), HLTBJetDQMSource::analyzeSoftmuon(), EMEnrichingFilterAlgo::applyBFieldCurv(), AlignmentMuonSelector::basicCuts(), ElectronLikelihood::CalculateFisher(), ElectronClassification::classify(), L2TauECALClustering::clusterSeperation(), JetPlusTrackCorrector::correction(), L4EMFCorrector::correction(), MCJetCorrector3D::correction(), egammaisolation::EgammaTrackExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposits(), reco::GenJet::detectorEta(), reco::CaloJet::detectorEta(), PFTauDiscriminants::Eta::doComputation(), HLTTauDQMSource::doL2(), EgHLTOffEle::eta(), reco::Jet::etaPhiStatistics(), GenericBenchmark::fill(), JetPlots::fill(), RecoMuonValidator::MuonME::fill(), pat::HistoPhoton::fill(), ZeePlots::fillEleClassesPlots(), ZeeCalibration::fillEleInfo(), CaloJetTester::fillMatchHists(), PFJetTester::fillMatchHists(), PFRootEventManager::fillOutEventWithClusters(), PFRootEventManager::fillOutEventWithPFCandidates(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), HeavyChHiggsToTauNuSkim::filter(), ZToMuMuFilter::filter(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), calib::CalibElectron::getCalibModulesWeights(), EtaPtBin::inBin(), is_B(), is_E(), is_F(), muon::isGoodMuon(), MuonIdProducer::isGoodTrackerMuon(), JetVertexMain::Main(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), AcceptJet::operator()(), reco::operator<<(), operator<<(), HLTmmkFilter::overlap(), reco::CaloJet::physicsEtaDetailed(), reco::CaloJet::physicsEtaQuick(), reco::CaloJet::physicsP4(), reco::GenJet::print(), reco::Jet::print(), reco::GenericJet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), CandOneToManyDeltaRMatcher::produce(), JetPartonMatcher::produce(), TauMVADiscriminator::produce(), JetTracksAssociationDRCalo::produce(), JetTracksAssociationDRVertex::produce(), CaloTowerCreatorForTauHLT::produce(), JetVetoedTracksAssociationDRVertex::produce(), ZToLLEdmNtupleDumper::produce(), CaloTowerCandidateCreator::produce(), PFRootEventManager::reconstructGenJets(), reco::SoftLeptonTagInfo::taggingVariables(), and VisGenJetTwig::update().
00097 { return eta_; }
bool reco::Particle::longLived | ( | ) | const [inline] |
is long lived?
Definition at line 160 of file Particle.h.
References longLivedTag, and status_.
Referenced by CandKinematicVertexFitter::set().
00160 { return status_ & longLivedTag; }
double reco::Particle::mass | ( | ) | const [inline] |
mass
Definition at line 77 of file Particle.h.
References mass_.
Referenced by ZHistogrammer::analyze(), ZMuMuAnalyzer_cynematics::analyze(), ZMuMuEfficiency::analyze(), ZMuMuAnalyzer::analyze(), ZMassHistogrammer::analyze(), HypothesisAnalyzer::analyze(), PFJetAnalyzer::analyze(), JetAnalyzer::analyze(), PFTauDiscriminants::InvariantMassOfSignal::doComputation(), ZToMuMuFilter::filter(), main(), operator<<(), reco::CaloJet::physicsEtaDetailed(), reco::CaloJet::physicsP4(), ZToLLEdmNtupleDumper::produce(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), PFCandCommonVertexFitterBase::set(), and CandMassKinFitter::set().
00077 { return mass_; }
double reco::Particle::massSqr | ( | ) | const [inline] |
Vector reco::Particle::momentum | ( | ) | const [inline] |
spatial momentum vector
Definition at line 66 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by MultiTrackValidator::analyze(), closestJet(), reco::GsfElectron::correctElectronEnergyScale(), reco::isodeposit::IsoDepositExtractor::deposit(), PFTauExtractor::depositFromObject(), reco::isodeposit::IsoDepositExtractor::deposits(), TauElementsOperators::discriminatorByIsolTracksN(), PFTauDiscriminants::MainTrackAngle::doComputation(), PFTauDiscriminants::TrackAngle::doComputation(), PFTauDiscriminants::PiZeroAngle::doComputation(), PFTauDiscriminants::ChargedOutlierAngle::doComputation(), PFTauDiscriminants::NeutralOutlierAngle::doComputation(), PFTauDiscriminants::OutlierAngle::doComputation(), CandIsoDepositProducer::extractTrack(), RecoMuonValidator::MuonME::fill(), reco::Pi0Algo::fillPi0sUsingPF(), TauElementsOperators::leadTk(), TrackingParticleSelector::operator()(), reco::TrackSelector::operator()(), PFTauDiscriminants::PFTauDiscriminantManager::outlierObjectsSortedByDR(), CaloRecoTauDiscriminationByIsolation::produce(), PFRecoTauDiscriminationByIsolationUsingLeadingPion::produce(), PFRecoTauDiscriminationByIsolation::produce(), HardTauAlgorithm::recalculateEnergy(), reco::Photon::setVertex(), and PFTauDiscriminants::PFTauDiscriminantManager::signalObjectsSortedByDR().
00066 { cacheCartesian(); return p4Cartesian_.Vect(); }
double reco::Particle::mt | ( | ) | const [inline] |
transverse mass
Definition at line 81 of file Particle.h.
References cachePolar(), and p4Polar_.
00081 { cachePolar(); return p4Polar_.Mt(); }
double reco::Particle::mtSqr | ( | ) | const [inline] |
transverse mass squared
Definition at line 83 of file Particle.h.
References cachePolar(), and p4Polar_.
00083 { cachePolar(); return p4Polar_.Mt2(); }
double reco::Particle::p | ( | ) | const [inline] |
magnitude of momentum vector
Definition at line 71 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), PFJetAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), JetAnalyzer::analyze(), ElectronCalibration::analyze(), RecoMuonValidator::MuonME::fill(), AcceptJet::operator()(), reco::CaloJet::physicsEtaDetailed(), reco::CaloJet::physicsP4(), reco::GenJet::print(), reco::Jet::print(), reco::GenericJet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), and PFRootEventManager::reconstructGenJets().
00071 { cacheCartesian(); return p4Cartesian_.P(); }
const LorentzVector& reco::Particle::p4 | ( | ) | const [inline] |
four-momentum Lorentz vector
Definition at line 62 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by ZHistogrammer::analyze(), ResolutionCreator::analyze(), PhotonIDAlgo::calculateBasicClusterIso(), JetCharge::charge(), CutBasedElectronID::classify(), L2TauECALClustering::clusterSeperation(), ElectronMomentumCorrector::correct(), reco::GsfElectron::correctElectronEnergyScale(), L2RelativeCorrector::correction(), L5FlavorCorrector::correction(), PUJetCorrector::correction(), ZSPJetCorrector::correction(), L7PartonCorrector::correction(), L3AbsoluteCorrector::correction(), L3PFAbsoluteCorrector::correction(), MCJetCorrector::correction(), TauJetCorrector::correction(), pat::ElectronSelector::customSelection_(), PFTauDiscriminants::Dalitz::doComputation(), PFTauDiscriminants::InvariantMass::doComputation(), HLTTauDQMSource::doL2(), pat::HistoGroup< PHYS_OBJECT >::fill(), JetPartonMatcher::fillAlgoritDefinition(), JetAnalyzer::fillMCParticles(), JetPartonMatcher::fillPhysicsDefinition(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), pat::CaloJetSelector::filter(), TopDecaySubset::fromTruncListing(), L2TauNarrowConeIsolationProducer::getECALHits(), JetAnalyzer::GetGenPhoton(), L2TauNarrowConeIsolationProducer::getHCALHits(), GeneratorTau::getOpeningAngle(), TtHadEvtSolution::getRecHadt(), TtHadEvtSolution::getRecHadtbar(), TtHadEvtSolution::getRecHadW_minus(), TtHadEvtSolution::getRecHadW_plus(), StEvtSolution::getRecLept(), GeneratorTau::getVisNuAngle(), helicityAngle(), JetFlavourIdentifier::identifyBasedOnPartons(), L2TauTowerIsolation::isolatedEt(), L2TauECALIsolation::isolatedEt(), L2TauAnalyzer::match(), HLTTauCaloDQMOfflineSource::match(), L25TauAnalyzer::match(), HLTTauCaloDQMOfflineSource::matchJet(), HLTTauTrkDQMOfflineSource::matchJet(), TtDilepLRSignalSelObservables::operator()(), TtSemiLRJetCombObservables::operator()(), operator<<(), reco::LeafCandidate::overlap(), EgHLTOffEle::p4(), reco::PFTauDecayMode::PFTauDecayMode(), reco::CaloJet::physicsEtaDetailed(), reco::CaloJet::physicsP4(), CandOneToManyDeltaRMatcher::produce(), PFRecoTauDecayModeDeterminator::produce(), L2TauJetsMerger::produce(), pat::PATTrigProducer::produce(), HardTauAlgorithm::recalculateEnergy(), reco::PFCandidate::rescaleMomentum(), CutBasedElectronID::result(), reco::Jet::scaleEnergy(), ApplyEnergyCorrection::set(), Booster::set(), CandMassKinFitter::set(), PFRootEventManager::tauBenchmark(), pat::DiObjectProxy::totalP4(), and pat::TriggerObjectStandAlone::triggerObject().
00062 { cacheCartesian(); return p4Cartesian_; }
int reco::Particle::pdgId | ( | ) | const [inline] |
PDG identifier.
Reimplemented in TrackingParticle.
Definition at line 148 of file Particle.h.
References pdgId_.
Referenced by FBaseSimEvent::addParticles(), ZHistogrammer::analyze(), ResolutionCreator::analyze(), MCEfficiencyAnalyzer::analyze(), HLTMuonGenericRate::analyze(), PFTester::analyze(), HLTMCtruth::analyze(), ZMassHistogrammer::analyze(), TopValidation::analyze(), GeneratorTau::computeDecayMode(), GeneratorTau::decayToPDGClassification(), JetPartonMatcher::fillAlgoritDefinition(), pat::GenericParticle::fillInFrom(), JetAnalyzer::fillMCParticles(), JetPartonMatcher::fillPhysicsDefinition(), BTagSkimMC::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), HLTMuonGenericRate::findMother(), GenParticlesHelper::findParticles(), reco::flavour(), InputGenJetsParticleSelector::fromResonance(), JetAnalyzer::GetGenPhoton(), PFJetBenchmark::gettrue(), GenParticlesHelper::hasAncestor(), CandMCTagUtils::hasBottom(), CandMCTagUtils::hasCharm(), BCToEFilterAlgo::isBCBaryon(), BCToEFilterAlgo::isBCMeson(), reco::isElectron(), reco::isLepton(), reco::isMuon(), reco::isNeutrino(), reco::isTau(), JetMaker::makeSpecific(), helpers::MCTruthPairSelector< T >::operator()(), FastCandMatcher< C >::operator()(), GenJetParticleSelector::operator()(), TtDilepLRSignalSelObservables::operator()(), operator<<(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PartonSelector::produce(), JetPartonMatcher::produce(), InputGenJetsParticleSelector::produce(), FlavorHistoryProducer::produce(), CSA07EventWeightProducer::produce(), JetAnalyzer::PtSpectrumInSideAJet(), PFRootEventManager::reconstructGenJets(), TtDecayChannelSelector::tauDecay(), pat::TriggerObjectStandAlone::triggerObject(), pat::TriggerPrimitive::triggerObjectId(), and zMCLeptonDaughters().
00148 { return pdgId_; }
double reco::Particle::phi | ( | ) | const [inline] |
momentum azimuthal angle
Reimplemented in reco::EcalIsolatedParticleCandidate, and pat::MHT.
Definition at line 93 of file Particle.h.
References phi_.
Referenced by ZIterativeAlgorithmWithFit::addEvent(), CaloSpecificAlgo::addInfo(), METTester::analyze(), ElectronAnalyzer::analyze(), ZHistogrammer::analyze(), PhotonValidator::analyze(), GsfElectronDataAnalyzer::analyze(), CaloMETAnalyzer::analyze(), PFTester::analyze(), JetToDigiDump::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), HLTMCtruth::analyze(), SimplePhotonAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), PFJetAnalyzer::analyze(), PFJetTester::analyze(), CaloJetTester::analyze(), CaloTowerAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), JetAnalyzer::analyze(), HLTBJetDQMSource::analyzeLifetime(), HLTBJetDQMSource::analyzePerformance(), HLTBJetDQMSource::analyzeSoftmuon(), AlignmentMuonSelector::basicCuts(), ElectronClassification::classify(), pat::DiObjectProxy::deltaPhi(), EMEnrichingFilterAlgo::deltaRxyAtEE(), egammaisolation::EgammaTrackExtractor::deposit(), muonisolation::CaloExtractorByAssociator::deposits(), reco::Jet::etaphiMoment(), reco::Jet::etaPhiStatistics(), GenericBenchmark::fill(), JetPlots::fill(), RecoMuonValidator::MuonME::fill(), pat::HistoPhoton::fill(), ZeeCalibration::fillEleInfo(), CaloJetTester::fillMatchHists(), PFJetTester::fillMatchHists(), PFRootEventManager::fillOutEventWithClusters(), PFRootEventManager::fillOutEventWithPFCandidates(), HeavyChHiggsToTauNuSkim::filter(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), JetVertexMain::Main(), reco::operator<<(), operator<<(), HLTmmkFilter::overlap(), EgHLTOffEle::phi(), reco::Jet::phiphiMoment(), reco::CaloJet::physicsEtaDetailed(), reco::CaloJet::physicsP4(), reco::GenJet::print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), JetPartonMatcher::produce(), CandOneToManyDeltaRMatcher::produce(), JetVetoedTracksAssociationDRVertex::produce(), CaloTowerCreatorForTauHLT::produce(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRCalo::produce(), ZToLLEdmNtupleDumper::produce(), cms::AlCaDiJetsProducer::produce(), CaloTowerCandidateCreator::produce(), PFRootEventManager::reconstructGenJets(), METAlgo::run(), pat::LeptonJetIsolationAngle::spaceAngle(), reco::SoftLeptonTagInfo::taggingVariables(), VisGenMETTwig::update(), VisGenJetTwig::update(), VisCaloMETTwig::update(), VisMETTwig::update(), and DumpEvent::WriteMET().
00093 { return phi_; }
const PolarLorentzVector& reco::Particle::polarP4 | ( | ) | const [inline] |
four-momentum Lorentz vector
Definition at line 64 of file Particle.h.
References cachePolar(), and p4Polar_.
Referenced by pat::GenericParticle::fillInFrom().
00064 { cachePolar(); return p4Polar_; }
double reco::Particle::pt | ( | ) | const [inline] |
transverse momentum
Reimplemented in reco::SiStripElectron.
Definition at line 91 of file Particle.h.
References pt_.
Referenced by METTester::analyze(), ElectronAnalyzer::analyze(), ZHistogrammer::analyze(), GsfElectronDataAnalyzer::analyze(), HLTMuonGenericRate::analyze(), MCEfficiencyAnalyzer::analyze(), ZToMuMuHistogrammer::analyze(), CaloMETAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), HLTMCtruth::analyze(), HypothesisAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), PFJetAnalyzer::analyze(), PFJetTester::analyze(), CaloJetTester::analyze(), GsfElectronFakeAnalyzer::analyze(), TopValidation::analyze(), JetAnalyzer::analyze(), AlignmentMuonSelector::basicCuts(), ElectronLikelihood::CalculateFisher(), PFIsolation::computeIsolation(), GlobalFitCorrector::correction(), L4EMFCorrector::correction(), MCJetCorrector3D::correction(), PFTauDiscriminants::Pt::doComputation(), PFTauDiscriminants::ChargedOutlierPt::doComputation(), PFTauDiscriminants::OutlierPt::doComputation(), PFTauDiscriminants::PiZeroPt::doComputation(), PFTauDiscriminants::MainTrackPt::doComputation(), PFTauDiscriminants::TrackPt::doComputation(), PFTauDiscriminants::NeutralOutlierPt::doComputation(), reco::PFTau::dump(), GenericBenchmark::fill(), RecoMuonValidator::MuonME::fill(), JetPartonMatcher::fillAlgoritDefinition(), CaloJetTester::fillMatchHists(), PFJetTester::fillMatchHists(), HLTHcalNoiseFilter::filter(), ZToMuMuFilter::filter(), EtaPtBin::inBin(), muon::isGoodMuon(), MuonIdProducer::isGoodTrackerMuon(), main(), pat::MHT::mht(), CaloJetSort::operator()(), AcceptJet::operator()(), BasicJetSort::operator()(), GenJetSort::operator()(), AlignmentMuonSelector::ComparePt::operator()(), TtSemiLRJetCombObservables::operator()(), reco::operator<<(), operator<<(), HLTmmkFilter::overlap(), reco::GenJet::print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), JetPartonMatcher::produce(), TauMVADiscriminator::produce(), InputGenJetsParticleSelector::produce(), IsolationProducerForTracks::produce(), L2TauJetsProvider::produce(), ZToLLEdmNtupleDumper::produce(), CSA07EventWeightProducer::produce(), TtDilepEvtSolutionMaker::PTComp(), JetAnalyzer::PtSpectrumInSideAJet(), PFRootEventManager::reconstructGenJets(), ElectronLikelihood::result(), VisGenMETTwig::update(), VisCaloMETTwig::update(), VisMETTwig::update(), and DumpEvent::WriteMET().
00091 { return pt_; }
double reco::Particle::px | ( | ) | const [inline] |
x coordinate of momentum vector
Definition at line 85 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), METTester::analyze(), CaloMETAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), ToyJetCorrection::applyCorrection(), InvariantMassAlgorithm::getMinimumClusterDR(), reco::IsolatedTauTagInfo::leadingSignalTrack(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), JetAnalyzer::PtSpectrumInSideAJet(), HardTauAlgorithm::recalculateEnergy(), and ImpactParameterAlgorithm::tag().
00085 { cacheCartesian(); return p4Cartesian_.Px(); }
double reco::Particle::py | ( | ) | const [inline] |
y coordinate of momentum vector
Definition at line 87 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), METTester::analyze(), GsfElectronDataAnalyzer::analyze(), CaloMETAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), ToyJetCorrection::applyCorrection(), InvariantMassAlgorithm::getMinimumClusterDR(), reco::IsolatedTauTagInfo::leadingSignalTrack(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), JetAnalyzer::PtSpectrumInSideAJet(), HardTauAlgorithm::recalculateEnergy(), and ImpactParameterAlgorithm::tag().
00087 { cacheCartesian(); return p4Cartesian_.Py(); }
double reco::Particle::pz | ( | ) | const [inline] |
z coordinate of momentum vector
Reimplemented in reco::SiStripElectron.
Definition at line 89 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), EMEnrichingFilterAlgo::applyBFieldCurv(), ToyJetCorrection::applyCorrection(), EMEnrichingFilterAlgo::deltaRxyAtEE(), InvariantMassAlgorithm::getMinimumClusterDR(), reco::IsolatedTauTagInfo::leadingSignalTrack(), reco::Jet::print(), reco::GenericJet::print(), PFJetBenchmark::printGenJet(), ParticleTreeDrawer::printInfo(), ParticleDecayDrawer::printP4(), PFJetBenchmark::printPFJet(), JetAnalyzer::PtSpectrumInSideAJet(), HardTauAlgorithm::recalculateEnergy(), and ImpactParameterAlgorithm::tag().
00089 { cacheCartesian(); return p4Cartesian_.Pz(); }
double reco::Particle::rapidity | ( | ) | const [inline] |
repidity
Definition at line 99 of file Particle.h.
References cachePolar(), and p4Polar_.
Referenced by ZHistogrammer::analyze(), ZToLLEdmNtupleDumper::produce(), and y().
00099 { cachePolar(); return p4Polar_.Rapidity(); }
set electric charge
Definition at line 56 of file Particle.h.
References qx3_.
Referenced by converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), pat::GenericParticle::fillInFrom(), reco::GsfElectron::GsfElectron(), reco::PFTauDecayMode::PFTauDecayMode(), MuonProducer::produce(), and AddFourMomenta::set().
00056 { qx3_ = q * 3; }
void reco::Particle::setLongLived | ( | ) | [inline] |
set long lived flag
Definition at line 158 of file Particle.h.
References longLivedTag, and status_.
00158 { status_ |= longLivedTag; }
void reco::Particle::setMass | ( | double | m | ) | [inline] |
set particle mass
Definition at line 124 of file Particle.h.
References clearCache(), and mass_.
Referenced by PFRecoTauDecayModeDeterminator::produce().
00124 { 00125 mass_ = m; 00126 clearCache(); 00127 }
void reco::Particle::setP4 | ( | const PolarLorentzVector & | p4 | ) | [inline] |
set 4-momentum
Definition at line 114 of file Particle.h.
References cacheCartesianFixed_, cachePolarFixed_, eta_, mass_, p4Polar_, phi_, and pt_.
00114 { 00115 p4Polar_ = p4; 00116 pt_ = p4Polar_.pt(); 00117 eta_ = p4Polar_.eta(); 00118 phi_ = p4Polar_.phi(); 00119 mass_ = p4Polar_.mass(); 00120 cachePolarFixed_ = true; 00121 cacheCartesianFixed_ = false; 00122 }
void reco::Particle::setP4 | ( | const LorentzVector & | p4 | ) | [inline] |
set 4-momentum
Definition at line 103 of file Particle.h.
References cacheCartesianFixed_, cachePolarFixed_, eta_, mass_, p4Cartesian_, p4Polar_, phi_, and pt_.
Referenced by EMEnrichingFilterAlgo::applyBFieldCurv(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), reco::GsfElectron::correctElectronEnergyScale(), reco::GsfElectron::correctElectronFourMomentum(), pat::GenericParticle::fillInFrom(), reco::GsfElectron::GsfElectron(), reco::PFTauDecayMode::PFTauDecayMode(), GenParticleProducer::produce(), MuonProducer::produce(), HardTauAlgorithm::recalculateEnergy(), reco::PFCandidate::rescaleMomentum(), reco::Jet::scaleEnergy(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), AddFourMomenta::set(), ApplyEnergyCorrection::set(), PFCandCommonVertexFitterBase::set(), Booster::set(), CandMassKinFitter::set(), reco::Photon::setVertex(), and cms::BasePilupSubtractionJetProducer::subtract_pedestal().
00103 { 00104 p4Cartesian_ = p4; 00105 p4Polar_ = p4; 00106 pt_ = p4Polar_.pt(); 00107 eta_ = p4Polar_.eta(); 00108 phi_ = p4Polar_.phi(); 00109 mass_ = p4Polar_.mass(); 00110 cachePolarFixed_ = true; 00111 cacheCartesianFixed_ = true; 00112 }
Definition at line 150 of file Particle.h.
References pdgId_.
Referenced by converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), pat::GenericParticle::fillInFrom(), TtDilepEvtSolution::getLeptNeg(), TtDilepEvtSolution::getLeptPos(), reco::GsfElectron::GsfElectron(), reco::PFCandidate::PFCandidate(), reco::PFTauDecayMode::PFTauDecayMode(), GenParticleProducer::produce(), reco::PFCandidate::setParticleType(), and pat::TriggerPrimitive::setTriggerObjectId().
void reco::Particle::setPz | ( | double | pz | ) | [inline] |
Definition at line 128 of file Particle.h.
References cacheCartesian(), eta_, mass_, p4Cartesian_, p4Polar_, phi_, and pt_.
00128 { 00129 cacheCartesian(); 00130 p4Cartesian_.SetPz(pz); 00131 p4Polar_ = p4Cartesian_; 00132 pt_ = p4Polar_.pt(); 00133 eta_ = p4Polar_.eta(); 00134 phi_ = p4Polar_.phi(); 00135 mass_ = p4Polar_.mass(); 00136 }
set status word
Definition at line 154 of file Particle.h.
References status_.
Referenced by pat::GenericParticle::fillInFrom(), reco::PFTauDecayMode::PFTauDecayMode(), and GenParticleProducer::produce().
set electric charge
Definition at line 60 of file Particle.h.
References qx3_.
Referenced by GenParticleProducer::produce().
00060 { qx3_ = qx3; }
set vertex
Reimplemented in reco::Photon.
Definition at line 146 of file Particle.h.
References vertex_.
Referenced by converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), pat::GenericParticle::fillInFrom(), reco::GsfElectron::GsfElectron(), GenParticleProducer::produce(), MuonProducer::produce(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), PFCandCommonVertexFitterBase::set(), TrackingParticle::setVertex(), and reco::V0Candidate::setVertex().
int reco::Particle::status | ( | ) | const [inline] |
status word
Definition at line 152 of file Particle.h.
References status_.
Referenced by ParticleTreeDrawer::accept(), FBaseSimEvent::addParticles(), ZHistogrammer::analyze(), ResolutionCreator::analyze(), MCEfficiencyAnalyzer::analyze(), HLTMuonGenericRate::analyze(), ZMassHistogrammer::analyze(), TopValidation::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), GeneratorTau::computeDecayMode(), GeneratorTau::computeStableDecayProducts(), TtDecayChannelSelector::countProngs(), GeneratorTau::decayToPDGClassification(), pat::GenericParticle::fillInFrom(), JetAnalyzer::fillMCParticles(), JetPartonMatcher::fillPhysicsDefinition(), BTagSkimMC::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), findHerwigPPME(), GenParticlesHelper::findParticles(), InputGenJetsParticleSelector::fromResonance(), JetAnalyzer::GetGenPhoton(), JetAnalyzer::GetParentPartons(), GenParticlesHelper::hasAncestor(), helpers::MCTruthPairSelector< T >::operator()(), FastCandMatcher< C >::operator()(), GenJetParticleSelector::operator()(), operator<<(), ParticleTreeDrawer::printInfo(), PartonSelector::produce(), JetPartonMatcher::produce(), InputGenJetsParticleSelector::produce(), FlavorHistoryProducer::produce(), CSA07EventWeightProducer::produce(), JetAnalyzer::PtSpectrumInSideAJet(), PFRootEventManager::reconstructGenJets(), ParticleDecayDrawer::select(), pat::Flags::test(), and zMCLeptonDaughters().
00152 { return status_; }
double reco::Particle::theta | ( | ) | const [inline] |
momentum polar angle
Definition at line 95 of file Particle.h.
References cacheCartesian(), and p4Cartesian_.
Referenced by ZHistogrammer::analyze(), EMEnrichingFilterAlgo::deltaRxyAtEE(), CaloTower::emEt(), CaloTower::hadEt(), CaloTower::outerEt(), METAlgo::run(), and pat::LeptonJetIsolationAngle::spaceAngle().
00095 { cacheCartesian(); return p4Cartesian_.Theta(); }
int reco::Particle::threeCharge | ( | ) | const [inline] |
electric charge
Definition at line 58 of file Particle.h.
References qx3_.
Referenced by TopDecaySubset::fromTruncListing().
00058 { return qx3_; }
const Point& reco::Particle::vertex | ( | ) | const [inline] |
vertex position
Reimplemented in reco::V0Candidate.
Definition at line 138 of file Particle.h.
References vertex_.
Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), MultiTrackValidator::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), pat::helper::VertexingHelper::associate(), PFPileUp::chargedHadronVertex(), reco::isodeposit::IsoDepositExtractor::deposit(), egammaisolation::EgammaTrackExtractor::deposit(), PFTauExtractor::depositFromObject(), reco::isodeposit::IsoDepositExtractor::deposits(), CandIsoDepositProducer::extractTrack(), RecoMuonValidator::MuonME::fill(), pat::GenericParticle::fillInFrom(), pat::PATSingleVertexSelector::filter_(), TopDecaySubset::fromTruncListing(), PhotonTkIsolation::getIso(), makeMet(), TrackingParticleSelector::operator()(), pat::VertexAssociationSelector::operator()(), operator<<(), reco::LeafCandidate::overlap(), EgammaHLTTrackIsolation::photonIsolation(), and pat::VertexAssociationSelector::simpleAssociation().
00138 { return vertex_; }
double reco::Particle::vx | ( | ) | const [inline] |
x coordinate of vertex position
Definition at line 140 of file Particle.h.
References vertex_.
Referenced by FBaseSimEvent::addParticles(), HLTMCtruth::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), reco::PFTau::dump(), JetAnalyzer::fillMCParticles(), pat::VertexAssociationSelector::operator()(), ParticleTreeDrawer::printInfo(), and ParticleDecayDrawer::printP4().
00140 { return vertex_.X(); }
double reco::Particle::vy | ( | ) | const [inline] |
y coordinate of vertex position
Definition at line 142 of file Particle.h.
References vertex_.
Referenced by FBaseSimEvent::addParticles(), HLTMCtruth::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), reco::PFTau::dump(), JetAnalyzer::fillMCParticles(), pat::VertexAssociationSelector::operator()(), ParticleTreeDrawer::printInfo(), and ParticleDecayDrawer::printP4().
00142 { return vertex_.Y(); }
double reco::Particle::vz | ( | ) | const [inline] |
z coordinate of vertex position
Definition at line 144 of file Particle.h.
References vertex_.
Referenced by FBaseSimEvent::addParticles(), HLTMCtruth::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), reco::PFTau::dump(), JetAnalyzer::fillMCParticles(), pat::PATSingleVertexSelector::filter_(), pat::VertexAssociationSelector::operator()(), ParticleTreeDrawer::printInfo(), and ParticleDecayDrawer::printP4().
00144 { return vertex_.Z(); }
double reco::Particle::y | ( | ) | const [inline] |
repidity
Definition at line 101 of file Particle.h.
References rapidity().
00101 { return rapidity(); }
edm::BoolCache reco::Particle::cacheCartesianFixed_ [mutable, protected] |
Definition at line 178 of file Particle.h.
Referenced by cacheCartesian(), clearCache(), and setP4().
edm::BoolCache reco::Particle::cachePolarFixed_ [mutable, protected] |
has cache been set?
Definition at line 178 of file Particle.h.
Referenced by cachePolar(), clearCache(), and setP4().
float reco::Particle::eta_ [protected] |
Reimplemented in reco::EcalIsolatedParticleCandidate.
Definition at line 166 of file Particle.h.
Referenced by cachePolar(), eta(), setP4(), and setPz().
const unsigned int reco::Particle::longLivedTag = 65536 [static] |
long lived flag
Definition at line 156 of file Particle.h.
Referenced by longLived(), and setLongLived().
float reco::Particle::mass_ [protected] |
Definition at line 166 of file Particle.h.
Referenced by cachePolar(), mass(), massSqr(), setMass(), setP4(), and setPz().
LorentzVector reco::Particle::p4Cartesian_ [mutable, protected] |
internal cache for p4
Definition at line 176 of file Particle.h.
Referenced by boostToCM(), cacheCartesian(), energy(), momentum(), p(), p4(), px(), py(), pz(), setP4(), setPz(), and theta().
PolarLorentzVector reco::Particle::p4Polar_ [mutable, protected] |
internal cache for p4
Definition at line 174 of file Particle.h.
Referenced by cacheCartesian(), cachePolar(), et(), mt(), mtSqr(), polarP4(), rapidity(), setP4(), and setPz().
int reco::Particle::pdgId_ [protected] |
PDG identifier.
Reimplemented in TrackingParticle.
Definition at line 170 of file Particle.h.
Referenced by pdgId(), and setPdgId().
float reco::Particle::phi_ [protected] |
Reimplemented in reco::EcalIsolatedParticleCandidate.
Definition at line 166 of file Particle.h.
Referenced by cachePolar(), phi(), setP4(), and setPz().
float reco::Particle::pt_ [protected] |
four-momentum Lorentz vector
Reimplemented in reco::SiStripElectron.
Definition at line 166 of file Particle.h.
Referenced by cachePolar(), pt(), setP4(), and setPz().
Charge reco::Particle::qx3_ [protected] |
electric charge
Definition at line 164 of file Particle.h.
Referenced by charge(), Particle(), setCharge(), setThreeCharge(), and threeCharge().
int reco::Particle::status_ [protected] |
status word
Definition at line 172 of file Particle.h.
Referenced by longLived(), setLongLived(), setStatus(), and status().
Point reco::Particle::vertex_ [protected] |
vertex position
Definition at line 168 of file Particle.h.
Referenced by setVertex(), reco::Photon::setVertex(), vertex(), vx(), vy(), and vz().