CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Private Member Functions | Private Attributes | Friends
reco::LeafCandidate Class Reference

#include <LeafCandidate.h>

Inheritance diagram for reco::LeafCandidate:
reco::Candidate CaloTower reco::CompositeRefCandidateT< GenParticleRefVector > reco::CompositeRefCandidateT< reco::edm::RefVector > l1extra::L1EmParticle l1extra::L1EtMissParticle l1extra::L1JetParticle l1extra::L1MuonParticle L1GObject l1t::L1Candidate pat::IsolatedTrack pat::TriggerObject pat::PATObject< reco::LeafCandidate > reco::CaloRecHitCandidate reco::CandidateWithRef< Ref > reco::CastorTower reco::CompositeCandidate reco::CompositePtrCandidate reco::CompositeRefBaseCandidate reco::CompositeRefCandidate reco::CompositeRefCandidateT< D > reco::EcalIsolatedParticleCandidate reco::LeafRefCandidateT reco::RecoCandidate reco::ShallowCloneCandidate reco::ShallowClonePtrCandidate ZMuMuRochCorAnalyzer.DiMuon

Public Types

typedef int Charge
 electric charge type More...
 
typedef CandidateCollection daughters
 collection of daughter candidates More...
 
typedef unsigned int index
 
typedef math::XYZTLorentzVector LorentzVector
 Lorentz vector. More...
 
typedef math::XYZPoint Point
 point in the space More...
 
typedef math::PtEtaPhiMLorentzVector PolarLorentzVector
 Lorentz vector. More...
 
typedef math::XYZVector Vector
 point in the space More...
 
- Public Types inherited from reco::Candidate
enum  { dimension = 3 }
 
enum  { size = dimension * (dimension + 1)/2 }
 matix size More...
 
typedef int Charge
 electric charge type More...
 
typedef candidate::const_iterator const_iterator
 
typedef math::Error< dimension >::type CovarianceMatrix
 covariance error matrix (3x3) More...
 
typedef unsigned int index
 index type More...
 
typedef candidate::iterator iterator
 
typedef math::XYZTLorentzVector LorentzVector
 Lorentz vector. More...
 
typedef math::XYZPoint Point
 point in the space More...
 
typedef math::PtEtaPhiMLorentzVector PolarLorentzVector
 Lorentz vector. More...
 
typedef size_t size_type
 
typedef math::XYZVector Vector
 point in the space More...
 

Public Member Functions

virtual Vector boostToCM () const final
 
virtual int charge () const final
 electric charge More...
 
virtual LeafCandidateclone () const
 returns a clone of the Candidate object More...
 
void construct (int qx3, float pt, float eta, float phi, float mass, const Point &vtx, int pdgId, int status)
 
virtual const Candidatedaughter (size_type) const
 return daughter at a given position (throws an exception) More...
 
virtual Candidatedaughter (size_type)
 return daughter at a given position (throws an exception) More...
 
virtual Candidatedaughter (const std::string &s)
 return daughter with a specified role name More...
 
virtual const Candidatedaughter (const std::string &s) const
 return daughter with a specified role name More...
 
virtual double energy () const final
 energy More...
 
virtual double et () const final
 transverse energy More...
 
virtual double et2 () const final
 transverse energy squared (use this for cut!) More...
 
virtual double eta () const final
 momentum pseudorapidity More...
 
virtual void fillVertexCovariance (CovarianceMatrix &v) const
 fill SMatrix More...
 
template<typename T >
T get () const
 get a component More...
 
template<typename T , typename Tag >
T get () const
 get a component More...
 
template<typename T >
T get (size_type i) const
 get a component More...
 
template<typename T , typename Tag >
T get (size_type i) const
 get a component More...
 
virtual bool hasMasterClone () const
 
virtual bool hasMasterClonePtr () const
 
virtual bool isCaloMuon () const
 
virtual bool isConvertedPhoton () const
 
virtual bool isElectron () const
 
virtual bool isGlobalMuon () const
 
virtual bool isJet () const
 
virtual bool isMuon () const
 
virtual bool isPhoton () const
 
virtual bool isStandAloneMuon () const
 
virtual bool isTrackerMuon () const
 
 LeafCandidate ()
 
 LeafCandidate (const Candidate &c)
 
template<typename... Args>
 LeafCandidate (Args &&...args)
 
 LeafCandidate (LeafCandidate &rh)
 
 LeafCandidate (LeafCandidate &&)=default
 
 LeafCandidate (LeafCandidate const &)=default
 
virtual bool longLived () const final
 is long lived? More...
 
virtual double mass () const final
 mass More...
 
virtual bool massConstraint () const final
 do mass constraint? More...
 
virtual double massSqr () const final
 mass squared More...
 
virtual const CandidateBaseRefmasterClone () const
 
virtual const CandidatePtrmasterClonePtr () const
 
template<typename Ref >
Ref masterRef () const
 cast master clone reference to a concrete type More...
 
virtual Vector momentum () const final
 spatial momentum vector More...
 
virtual const Candidatemother (size_type) const
 return mother at a given position (throws an exception) More...
 
virtual double mt () const final
 transverse mass More...
 
virtual double mtSqr () const final
 transverse mass squared More...
 
template<typename T >
size_type numberOf () const
 number of components More...
 
template<typename T , typename Tag >
size_type numberOf () const
 number of components More...
 
virtual size_t numberOfDaughters () const
 number of daughters More...
 
virtual size_t numberOfMothers () const
 number of mothers More...
 
virtual size_t numberOfSourceCandidatePtrs () const
 
LeafCandidateoperator= (LeafCandidate &&)=default
 
LeafCandidateoperator= (LeafCandidate const &)=default
 
virtual double p () const final
 magnitude of momentum vector More...
 
virtual const LorentzVectorp4 () const final
 four-momentum Lorentz vector More...
 
virtual int pdgId () const final
 PDG identifier. More...
 
virtual double phi () const final
 momentum azimuthal angle More...
 
virtual const PolarLorentzVectorpolarP4 () const final
 four-momentum Lorentz vector More...
 
virtual double pt () const final
 transverse momentum More...
 
virtual double px () const final
 x coordinate of momentum vector More...
 
virtual double py () const final
 y coordinate of momentum vector More...
 
virtual double pz () const final
 z coordinate of momentum vector More...
 
virtual double rapidity () const final
 rapidity More...
 
virtual void setCharge (Charge q) final
 set electric charge More...
 
virtual void setLongLived () final
 
virtual void setMass (double m) final
 set particle mass More...
 
virtual void setMassConstraint () final
 
virtual void setP4 (const LorentzVector &p4) final
 set 4-momentum More...
 
virtual void setP4 (const PolarLorentzVector &p4) final
 set 4-momentum More...
 
virtual void setPdgId (int pdgId) final
 
virtual void setPz (double pz) final
 
virtual void setStatus (int status) final
 set status word More...
 
virtual void setThreeCharge (Charge qx3) final
 set electric charge More...
 
virtual void setVertex (const Point &vertex)
 set vertex More...
 
virtual CandidatePtr sourceCandidatePtr (size_type i) const
 
virtual int status () const final
 status word More...
 
virtual double theta () const final
 momentum polar angle More...
 
virtual int threeCharge () const final
 electric charge More...
 
virtual const Pointvertex () const
 vertex position (overwritten by PF...) More...
 
virtual double vertexChi2 () const
 chi-squares More...
 
virtual double vertexCovariance (int i, int j) const
 (i, j)-th element of error matrix, i, j = 0, ... 2 More...
 
CovarianceMatrix vertexCovariance () const final
 return SMatrix More...
 
virtual double vertexNdof () const
 
virtual double vertexNormalizedChi2 () const
 chi-squared divided by n.d.o.f. More...
 
virtual double vx () const
 x coordinate of vertex position More...
 
virtual double vy () const
 y coordinate of vertex position More...
 
virtual double vz () const
 z coordinate of vertex position More...
 
virtual double y () const final
 rapidity More...
 
virtual ~LeafCandidate ()
 destructor More...
 
- Public Member Functions inherited from reco::Candidate
const_iterator begin () const
 first daughter const_iterator More...
 
iterator begin ()
 first daughter iterator More...
 
virtual const TrackbestTrack () const
 
 Candidate ()
 default constructor More...
 
virtual float dxyError () const
 uncertainty on dxy More...
 
virtual float dzError () const
 uncertainty on dz More...
 
const_iterator end () const
 last daughter const_iterator More...
 
iterator end ()
 last daughter iterator More...
 
template<typename T >
T get () const
 get a component More...
 
template<typename T , typename Tag >
T get () const
 get a component More...
 
template<typename T >
T get (size_type i) const
 get a component More...
 
template<typename T , typename Tag >
T get (size_type i) const
 get a component More...
 
template<typename Ref >
Ref masterRef () const
 cast master clone reference to a concrete type More...
 
template<typename T >
size_type numberOf () const
 number of components More...
 
template<typename T , typename Tag >
size_type numberOf () const
 number of components More...
 
virtual void setSourceCandidatePtr (const CandidatePtr &ptr)
 Set the ptr to the source Candidate. More...
 
virtual ~Candidate ()
 destructor More...
 

Private Member Functions

virtual bool overlap (const Candidate &) const
 check overlap with another Candidate More...
 

Private Attributes

ParticleState m_state
 

Friends

class ::OverlapChecker
 
template<typename , typename , typename >
struct component
 
class ShallowCloneCandidate
 
class ShallowClonePtrCandidate
 

Additional Inherited Members

Detailed Description

particle candidate with no constituent nor daughters

Author
Luca Lista, INFN

Definition at line 16 of file LeafCandidate.h.

Member Typedef Documentation

electric charge type

Definition at line 21 of file LeafCandidate.h.

collection of daughter candidates

Definition at line 19 of file LeafCandidate.h.

typedef unsigned int reco::LeafCandidate::index

Definition at line 31 of file LeafCandidate.h.

Lorentz vector.

Definition at line 23 of file LeafCandidate.h.

point in the space

Definition at line 27 of file LeafCandidate.h.

Lorentz vector.

Definition at line 25 of file LeafCandidate.h.

point in the space

Definition at line 29 of file LeafCandidate.h.

Constructor & Destructor Documentation

reco::LeafCandidate::LeafCandidate ( )
inline

Definition at line 33 of file LeafCandidate.h.

Referenced by clone(), and LeafCandidate().

33 {}
reco::LeafCandidate::LeafCandidate ( const Candidate c)
inlineexplicit

Definition at line 36 of file LeafCandidate.h.

36 : m_state(c.charge(),c.polarP4(), c.vertex(), c.pdgId(), c.status() ){}
ParticleState m_state
template<typename... Args>
reco::LeafCandidate::LeafCandidate ( Args &&...  args)
inlineexplicit

Definition at line 40 of file LeafCandidate.h.

40  :
41  m_state(std::forward<Args>(args)...) {}
ParticleState m_state
reco::LeafCandidate::LeafCandidate ( LeafCandidate rh)
inline

Definition at line 43 of file LeafCandidate.h.

References LeafCandidate(), operator=(), p3, p4(), pdgId(), lumiQueryAPI::q, status(), and badGlobalMuonTaggersAOD_cff::vtx.

43 : m_state(rh.m_state){}
ParticleState m_state
reco::LeafCandidate::LeafCandidate ( LeafCandidate &&  )
default
reco::LeafCandidate::LeafCandidate ( LeafCandidate const &  )
default
LeafCandidate::~LeafCandidate ( )
virtual

destructor

Definition at line 5 of file LeafCandidate.cc.

Referenced by construct().

5 { }

Member Function Documentation

virtual Vector reco::LeafCandidate::boostToCM ( ) const
inlinefinalvirtual

boost vector to boost a Lorentz vector to the particle center of mass system

Implements reco::Candidate.

Definition at line 106 of file LeafCandidate.h.

References reco::ParticleState::boostToCM(), and m_state.

106 { return m_state.boostToCM(); }
ParticleState m_state
Vector boostToCM() const
Definition: ParticleState.h:87
virtual int reco::LeafCandidate::charge ( ) const
inlinefinalvirtual

electric charge

Implements reco::Candidate.

Definition at line 91 of file LeafCandidate.h.

References reco::ParticleState::charge(), and m_state.

Referenced by PFTester::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), HLTMuonMatchAndPlot::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), PFRecoTauDiscriminationByIsolation::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), HPSPFRecoTauAlgorithm::buildOneProng(), HPSPFRecoTauAlgorithm::buildThreeProngs(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), egHLT::OffEle::charge(), reco::PFTau::dump(), RecoMuonValidator::MuonME::fill(), EwkElecTauHistManager::fillHistograms(), WMuNuSelector::filter(), WZInterestingEventSelector::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), pat::PATObject< ObjectType >::genParticleById(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), MuonMETAlgo::GetMuDepDeltas(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), reco::tau::disc::mainTrack(), GenParticleCustomSelector::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), WPlusJetsEventSelector::operator()(), reco::operator<<(), reco::LeafRefCandidateT::overlap(), overlap(), reco::PFTauDecayMode::PFTauDecayMode(), reco::PFRecoTauChargedHadron::print(), PFAlgo::processBlock(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), pat::L1MuonMatcher::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), pat::PATLostTracks::produce(), reco::TrackJet::resetCharge(), ClassBasedElectronID::result(), MuScleFitMuonSelector::selectMuons(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), l1t::Muon::setHwCharge(), TtSemiLepHypothesis::setNeutrino(), GsfElectronAlgo::setPixelMatchInfomation(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), reco::PFCandidate::setTrackRef(), TtSemiEvtSolution::setupHyp(), reco::tau::sumPFCandCharge(), and reco::PFCandidate::translateTypeToPdgId().

91 { return m_state.charge(); }
ParticleState m_state
int charge() const
electric charge
Definition: ParticleState.h:72
virtual LeafCandidate* reco::LeafCandidate::clone ( void  ) const
inlinevirtual

returns a clone of the Candidate object

Implements reco::Candidate.

Reimplemented in reco::PFJet, reco::CaloJet, reco::JPTJet, reco::PFCandidate, l1extra::L1EtMissParticle, reco::GsfElectron, reco::IsolatedPixelTrackCandidate, pat::Jet, l1extra::L1MuonParticle, reco::GenJet, pat::Tau, reco::SiStripElectron, l1extra::L1JetParticle, l1extra::L1EmParticle, pat::Electron, reco::PFTauDecayMode, pat::MET, pat::Muon, pat::Photon, reco::HcalIsolatedTrackCandidate, reco::PFTau, pat::GenericParticle, reco::MET, reco::CompositeCandidate, reco::Photon, pat::PFParticle, pat::CompositeCandidate, reco::NamedCompositeCandidate, pat::Particle, pat::Lepton< reco::BaseTau >, pat::Lepton< reco::GsfElectron >, pat::Lepton< reco::Muon >, reco::CompositeRefCandidateT< D >, reco::TrackJet, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::ShallowCloneCandidate, reco::PFClusterJet, reco::CompositePtrCandidate, reco::CompositeRefCandidate, reco::ShallowClonePtrCandidate, reco::VertexCompositeCandidate, reco::VertexCompositePtrCandidate, reco::GenParticle, reco::CompositeRefBaseCandidate, reco::EcalIsolatedParticleCandidate, reco::RecoCandidate, reco::BasicJet, reco::Muon, reco::IsolatedPFCandidate, reco::PileUpPFCandidate, reco::CaloRecHitCandidate, reco::CandidateWithRef< Ref >, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::RecoCaloTowerCandidate, reco::Electron, reco::BaseTau, reco::CaloTau, reco::RecoPFClusterRefCandidate, and reco::RecoChargedRefCandidate.

Definition at line 180 of file LeafCandidate.h.

References mps_fire::i, LeafCandidate(), vertexChi2(), vertexCovariance(), vertexNdof(), and vertexNormalizedChi2().

180  {
181  return new LeafCandidate( *this );
182  }
void reco::LeafCandidate::construct ( int  qx3,
float  pt,
float  eta,
float  phi,
float  mass,
const Point vtx,
int  pdgId,
int  status 
)
inline

Definition at line 61 of file LeafCandidate.h.

References daughter(), m_state, mother(), numberOfDaughters(), numberOfMothers(), alignCSCRings::s, AlCaHLTBitMon_QueryRunRegistry::string, and ~LeafCandidate().

61  {
62  m_state = ParticleState(qx3, PolarLorentzVector(pt,eta,phi,mass), vtx, pdgId, status, false);
63  }
virtual double pt() const final
transverse momentum
virtual double mass() const final
mass
virtual double eta() const final
momentum pseudorapidity
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
Definition: LeafCandidate.h:25
virtual int status() const final
status word
ParticleState m_state
virtual double phi() const final
momentum azimuthal angle
virtual int pdgId() const final
PDG identifier.
const Candidate * LeafCandidate::daughter ( size_type  ) const
virtual
Candidate * LeafCandidate::daughter ( size_type  )
virtual
Candidate * LeafCandidate::daughter ( const std::string &  s)
virtual

return daughter with a specified role name

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, reco::CompositeCandidate, and reco::NamedCompositeCandidate.

Definition at line 54 of file LeafCandidate.cc.

References Exception, and edm::errors::UnimplementedFeature.

54  {
56  << "This Candidate type does not implement daughter(std::string). "
57  << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
58 }
const Candidate * LeafCandidate::daughter ( const std::string &  s) const
virtual

return daughter with a specified role name

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, reco::CompositeCandidate, and reco::NamedCompositeCandidate.

Definition at line 48 of file LeafCandidate.cc.

References Exception, and edm::errors::UnimplementedFeature.

48  {
50  << "This Candidate type does not implement daughter(std::string). "
51  << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
52 }
virtual double reco::LeafCandidate::energy ( ) const
inlinefinalvirtual

energy

Implements reco::Candidate.

Definition at line 110 of file LeafCandidate.h.

References reco::ParticleState::energy(), and m_state.

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), JetValidation::analyze(), PatTauAnalyzer::analyze(), QcdHighPtDQM::analyze(), TreeWriterForEcalCorrection::analyze(), EwkElecDQM::analyze(), PFCandidateChecker::analyze(), DQMHcalDiJetsAlCaReco::analyze(), IsolatedParticlesGeneratedJets::analyze(), SimplePhotonAnalyzer::analyze(), ResolutionCreator::analyze(), PhotonValidatorMiniAOD::analyze(), L1GenTreeProducer::analyze(), ZdcSimHitStudy::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), reco::FlavorHistoryEvent::cache(), reco::helper::CastorJetIDHelper::calculate(), reco::helper::JetIDHelper::calculate(), pat::CaloIsolationEnergy::calculate(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), reco::CastorTower::CastorTower(), reco::JPTJet::chargedEmEnergyFraction(), reco::PFJet::chargedEmEnergyFraction(), reco::JPTJet::chargedHadronEnergyFraction(), reco::PFJet::chargedHadronEnergyFraction(), reco::PFJet::chargedMuEnergyFraction(), reco::helper::JetIDHelper::classifyJetComponents(), TauElementsOperators::computeConeSize(), MVAJetPuId::computeIdVariables(), PileupJetIdAlgo::computeIdVariables(), JetPlusTrackCorrector::correctAA(), L1FastjetCorrector::correction(), L1JPTOffsetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), L1FastjetCorrectorImpl::correction(), L1JPTOffsetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), reco::PFJet::electronEnergyFraction(), metsig::SignAlgoResolutions::ElectronPtResolution(), egHLT::OffPho::energy(), egHLT::OffEle::energy(), CaloTower::energyInHF(), CaloTower::energyInHO(), metsig::SignAlgoResolutions::evalPF(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), AdHocNTupler::fill(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), PFJetIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), PFJetBenchmark::gettrue(), CaloTower::hadP4(), reco::PFJet::HFEMEnergyFraction(), reco::PFJet::HFHadronEnergyFraction(), reco::PFJet::hoEnergyFraction(), HPSPFRecoTauAlgorithm::isNarrowTau(), TauValidation::leadingPionP4(), main(), reco::tau::RecoTauIsolationMasking::mask(), MatchJet::matchCollections(), TauValidation::motherP4(), reco::PFJet::muonEnergyFraction(), reco::JPTJet::neutralEmEnergyFraction(), reco::PFJet::neutralEmEnergyFraction(), reco::JPTJet::neutralHadronEnergyFraction(), reco::PFJet::neutralHadronEnergyFraction(), GsfEleDEtaInLinearCut::operator()(), AcceptJet::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), TtSemiLRSignalSelObservables::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), EgammaHLTFilteredSuperClusterProducer::SelectionCut::CutValues::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::operator<<(), CaloTower::p4(), reco::PFMETProducerMVA::passPFLooseId(), reco::PFJet::photonEnergyFraction(), PFAlgo::processBlock(), FSRWeightProducer::produce(), CaloTowerCandidateCreator::produce(), EgammaHLTCaloTowerProducer::produce(), EgammaHLTPFNeutralIsolationProducer::produce(), pf2pat::PFMETAlgo::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), JetPlusTrackProducer::produce(), NoPileUpPFMEtDataProducer::produce(), CastorClusterProducer::produce(), JetPlusTrackProducerAA::produce(), JetIdSelector< T >::produce(), BoostedTopProducer::produce(), SmearedJetProducerT< T >::produce(), Jet.Jet::rawEnergy(), reco::tau::RecoTauIsolationMasking::resolution(), pf2pat::PFIsoDepositAlgo::sameParticle(), TauValidation::spinEffectsZH(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().

110 { return m_state.energy(); }
double energy() const
energy
Definition: ParticleState.h:91
ParticleState m_state
virtual double reco::LeafCandidate::et ( ) const
inlinefinalvirtual

transverse energy

Implements reco::Candidate.

Definition at line 112 of file LeafCandidate.h.

References reco::ParticleState::et(), and m_state.

Referenced by StKinFitter::addKinFitInfo(), PFTester::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), PatPhotonSimpleAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), EwkDQM::analyze(), ZeePlots::analyze(), WenuPlots::analyze(), SimplePi0DiscAnalyzer::analyze(), HigPhotonJetHLTOfflineSource::analyze(), PhotonValidator::analyze(), PhotonAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), EgammaObjects::analyzePhotons(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), razor::CalcMTR(), reco::helper::JetIDHelper::calculate(), l1t::CaloRegion::CaloRegion(), l1t::CaloTower::CaloTower(), EmDQM::checkGeneratedParticlesRequirement(), TauElementsOperators::computeConeSize(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1JetRecoTreeProducer::doPFMet(), egHLT::OffPho::et(), egHLT::OffEle::et(), pat::ObjectResolutionCalc::etaBin(), reco::tau::qcuts::etMin_cand(), l1extra::L1EtMissParticle::etMiss(), HLTOfflineDQMTopDiLepton::MonitorDiLepton::fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), AdHocNTupler::fill(), L1TEGammaOffline::fillElectrons(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), L1TEGammaOffline::fillPhotons(), WMuNuValidator::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), HeavyChHiggsToTauNuSkim::filter(), WMuNuSelector::filter(), PhotonEnrichmentFilter::filter(), ZeeCandidateFilter::filter(), reco::tau::RecoTauQualityCuts::filterGammaCand(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), reco::tau::RecoTauQualityCuts::filterNeutralHadronCand(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), ElectronVPlusJetsIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), HLTRechitInRegionsProducer< T1 >::getEtaPhiRegions(), WtoLNuSelector::getMt(), GsfEleValueMapIsoRhoCut::getRhoCorr(), l1t::HGCalTower::HGCalTower(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), HPSPFRecoTauAlgorithm::isNarrowTau(), l1t::Jet::Jet(), JetVertexMain::Main(), reco::MET::mEtSig(), GsfEleValueMapIsoRhoCut::operator()(), GsfEleTrkPtIsoRhoCut::operator()(), GsfEleEmHadD1IsoRhoCut::operator()(), GsfEleTrkPtIsoCut::operator()(), GsfEleDEtaInLinearCut::operator()(), TtDilepLRSignalSelObservables::operator()(), TtSemiLRSignalSelObservables::operator()(), TtHadLRSignalSelObservables::CompareET::operator()(), TtSemiLRSignalSelObservables::CompareET::operator()(), EgammaHLTFilteredSuperClusterProducer::SelectionCut::CutValues::operator()(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), DistortedMETProducer::produce(), ParticleTowerProducer::produce(), JetEnergyShift::produce(), HiL1Subtractor::produce(), JetPlusTrackCorrector::rebuildJta(), L1GObject::setEt(), l1t::CaloRegion::setEtEm(), l1t::HGCalTower::setEtEm(), l1t::CaloTower::setEtEm(), l1t::CaloRegion::setEtHad(), l1t::HGCalTower::setEtHad(), l1t::CaloTower::setEtHad(), l1t::EGamma::setFootprintEt(), l1t::CaloRegion::setHwEtEm(), l1t::CaloTower::setHwEtEm(), l1t::HGCalTower::setHwEtEm(), l1t::CaloRegion::setHwEtHad(), l1t::HGCalTower::setHwEtHad(), l1t::CaloTower::setHwEtHad(), l1t::EGamma::setIsoEt(), L1Analysis::L1AnalysisRecoMet::SetMet(), l1t::EGamma::setRawEt(), FWPhotonDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), PFElectronSelector::spring11Cuts(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), and l1t::Tau::Tau().

112 { return m_state.et(); }
ParticleState m_state
double et() const
transverse energy
Definition: ParticleState.h:93
virtual double reco::LeafCandidate::et2 ( ) const
inlinefinalvirtual

transverse energy squared (use this for cut!)

Implements reco::Candidate.

Definition at line 114 of file LeafCandidate.h.

References reco::ParticleState::et2(), and m_state.

114 { return m_state.et2(); }
ParticleState m_state
double et2() const
transverse energy squared (use this for cuts)!
Definition: ParticleState.h:95
virtual double reco::LeafCandidate::eta ( ) const
inlinefinalvirtual

momentum pseudorapidity

Implements reco::Candidate.

Definition at line 137 of file LeafCandidate.h.

References reco::ParticleState::eta(), and m_state.

Referenced by Particle.Particle::__str__(), reco::tau::disc::AbsEta(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), ZIterativeAlgorithmWithFit::addEvent(), StKinFitter::addKinFitInfo(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), GlbMuQualityCutsAnalysis::analyze(), ZMuPtScaleAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), CMSDAS11DijetAnalyzer::analyze(), JetValidation::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), PFTester::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), RPCMonitorDigi::analyze(), EwkMuDQM::analyze(), TreeWriterForEcalCorrection::analyze(), testAnalyzer::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), PFCandidateChecker::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), QcdPhotonsDQM::analyze(), IsolatedParticlesGeneratedJets::analyze(), PatPhotonSimpleAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), ZeePlots::analyze(), EwkDQM::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), WenuPlots::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), SimplePi0DiscAnalyzer::analyze(), ElectronCalibration::analyze(), MuTriggerAnalyzer::analyze(), gamma_radiative_analyzer::analyze(), ZMuMu_Radiative_analyzer::analyze(), B2GHadronicHLTValidation::analyze(), B2GSingleLeptonHLTValidation::analyze(), TopSingleLeptonHLTValidation::analyze(), B2GDoubleLeptonHLTValidation::analyze(), PhotonValidatorMiniAOD::analyze(), DQMExample_Step1::analyze(), TopDiLeptonHLTValidation::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), L1Validator::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), PhotonAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::RecoTauVertexAssociator::associatedVertex(), HPSPFRecoTauAlgorithm::associateIsolationCandidates(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWMuonDetailView::build(), FWMuonLegoProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWMETProxyBuilder::buildViewType(), reco::helper::JetMuonHitsIDHelper::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateInMipT(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), JetPlusTrackCorrector::canCorrect(), hitfit::LeptonTranslatorBase< ALepton >::CheckEta(), hitfit::JetTranslatorBase< AJet >::CheckEta(), ElectronClassification::classify(), PFMuonAlgo::cleanPunchThroughAndFakes(), compare_l1candidate(), MVAJetPuId::computeIdVariables(), PileupJetIdAlgo::computeIdVariables(), JetPlusTrackCorrector::correctAA(), LXXXCorrector::correction(), L1FastjetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), LXXXCorrectorImpl::correction(), L1FastjetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), reco::GenJet::detectorEta(), PFRecoTauDiscriminationByHPSSelection::discriminate(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), metsig::SignAlgoResolutions::ElectronPtResolution(), FWPFCandidateDetailView::eta(), reco::tau::disc::Eta(), MuonGmtPair::eta(), egHLT::OffPho::eta(), egHLT::OffEle::eta(), pat::ObjectResolutionCalc::etaBin(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), TopSingleLepton::MonitorEnsemble::fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), ZeePlots::fillEleClassesPlots(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), L1TStage2CaloLayer2Offline::fillJets(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuon(), PhotonMVAEstimatorRun2Phys14NonTrig::fillMVAVariables(), PhotonMVAEstimatorRun2Spring15NonTrig::fillMVAVariables(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), L1TEGammaOffline::fillPhotons(), WMuNuValidator::filter(), doubleEMEnrichingFilterAlgo::filter(), BCToEFilterAlgo::filter(), BadParticleFilter::filter(), WMuNuSelector::filter(), HeavyChHiggsToTauNuSkim::filter(), GenHTFilter::filter(), PhotonEnrichmentFilter::filter(), WZInterestingEventSelector::filter(), ZeeCandidateFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), CalibratableTest::findCandidatesInDeltaR(), TtSemiLepHypGenMatch::findMatchingLepton(), TtFullLepHypGenMatch::findMatchingLepton(), PFJetIDSelectionFunctor::firstDataCuts(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), TrackIsoCalculator::getBkgSubTrackIso(), calib::CalibElectron::getCalibModulesWeights(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), ParticleTowerProducer::getNearestTower(), getTheTauJet(), MuonGmtPair::gmtEta(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), CosmicSplitterValidation::is_gold_muon(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFEGammaFilters::isElectronSafeForJetMET(), muon::isGoodMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), MuTriggerAnalyzer::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), PFPhotonIsolationCalculator::isNeutralParticleVetoed(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFPhotonIsolationCalculator::isPhotonParticleVetoed(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), l1t::Jet::Jet(), L1JetRecoTreeProducer::jetId(), Jet.Jet::jetID(), main(), JetVertexMain::Main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), reco::RecoTauPiZero::maxDeltaEta(), DQMExample_Step1::MediumEle(), ZToMuMuGammaAnalyzer::muonSelection(), ElectronMVAEstimator::mva(), SoftElectronMVAEstimator::mva(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), AcceptJet::operator()(), GenParticleCustomSelector::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), hitfit::JetTranslatorBase< AJet >::operator()(), reco::operator<<(), operator<<(), pat::TriggerObjectStandAlone::packP4(), PFEGammaFilters::passElectronSelection(), passesElectronId(), passesElectronPreId(), reco::PFMETProducerMVA::passPFLooseId(), PhotonAnalyzer::photonSelection(), reco::tau::disc::PiZeroEta(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetTracksAssociationDRCalo::produce(), JetVetoedTracksAssociationDRVertex::produce(), DistortedMuonProducerFromDB::produce(), QuarkoniaTrackSelector::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), RegressionEnergyPatElectronProducer::produce(), CaloMuonMerger::produce(), CaloTowerCandidateCreator::produce(), PileupJPTJetIdProducer::produce(), EgammaHLTCaloTowerProducer::produce(), MVAJetPuIdProducer::produce(), ParticleTowerProducer::produce(), MuonReSeeder::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), BoostedTauSeedsProducer::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), PileupJetIdProducer::produce(), CastorClusterProducer::produce(), HiL1Subtractor::produce(), reco::CentralityProducer::produce(), JetIdSelector< T >::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), TauIdMVAAuxiliaries::pt_weighted_dx(), Jet.Jet::puJetId(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), reco::tau::RecoTauIsolationMasking::resolution(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), PFPhotonAlgo::RunPFPhoton(), pf2pat::PFIsoDepositAlgo::sameParticle(), L1GObject::setEta(), reco::HcalIsolatedTrackCandidate::SetEtaPhiEcal(), reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), reco::HcalIsolatedTrackCandidate::SetEtaPhiHcal(), l1t::L1Candidate::setHwEta(), reco::HcalIsolatedTrackCandidate::setL1(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), HiFJGridEmptyAreaCalculator::setupGridJet(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), l1t::Tau::Tau(), HiFJGridEmptyAreaCalculator::tileIndexEta(), HiFJGridEmptyAreaCalculator::tileIndexEtaJet(), reco::tau::disc::TrackEta(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().

137 { return m_state.eta(); }
ParticleState m_state
double eta() const
momentum pseudorapidity
void LeafCandidate::fillVertexCovariance ( CovarianceMatrix v) const
virtual

fill SMatrix

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate, and reco::VertexCompositePtrCandidate.

Definition at line 83 of file LeafCandidate.cc.

References Exception, and edm::errors::UnimplementedFeature.

Referenced by vertexCovariance().

83  {
85  << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
86 }
template<typename T >
T reco::LeafCandidate::get ( ) const
inline
template<typename T , typename Tag >
T reco::LeafCandidate::get ( ) const
inline
template<typename T >
T reco::LeafCandidate::get ( size_type  i) const
inline
template<typename T , typename Tag >
T reco::LeafCandidate::get ( size_type  i) const
inline
bool LeafCandidate::hasMasterClone ( ) const
virtual

returns true if this candidate has a reference to a master clone. This only happens if the concrete Candidate type is ShallowCloneCandidate

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, and reco::ShallowCloneCandidate.

Definition at line 13 of file LeafCandidate.cc.

Referenced by get(), numberOf(), and vertexCovariance().

13  {
14  return false;
15 }
bool LeafCandidate::hasMasterClonePtr ( ) const
virtual

returns true if this candidate has a ptr to a master clone. This only happens if the concrete Candidate type is ShallowClonePtrCandidate

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, and reco::ShallowClonePtrCandidate.

Definition at line 17 of file LeafCandidate.cc.

Referenced by vertexCovariance().

17  {
18  return false;
19 }
bool LeafCandidate::isCaloMuon ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 98 of file LeafCandidate.cc.

Referenced by numberOf().

98 { return false; }
bool LeafCandidate::isConvertedPhoton ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 102 of file LeafCandidate.cc.

Referenced by numberOf().

102 { return false; }
bool LeafCandidate::isElectron ( ) const
virtual
bool LeafCandidate::isGlobalMuon ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 92 of file LeafCandidate.cc.

Referenced by Muon.Muon::muonID(), and numberOf().

92 { return false; }
bool LeafCandidate::isJet ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, reco::Jet, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 104 of file LeafCandidate.cc.

Referenced by numberOf().

104 { return false; }
bool LeafCandidate::isMuon ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 90 of file LeafCandidate.cc.

Referenced by numberOf().

90 { return false; }
bool LeafCandidate::isPhoton ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, reco::Photon, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 100 of file LeafCandidate.cc.

Referenced by numberOf().

100 { return false; }
bool LeafCandidate::isStandAloneMuon ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 94 of file LeafCandidate.cc.

Referenced by numberOf().

94 { return false; }
bool LeafCandidate::isTrackerMuon ( ) const
virtual

Implements reco::Candidate.

Reimplemented in reco::Muon, reco::LeafRefCandidateT, reco::ShallowCloneCandidate, and reco::ShallowClonePtrCandidate.

Definition at line 96 of file LeafCandidate.cc.

Referenced by numberOf().

96 { return false; }
virtual bool reco::LeafCandidate::longLived ( ) const
inlinefinalvirtual

is long lived?

Implements reco::Candidate.

Definition at line 172 of file LeafCandidate.h.

References reco::ParticleState::longLived(), and m_state.

172 { return m_state.longLived(); }
ParticleState m_state
bool longLived() const
is long lived?
virtual double reco::LeafCandidate::mass ( ) const
inlinefinalvirtual

mass

Implements reco::Candidate.

Definition at line 116 of file LeafCandidate.h.

References m_state, and reco::ParticleState::mass().

Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), BPHCompositeBasicSelect::accept(), ZMuPtScaleAnalyzer::analyze(), JetTester::analyze(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), BPHKx0ToKPiBuilder::build(), HPSPFRecoTauAlgorithm::buildThreeProngs(), MVAJetPuId::computeIdVariables(), PileupJetIdAlgo::computeIdVariables(), JetPlusTrackCorrector::correction(), BPHHistoSpecificDecay::endJob(), BPhysicsValidation::ParticleMonitor::Fill(), HSCPTreeBuilder::filter(), V0Fitter::fitAll(), reco::tau::disc::InvariantMassOfSignal(), reco::tau::disc::Mass(), massSqr(), AntiElectronIDMVA5::MVAValue(), CATopJetHelper::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), CAWZJetHelperUser::operator()(), CATopJetHelperUser::operator()(), reco::operator<<(), pat::TriggerObjectStandAlone::packP4(), reco::PFRecoTauChargedHadron::print(), WeakEffectsWeightProducer::produce(), DistortedMuonProducerFromDB::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), ISRGammaWeightProducer::produce(), FSRWeightProducer::produce(), PdfWeightProducer::produce(), Onia2MuMuPAT::produce(), BoostedTauSeedsProducer::produce(), PatJPsiProducer::produce(), heppy::FSRWeightAlgo::weight(), BPHMassSelect::~BPHMassSelect(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().

116 { return m_state.mass(); }
ParticleState m_state
double mass() const
mass
Definition: ParticleState.h:97
virtual bool reco::LeafCandidate::massConstraint ( ) const
inlinefinalvirtual

do mass constraint?

Implements reco::Candidate.

Definition at line 177 of file LeafCandidate.h.

References m_state, and reco::ParticleState::massConstraint().

Referenced by CandKinematicVertexFitter::fill().

177 { return m_state.massConstraint(); }
ParticleState m_state
bool massConstraint() const
do mass constraint?
virtual double reco::LeafCandidate::massSqr ( ) const
inlinefinalvirtual

mass squared

Implements reco::Candidate.

Definition at line 118 of file LeafCandidate.h.

References mass().

Referenced by EwkElecDQM::analyze().

118 { return mass() * mass(); }
virtual double mass() const final
mass
const CandidateBaseRef & LeafCandidate::masterClone ( ) const
virtual

returns ptr to master clone, if existing. Throws an exception unless the concrete Candidate type is ShallowCloneCandidate

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, and reco::ShallowCloneCandidate.

Definition at line 7 of file LeafCandidate.cc.

References Exception.

Referenced by get(), masterRef(), numberOf(), and vertexCovariance().

7  {
8  throw cms::Exception("Invalid Reference")
9  << "this Candidate has no master clone reference."
10  << "Can't call masterClone() method.\n";
11 }
const CandidatePtr & LeafCandidate::masterClonePtr ( ) const
virtual

returns ptr to master clone, if existing. Throws an exception unless the concrete Candidate type is ShallowClonePtrCandidate

Implements reco::Candidate.

Reimplemented in reco::LeafRefCandidateT, and reco::ShallowClonePtrCandidate.

Definition at line 22 of file LeafCandidate.cc.

References Exception.

Referenced by vertexCovariance().

22  {
23  throw cms::Exception("Invalid Reference")
24  << "this Candidate has no master clone ptr."
25  << "Can't call masterClonePtr() method.\n";
26 }
template<typename Ref >
Ref reco::LeafCandidate::masterRef ( ) const
inline

cast master clone reference to a concrete type

Definition at line 216 of file LeafCandidate.h.

References masterClone().

216 { return masterClone().template castTo<Ref>(); }
virtual const CandidateBaseRef & masterClone() const
Definition: LeafCandidate.cc:7
virtual Vector reco::LeafCandidate::momentum ( ) const
inlinefinalvirtual
const Candidate * LeafCandidate::mother ( size_type  ) const
virtual
virtual double reco::LeafCandidate::mt ( ) const
inlinefinalvirtual

transverse mass

Implements reco::Candidate.

Definition at line 121 of file LeafCandidate.h.

References m_state, and reco::ParticleState::mt().

Referenced by reco::WMuNuCandidate::massT(), and reco::WMuNuCandidatePtr::massT().

121 { return m_state.mt(); }
ParticleState m_state
double mt() const
transverse mass
virtual double reco::LeafCandidate::mtSqr ( ) const
inlinefinalvirtual

transverse mass squared

Implements reco::Candidate.

Definition at line 123 of file LeafCandidate.h.

References m_state, and reco::ParticleState::mtSqr().

123 { return m_state.mtSqr(); }
ParticleState m_state
double mtSqr() const
transverse mass squared
template<typename T >
size_type reco::LeafCandidate::numberOf ( ) const
inline

number of components

Definition at line 239 of file LeafCandidate.h.

References hasMasterClone(), and masterClone().

239  {
240  if ( hasMasterClone() ) return masterClone()->numberOf<T>();
241  else return reco::numberOf<T>( * this );
242  }
virtual bool hasMasterClone() const
size_type numberOf() const
number of components
Definition: Candidate.h:237
virtual const CandidateBaseRef & masterClone() const
Definition: LeafCandidate.cc:7
long double T
template<typename T , typename Tag >
size_type reco::LeafCandidate::numberOf ( ) const
inline

number of components

Definition at line 244 of file LeafCandidate.h.

References hasMasterClone(), isCaloMuon(), isConvertedPhoton(), isElectron(), isGlobalMuon(), isJet(), isMuon(), isPhoton(), isStandAloneMuon(), isTrackerMuon(), and masterClone().

244  {
245  if ( hasMasterClone() ) return masterClone()->numberOf<T, Tag>();
246  else return reco::numberOf<T, Tag>( * this );
247  }
virtual bool hasMasterClone() const
size_type numberOf() const
number of components
Definition: Candidate.h:237
virtual const CandidateBaseRef & masterClone() const
Definition: LeafCandidate.cc:7
long double T
size_t LeafCandidate::numberOfDaughters ( ) const
virtual
size_t LeafCandidate::numberOfMothers ( ) const
virtual
virtual size_t reco::LeafCandidate::numberOfSourceCandidatePtrs ( ) const
inlinevirtual

return the number of source Candidates ( the candidates used to construct this Candidate)

Implements reco::Candidate.

Reimplemented in pat::Photon, pat::Tau, pat::Electron, reco::PFTau, pat::Muon, reco::PFCandidate, reco::LeafRefCandidateT, and reco::CompositePtrCandidate.

Definition at line 83 of file LeafCandidate.h.

83 { return 0;}
LeafCandidate& reco::LeafCandidate::operator= ( LeafCandidate &&  )
default
LeafCandidate& reco::LeafCandidate::operator= ( LeafCandidate const &  )
default
bool LeafCandidate::overlap ( const Candidate o) const
privatevirtual

check overlap with another Candidate

Implements reco::Candidate.

Reimplemented in reco::Photon, reco::PFCandidate, reco::Muon, reco::PFTau, reco::PFJet, reco::GsfElectron, reco::CaloJet, reco::IsolatedPixelTrackCandidate, reco::JPTJet, reco::LeafRefCandidateT, reco::SiStripElectron, reco::HcalIsolatedTrackCandidate, reco::GenParticle, reco::GenJet, reco::GenMET, reco::CaloMET, reco::CompositeRefCandidateT< D >, reco::CompositeRefCandidateT< GenParticleRefVector >, reco::CompositeRefCandidateT< reco::edm::RefVector >, reco::CompositeCandidate, reco::MET, reco::CompositePtrCandidate, reco::CompositeRefCandidate, reco::ShallowCloneCandidate, reco::ShallowClonePtrCandidate, reco::TrackJet, reco::CaloTau, reco::ME0Muon, reco::CompositeRefBaseCandidate, reco::PFClusterJet, reco::Electron, reco::BaseTau, reco::CandidateWithRef< Ref >, reco::BasicJet, reco::CaloRecHitCandidate, reco::RecoChargedCandidate, reco::RecoEcalCandidate, reco::RecoStandAloneMuonCandidate, reco::RecoCaloTowerCandidate, and reco::RecoCandidate.

Definition at line 36 of file LeafCandidate.cc.

References reco::Candidate::charge(), charge(), reco::Candidate::p4(), p4(), reco::Candidate::vertex(), and vertex().

36  {
37  return p4() == o.p4() && vertex() == o.vertex() && charge() == o.charge();
38 }
virtual const Point & vertex() const
vertex position (overwritten by PF...)
virtual int charge() const final
electric charge
Definition: LeafCandidate.h:91
virtual const LorentzVector & p4() const =0
four-momentum Lorentz vector
virtual int charge() const =0
electric charge
virtual const Point & vertex() const =0
vertex position
virtual const LorentzVector & p4() const final
four-momentum Lorentz vector
Definition: LeafCandidate.h:99
virtual double reco::LeafCandidate::p ( ) const
inlinefinalvirtual

magnitude of momentum vector

Implements reco::Candidate.

Definition at line 108 of file LeafCandidate.h.

References m_state, and reco::ParticleState::p().

Referenced by ElectronMcSignalValidatorMiniAOD::analyze(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), HiggsDQM::analyze(), ElectronCalibrationUniv::analyze(), JetTagPlotter::analyzeTag(), AlignmentMuonSelector::basicCuts(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), PFMuonAlgo::cleanPunchThroughAndFakes(), reco::CompositeCandidate::CompositeCandidate(), CaloTower::emP4(), RecoMuonValidator::MuonME::fill(), ElectronMVAEstimatorRun2Phys14NonTrig::fillMVAVariables(), GreedyMuonPFCandidateFilter::filter(), HSCPTreeBuilder::filter(), CaloTower::hadP4(), HLTMuonTrackMassFilter::hltFilter(), BPhysicsOniaDQM::isMuonInAccept(), TauValidation::leadingPionP4(), SoftElectronMVAEstimator::mva(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), reco::NamedCompositeCandidate::NamedCompositeCandidate(), AcceptJet::operator()(), CaloTower::p4(), CaloTower::p4_HO(), reco::GenericJet::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), QuarkoniaTrackSelector::produce(), RegressionEnergyPatElectronProducer::produce(), CalibratedElectronProducer::produce(), and Electron.Electron::ptErr().

108 { return m_state.p(); }
ParticleState m_state
double p() const
magnitude of momentum vector
Definition: ParticleState.h:89
virtual const LorentzVector& reco::LeafCandidate::p4 ( ) const
inlinefinalvirtual

four-momentum Lorentz vector

Implements reco::Candidate.

Definition at line 99 of file LeafCandidate.h.

References m_state, and reco::ParticleState::p4().

Referenced by l1t::HGCalClusterT< l1t::HGCalCluster >::addConstituent(), reco::tau::RecoTauConstructor::addPiZero(), reco::tau::RecoTauConstructor::addTauChargedHadron(), PFCandConnector::analyseNuclearWPrim(), PFCandConnector::analyseNuclearWSec(), CMSDAS11DijetAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), QcdHighPtDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ResolutionCreator::analyze(), MuonPFAnalyzer::analyze(), MuTriggerAnalyzer::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), HLTMuonMatchAndPlot::analyze(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), EmbeddingLHEProducer::assign_4vector(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), TtSemiLepJetComb::bOverLightQPt(), TtSemiLepJetComb::bQuarkVar(), FWVertexCandidateProxyBuilder::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), HPSPFRecoTauAlgorithm::buildOneProng(), HPSPFRecoTauAlgorithm::buildThreeProngs(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), reco::tau::disc::ChargedOutlierAngle(), TtSemiLepJetComb::compareBNeutrino(), TtSemiLepJetComb::compareLeptonNeutrino(), TtSemiLepJetComb::compareTopNeutrino(), TtSemiLepJetComb::compareWNeutrino(), PFMEtSignInterfaceBase::compResolution(), TtFullHadKinFitter::KinFit::corJet(), pat::Jet::correctedP4(), pat::Tau::correctedP4(), TauJetCorrector::correction(), ZSPJPTJetCorrector::correction(), LXXXCorrector::correction(), LXXXCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), reco::GsfElectron::Corrections::Corrections(), PFElectronTranslator::createGsfElectrons(), reco::tau::disc::Dalitz2(), TtSemiLepJetComb::deduceMothers(), PFRecoTauDiscriminationByHPSSelection::discriminate(), PFRecoTauDiscriminationByIsolation::discriminate(), Tau.Tau::dxy_approx(), Tau.Tau::dz(), l1t::EGamma::EGamma(), CaloTower::emEt(), reco::Photon::EnergyCorrections::EnergyCorrections(), ErsatzMEt::ersatzFabrik(), CaloTower::et(), l1t::EtSum::EtSum(), JetPartonMatcher::fillAlgoritDefinition(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), TopDecaySubset::fillListing(), JetPartonMatcher::fillPhysicsDefinition(), VBFGenJetFilter::filter(), pat::CaloJetSelector::filter(), HLTRHemisphere::filter(), VBFGenJetFilter::filterGenJets(), reco::Photon::getCandidateP4type(), GeneratorTau::getOpeningAngle(), TauSpinnerCMS::GetRecoDaughters(), GeneratorTau::getVisNuAngle(), CaloTower::hadEt(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), reco::tau::RecoTauIsolationMasking::inCone(), l1t::Jet::Jet(), reco::tau::disc::JetTauDR(), LeafCandidate(), TtSemiLepJetComb::lightQVar(), reco::tau::disc::MainTrackAngle(), ZToMuMuGammaAnalyzer::mumuGammaInvMass(), ZToMuMuGammaAnalyzer::mumuInvMass(), MuonMETAlgo::MuonMETAlgo_run(), reco::tau::disc::NeutralOutlierAngle(), TtSemiLepJetComb::neutrinoVar(), reco::tau::disc::OpeningAngle3D(), reco::tau::disc::OpeningDeltaR(), pat::RawJetExtractorT< pat::Jet >::operator()(), CorrectJet::operator()(), TtDilepLRSignalSelObservables::operator()(), reco::tau::RecoTauPhotonFilter::operator()(), JetCleanerForType1MET_namespace::RawJetExtractorT< pat::Jet >::operator()(), PFJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), CaloJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), TtHadLRJetCombObservables::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin2::operator()(), TtSemiLRJetCombObservables::operator()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), JetIDSelectionFunctor::operator()(), reco::operator<<(), CaloTower::outerEt(), reco::tau::disc::OutlierAngle(), reco::LeafRefCandidateT::overlap(), overlap(), CaloTower::p(), CaloTower::p4(), Lepton.Lepton::p4WithFSR(), reco::PFTauDecayMode::PFTauDecayMode(), reco::Photon::Photon(), reco::tau::disc::PiZeroAngle(), QuarkoniaTrackSelector::produce(), L1THLTTauMatching::produce(), ISRGammaWeightProducer::produce(), L1HLTTauMatching::produce(), pat::PATSecondaryVertexSlimmer::produce(), HLTTriMuonIsolation::produce(), JetTracksAssociationToTrackRefs::produce(), PFJetsTauOverlapRemoval::produce(), DeltaBetaWeights::produce(), PuppiProducer::produce(), SoftPFMuonTagInfoProducer::produce(), Type0PFMETcorrInputProducer::produce(), SoftPFElectronTagInfoProducer::produce(), reco::PFMETProducerMVA::produce(), TruthTauDecayModeProducer::produce(), MuonProducer::produce(), BoostedDoubleSVProducer::produce(), TauSpinnerCMS::readParticlesfromReco(), TtSemiLepJetComb::relativePtHadronicTop(), reco::PFCandidate::rescaleMomentum(), HGCalTriggerBackend::HGCalTriggerSimCluster< FECODEC, DATA >::run(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), reco::GsfElectron::setCorrectedEcalEnergy(), pat::PATMuonProducer::setMuonMiniIso(), reco::GsfElectron::setP4(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), TtSemiEvtSolution::setupHyp(), reco::tau::RecoTauConstructor::sortAndCopyIntoTau(), reco::tau::sumPFCandP4(), l1t::Tau::Tau(), reco::tau::disc::TrackAngle(), reco::GsfElectron::trackMomentumError(), pat::TriggerObjectStandAlone::triggerObject(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), and NoPileUpPFMEtDataProducer::~NoPileUpPFMEtDataProducer().

99 { return m_state.p4(); }
ParticleState m_state
const LorentzVector & p4() const
four-momentum Lorentz vector
Definition: ParticleState.h:80
virtual int reco::LeafCandidate::pdgId ( ) const
inlinefinalvirtual

PDG identifier.

Implements reco::Candidate.

Definition at line 161 of file LeafCandidate.h.

References m_state, and reco::ParticleState::pdgId().

Referenced by Particle.Particle::__str__(), MCTruthHelper< P >::absPdgId(), TopDecaySubset::addRadiation(), TauDecay_GenParticle::AddRadInfo(), EWKSystUnc::analyze(), ZLONLOHistogrammer::analyze(), zPdfUnc::analyze(), ZMuPtScaleAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), PFTester::analyze(), TauDecay_GenParticle::Analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), ZdcSimHitStudy::analyze(), L1Validator::analyze(), ExoticaDQM::analyzeDisplacedJets(), ExoticaDQM::analyzeDisplacedLeptons(), TauDecay_GenParticle::AnalyzeTau(), HPSPFRecoTauAlgorithm::applyElectronRejection(), reco::PFCandidate::bestTrack(), TtFullHadHypGenMatch::buildHypo(), TtSemiLepHypGenMatch::buildHypo(), PFCandidateStripMerger::candidateMatches(), TopDecaySubset::checkShowerModel(), GeneratorTau::computeDecayMode(), TauValidation::countParticles(), TopGenEvent::daughterQuarkOfTop(), GeneratorTau::decayToPDGClassification(), PFIsolationEstimator::fGetIsolationInRings(), CandKinematicVertexFitter::fill(), BPhysicsValidation::ParticleMonitor::Fill(), BPhysicsValidation::FillDaughters(), TopDecaySubset::fillListing(), DYToMuMuGenFilter::filter(), HeavyQuarkFromMPIFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), ChargedHadronTrackResolutionFilter::filter(), MuonBadTrackFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), TauValidation::findFSRandBrem(), GenHFHadronMatcher::findHadronJets(), TopDecaySubset::findLastParticleInChain(), TauValidation::findMother(), GenParticlesHelper::findParticles(), TauValidation::FindPhotosFSR(), TauValidation::findTauList(), pat::PATObject< ObjectType >::genParticleById(), TauSpinnerCMS::GetLastSelf(), TauValidation::GetMother(), TauValidation::GetMothers(), TauSpinnerCMS::GetRecoDaughters(), ttHFGenFilter::GetTops(), PFJetBenchmark::gettrue(), TrackClassifier::hadronFlavor(), GenParticlesHelper::hasAncestor(), BCToEFilterAlgo::isBCBaryon(), doubleEMEnrichingFilterAlgo::isBCBaryon(), BCToEFilterAlgo::isBCMeson(), doubleEMEnrichingFilterAlgo::isBCMeson(), TauSpinnerCMS::isFirst(), HiGammaJetSignalDef::IsIsolated(), TauValidation::isLastTauinChain(), HiPhotonType::IsPrompt(), TauValidation::leadingPionP4(), LeafCandidate(), BasicGenParticleValidation::matchParticles(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), reco::RecoTauPiZero::numberOfElectrons(), reco::RecoTauPiZero::numberOfGammas(), GenParticleCustomSelector::operator()(), TtDilepLRSignalSelObservables::operator()(), reco::PFCandidate::particleId(), MCTruthHelper< P >::pdgId(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), WeakEffectsWeightProducer::produce(), ISRGammaWeightProducer::produce(), FSRWeightProducer::produce(), ISRWeightProducer::produce(), PdfWeightProducer::produce(), HLTTauMCProducer::produce(), pat::PATPackedCandidateProducer::produce(), pat::PATLostTracks::produce(), PartonSelector::produce(), JetPartonMatcher::produce(), TauSpinnerCMS::readParticlesfromReco(), setPdgId(), TauValidation::spinEffectsZH(), TauValidation::tauMother(), toTrackRef(), HistoryBase::traceRecoGenHistory(), pat::TriggerObjectStandAlone::triggerObject(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), TauValidation::visibleTauEnergy(), and heppy::FSRWeightAlgo::weight().

161 { return m_state.pdgId(); }
int pdgId() const
PDG identifier.
ParticleState m_state
virtual double reco::LeafCandidate::phi ( ) const
inlinefinalvirtual

momentum azimuthal angle

Implements reco::Candidate.

Definition at line 133 of file LeafCandidate.h.

References m_state, and reco::ParticleState::phi().

Referenced by Particle.Particle::__str__(), reco::WMuNuCandidate::acop(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), ZIterativeAlgorithmWithFit::addEvent(), reco::tau::RecoTauConstructor::addPiZero(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), reco::tau::RecoTauConstructor::addTauChargedHadron(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), CMSDAS11DijetAnalyzer::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), PFTester::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), CaloTowerAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), DQMHcalDiJetsAlCaReco::analyze(), PFCandidateChecker::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), QcdPhotonsDQM::analyze(), PatPhotonSimpleAnalyzer::analyze(), IsolatedParticlesGeneratedJets::analyze(), SimplePhotonAnalyzer::analyze(), ZeePlots::analyze(), EwkDQM::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), WenuPlots::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), SimplePi0DiscAnalyzer::analyze(), ZMuMu_Radiative_analyzer::analyze(), METTester::analyze(), PhotonValidatorMiniAOD::analyze(), DQMExample_Step1::analyze(), HigPhotonJetHLTOfflineSource::analyze(), ZdcSimHitStudy::analyze(), L1GenTreeProducer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), L1Validator::analyze(), METMonitor::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), JetAnalyzer::analyze(), ErsatzMEt::analyze(), PhotonAnalyzer::analyze(), B2GDQM::analyzeAllHad(), ExoticaDQM::analyzeMonoElectrons(), ExoticaDQM::analyzeMonoJets(), ExoticaDQM::analyzeMonoMuons(), ExoticaDQM::analyzeMonoPhotons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), JetTracksAssociationXtrpCalo::associateInputTracksToJet(), HPSPFRecoTauAlgorithm::associateIsolationCandidates(), AlignmentMuonSelector::basicCuts(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWJetLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWPhotonLegoProxyBuilder::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWL1EtMissParticleLegoProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWMETLegoProxyBuilder::build(), FWMuonDetailView::build(), FWMuonLegoProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMET3DProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWPhotonProxyBuilder::buildViewType(), FWElectronProxyBuilder::buildViewType(), FWMETProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), reco::helper::CastorJetIDHelper::calculate(), reco::helper::JetMuonHitsIDHelper::calculate(), GlobalHaloAlgo::Calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), QGTagger::calcVariables(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), compare_l1candidate(), L6SLBCorrector::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), PFRecoTauDiscriminationByHPSSelection::discriminate(), L1JetRecoTreeProducer::doCaloMet(), L1JetRecoTreeProducer::doCaloMetBE(), L1JetRecoTreeProducer::doPFMet(), EcalDeadCellDeltaRFilter::dPhiToMETfunc(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), pat::JetCorrFactorsProducer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), L1ValidatorHists::Fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), L1TEGammaOffline::fillElectrons(), ZeeCalibration::fillEleInfo(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), L1TStage2CaloLayer2Offline::fillJets(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), METAnalyzer::fillMonitorElement(), l1t::MuonRawDigiTranslator::fillMuon(), PhotonMVAEstimatorRun2Spring15NonTrig::fillMVAVariables(), PhotonMVAEstimatorRun2Phys14NonTrig::fillMVAVariables(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), L1TEGammaOffline::fillPhotons(), WMuNuValidator::filter(), BadParticleFilter::filter(), HeavyChHiggsToTauNuSkim::filter(), WZInterestingEventSelector::filter(), ZeeCandidateFilter::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), L1Validator::FindBest(), CalibratableTest::findCandidatesInDeltaR(), TtSemiLepHypGenMatch::findMatchingLepton(), TtFullLepHypGenMatch::findMatchingLepton(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), WtoLNuSelector::getMt(), ParticleTowerProducer::getNearestTower(), MuonGmtPair::gmtPhi(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), tnp::BaseTreeFiller::init(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), PFPhotonIsolationCalculator::isNeutralParticleVetoed(), PFIsolationEstimator::isNeutralParticleVetoed(), EGammaMvaEleEstimator::isoMvaValue(), PFPhotonIsolationCalculator::isPhotonParticleVetoed(), PFIsolationEstimator::isPhotonParticleVetoed(), FWPFCandidateDetailView::isPntInRng(), l1t::Jet::Jet(), main(), JetVertexMain::Main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), JetIDStudiesSelector::operator()(), reco::operator<<(), operator<<(), pat::TriggerObjectStandAlone::packP4(), FWPFCandidateDetailView::phi(), MuonGmtPair::phi(), egHLT::OffPho::phi(), egHLT::OffEle::phi(), MuonIdProducer::phiOfMuonIneteractionRegion(), ntupleDataFormat.Track::phiPull(), reco::GenericJet::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), reco::JPTJet::printJet(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), JetTracksAssociationDRVertex::produce(), JetTracksAssociationDRVertexAssigned::produce(), JetTracksAssociationDRCalo::produce(), DistortedMETProducer::produce(), JetVetoedTracksAssociationDRVertex::produce(), DistortedMuonProducerFromDB::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), RegressionEnergyPatElectronProducer::produce(), FSRWeightProducer::produce(), CaloTowerCandidateCreator::produce(), PileupJPTJetIdProducer::produce(), EgammaHLTCaloTowerProducer::produce(), MVAJetPuIdProducer::produce(), ParticleTowerProducer::produce(), MuonReSeeder::produce(), pf2pat::PFMETAlgo::produce(), NoPileUpPFMEtProducer::produce(), pat::PATPackedCandidateProducer::produce(), CaloTowerFromL1TCreatorForTauHLT::produce(), CaloTowerCreatorForTauHLT::produce(), BoostedTauSeedsProducer::produce(), reco::PFMETProducerMVA::produce(), PileupJetIdProducer::produce(), CastorClusterProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), TauIdMVAAuxiliaries::pt_weighted_dx(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), reco::tau::RecoTauIsolationMasking::resolution(), reco::HcalIsolatedTrackCandidate::SetEtaPhiEcal(), reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), reco::HcalIsolatedTrackCandidate::SetEtaPhiHcal(), l1t::L1Candidate::setHwPhi(), reco::HcalIsolatedTrackCandidate::setL1(), L1Analysis::L1AnalysisRecoMet::SetMet(), L1GObject::setPhi(), FWCaloTowerDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), pat::LeptonJetIsolationAngle::spaceAngle(), reco::TemplatedSoftLeptonTagInfo< REF >::taggingVariables(), l1t::Tau::Tau(), HiFJGridEmptyAreaCalculator::tileIndexPhi(), reco::IsolatedPixelTrackCandidate::towerIndex(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), heppy::FSRWeightAlgo::weight(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().

133 { return m_state.phi(); }
ParticleState m_state
double phi() const
momentum azimuthal angle
virtual const PolarLorentzVector& reco::LeafCandidate::polarP4 ( ) const
inlinefinalvirtual

four-momentum Lorentz vector

Implements reco::Candidate.

Definition at line 101 of file LeafCandidate.h.

References m_state, and reco::ParticleState::polarP4().

Referenced by pat::L1MuonMatcher::produce(), and pat::PATPackedCandidateProducer::produce().

101 { return m_state.polarP4(); }
ParticleState m_state
const PolarLorentzVector & polarP4() const
four-momentum Lorentz vector
Definition: ParticleState.h:82
virtual double reco::LeafCandidate::pt ( ) const
inlinefinalvirtual

transverse momentum

Implements reco::Candidate.

Definition at line 131 of file LeafCandidate.h.

References m_state, and reco::ParticleState::pt().

Referenced by Particle.Particle::__str__(), DiObject.DiMuon::__str__(), reco::tau::RecoTauPiZeroStripPlugin3::addCandsToStrip(), StKinFitter::addKinFitInfo(), reco::tau::RecoTauConstructor::addPiZero(), reco::tau::RecoTauConstructor::addTauChargedHadron(), GlbMuQualityCutsAnalysis::analyze(), FlavorJetCorrectionExample::analyze(), PartonJetCorrectionExample::analyze(), CMSDAS11DijetAnalyzer::analyze(), JetValidation::analyze(), PatTauAnalyzer::analyze(), PatZjetsJetAnalyzer::analyze(), TopGenEventAnalyzer::analyze(), ElectronMcSignalValidatorMiniAOD::analyze(), RPCRecHitProbability::analyze(), QcdHighPtDQM::analyze(), ElectronMcSignalValidator::analyze(), SUSYDQMAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), RPCMonitorDigi::analyze(), EwkMuDQM::analyze(), testAnalyzer::analyze(), EwkElecDQM::analyze(), ZMuMuIsolationAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), QcdPhotonsDQM::analyze(), IsolatedParticlesGeneratedJets::analyze(), EwkDQM::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), MuonPFAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), JetTester::analyze(), HiggsDQM::analyze(), MuTriggerAnalyzer::analyze(), ZMuMu_Radiative_analyzer::analyze(), gamma_radiative_analyzer::analyze(), B2GHadronicHLTValidation::analyze(), B2GSingleLeptonHLTValidation::analyze(), TopSingleLeptonHLTValidation::analyze(), B2GDoubleLeptonHLTValidation::analyze(), METTester::analyze(), DQMExample_Step1::analyze(), TopDiLeptonHLTValidation::analyze(), L1GenTreeProducer::analyze(), HLTMuonMatchAndPlot::analyze(), METMonitor::analyze(), JetTester_HeavyIons::analyze(), DQMPFCandidateAnalyzer::analyze(), JetAnalyzer_HeavyIons::analyze(), IsoTrackCalib::analyze(), JetAnalyzer::analyze(), ErsatzMEt::analyze(), ZToMuMuGammaAnalyzer::analyze(), BeamHaloAnalyzer::analyze(), B2GDQM::analyzeAllHad(), ExoticaDQM::analyzeDisplacedLeptons(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), JetTagPlotter::analyzeTag(), reco::tau::RecoTauVertexAssociator::associatedVertex(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), HPSPFRecoTauAlgorithm::buildOneProng(), PFRecoTauAlgorithm::buildPFTau(), HPSPFRecoTauAlgorithm::buildThreeProngs(), reco::helper::JetIDHelper::calculate(), pat::LeptonJetIsolationAngle::calculate(), GlobalHaloAlgo::Calculate(), FWMuonBuilder::calculateField(), HiFJGridEmptyAreaCalculator::calculateGridRho(), PFMETBenchmark::calculateQuantities(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergy(), ElectronEnergyRegressionEvaluate::calculateRegressionEnergyUncertainty(), l1t::CaloCluster::CaloCluster(), l1t::CaloEmCand::CaloEmCand(), l1t::CaloRegion::CaloRegion(), l1t::CaloSpare::CaloSpare(), l1t::CaloStage1Cluster::CaloStage1Cluster(), l1t::CaloTower::CaloTower(), Photon.Photon::calScaledIsoValueExp(), Photon.Photon::calScaledIsoValueLin(), Photon.Photon::calScaledIsoValueQuadr(), reco::tau::disc::ChargedOutlierPt(), PFAlgo::checkCleaning(), PFMuonAlgo::cleanMismeasured(), PFMuonAlgo::cleanPunchThroughAndFakes(), MuonPFAnalyzer::combRelIso(), CMSDAS11DijetAnalyzer::compare_JetPt(), CMSDAS11DijetTestAnalyzer::compare_JetPt(), compare_l1candidate(), MVAJetPuId::computeIdVariables(), PileupJetIdAlgo::computeIdVariables(), LXXXCorrector::correction(), L1FastjetCorrector::correction(), L1OffsetCorrector::correction(), L6SLBCorrector::correction(), LXXXCorrectorImpl::correction(), L1FastjetCorrectorImpl::correction(), L1OffsetCorrectorImpl::correction(), L6SLBCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), CutBasedPhotonIDAlgo::decideEB(), CutBasedPhotonIDAlgo::decideEE(), PFCandWithSuperClusterExtractor::depositFromObject(), PATTauDiscriminationAgainstElectronMVA6::discriminate(), reco::PFTau::dump(), HLTObjectsMonitor::dzFinder(), l1t::EGamma::EGamma(), WZInterestingEventSelector::electronSelection(), reco::tau::disc::EMFraction(), l1t::EtSum::EtSum(), metsig::SignAlgoResolutions::evalPFJet(), pat::JetCorrFactorsProducer::evaluate(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), PFIsolationEstimator::fGetIsolationInRings(), PFJetMonitor::fill(), SingleTopTChannelLepton_miniAOD::MonitorEnsemble::fill(), TopSingleLepton_miniAOD::MonitorEnsemble::fill(), PFCandidateManager::fill(), BPhysicsValidation::ParticleMonitor::Fill(), TopSingleLepton::MonitorEnsemble::fill(), SingleTopTChannelLepton::MonitorEnsemble::fill(), L1ValidatorHists::Fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), RecoMuonValidator::MuonME::fill(), AdHocNTupler::fill(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), JetMETHLTOfflineSource::fillMEforTriggerNTfired(), METAnalyzer::fillMonitorElement(), PhotonMVAEstimatorRun2Spring16NonTrig::fillMVAVariables(), PhotonMVAEstimatorRun2Phys14NonTrig::fillMVAVariables(), PhotonMVAEstimatorRun2Spring15NonTrig::fillMVAVariables(), ElectronMVAEstimatorRun2Phys14NonTrig::fillMVAVariables(), ElectronMVAEstimatorRun2Spring15Trig::fillMVAVariables(), ElectronMVAEstimatorRun2Spring15NonTrig::fillMVAVariables(), ElectronMVAEstimatorRun2Spring16GeneralPurpose::fillMVAVariables(), ElectronMVAEstimatorRun2Spring16HZZ::fillMVAVariables(), MatchMETBenchmark::fillOne(), PFCandidateBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), HLTHcalMETNoiseCleaner::filter(), reco::tau::RecoTauPhotonFilter::filter(), WMuNuValidator::filter(), BadParticleFilter::filter(), InconsistentMuonPFCandidateFilter::filter(), MuonBadTrackFilter::filter(), WMuNuSelector::filter(), GenHTFilter::filter(), NJetsMC::filter(), WZInterestingEventSelector::filter(), LeptonRecoSkim::filter(), HSCPTreeBuilder::filter(), ElectronMVAEstimatorRun2Phys14NonTrig::findCategory(), ElectronMVAEstimatorRun2Spring15NonTrig::findCategory(), ElectronMVAEstimatorRun2Spring16HZZ::findCategory(), MuonVPlusJetsIDSelectionFunctor::firstDataCuts(), reco::PFCandidate::flag(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), reco::tau::RecoTauVertexAssociator::getLeadTrack(), getTheElectron(), getTheMuon(), getTheTauJet(), MuonGmtPair::gmtPt(), PFCandidateChecker::greaterPt(), l1t::HGCalCluster::HGCalCluster(), l1t::HGCalMulticluster::HGCalMulticluster(), l1t::HGCalTower::HGCalTower(), l1t::HGCalTriggerCell::HGCalTriggerCell(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTHcalNoiseFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EGammaMvaEleEstimator::IDIsoCombinedMvaValue(), EtaPtBin::inBin(), tnp::BaseTreeFiller::init(), reco::tau::xclean::CrossCleanPtrs< PtrIter >::initialize(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), cms::MuonTCMETValueMapProducer::isGoodCaloMuon(), muon::isGoodMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), HiGammaJetSignalDef::IsIsolated(), EwkMuLumiMonitorDQM::IsMuMatchedToHLTMu(), MuTriggerAnalyzer::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), reco::tau::disc::IsolationChargedSumHard(), reco::tau::disc::IsolationChargedSumSoft(), reco::tau::disc::IsolationECALSumHard(), reco::tau::disc::IsolationECALSumSoft(), EGammaMvaEleEstimator::isoMvaValue(), PFEGammaFilters::isPhotonSafeForJetMET(), GsfElectronAlgo::isPreselected(), l1t::Jet::Jet(), DQMPFCandidateAnalyzer::jetSortingRule(), JetAnalyzer::jetSortingRule(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), main(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), PFPhotonIsolationCalculator::matchPFObject(), PFIsolationEstimator::matchPFObject(), DQMExample_Step1::MediumEle(), pat::MHT::mht(), EwkMuLumiMonitorDQM::muIso(), ElectronMVAEstimator::mva(), SoftElectronMVAEstimator::mva(), Electron.Electron::mvaIDLoose(), Electron.Electron::mvaIDRun2(), Electron.Electron::mvaIDTight(), EGammaMvaEleEstimatorCSA14::mvaValue(), EGammaMvaEleEstimator::mvaValue(), AntiElectronIDMVA5::MVAValue(), AntiElectronIDMVA6::MVAValue(), reco::tau::disc::NeutralOutlierPt(), GsfEleEffAreaPFIsoCut::operator()(), PhoAnyPFIsoWithEAAndExpoScalingCut::operator()(), PhoAnyPFIsoWithEAAndExpoScalingEBCut::operator()(), PhoAnyPFIsoWithEAAndQuadScalingCut::operator()(), PhoAnyPFIsoWithEACut::operator()(), GsfEleCalPFClusterIsoCut::operator()(), GenJetSort::operator()(), reco::TrackSelector::operator()(), AcceptJet::operator()(), GenParticleCustomSelector::operator()(), BasicJetSort::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), CaloJetSort::operator()(), TtHadLRJetCombObservables::operator()(), L2TauJetsMerger::SorterByPt::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), WSelector::operator()(), TtSemiLepSignalSelMVATrainer::JetwithHigherPt::operator()(), WPlusJetsEventSelector::operator()(), TtSemiLRJetCombObservables::operator()(), WMuNuProducer::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin::operator()(), reco::tau::PFRecoTauChargedHadronFromTrackPlugin::operator()(), AlignmentMuonSelector::ComparePt::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), reco::tau::RecoTauPiZeroStripPlugin3::operator()(), HPSPFRecoTauAlgorithm::HPSTauPtSorter::operator()(), MuScleFitUtils::byPt::operator()(), reco::operator<<(), l1t::operator>(), reco::tau::disc::OutlierPt(), muon::overlap(), pat::TriggerObjectStandAlone::packP4(), BadGlobalMuonTagger::partnerId(), PFEGammaFilters::passElectronSelection(), PhotonSelectorAlgo::passPhotonSelection(), PFEGammaFilters::passPhotonSelection(), EgammaCutBasedEleId::PassTriggerCuts(), PhotonAnalyzer::photonSelection(), reco::tau::disc::PiZeroPt(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), PatJetAnalyzer::print(), reco::PFRecoTauChargedHadron::print(), reco::GenJet::print(), reco::RecoTauPiZero::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), PFAlgo::processBlock(), MuonWithPFIsoProducer::produce(), DistortedMuonProducerFromDB::produce(), QuarkoniaTrackSelector::produce(), DistortedMuonProducer::produce(), DistortedPFCandProducer::produce(), L1THLTTauMatching::produce(), RegressionEnergyPatElectronProducer::produce(), L1HLTTauMatching::produce(), ISRWeightProducer::produce(), CaloMuonMerger::produce(), reco::ParticleFlowForChargedMETProducer::produce(), PileupJPTJetIdProducer::produce(), MVAJetPuIdProducer::produce(), QjetsAdder::produce(), MuonReSeeder::produce(), EgammaHLTPFChargedIsolationProducer::produce(), MuonMETcorrInputProducer::produce(), EgammaHLTPFNeutralIsolationProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), pat::PATPackedCandidateProducer::produce(), WMuNuProducer::produce(), AlCaHcalNoiseProducer::produce(), BoostedTauSeedsProducer::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), reco::PFMETProducerMVA::produce(), PileupJetIdProducer::produce(), reco::CentralityProducer::produce(), JetPartonMatcher::produce(), SmearedJetProducerT< T >::produce(), reco::tau::disc::Pt(), MuonGmtPair::pt(), egHLT::OffPho::pt(), TauIdMVAAuxiliaries::pt_weighted_dx(), HLTTriMuonIsolation::ptComparer(), Electron.Electron::ptErr(), reco::tau::qcuts::ptMin_cand(), ntupleDataFormat.Track::ptPull(), MuonIsolationDQM::RecordData(), reco::tau::RecoTauPhotonFilter::RecoTauPhotonFilter(), Lepton.Lepton::relIso(), Lepton.Lepton::relIsoFromEA(), Lepton.Lepton::relIsoR(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), reco::tau::disc::ScaledOpeningDeltaR(), Jet.Jet::setCorrP4(), l1t::L1Candidate::setHwPt(), l1t::CaloCluster::setHwPtEm(), l1t::CaloCluster::setHwPtHad(), l1t::CaloCluster::setHwSeedPt(), reco::HcalIsolatedTrackCandidate::setL1(), reco::tau::RecoTauBuilderConePlugin::setTauQuantities(), FWMuonDetailView::setTextInfo(), FWPFCandidateDetailView::setTextInfo(), cms::MuonMETValueMapProducer::should_type_MuonCandidateValuesUsed(), reco::tau::disc::SignalPtFraction(), reco::tau::RecoTauConstructor::sortAndCopyIntoTau(), MuonVPlusJetsIDSelectionFunctor::spring10Cuts(), MuonVPlusJetsIDSelectionFunctor::summer08Cuts(), reco::tau::sumPFCandPt(), l1t::Tau::Tau(), EgammaCutBasedEleId::TestWP(), PFMuonSelector::TopPag12LjetsCuts(), reco::tau::disc::TrackPt(), PFMuonAlgo::tracksWithBetterMET(), PhoAnyPFIsoWithEAAndExpoScalingEBCut::value(), PhoAnyPFIsoWithEAAndQuadScalingCut::value(), GsfEleEffAreaPFIsoCut::value(), PhoAnyPFIsoWithEACut::value(), PhoAnyPFIsoWithEAAndExpoScalingCut::value(), GsfEleCalPFClusterIsoCut::value(), JVFJetIdProducer::~JVFJetIdProducer(), and RecoTauCleanerImpl< Prod >::~RecoTauCleanerImpl().

131 { return m_state.pt();}
ParticleState m_state
double pt() const
transverse momentum
virtual double reco::LeafCandidate::px ( ) const
inlinefinalvirtual

x coordinate of momentum vector

Implements reco::Candidate.

Definition at line 125 of file LeafCandidate.h.

References m_state, and reco::ParticleState::px().

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), HiggsDQM::analyze(), METTester::analyze(), JetAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), TtFullLepHypGenMatch::buildMatchingNeutrinos(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFAlgo::checkCleaning(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), AdHocNTupler::fill(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), WMuNuValidator::filter(), ChargedHadronTrackResolutionFilter::filter(), WMuNuSelector::filter(), HSCPTreeBuilder::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), HLTElectronPFMTFilter< T >::hltFilter(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PseudoTopProducer::produce(), MuonMETcorrInputProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetEnergyShift::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), pat::MET::setCorShift(), TtSemiLepHypothesis::setNeutrino(), pat::MET::setUncShift(), pat::MET::shiftedP2(), pat::MET::shiftedP2_74x(), pat::MET::shiftedP3(), pat::MET::shiftedP3_74x(), pat::MET::shiftedP4(), pat::MET::shiftedP4_74x(), reco::MET::significance(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), TauValidation::visibleTauEnergy(), and reco::WMuNuCandidatePtr::WMuNuCandidatePtr().

125 { return m_state.px(); }
double px() const
x coordinate of momentum vector
ParticleState m_state
virtual double reco::LeafCandidate::py ( ) const
inlinefinalvirtual

y coordinate of momentum vector

Implements reco::Candidate.

Definition at line 127 of file LeafCandidate.h.

References m_state, and reco::ParticleState::py().

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), ElectronMcSignalValidator::analyze(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), HiggsDQM::analyze(), METTester::analyze(), JetAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), TtFullLepHypGenMatch::buildMatchingNeutrinos(), reco::FlavorHistoryEvent::cache(), razor::CalcMTR(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFAlgo::checkCleaning(), PFMuonAlgo::cleanMismeasured(), AddCorrectionsToGenericMET::constructP4From(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), L1JetRecoTreeProducer::doPFMet(), AdHocNTupler::fill(), EwkElecTauHistManager::fillHistograms(), EwkMuTauHistManager::fillHistograms(), METAnalyzer::fillMonitorElement(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), WMuNuValidator::filter(), ChargedHadronTrackResolutionFilter::filter(), WMuNuSelector::filter(), HSCPTreeBuilder::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), PFMuonAlgo::getMinMaxMET2(), metsig::METSignificance::getSignificance(), HLTElectronPFMTFilter< T >::hltFilter(), PFPhotonIsolationCalculator::isChargedParticleVetoed(), PFIsolationEstimator::isChargedParticleVetoed(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), CalculateHLT::operator()(), Calculate_miniAOD::operator()(), Calculate::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenericJet::print(), MEzCalculator::Print(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), MuonMETcorrInputProducer::produce(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), NoPileUpPFMEtProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetEnergyShift::produce(), JetPlusTrackProducer::produce(), reco::PFMETProducerMVA::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), pat::PATMETSlimmer::OneMETShift::readAndSet(), Type1PFMET::run(), pat::MET::setCorShift(), TtSemiLepHypothesis::setNeutrino(), pat::MET::setUncShift(), pat::MET::shiftedP2(), pat::MET::shiftedP2_74x(), pat::MET::shiftedP3(), pat::MET::shiftedP3_74x(), pat::MET::shiftedP4(), pat::MET::shiftedP4_74x(), reco::MET::significance(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), and TauValidation::visibleTauEnergy().

127 { return m_state.py(); }
ParticleState m_state
double py() const
y coordinate of momentum vector
virtual double reco::LeafCandidate::pz ( ) const
inlinefinalvirtual

z coordinate of momentum vector

Implements reco::Candidate.

Definition at line 129 of file LeafCandidate.h.

References m_state, and reco::ParticleState::pz().

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), EwkMuDQM::analyze(), EwkElecDQM::analyze(), HiggsDQM::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), FWPFCandidateWithHitsProxyBuilder::build(), FWPFCandidate3DProxyBuilder::build(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), L1JPTOffsetCorrector::correction(), L1JPTOffsetCorrectorImpl::correction(), JetPlusTrackCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), AdHocNTupler::fill(), HSCPTreeBuilder::filter(), TtSemiLepKinFitter::fit(), TtFullHadKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), ExoticaDQM::getGenParticleTrajectoryAtBeamline(), TauValidation::leadingPionP4(), reco::IsolatedTauTagInfo::leadingSignalTrack(), main(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TauValidation::motherP4(), TtSemiLRSignalSelObservables::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::GenericJet::print(), MEzCalculator::Print(), METzCalculator::Print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), SoftPFMuonTagInfoProducer::produce(), SoftPFElectronTagInfoProducer::produce(), WMuNuProducer::produce(), Onia2MuMuPAT::produce(), JetPlusTrackProducer::produce(), JetPlusTrackProducerAA::produce(), BoostedTopProducer::produce(), setPz(), TauValidation::spinEffectsZH(), ImpactParameterAlgorithm::tag(), and TauValidation::visibleTauEnergy().

129 { return m_state.pz(); }
double pz() const
z coordinate of momentum vector
ParticleState m_state
virtual double reco::LeafCandidate::rapidity ( ) const
inlinefinalvirtual

rapidity

Implements reco::Candidate.

Definition at line 139 of file LeafCandidate.h.

References m_state, and reco::ParticleState::rapidity().

Referenced by BPHCompositeBasicSelect::accept(), B2GDQM::analyzeAllHad(), B2GDQM::analyzeSemiE(), B2GDQM::analyzeSemiMu(), and y().

139 { return m_state.rapidity(); }
double rapidity() const
repidity
ParticleState m_state
virtual void reco::LeafCandidate::setCharge ( Charge  q)
inlinefinalvirtual
virtual void reco::LeafCandidate::setLongLived ( )
inlinefinalvirtual

long lived flag set long lived flag

Implements reco::Candidate.

Definition at line 170 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setLongLived().

170 { m_state.setLongLived(); }
ParticleState m_state
void setLongLived()
set long lived flag
virtual void reco::LeafCandidate::setMass ( double  m)
inlinefinalvirtual

set particle mass

Implements reco::Candidate.

Definition at line 147 of file LeafCandidate.h.

References funct::m, m_state, and reco::ParticleState::setMass().

Referenced by RecoTauPiZeroProducer::produce().

147 {m_state.setMass(m);}
ParticleState m_state
void setMass(double m)
set particle mass
virtual void reco::LeafCandidate::setMassConstraint ( )
inlinefinalvirtual

do mass constraint flag set mass constraint flag

Implements reco::Candidate.

Definition at line 175 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setMassConstraint().

void setMassConstraint()
set mass constraint flag
ParticleState m_state
virtual void reco::LeafCandidate::setP4 ( const LorentzVector p4)
inlinefinalvirtual

set 4-momentum

Implements reco::Candidate.

Definition at line 143 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setP4().

Referenced by l1t::HGCalClusterT< l1t::HGCalCluster >::addConstituent(), ParticleLevelProducer::addGenJet(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::beginEvent(), HPSPFRecoTauAlgorithm::buildPFTau(), HGCalTriggerCellCalibration::calibrateMipTinGeV(), PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), TtFullHadKinFitter::KinFit::corJet(), reco::GsfElectron::Corrections::Corrections(), PFRecoTauDiscriminationByIsolation::discriminate(), reco::Photon::EnergyCorrections::EnergyCorrections(), pat::GenericParticle::fillInFrom(), l1t::MuonRawDigiTranslator::fillMuon(), pat::PATMuonProducer::fillMuon(), PFEGammaAlgo::fillPFCandidates(), MuScleFitFilter::filter(), L1GObject::initialize(), OniaPhotonConversionProducer::makePhotonCandidate(), TransientVertex::operator reco::VertexCompositePtrCandidate(), reco::tau::RecoTauPhotonFilter::operator()(), reco::tau::PFRecoTauMassPlugin::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::tau::PFRecoTauEnergyAlgorithmPlugin::operator()(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), reco::operator<<(), pat::TriggerObjectStandAlone::packP4(), reco::PFTauDecayMode::PFTauDecayMode(), PFAlgo::processBlock(), l1t::Stage2Layer2EGammaAlgorithmFirmwareImp1::processEvent(), ParticleLevelProducer::produce(), DistortedMuonProducerFromDB::produce(), DistortedPFCandProducer::produce(), DistortedMuonProducer::produce(), HLTTriMuonIsolation::produce(), PuppiPhoton::produce(), GlobalMuonToMuonProducer::produce(), DeltaBetaWeights::produce(), ShiftedPFCandidateProducerByMatchedObject::produce(), NoPileUpPFMEtProducer::produce(), pat::PATJetUpdater::produce(), PFLinker::produce(), ShiftedPFCandidateProducerForPFMVAMEt::produce(), Onia2MuMuPAT::produce(), NoPileUpPFMEtDataProducer::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), ShiftedPFCandidateProducerForPFNoPUMEt::produce(), reco::PFMETProducerMVA::produce(), SoftKillerProducer::produce(), MuonProducer::produce(), HPSPFRecoTauAlgorithm::refitThreeProng(), reco::PFCandidate::rescaleMomentum(), PFPhotonAlgo::RunPFPhoton(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), reco::tau::setChargedHadronP4(), Jet.Jet::setCorrP4(), MEzCalculator::SetLepton(), MEzCalculator::SetMET(), METzCalculator::SetMET(), METzCalculator::SetMuon(), l1t::stage2::EGammaUnpacker::unpack(), l1t::stage2::MPUnpacker::unpack(), l1t::stage2::EtSumUnpacker::unpack(), l1t::stage2::JetUnpacker::unpack(), l1t::stage2::MPUnpacker_0x10010033::unpack(), l1t::stage2::MPUnpacker_0x10010010::unpack(), l1t::stage2::TauUnpacker::unpack(), and l1t::stage2::MPUnpacker_0x1001000b::unpack().

143 { m_state.setP4(p4);}
ParticleState m_state
void setP4(const LorentzVector &p4)
set 4-momentum
virtual const LorentzVector & p4() const final
four-momentum Lorentz vector
Definition: LeafCandidate.h:99
virtual void reco::LeafCandidate::setP4 ( const PolarLorentzVector p4)
inlinefinalvirtual

set 4-momentum

Implements reco::Candidate.

Definition at line 145 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setP4().

Referenced by Jet.Jet::setCorrP4().

145 {m_state.setP4(p4); }
ParticleState m_state
void setP4(const LorentzVector &p4)
set 4-momentum
virtual const LorentzVector & p4() const final
four-momentum Lorentz vector
Definition: LeafCandidate.h:99
virtual void reco::LeafCandidate::setPdgId ( int  pdgId)
inlinefinalvirtual
virtual void reco::LeafCandidate::setPz ( double  pz)
inlinefinalvirtual

Implements reco::Candidate.

Definition at line 148 of file LeafCandidate.h.

References m_state, pz(), and reco::ParticleState::setPz().

Referenced by BoostedTopProducer::produce().

148 { m_state.setPz(pz);}
void setPz(double pz)
ParticleState m_state
virtual double pz() const final
z coordinate of momentum vector
virtual void reco::LeafCandidate::setStatus ( int  status)
inlinefinalvirtual
virtual void reco::LeafCandidate::setThreeCharge ( Charge  qx3)
inlinefinalvirtual

set electric charge

Implements reco::Candidate.

Definition at line 97 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setThreeCharge().

Referenced by GenParticleProducer::convertParticle().

97 {m_state.setThreeCharge(qx3); }
ParticleState m_state
void setThreeCharge(Charge qx3)
set electric charge
Definition: ParticleState.h:78
virtual void reco::LeafCandidate::setVertex ( const Point vertex)
inlinevirtual

set vertex

Implements reco::Candidate.

Reimplemented in reco::PFCandidate, and reco::Photon.

Definition at line 158 of file LeafCandidate.h.

References m_state, and reco::ParticleState::setVertex().

Referenced by ParticleLevelProducer::addGenJet(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), pat::GenericParticle::fillInFrom(), reco::GsfElectron::GsfElectron(), OniaPhotonConversionProducer::makePhotonCandidate(), TransientVertex::operator reco::VertexCompositePtrCandidate(), TemplatedSecondaryVertexProducer< IPTI, VTX >::SVBuilder::operator()(), ParticleLevelProducer::produce(), L2TauPixelTrackMatch::produce(), HLTTriMuonIsolation::produce(), GlobalMuonToMuonProducer::produce(), FastjetJetProducer::produceTrackJets(), HPSPFRecoTauAlgorithm::refitThreeProng(), CandCommonVertexFitterBase::set(), PFCandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), reco::V0Candidate::setVertex(), reco::PFCandidate::setVertex(), and reco::PFCandidate::setVertexSource().

virtual const Point & vertex() const
vertex position (overwritten by PF...)
ParticleState m_state
void setVertex(const Point &vertex)
set vertex
virtual CandidatePtr reco::LeafCandidate::sourceCandidatePtr ( size_type  i) const
inlinevirtual

return a Ptr to one of the source Candidates ( the candidates used to construct this Candidate)

Reimplemented from reco::Candidate.

Reimplemented in pat::Photon, pat::Tau, pat::Electron, reco::PFTau, pat::Muon, reco::PFCandidate, reco::LeafRefCandidateT, and reco::CompositePtrCandidate.

Definition at line 86 of file LeafCandidate.h.

Referenced by reco::operator<<().

86  {
87  return CandidatePtr();
88  }
edm::Ptr< Candidate > CandidatePtr
persistent reference to an object in a collection of Candidate objects
Definition: CandidateFwd.h:25
virtual int reco::LeafCandidate::status ( ) const
inlinefinalvirtual

status word

Implements reco::Candidate.

Definition at line 165 of file LeafCandidate.h.

References m_state, and reco::ParticleState::status().

Referenced by TauDecay_GenParticle::AddPi0Info(), EWKSystUnc::analyze(), ZLONLOHistogrammer::analyze(), zPdfUnc::analyze(), ZMuPtScaleAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), TauDecay_GenParticle::Analyze(), ResolutionCreator::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), L1GenTreeProducer::analyze(), L1Validator::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), GeneratorTau::computeDecayMode(), GeneratorTau::computeStableDecayProducts(), GeneratorTau::decayToPDGClassification(), TopDecaySubset::fillListing(), HeavyQuarkFromMPIFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), BCToEFilterAlgo::filter(), HighETPhotonsFilterAlgo::filter(), HSCPTreeBuilder::filter(), EMEnrichingFilterAlgo::filterIsoGenPar(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), TopDecaySubset::findLastParticleInChain(), GenParticlesHelper::findParticles(), pat::PATObject< ObjectType >::genParticleById(), GenParticlesHelper::hasAncestor(), HeavyQuarkFromMPIFilterAlgo::hasMPIAncestor(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), LeafCandidate(), GenParticleCustomSelector::operator()(), WeakEffectsWeightProducer::produce(), ISRGammaWeightProducer::produce(), MCTrackMatcher::produce(), FSRWeightProducer::produce(), ISRWeightProducer::produce(), PdfWeightProducer::produce(), PartonSelector::produce(), pat::PATPackedGenParticleProducer::produce(), JetPartonMatcher::produce(), setStatus(), TauValidation::tauDecayChannel(), HistoryBase::traceRecoGenHistory(), reco::VertexCompositeCandidate::VertexCompositeCandidate(), reco::VertexCompositePtrCandidate::VertexCompositePtrCandidate(), and heppy::FSRWeightAlgo::weight().

165 { return m_state.status(); }
ParticleState m_state
int status() const
status word
virtual double reco::LeafCandidate::theta ( ) const
inlinefinalvirtual
virtual int reco::LeafCandidate::threeCharge ( ) const
inlinefinalvirtual

electric charge

Implements reco::Candidate.

Definition at line 95 of file LeafCandidate.h.

References m_state, and reco::ParticleState::threeCharge().

Referenced by TopDecaySubset::fillListing().

95 { return m_state.threeCharge(); }
int threeCharge() const
electric charge
Definition: ParticleState.h:76
ParticleState m_state
virtual const Point& reco::LeafCandidate::vertex ( ) const
inlinevirtual

vertex position (overwritten by PF...)

Implements reco::Candidate.

Reimplemented in reco::PFCandidate.

Definition at line 150 of file LeafCandidate.h.

References m_state, and reco::ParticleState::vertex().

Referenced by MultiTrackValidatorGenPs::analyze(), ElectronMcSignalValidator::analyze(), ElectronTagProbeAnalyzer::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronMCFakeAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), ExoticaDQM::analyzeDisplacedLeptons(), BoostedTauSeedsProducer::BoostedTauSeedsProducer(), reco::Photon::caloPosition(), PFMEtSignInterfaceBase::compResolution(), reco::TemplatedSecondaryVertex< SV >::computeDist1d(), reco::TemplatedSecondaryVertex< SV >::computeDist2d(), reco::TemplatedSecondaryVertex< SV >::computeDist3d(), PFTauExtractor::depositFromObject(), PFCandWithSuperClusterExtractor::depositFromObject(), reco::CaloJet::detectorP4(), Tau.Tau::dxy(), ErsatzMEt::ersatzFabrik(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), TopDecaySubset::fillListing(), PF_PU_AssoMapAlgos::FindV0Vertex(), BtoCharmDecayVertexMergerT< VTX >::flightDirection(), flightDirection(), AddCorrectionsToGenericMET::getCorrectedCaloMET(), AddCorrectionsToGenericMET::getCorrectedMET(), AddCorrectionsToGenericMET::getCorrectedPFMET(), MuonMETAlgo::GetMuDepDeltas(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), fireworks::makeEveJetCone(), reco::CaloJet::n60(), reco::Jet::nConstituents(), GenParticleCustomSelector::operator()(), CorrectJet::operator()(), reco::LeafRefCandidateT::overlap(), overlap(), EgammaHLTTrackIsolation::photonIsolation(), reco::CaloJet::physicsP4(), reco::VertexCompositePtrCandidate::position(), position(), pat::PATSecondaryVertexSlimmer::produce(), pat::PATTrackAndVertexUnpacker::produce(), Type1PFMET::run(), reco::TemplatedSecondaryVertexTagInfo< reco::CandIPTagInfo, reco::VertexCompositePtrCandidate >::secondaryVertex(), TtFullHadHypothesis::setCandidate(), TtFullLepHypothesis::setCandidate(), TtSemiLepHypothesis::setCandidate(), TtSemiLepHypothesis::setNeutrino(), TtSemiEvtSolution::setupHyp(), and reco::PFCandidate::vertex().

150 { return m_state.vertex(); }
ParticleState m_state
const Point & vertex() const
vertex position
double LeafCandidate::vertexChi2 ( ) const
virtual

chi-squares

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate, and reco::VertexCompositePtrCandidate.

Definition at line 66 of file LeafCandidate.cc.

Referenced by clone().

66  {
67  return 0;
68 }
double LeafCandidate::vertexCovariance ( int  i,
int  j 
) const
virtual

(i, j)-th element of error matrix, i, j = 0, ... 2

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate, and reco::VertexCompositePtrCandidate.

Definition at line 78 of file LeafCandidate.cc.

References Exception, and edm::errors::UnimplementedFeature.

78  {
80  << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
81 }
CovarianceMatrix reco::LeafCandidate::vertexCovariance ( ) const
inlinefinalvirtual
double LeafCandidate::vertexNdof ( ) const
virtual

Number of degrees of freedom Meant to be Double32_t for soft-assignment fitters: tracks may contribute to the vertex with fractional weights. The ndof is then = to the sum of the track weights. see e.g. CMS NOTE-2006/032, CMS NOTE-2004/002

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate, and reco::VertexCompositePtrCandidate.

Definition at line 70 of file LeafCandidate.cc.

Referenced by clone().

70  {
71  return 0;
72 }
double LeafCandidate::vertexNormalizedChi2 ( ) const
virtual

chi-squared divided by n.d.o.f.

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate, and reco::VertexCompositePtrCandidate.

Definition at line 74 of file LeafCandidate.cc.

Referenced by clone().

74  {
75  return 0;
76 }
virtual double reco::LeafCandidate::vx ( ) const
inlinevirtual
virtual double reco::LeafCandidate::vy ( ) const
inlinevirtual
virtual double reco::LeafCandidate::vz ( ) const
inlinevirtual
virtual double reco::LeafCandidate::y ( ) const
inlinefinalvirtual

Friends And Related Function Documentation

friend class ::OverlapChecker
friend

Definition at line 268 of file LeafCandidate.h.

template<typename , typename , typename >
friend struct component
friend

Definition at line 267 of file LeafCandidate.h.

friend class ShallowCloneCandidate
friend

Definition at line 269 of file LeafCandidate.h.

friend class ShallowClonePtrCandidate
friend

Definition at line 270 of file LeafCandidate.h.

Member Data Documentation

ParticleState reco::LeafCandidate::m_state
private