CMS 3D CMS Logo

Classes | Public Types | Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Private Types | Friends

reco::LeafCandidate Class Reference

#include <LeafCandidate.h>

Inheritance diagram for reco::LeafCandidate:
reco::Candidate CaloTower reco::CompositeRefCandidateT< GenParticleRefVector > l1extra::L1EmParticle l1extra::L1EtMissParticle l1extra::L1JetParticle l1extra::L1MuonParticle 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::RecoCandidate reco::ShallowCloneCandidate reco::ShallowClonePtrCandidate

List of all members.

Classes

struct  GCC11_FINAL

Public Types

typedef int Charge
 electric charge type
typedef CandidateCollection daughters
 collection of daughter candidates
typedef unsigned int index
 index type
typedef math::XYZTLorentzVector LorentzVector
 Lorentz vector.
typedef math::XYZPoint Point
 point in the space
typedef
math::PtEtaPhiMLorentzVector 
PolarLorentzVector
 Lorentz vector.
typedef math::XYZVector Vector
 point in the space

Public Member Functions

virtual const_iterator begin () const
 first daughter const_iterator
virtual iterator begin ()
 first daughter iterator
template<typename S >
daughter_iterator< S >::type beginFilter (const S &s) const
virtual Vector boostToCM () const GCC11_FINAL
virtual int charge () const GCC11_FINAL
 electric charge
virtual LeafCandidateclone () const
 returns a clone of the Candidate object
virtual Candidatedaughter (size_type)
 return daughter at a given position (throws an exception)
virtual Candidatedaughter (const std::string &s)
 return daughter with a specified role name
virtual const Candidatedaughter (const std::string &s) const
 return daughter with a specified role name
virtual const Candidatedaughter (size_type) const
 return daughter at a given position (throws an exception)
virtual const_iterator end () const
 last daughter const_iterator
virtual iterator end ()
 last daughter iterator
template<typename S >
daughter_iterator< S >::type endFilter (const S &s) const
virtual double energy () const GCC11_FINAL
 energy
virtual double et () const GCC11_FINAL
 transverse energy
virtual float eta () const GCC11_FINAL
 momentum pseudorapidity
virtual void fillVertexCovariance (CovarianceMatrix &v) const
 fill SMatrix
template<typename T >
T get () const
 get a component
template<typename T , typename Tag >
T get () const
 get a component
template<typename T >
T get (size_type i) const
 get a component
template<typename T , typename Tag >
T get (size_type i) const
 get a component
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 (Charge q, const PtEtaPhiMass &p4, const Point &vtx=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true)
 constructor from values
 LeafCandidate ()
 default constructor
 LeafCandidate (Charge q, const LorentzVector &p4, const Point &vtx=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true)
 constructor from values
 LeafCandidate (const Candidate &c)
template<typename P4 >
 LeafCandidate (Charge q, const P4 &p4, const Point &vtx=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true)
 constructor from Any values
 LeafCandidate (Charge q, const PolarLorentzVector &p4, const Point &vtx=Point(0, 0, 0), int pdgId=0, int status=0, bool integerCharge=true)
 constructor from values
virtual bool longLived () const GCC11_FINAL
 is long lived?
virtual float mass () const GCC11_FINAL
 mass
virtual bool massConstraint () const GCC11_FINAL
 do mass constraint?
virtual float massSqr () const GCC11_FINAL
 mass squared
virtual const CandidateBaseRefmasterClone () const
virtual const CandidatePtrmasterClonePtr () const
template<typename Ref >
Ref masterRef () const
 cast master clone reference to a concrete type
virtual Vector momentum () const GCC11_FINAL
 spatial momentum vector
virtual const Candidatemother (size_type) const
 return mother at a given position (throws an exception)
virtual double mt () const GCC11_FINAL
 transverse mass
virtual double mtSqr () const GCC11_FINAL
 transverse mass squared
template<typename T >
size_type numberOf () const
 number of components
template<typename T , typename Tag >
size_type numberOf () const
 number of components
virtual size_t numberOfDaughters () const
 number of daughters
virtual size_t numberOfMothers () const
 number of mothers
virtual size_t numberOfSourceCandidatePtrs () const
virtual double p () const GCC11_FINAL
 magnitude of momentum vector
virtual const LorentzVectorp4 () const GCC11_FINAL
 four-momentum Lorentz vector
virtual int pdgId () const GCC11_FINAL
 PDG identifier.
virtual float phi () const GCC11_FINAL
 momentum azimuthal angle
virtual const PolarLorentzVectorpolarP4 () const GCC11_FINAL
 four-momentum Lorentz vector
virtual float pt () const GCC11_FINAL
 transverse momentum
virtual double px () const GCC11_FINAL
 x coordinate of momentum vector
virtual double py () const GCC11_FINAL
 y coordinate of momentum vector
virtual double pz () const GCC11_FINAL
 z coordinate of momentum vector
virtual double rapidity () const GCC11_FINAL
 rapidity
virtual void setCharge (Charge q) GCC11_FINAL
 set electric charge
virtual void setLongLived () GCC11_FINAL
 set long lived flag
virtual void setMass (double m) GCC11_FINAL
 set particle mass
virtual void setMassConstraint () GCC11_FINAL
 set mass constraint flag
virtual void setP4 (const PolarLorentzVector &p4) GCC11_FINAL
 set 4-momentum
virtual void setP4 (const LorentzVector &p4) GCC11_FINAL
 set 4-momentum
virtual void setPdgId (int pdgId) GCC11_FINAL
virtual void setPz (double pz) GCC11_FINAL
virtual void setStatus (int status) GCC11_FINAL
 set status word
virtual void setThreeCharge (Charge qx3) GCC11_FINAL
 set electric charge
virtual void setVertex (const Point &vertex)
 set vertex
virtual CandidatePtr sourceCandidatePtr (size_type i) const
virtual int status () const GCC11_FINAL
 status word
virtual double theta () const GCC11_FINAL
 momentum polar angle
virtual int threeCharge () const GCC11_FINAL
 electric charge
virtual const Pointvertex () const
 vertex position (overwritten by PF...)
virtual double vertexChi2 () const
 chi-squares
virtual double vertexCovariance (int i, int j) const
 (i, j)-th element of error matrix, i, j = 0, ... 2
CovarianceMatrix vertexCovariance () const GCC11_FINAL
 return SMatrix
virtual double vertexNdof () const
virtual double vertexNormalizedChi2 () const
 chi-squared divided by n.d.o.f.
virtual double vx () const
 x coordinate of vertex position
virtual double vy () const
 y coordinate of vertex position
virtual double vz () const
 z coordinate of vertex position
virtual double y () const GCC11_FINAL
 rapidity
virtual ~LeafCandidate ()
 destructor

Static Public Attributes

static const unsigned int longLivedTag = 65536
 long lived flag
static const unsigned int massConstraintTag = 131072
 do mass constraint flag

Protected Member Functions

void cacheCartesian () const
 set internal cache
void cachePolar () const
 set internal cache
void clearCache () const
 clear internal cache
virtual bool overlap (const Candidate &) const
 check overlap with another Candidate

Protected Attributes

bool cacheCartesianFixed_
bool cachePolarFixed_
 has cache been set?
float eta_
float mass_
LorentzVector p4Cartesian_
 internal cache for p4
PolarLorentzVector p4Polar_
 internal cache for p4
int pdgId_
 PDG identifier.
float phi_
float pt_
 four-momentum Lorentz vector
Charge qx3_
 electric charge
int status_
 status word
Point vertex_
 vertex position

Private Types

typedef
candidate::const_iterator_imp_specific
< daughters
const_iterator_imp_specific
typedef
candidate::iterator_imp_specific
< daughters
iterator_imp_specific

Friends

class ::OverlapChecker
struct component
class ShallowCloneCandidate
class ShallowClonePtrCandidate

Detailed Description

particle candidate with no constituent nor daughters

Author:
Luca Lista, INFN

Definition at line 19 of file LeafCandidate.h.


Member Typedef Documentation

electric charge type

Reimplemented from reco::Candidate.

Definition at line 24 of file LeafCandidate.h.

typedef unsigned int reco::LeafCandidate::index

index type

Reimplemented from reco::Candidate.

Definition at line 34 of file LeafCandidate.h.

Lorentz vector.

Reimplemented from reco::Candidate.

Definition at line 26 of file LeafCandidate.h.

point in the space

Reimplemented from reco::Candidate.

Definition at line 30 of file LeafCandidate.h.

Lorentz vector.

Reimplemented from reco::Candidate.

Definition at line 28 of file LeafCandidate.h.

point in the space

Reimplemented from reco::Candidate.

Definition at line 32 of file LeafCandidate.h.


Constructor & Destructor Documentation

reco::LeafCandidate::LeafCandidate ( ) [inline]

default constructor

Definition at line 37 of file LeafCandidate.h.

Referenced by clone().

                    : 
      qx3_(0), pt_(0), eta_(0), phi_(0), mass_(0), 
      vertex_(0, 0, 0), pdgId_(0), status_(0),
      cachePolarFixed_( false ), cacheCartesianFixed_( false ) { }
reco::LeafCandidate::LeafCandidate ( const Candidate c) [inline, explicit]

Definition at line 42 of file LeafCandidate.h.

                                                 :
    qx3_( c.charge()*3 ), pt_( c.p4().pt() ), eta_( c.p4().eta() ), phi_( c.p4().phi() )
    , mass_( c.p4().mass() ),
    vertex_( c.vertex() ), pdgId_( c.pdgId() ), status_( c.status() ),
    cachePolarFixed_( false ), cacheCartesianFixed_( false ) {}
template<typename P4 >
reco::LeafCandidate::LeafCandidate ( Charge  q,
const P4 &  p4,
const Point vtx = Point( 0, 0, 0 ),
int  pdgId = 0,
int  status = 0,
bool  integerCharge = true 
) [inline]

constructor from Any values

Definition at line 50 of file LeafCandidate.h.

                                                                              :
      qx3_(integerCharge ? 3*q : q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ),
      vertex_( vtx ), pdgId_( pdgId ), status_( status ),
      cachePolarFixed_( false ), cacheCartesianFixed_( false ) {}
reco::LeafCandidate::LeafCandidate ( Charge  q,
const PtEtaPhiMass &  p4,
const Point vtx = Point( 0, 0, 0 ),
int  pdgId = 0,
int  status = 0,
bool  integerCharge = true 
) [inline]

constructor from values

Definition at line 58 of file LeafCandidate.h.

                                                                              :
      qx3_(integerCharge ? 3*q : q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ),
      vertex_( vtx ), pdgId_( pdgId ), status_( status ),
      cachePolarFixed_( false ), cacheCartesianFixed_( false ) {}
reco::LeafCandidate::LeafCandidate ( Charge  q,
const LorentzVector p4,
const Point vtx = Point( 0, 0, 0 ),
int  pdgId = 0,
int  status = 0,
bool  integerCharge = true 
) [inline]

constructor from values

Definition at line 65 of file LeafCandidate.h.

References qx3_.

                                                                              :
      qx3_( q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ),
      vertex_( vtx ), pdgId_( pdgId ), status_( status ),
      cachePolarFixed_( false ), cacheCartesianFixed_( false ) {
      if ( integerCharge ) qx3_ *= 3;
    }
reco::LeafCandidate::LeafCandidate ( Charge  q,
const PolarLorentzVector p4,
const Point vtx = Point( 0, 0, 0 ),
int  pdgId = 0,
int  status = 0,
bool  integerCharge = true 
) [inline]

constructor from values

Definition at line 73 of file LeafCandidate.h.

References qx3_.

                                                                              :
      qx3_( q ), pt_( p4.pt() ), eta_( p4.eta() ), phi_( p4.phi() ), mass_( p4.mass() ),
      vertex_( vtx ), pdgId_( pdgId ), status_( status ),
      cachePolarFixed_( false ), cacheCartesianFixed_( false ){
      if ( integerCharge ) qx3_ *= 3;
    }
LeafCandidate::~LeafCandidate ( ) [virtual]

destructor

Definition at line 6 of file LeafCandidate.cc.

{ }

Member Function Documentation

Candidate::const_iterator LeafCandidate::begin ( void  ) const [virtual]
Candidate::iterator LeafCandidate::begin ( void  ) [virtual]
template<typename S >
daughter_iterator<S>::type reco::LeafCandidate::beginFilter ( const S &  s) const [inline]

Reimplemented from reco::Candidate.

Definition at line 307 of file LeafCandidate.h.

References begin(), and end().

                                                                         {
      return boost::make_filter_iterator(s, begin(), end());
    }
virtual Vector reco::LeafCandidate::boostToCM ( ) const [inline, virtual]

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

Implements reco::Candidate.

Definition at line 130 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

{ cacheCartesian(); return p4Cartesian_.BoostToCM(); }
void reco::LeafCandidate::cacheCartesian ( ) const [inline, protected]

set internal cache

Definition at line 350 of file LeafCandidate.h.

References cacheCartesianFixed_, cachePolar(), p4Cartesian_, and p4Polar_.

Referenced by boostToCM(), energy(), momentum(), p(), p4(), px(), py(), pz(), setPz(), and theta().

void reco::LeafCandidate::cachePolar ( ) const [inline, protected]

set internal cache

Definition at line 344 of file LeafCandidate.h.

References cachePolarFixed_, eta_, mass_, p4Polar_, phi_, and pt_.

Referenced by cacheCartesian(), et(), mt(), mtSqr(), polarP4(), and rapidity().

virtual int reco::LeafCandidate::charge ( ) const [inline, virtual]

electric charge

Implements reco::Candidate.

Definition at line 115 of file LeafCandidate.h.

References qx3_.

Referenced by ElectronMcFakeValidator::analyze(), HLTMuonMatchAndPlot::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcSignalValidator::analyze(), TauMVATrainer::analyze(), PFTester::analyze(), GsfElectronMCFakeAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), EwkMuDQM::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidate3DProxyBuilder::build(), FWPFCandidateWithHitsProxyBuilder::build(), egHLT::OffEle::charge(), reco::PFTau::dump(), RecoMuonValidator::MuonME::fill(), EwkElecTauHistManager::fillHistograms(), HLTOniaSource::fillOniaTriggerMEs(), HSCPTreeBuilder::filter(), WZInterestingEventSelector::filter(), WMuNuSelector::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), pat::PATObject< ObjectType >::genParticleById(), MuonMETAlgo::GetMuDepDeltas(), HLTMuonTrackMassFilter::hltFilter(), reco::tau::disc::mainTrack(), GenParticleCustomSelector::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::operator<<(), overlap(), reco::PFTauDecayMode::PFTauDecayMode(), QuarkoniaTrackSelector::produce(), ParticleReplacerClass::produce(), pat::L1MuonMatcher::produce(), ClassBasedElectronID::result(), MuScleFitMuonSelector::selectMuons(), FWElectronDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), reco::PFCandidate::setTrackRef(), reco::tau::sumPFCandCharge(), PFRootEventManager::tauBenchmark(), and reco::PFCandidate::translateTypeToPdgId().

{ return qx3_ / 3; }
void reco::LeafCandidate::clearCache ( ) const [inline, protected]

clear internal cache

Definition at line 357 of file LeafCandidate.h.

References cacheCartesianFixed_, and cachePolarFixed_.

Referenced by setMass().

                                   {
      cachePolarFixed_ = false;
      cacheCartesianFixed_ = false;
    }
virtual LeafCandidate* reco::LeafCandidate::clone ( void  ) const [inline, virtual]
Candidate * LeafCandidate::daughter ( const std::string &  s) [virtual]

return daughter with a specified role name

Implements reco::Candidate.

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

Definition at line 71 of file LeafCandidate.cc.

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

                                                    {
  throw edm::Exception(edm::errors::UnimplementedFeature)
    << "This Candidate type does not implement daughter(std::string). "
    << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
}
Candidate * LeafCandidate::daughter ( size_type  ) [virtual]
const Candidate * LeafCandidate::daughter ( const std::string &  s) const [virtual]

return daughter with a specified role name

Implements reco::Candidate.

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

Definition at line 65 of file LeafCandidate.cc.

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

                                                                {
  throw edm::Exception(edm::errors::UnimplementedFeature)
    << "This Candidate type does not implement daughter(std::string). "
    << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
}
const Candidate * LeafCandidate::daughter ( size_type  ) const [virtual]
Candidate::const_iterator LeafCandidate::end ( void  ) const [virtual]
Candidate::iterator LeafCandidate::end ( void  ) [virtual]
template<typename S >
daughter_iterator<S>::type reco::LeafCandidate::endFilter ( const S &  s) const [inline]

Reimplemented from reco::Candidate.

Definition at line 311 of file LeafCandidate.h.

References end().

                                                                       {
      return boost::make_filter_iterator(s, end(), end());
    }
virtual double reco::LeafCandidate::energy ( ) const [inline, virtual]

energy

Implements reco::Candidate.

Definition at line 134 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), JetValidation::analyze(), PhotonValidator::analyze(), ResolutionCreator::analyze(), QcdHighPtDQM::analyze(), IsolatedParticlesGeneratedJets::analyze(), ZdcSimHitStudy::analyze(), HLTMonBTagIPSource::analyze(), SimplePhotonAnalyzer::analyze(), DQMHcalDiJetsAlCaReco::analyze(), JPTJetAnalyzer::analyze(), EwkElecDQM::analyze(), HLTMonBTagMuSource::analyze(), PFCandidateChecker::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWMET3DProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWJetProxyBuilder::buildViewType(), FWMETProxyBuilder::buildViewType(), reco::FlavorHistoryEvent::cache(), pat::CaloIsolationEnergy::calculate(), reco::helper::JetIDHelper::calculate(), MEzCalculator::Calculate(), reco::helper::CastorJetIDHelper::calculate(), pat::LeptonJetIsolationAngle::calculate(), METzCalculator::Calculate(), reco::CastorTower::CastorTower(), reco::PFJet::chargedEmEnergyFraction(), pat::Jet::chargedEmEnergyFraction(), reco::JPTJet::chargedEmEnergyFraction(), pat::Jet::chargedHadronEnergyFraction(), reco::JPTJet::chargedHadronEnergyFraction(), reco::PFJet::chargedHadronEnergyFraction(), reco::PFJet::chargedMuEnergyFraction(), pat::Jet::chargedMuEnergyFraction(), reco::helper::JetIDHelper::classifyJetComponents(), TauElementsOperators::computeConeSize(), PileupJetIdAlgo::computeIdVariables(), CaloTowersCreationAlgo::convert(), JetPlusTrackCorrector::correctAA(), JetPlusTrackCorrector::correction(), L1JPTOffsetCorrector::correction(), L6SLBCorrector::correction(), pat::Jet::electronEnergyFraction(), reco::PFJet::electronEnergyFraction(), metsig::SignAlgoResolutions::ElectronPtResolution(), egHLT::OffEle::energy(), egHLT::OffPho::energy(), CaloTower::energyInHF(), CaloTower::energyInHO(), metsig::SignAlgoResolutions::evalPF(), PFPhotonAlgo::EvaluateGCorrMVA(), PFEGammaAlgo::EvaluateGCorrMVA(), PFPhotonAlgo::EvaluateResMVA(), SoftPFElectronTagInfoProducer::fillElecProperties(), CaloJetTesterUnCorr::fillMatchHists(), JPTJetTesterUnCorr::fillMatchHists(), PFJetTesterUnCorr::fillMatchHists(), SoftPFMuonTagInfoProducer::fillMuonProperties(), PFRootEventManager::fillOutEventWithCaloTowers(), PFRootEventManager::fillOutEventWithPFCandidates(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), HSCPTreeBuilder::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), PFJetIDSelectionFunctor::firstDataCuts(), TtFullHadKinFitter::fit(), TtSemiLepKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), PFJetBenchmark::gettrue(), CaloTower::hadP4(), reco::PFJet::HFEMEnergyFraction(), pat::Jet::HFEMEnergyFraction(), reco::PFJet::HFHadronEnergyFraction(), pat::Jet::HFHadronEnergyFraction(), HPSPFRecoTauAlgorithm::isNarrowTau(), JetMaker::makeSpecific(), reco::tau::RecoTauIsolationMasking::mask(), MatchJet::matchCollections(), PFSpecificAlgo::mkSpecificPFMETData(), reco::PFJet::muonEnergyFraction(), pat::Jet::muonEnergyFraction(), reco::PFJet::neutralEmEnergyFraction(), reco::JPTJet::neutralEmEnergyFraction(), pat::Jet::neutralEmEnergyFraction(), reco::PFJet::neutralHadronEnergyFraction(), reco::JPTJet::neutralHadronEnergyFraction(), pat::Jet::neutralHadronEnergyFraction(), TtSemiLRSignalSelObservables::operator()(), SmearedJetProducer_namespace::JetResolutionExtractorT< pat::Jet >::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), SmearedJetProducer_namespace::JetResolutionExtractorT< reco::PFJet >::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), reco::operator<<(), CaloTower::p4(), pat::Jet::photonEnergyFraction(), reco::PFJet::photonEnergyFraction(), PFAlgoTestBenchElectrons::processBlock(), pf2pat::PFMETAlgo::produce(), JetIdSelector< T >::produce(), JetPlusTrackProducerAA::produce(), JetPlusTrackProducer::produce(), SmearedJetProducerT< T, Textractor >::produce(), CaloTowerCreatorForTauHLT::produce(), CastorClusterProducer::produce(), BoostedTopProducer::produce(), FSRWeightProducer::produce(), CaloTowerCandidateCreator::produce(), TCTauAlgorithm::recalculateEnergy(), reco::tau::RecoTauIsolationMasking::resolution(), pf2pat::PFIsoDepositAlgo::sameParticle(), reco::Photon::setVertex(), reco::SoftLeptonTagInfo::taggingVariables(), and PFMETAnalyzer::validateMET().

{ cacheCartesian(); return p4Cartesian_.E(); }
virtual double reco::LeafCandidate::et ( ) const [inline, virtual]

transverse energy

Implements reco::Candidate.

Definition at line 136 of file LeafCandidate.h.

References cachePolar(), and p4Polar_.

Referenced by StKinFitter::addKinFitInfo(), PhotonValidator::analyze(), L2TauAnalyzer::analyze(), TopElectronHLTOfflineSource::analyze(), PatPhotonSimpleAnalyzer::analyze(), WenuPlots::analyze(), PFTester::analyze(), EwkMuDQM::analyze(), HLTMonBTagIPSource::analyze(), SimplePhotonAnalyzer::analyze(), DQMHcalDiJetsAlCaReco::analyze(), JPTJetAnalyzer::analyze(), HLTTauDQMCaloPlotter::analyze(), SimplePi0DiscAnalyzer::analyze(), EwkElecDQM::analyze(), EwkDQM::analyze(), HLTMonBTagMuSource::analyze(), L25TauAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), ExoticaDQM::analyzeEventInterpretation(), ExoticaDQM::analyzeMultiJets(), EgammaObjects::analyzePhotons(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWMET3DProxyBuilder::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMETGlimpseProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), FWJetProxyBuilder::buildViewType(), FWMETProxyBuilder::buildViewType(), reco::helper::JetIDHelper::calculate(), EmDQM::checkGeneratedParticlesRequirement(), TauElementsOperators::computeConeSize(), JetPlusTrackCorrector::correction(), TCTauCorrector::correction(), egHLT::OffEle::et(), egHLT::OffPho::et(), reco::tau::qcuts::etMin(), l1extra::L1EtMissParticle::etMiss(), TopDiLeptonOffline::MonitorEnsemble::fill(), TopElectronHLTOfflineSource::EleMEs::fill(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforEffWrtMBTrigger(), JetMETHLTOfflineSource::fillMEforEffWrtMuTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTriggerwrtMuonTrigger(), WMuNuSelector::filter(), WMuNuValidator::filter(), PhotonEnrichmentFilter::filter(), HeavyChHiggsToTauNuSkim::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), ElectronVPlusJetsIDSelectionFunctor::firstDataCuts(), TtSemiLepKinFitter::fit(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), HPSPFRecoTauAlgorithm::isNarrowTau(), JetVertexMain::Main(), L25TauAnalyzer::matchedToPFTau(), reco::MET::mEtSig(), reco::Jet::nCarrying(), TtSemiLRSignalSelObservables::operator()(), PhotonValidator::sortPhotons::operator()(), TtHadLRSignalSelObservables::CompareET::operator()(), TtSemiLRSignalSelObservables::CompareET::operator()(), TtDilepLRSignalSelObservables::operator()(), L25TauAnalyzer::printInfo(), PFCandidateChecker::printJets(), L2TauIsolationSelector::produce(), L2TauRelaxingIsolationSelector::produce(), L2TauModularIsolationSelector::produce(), ParticleTowerProducer::produce(), HiL1Subtractor::produce(), JetPlusTrackCorrector::rebuildJta(), FWElectronDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), PFElectronSelector::spring11Cuts(), and reco::SoftLeptonTagInfo::taggingVariables().

{ cachePolar(); return p4Polar_.Et(); }
virtual float reco::LeafCandidate::eta ( ) const [inline, virtual]

momentum pseudorapidity

Implements reco::Candidate.

Definition at line 159 of file LeafCandidate.h.

References eta_.

Referenced by reco::tau::disc::AbsEta(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), ZIterativeAlgorithmWithFit::addEvent(), StKinFitter::addKinFitInfo(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), ZMuMuIsolationAnalyzer::analyze(), ElectronMcFakeValidator::analyze(), HLTMuonMatchAndPlot::analyze(), GsfElectronDataAnalyzer::analyze(), JetValidation::analyze(), PhotonValidator::analyze(), GlbMuQualityCutsAnalysis::analyze(), L2TauAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), TopElectronHLTOfflineSource::analyze(), ZMuPtScaleAnalyzer::analyze(), RPCRecHitProbability::analyze(), PatPhotonSimpleAnalyzer::analyze(), JPTJetTester::analyze(), WenuPlots::analyze(), testAnalyzer::analyze(), ZMuMu_Radiative_analyzer::analyze(), ElectronMcSignalValidator::analyze(), RPCMonitorDigi::analyze(), GsfElectronMCFakeAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), PFTester::analyze(), ElectronTagProbeAnalyzer::analyze(), PartonJetCorrectionExample::analyze(), IsolatedParticlesGeneratedJets::analyze(), EwkMuDQM::analyze(), ZdcSimHitStudy::analyze(), JPTJetTesterUnCorr::analyze(), HLTMonBTagIPSource::analyze(), QcdPhotonsDQM::analyze(), GsfElectronMCAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), CMSDAS11DijetAnalyzer::analyze(), DQMHcalDiJetsAlCaReco::analyze(), JPTJetAnalyzer::analyze(), HLTTauDQMCaloPlotter::analyze(), SimplePi0DiscAnalyzer::analyze(), PFJetTester::analyze(), EwkDQM::analyze(), EwkElecDQM::analyze(), TopHLTDiMuonDQM::analyze(), gamma_radiative_analyzer::analyze(), CaloJetTester::analyze(), PFCandidateChecker::analyze(), HLTMonBTagMuSource::analyze(), MuTriggerAnalyzer::analyze(), L25TauAnalyzer::analyze(), CaloJetTesterUnCorr::analyze(), PFJetTesterUnCorr::analyze(), MuonEnergyDepositAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), EgammaObjects::analyzePhotons(), JetTagPlotter::analyzeTag(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), FWMuonDetailView::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWMET3DProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWMuonLegoProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWJetLegoProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWMETProxyBuilder::buildViewType(), reco::helper::JetMuonHitsIDHelper::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), FWMuonBuilder::calculateField(), JetPlusTrackCorrector::canCorrect(), hitfit::LeptonTranslatorBase< ALepton >::CheckEta(), hitfit::JetTranslatorBase< AJet >::CheckEta(), ElectronClassification::classify(), PFMuonAlgo::cleanPunchThroughAndFakes(), PileupJetIdAlgo::computeIdVariables(), JetPlusTrackCorrector::correctAA(), JetPlusTrackCorrector::correction(), L1FastjetCorrector::correction(), L6SLBCorrector::correction(), L1OffsetCorrector::correction(), LXXXCorrector::correction(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), reco::GenJet::detectorEta(), PFTauDiscriminants::Eta::doComputation(), metsig::SignAlgoResolutions::ElectronPtResolution(), egHLT::OffEle::eta(), reco::tau::disc::Eta(), egHLT::OffPho::eta(), reco::Jet::etaPhiStatistics(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFEGammaAlgo::EvaluateGCorrMVA(), TauDiscriminationAgainstMuon< TauType, TauDiscriminator >::evaluateMuonVeto(), PFPhotonAlgo::EvaluateResMVA(), PFCandidateManager::fill(), RecoMuonValidator::MuonME::fill(), TopHLTSingleLepton::MonitorEnsemble::fill(), TopElectronHLTOfflineSource::EleMEs::fill(), PFJetMonitor::fill(), ZeePlots::fillEleClassesPlots(), ZeeCalibration::fillEleInfo(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), objMon< T >::fillL1MCMatch(), CaloJetTesterUnCorr::fillMatchHists(), JPTJetTesterUnCorr::fillMatchHists(), PFJetTesterUnCorr::fillMatchHists(), objMon< T >::fillMC(), objMon< T >::fillOffMCMatch(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), PFCandidateBenchmark::fillOne(), HLTOniaSource::fillOniaTriggerMEs(), objMon< T >::fillOnMCMatch(), PFRootEventManager::fillOutEventWithPFCandidates(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), HSCPTreeBuilder::filter(), WZInterestingEventSelector::filter(), WMuNuSelector::filter(), WMuNuValidator::filter(), PhotonEnrichmentFilter::filter(), HeavyChHiggsToTauNuSkim::filter(), reco::CentralityProducer::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), CalibratableTest::findCandidatesInDeltaR(), TtFullLepHypGenMatch::findMatchingLepton(), PFJetIDSelectionFunctor::firstDataCuts(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), calib::CalibElectron::getCalibModulesWeights(), TxCalculator::getCTx(), dRxyCalculator::getDRxy(), TxyCalculator::getHollSxy(), TxCalculator::getJct(), TxCalculator::getJt(), ParticleTowerProducer::getNearestTower(), TxyCalculator::getNumLocalTracks(), getTheTauJet(), TxCalculator::getTx(), TxyCalculator::getTxy(), objMon< T >::hasBPartonInCone(), HLTMuonTrackMassFilter::hltFilter(), EtaPtBin::inBin(), CosmicSplitterValidation::is_gold_muon(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), cms::MuonTCMETValueMapProducer::isGoodMuon(), muon::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), BPhysicsOniaDQM::isMuonInAccept(), BTagHLTOfflineSource::isMuonJet(), McSelector::isSelected(), BTagHLTOfflineSource::isVBTFMuon(), JetVertexMain::Main(), main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), FWCaloTowerSliceSelector::matchCell(), reco::RecoTauPiZero::maxDeltaEta(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), ZToMuMuGammaAnalyzer::muonSelection(), ElectronMVAEstimator::mva(), AntiElectronIDMVA3::MVAValue(), AntiElectronIDMVA2::MVAValue(), muonisolation::CaloExtractor::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseEcal(), muonisolation::CaloExtractorByAssociator::noiseHcal(), AcceptJet::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), hitfit::JetTranslatorBase< AJet >::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), GenParticleCustomSelector::operator()(), WPlusJetsEventSelector::operator()(), reco::operator<<(), operator<<(), passesElectronId(), passesElectronPreId(), ZToMuMuGammaAnalyzer::photonSelection(), reco::tau::disc::PiZeroEta(), reco::GenJet::print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), L25TauAnalyzer::printInfo(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), OutsideInMuonSeeder::produce(), QuarkoniaTrackSelector::produce(), JetPartonMatcher::produce(), JetTracksAssociationDRVertexAssigned::produce(), CaloMuonMerger::produce(), JetIdSelector< T >::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), cms::MuonMETValueMapProducer::produce(), SmearedJetProducerT< T, Textractor >::produce(), JetVetoedTracksAssociationDRVertex::produce(), CaloTowerCreatorForTauHLT::produce(), JetTracksAssociationDRCalo::produce(), JetTracksAssociationDRVertex::produce(), MuonReSeeder::produce(), CastorClusterProducer::produce(), PileupJetIdProducer::produce(), ParticleTowerProducer::produce(), CaloTowerCandidateCreator::produce(), HiL1Subtractor::produce(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), PFRootEventManager::reconstructGenJets(), reco::tau::RecoTauIsolationMasking::resolution(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), PFPhotonAlgo::RunPFPhoton(), pf2pat::PFIsoDepositAlgo::sameParticle(), FWCaloTowerDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), reco::SoftLeptonTagInfo::taggingVariables(), reco::tau::disc::TrackEta(), and CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF().

{ return eta_; }
void LeafCandidate::fillVertexCovariance ( CovarianceMatrix v) const [virtual]

fill SMatrix

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate.

Definition at line 100 of file LeafCandidate.cc.

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

Referenced by vertexCovariance().

                                                                     {
  throw edm::Exception(edm::errors::UnimplementedFeature)
    << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
}
template<typename T >
T reco::LeafCandidate::get ( void  ) const [inline]

get a component

Reimplemented from reco::Candidate.

Definition at line 271 of file LeafCandidate.h.

References edm::RefToBase< T >::get(), hasMasterClone(), and masterClone().

Referenced by PFTauDiscriminants::PFTauDiscriminantManager::fillOutlierObjects(), and ElectronLikelihood::getInputVar().

                                       {
      if ( hasMasterClone() ) return masterClone()->get<T>();
      else return reco::get<T>( * this );
    }
template<typename T , typename Tag >
T reco::LeafCandidate::get ( void  ) const [inline]

get a component

Reimplemented from reco::Candidate.

Definition at line 276 of file LeafCandidate.h.

References edm::RefToBase< T >::get(), hasMasterClone(), and masterClone().

                                                     {
      if ( hasMasterClone() ) return masterClone()->get<T, Tag>();
      else return reco::get<T, Tag>( * this );
    }
template<typename T >
T reco::LeafCandidate::get ( size_type  i) const [inline]

get a component

Reimplemented from reco::Candidate.

Definition at line 281 of file LeafCandidate.h.

References edm::RefToBase< T >::get(), hasMasterClone(), i, and masterClone().

                                                    {
      if ( hasMasterClone() ) return masterClone()->get<T>( i );
      else return reco::get<T>( * this, i );
    }
template<typename T , typename Tag >
T reco::LeafCandidate::get ( size_type  i) const [inline]

get a component

Reimplemented from reco::Candidate.

Definition at line 286 of file LeafCandidate.h.

References edm::RefToBase< T >::get(), hasMasterClone(), i, and masterClone().

                                                                  {
      if ( hasMasterClone() ) return masterClone()->get<T, Tag>( i );
      else return reco::get<T, Tag>( * this, i );
    }
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::ShallowCloneCandidate.

Definition at line 30 of file LeafCandidate.cc.

Referenced by get(), and numberOf().

                                         {
  return false;
}
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::ShallowClonePtrCandidate.

Definition at line 34 of file LeafCandidate.cc.

                                            {
  return false;
}
bool LeafCandidate::isCaloMuon ( ) const [virtual]

Implements reco::Candidate.

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

Definition at line 115 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 119 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 109 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 121 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 107 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 117 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 111 of file LeafCandidate.cc.

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

Implements reco::Candidate.

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

Definition at line 113 of file LeafCandidate.cc.

{ return false; }
virtual bool reco::LeafCandidate::longLived ( ) const [inline, virtual]

is long lived?

Implements reco::Candidate.

Definition at line 223 of file LeafCandidate.h.

References longLivedTag, and status_.

{ return status_ & longLivedTag; }
virtual float reco::LeafCandidate::mass ( ) const [inline, virtual]
virtual bool reco::LeafCandidate::massConstraint ( ) const [inline, virtual]

do mass constraint?

Implements reco::Candidate.

Definition at line 229 of file LeafCandidate.h.

References massConstraintTag, and status_.

{ return status_ & massConstraintTag; }
virtual float reco::LeafCandidate::massSqr ( ) const [inline, virtual]

mass squared

Implements reco::Candidate.

Definition at line 140 of file LeafCandidate.h.

References mass_.

Referenced by EwkElecDQM::analyze().

{ return mass_ * 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::ShallowCloneCandidate.

Definition at line 24 of file LeafCandidate.cc.

References Exception.

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

                                                          {
  throw cms::Exception("Invalid Reference")
    << "this Candidate has no master clone reference."
    << "Can't call masterClone() method.\n";
}
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::ShallowClonePtrCandidate.

Definition at line 39 of file LeafCandidate.cc.

References Exception.

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

cast master clone reference to a concrete type

Reimplemented from reco::Candidate.

Definition at line 268 of file LeafCandidate.h.

References masterClone().

{ return masterClone().template castTo<Ref>(); }
virtual Vector reco::LeafCandidate::momentum ( ) const [inline, virtual]
const Candidate * LeafCandidate::mother ( size_type  ) const [virtual]
virtual double reco::LeafCandidate::mt ( ) const [inline, virtual]

transverse mass

Implements reco::Candidate.

Definition at line 143 of file LeafCandidate.h.

References cachePolar(), and p4Polar_.

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

{ cachePolar(); return p4Polar_.Mt(); }
virtual double reco::LeafCandidate::mtSqr ( ) const [inline, virtual]

transverse mass squared

Implements reco::Candidate.

Definition at line 145 of file LeafCandidate.h.

References cachePolar(), and p4Polar_.

{ cachePolar(); return p4Polar_.Mt2(); }
template<typename T , typename Tag >
size_type reco::LeafCandidate::numberOf ( ) const [inline]

number of components

Reimplemented from reco::Candidate.

Definition at line 296 of file LeafCandidate.h.

References hasMasterClone(), and masterClone().

                                                                  {
      if ( hasMasterClone() ) return masterClone()->numberOf<T, Tag>();
      else return reco::numberOf<T, Tag>( * this );
    }
template<typename T >
size_type reco::LeafCandidate::numberOf ( ) const [inline]

number of components

Reimplemented from reco::Candidate.

Definition at line 291 of file LeafCandidate.h.

References hasMasterClone(), and masterClone().

                                                    {
      if ( hasMasterClone() ) return masterClone()->numberOf<T>();
      else return reco::numberOf<T>( * this );
    }
size_t LeafCandidate::numberOfDaughters ( ) const [virtual]
size_t LeafCandidate::numberOfMothers ( ) const [virtual]
virtual size_t reco::LeafCandidate::numberOfSourceCandidatePtrs ( ) const [inline, virtual]

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

Implements reco::Candidate.

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

Definition at line 107 of file LeafCandidate.h.

{ return 0;}
bool LeafCandidate::overlap ( const Candidate o) const [protected, virtual]
virtual double reco::LeafCandidate::p ( ) const [inline, virtual]
virtual const LorentzVector& reco::LeafCandidate::p4 ( ) const [inline, virtual]

four-momentum Lorentz vector

Implements reco::Candidate.

Definition at line 123 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

Referenced by reco::tau::RecoTauConstructor::addPiZero(), PFCandConnector::analyseNuclearWPrim(), PFCandConnector::analyseNuclearWSec(), MuonPFAnalyzer::analyze(), HLTMuonMatchAndPlot::analyze(), TTbarSpinCorrHepMCAnalyzer::analyze(), ResolutionCreator::analyze(), JetAnaPythia< Jet >::analyze(), EwkMuLumiMonitorDQM::analyze(), TTbar_Kinematics::analyze(), QcdHighPtDQM::analyze(), CMSDAS11DijetAnalyzer::analyze(), HLTTauDQMCaloPlotter::analyze(), MuTriggerAnalyzer::analyze(), L25TauAnalyzer::analyze(), HPSPFRecoTauAlgorithm::associateIsolationCandidates(), TtSemiLepJetComb::bOverLightQPt(), TtSemiLepJetComb::bQuarkVar(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), HPSPFRecoTauAlgorithm::buildThreeProngs(), reco::tau::disc::ChargedOutlierAngle(), TtSemiLepJetComb::compareBNeutrino(), TtSemiLepJetComb::compareLeptonNeutrino(), TtSemiLepJetComb::compareTopNeutrino(), TtSemiLepJetComb::compareWNeutrino(), TtFullHadKinFitter::KinFit::corJet(), pat::Jet::correctedJet(), pat::Tau::correctedP4(), pat::Jet::correctedP4(), pat::Tau::correctedTauJet(), ZSPJPTJetCorrector::correction(), JetPlusTrackCorrector::correction(), TauJetCorrector::correction(), LXXXCorrector::correction(), PFElectronTranslator::createGsfElectrons(), reco::tau::disc::Dalitz2(), TtSemiLepJetComb::deduceMothers(), PFRecoTauDiscriminationByHPSSelection::discriminate(), PFTauDiscriminants::InvariantMassOfSignalWithFiltered::doComputation(), CaloTower::emEt(), ErsatzMEt::ersatzFabrik(), CaloTower::et(), JetPartonMatcher::fillAlgoritDefinition(), SoftPFElectronTagInfoProducer::fillElecProperties(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), SoftPFMuonTagInfoProducer::fillMuonProperties(), JetPartonMatcher::fillPhysicsDefinition(), pat::CaloJetSelector::filter(), HLTRHemisphere::filter(), L2TauModularIsolationProducer::getECALHits(), L2TauNarrowConeIsolationProducer::getECALHits(), L2TauModularIsolationProducer::getHCALHits(), L2TauNarrowConeIsolationProducer::getHCALHits(), GeneratorTau::getOpeningAngle(), L2TauModularIsolationProducer::getPFClusters(), GeneratorTau::getVisNuAngle(), CaloTower::hadEt(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), reco::tau::RecoTauIsolationMasking::inCone(), pat::Tau::initializeJEC(), pat::Jet::initializeJEC(), reco::tau::disc::JetTauDR(), TtSemiLepJetComb::lightQVar(), reco::tau::disc::MainTrackAngle(), L2TauAnalyzer::match(), L25TauAnalyzer::match(), L25TauAnalyzer::matchedToPFTau(), HLTTauDQMCaloPlotter::matchJet(), HLTTauDQMTrkPlotter::matchJet(), ZToMuMuGammaAnalyzer::mumuGammaInvMass(), ZToMuMuGammaAnalyzer::mumuInvMass(), MuonMETAlgo::MuonMETAlgo_run(), reco::tau::disc::NeutralOutlierAngle(), TtSemiLepJetComb::neutrinoVar(), reco::tau::disc::OpeningAngle3D(), reco::tau::disc::OpeningDeltaR(), SmearedJetProducer_namespace::JetResolutionExtractorT< pat::Jet >::operator()(), SmearedJetProducer_namespace::GenJetMatcherT< pat::Jet >::operator()(), reco::tau::RecoTauPhotonFilter::operator()(), TtHadLRJetCombObservables::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin2::operator()(), PFJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), SmearedJetProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), CaloJetMETcorrInputProducer_namespace::RawJetExtractorT< pat::Jet >::operator()(), CalculateHLT::operator()(), CorrectJet::operator()(), TtDilepLRSignalSelObservables::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), TtSemiLRJetCombObservables::operator()(), JetIDSelectionFunctor::operator()(), CaloTower::outerEt(), reco::tau::disc::OutlierAngle(), overlap(), CaloTower::p(), CaloTower::p4(), reco::PFTauDecayMode::PFTauDecayMode(), reco::tau::disc::PiZeroAngle(), reco::RecoTauPiZero::print(), QuarkoniaTrackSelector::produce(), Type0PFMETcorrInputProducer::produce(), ParticleReplacerClass::produce(), ISRGammaWeightProducer::produce(), TruthTauDecayModeProducer::produce(), L1HLTTauMatching::produce(), MuonProducer::produce(), TCTauAlgorithm::recalculateEnergy(), TtSemiLepJetComb::relativePtHadronicTop(), reco::PFCandidate::rescaleMomentum(), reco::Jet::scaleEnergy(), reco::GsfElectron::setCorrectedEcalEnergy(), reco::Photon::setCorrectedEnergy(), setP4(), reco::Photon::setP4(), reco::Muon::setPFP4(), reco::tau::sumPFCandP4(), PFRootEventManager::tauBenchmark(), reco::tau::disc::TrackAngle(), SelectReplacementCandidates::transformMuMu2TauTau(), and pat::TriggerObjectStandAlone::triggerObject().

virtual int reco::LeafCandidate::pdgId ( ) const [inline, virtual]

PDG identifier.

Implements reco::Candidate.

Definition at line 211 of file LeafCandidate.h.

References pdgId_.

Referenced by FBaseSimEvent::addParticles(), TTbarSpinCorrHepMCAnalyzer::analyze(), ResolutionCreator::analyze(), JetAnaPythia< Jet >::analyze(), ZMuPtScaleAnalyzer::analyze(), PFTester::analyze(), zPdfUnc::analyze(), ZdcSimHitStudy::analyze(), ZLONLOHistogrammer::analyze(), EWKSystUnc::analyze(), TopDecaySubset::checkShowerModel(), GeneratorTau::computeDecayMode(), TopGenEvent::daughterQuarkOfTop(), GeneratorTau::decayToPDGClassification(), TopDecaySubset::fillListing(), objMon< T >::fillMC(), HSCPTreeBuilder::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), GenParticlesHelper::findParticles(), InputGenJetsParticleSelector::fromResonance(), pat::PATObject< ObjectType >::genParticleById(), PFJetBenchmark::gettrue(), GenParticlesHelper::hasAncestor(), objMon< T >::hasBPartonInCone(), BCToEFilterAlgo::isBCBaryon(), doubleEMEnrichingFilterAlgo::isBCBaryon(), doubleEMEnrichingFilterAlgo::isBCMeson(), BCToEFilterAlgo::isBCMeson(), HiGammaJetSignalDef::IsIsolated(), HiPhotonType::IsPrompt(), McSelector::isSelected(), JetMaker::makeSpecific(), BasicGenParticleValidation::matchParticles(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), reco::RecoTauPiZero::numberOfElectrons(), reco::RecoTauPiZero::numberOfGammas(), GenParticleCustomSelector::operator()(), TtDilepLRSignalSelObservables::operator()(), reco::GenJet::print(), PFJetBenchmark::printGenJet(), PartonSelector::produce(), JetPartonMatcher::produce(), InputGenJetsParticleSelector::produce(), WeakEffectsWeightProducer::produce(), ParticleReplacerClass::produce(), ISRWeightProducer::produce(), ISRGammaWeightProducer::produce(), PdfWeightProducer::produce(), FSRWeightProducer::produce(), PFRootEventManager::reconstructGenJets(), setPdgId(), SelectReplacementCandidates::transformMuMu2TauTau(), and pat::TriggerObjectStandAlone::triggerObject().

{ return pdgId_; }
virtual float reco::LeafCandidate::phi ( ) const [inline, virtual]

momentum azimuthal angle

Implements reco::Candidate.

Definition at line 155 of file LeafCandidate.h.

References phi_.

Referenced by reco::WMuNuCandidate::acop(), reco::tau::RecoTauPiZeroStripPlugin2::addCandsToStrip(), ZIterativeAlgorithmWithFit::addEvent(), FWMuonDetailView::addSceneInfo(), FWElectronDetailView::addSceneInfo(), METTester::analyze(), ElectronMcFakeValidator::analyze(), ZMuMuIsolationAnalyzer::analyze(), PhotonValidator::analyze(), HLTMuonMatchAndPlot::analyze(), GsfElectronDataAnalyzer::analyze(), JetValidation::analyze(), ErsatzMEt::analyze(), EwkMuLumiMonitorDQM::analyze(), JPTJetTester::analyze(), RPCRecHitProbability::analyze(), PatPhotonSimpleAnalyzer::analyze(), ElectronMcSignalValidator::analyze(), ZMuMu_Radiative_analyzer::analyze(), WenuPlots::analyze(), PFTester::analyze(), GsfElectronMCFakeAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), ElectronTagProbeAnalyzer::analyze(), PartonJetCorrectionExample::analyze(), JPTJetTesterUnCorr::analyze(), ZdcSimHitStudy::analyze(), EwkMuDQM::analyze(), IsolatedParticlesGeneratedJets::analyze(), QcdPhotonsDQM::analyze(), HLTMonBTagIPSource::analyze(), GsfElectronMCAnalyzer::analyze(), SimplePhotonAnalyzer::analyze(), CMSDAS11DijetAnalyzer::analyze(), PFJetTester::analyze(), HLTTauDQMCaloPlotter::analyze(), JPTJetAnalyzer::analyze(), DQMHcalDiJetsAlCaReco::analyze(), SimplePi0DiscAnalyzer::analyze(), CaloJetTester::analyze(), TopHLTDiMuonDQM::analyze(), EwkElecDQM::analyze(), EwkDQM::analyze(), PFJetTesterUnCorr::analyze(), CaloJetTesterUnCorr::analyze(), PFCandidateChecker::analyze(), CaloTowerAnalyzer::analyze(), HLTMonBTagMuSource::analyze(), L25TauAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), myJetAna::analyze(), ExoticaDQM::analyzeMultiJets(), JetTagPlotter::analyzeTag(), JetTracksAssociationXtrpCalo::associateInputTracksToJet(), AlignmentMuonSelector::basicCuts(), FWMuonDetailView::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWElectronDetailView::build(), FWMET3DProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWPhotonLegoProxyBuilder::build(), FWL1EtMissParticleLegoProxyBuilder::build(), FWMuonLegoProxyBuilder::build(), FWGenParticleLegoProxyBuilder::build(), FWJetLegoProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1EtMissParticleGlimpseProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), FWMETLegoProxyBuilder::build(), FWCaloTowerDetailView::build(), FWMETGlimpseProxyBuilder::build(), FWTauProxyBuilderBase::buildBaseTau(), pf2pat::PFIsoDepositAlgo::buildIsoDeposit(), FWPhotonProxyBuilder::buildViewType(), FWJetProxyBuilder::buildViewType(), FWElectronProxyBuilder::buildViewType(), FWMETProxyBuilder::buildViewType(), GlobalHaloAlgo::Calculate(), reco::helper::CastorJetIDHelper::calculate(), reco::helper::JetMuonHitsIDHelper::calculate(), JetPlusTrackProducerAA::calculateBGtracksJet(), PFMETBenchmark::calculateQuantities(), AlignmentTwoBodyDecayTrackSelector::checkMETAcoplanarity(), JetPlusTrackCorrector::correction(), L6SLBCorrector::correction(), METManager::coutTailEvents(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), PFCandWithSuperClusterExtractor::depositFromObject(), muonisolation::CaloExtractorByAssociator::deposits(), EcalDeadCellDeltaRFilter::dPhiToMETfunc(), reco::Jet::etaphiMoment(), reco::Jet::etaPhiStatistics(), metsig::SignAlgoResolutions::evalPF(), metsig::SignAlgoResolutions::evalPFJet(), ZGlobalVsSAIsolationAnalyzer::evaluate(), PFPhotonAlgo::EvaluateGCorrMVA(), PFEGammaAlgo::EvaluateGCorrMVA(), TauDiscriminationAgainstMuon< TauType, TauDiscriminator >::evaluateMuonVeto(), PFPhotonAlgo::EvaluateResMVA(), PFCandidateManager::fill(), RecoMuonValidator::MuonME::fill(), TopElectronHLTOfflineSource::EleMEs::fill(), PFJetMonitor::fill(), ZeeCalibration::fillEleInfo(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), objMon< T >::fillL1MCMatch(), JPTJetTesterUnCorr::fillMatchHists(), CaloJetTesterUnCorr::fillMatchHists(), PFJetTesterUnCorr::fillMatchHists(), objMon< T >::fillMC(), JetMETHLTOfflineSource::fillMEforEffAllTrigger(), JetMETHLTOfflineSource::fillMEforEffWrtMBTrigger(), JetMETHLTOfflineSource::fillMEforEffWrtMuTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTrigger(), JetMETHLTOfflineSource::fillMEforMonAllTriggerwrtMuonTrigger(), MuCorrMETAnalyzer::fillMonitorElement(), PFMETAnalyzer::fillMonitorElement(), METAnalyzer::fillMonitorElement(), TcMETAnalyzer::fillMonitorElement(), CaloMETAnalyzer::fillMonitorElementTriggered(), objMon< T >::fillOffMCMatch(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), PFCandidateBenchmark::fillOne(), HLTOniaSource::fillOniaTriggerMEs(), objMon< T >::fillOnMCMatch(), PFRootEventManager::fillOutEventWithPFCandidates(), HSCPTreeBuilder::filter(), WZInterestingEventSelector::filter(), WMuNuValidator::filter(), HeavyChHiggsToTauNuSkim::filter(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), CalibratableTest::findCandidatesInDeltaR(), TtFullLepHypGenMatch::findMatchingLepton(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), TxCalculator::getCTx(), dRxyCalculator::getDRxy(), TxyCalculator::getHollSxy(), TxCalculator::getJct(), TxCalculator::getJt(), ParticleTowerProducer::getNearestTower(), TxyCalculator::getNumLocalTracks(), TxCalculator::getTx(), TxyCalculator::getTxy(), objMon< T >::hasBPartonInCone(), HLTMuonTrackMassFilter::hltFilter(), EcalDeadCellDeltaRFilter::isCloseToBadEcalChannel(), BTagHLTOfflineSource::isMuonJet(), main(), JetVertexMain::Main(), fireworks::makeEveJetCone(), SignCaloSpecificAlgo::makeVectorOutOfCaloTowers(), L1MuonMatcherAlgo::match(), FWCaloTowerSliceSelector::matchCell(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), AntiElectronIDMVA3::MVAValue(), AntiElectronIDMVA2::MVAValue(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), WPlusJetsEventSelector::operator()(), reco::operator<<(), operator<<(), egHLT::OffPho::phi(), egHLT::OffEle::phi(), MuonIdProducer::phiOfMuonIneteractionRegion(), reco::Jet::phiphiMoment(), reco::GenJet::print(), reco::Jet::print(), reco::GenericJet::print(), PFJetBenchmark::printGenJet(), L25TauAnalyzer::printInfo(), PFCandidateChecker::printJets(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), OutsideInMuonSeeder::produce(), JetPartonMatcher::produce(), pf2pat::PFMETAlgo::produce(), JetTracksAssociationDRVertexAssigned::produce(), SmearedJetProducerT< T, Textractor >::produce(), JetVetoedTracksAssociationDRVertex::produce(), CaloTowerCreatorForTauHLT::produce(), JetTracksAssociationDRCalo::produce(), JetTracksAssociationDRVertex::produce(), MuonReSeeder::produce(), CastorClusterProducer::produce(), cms::AlCaDiJetsProducer::produce(), PileupJetIdProducer::produce(), FSRWeightProducer::produce(), ParticleTowerProducer::produce(), CaloTowerCandidateCreator::produce(), AcceptJet::ratio(), JetPlusTrackCorrector::rebuildJta(), PFRootEventManager::reconstructGenJets(), reco::tau::RecoTauIsolationMasking::resolution(), FWCaloTowerDetailView::setTextInfo(), FWElectronDetailView::setTextInfo(), FWPhotonDetailView::setTextInfo(), FWMuonDetailView::setTextInfo(), pat::LeptonJetIsolationAngle::spaceAngle(), reco::SoftLeptonTagInfo::taggingVariables(), pat::MET::uncorrectedPhi(), CaloSpecificAlgo::update_sumEtInpHF_MExInpHF_MEyInpHF_sumEtInmHF_MExInmHF_MEyInmHF(), and PFMETAnalyzer::validateMET().

{ return phi_; }
virtual const PolarLorentzVector& reco::LeafCandidate::polarP4 ( ) const [inline, virtual]

four-momentum Lorentz vector

Implements reco::Candidate.

Definition at line 125 of file LeafCandidate.h.

References cachePolar(), and p4Polar_.

Referenced by pat::L1MuonMatcher::produce().

{ cachePolar(); return p4Polar_; }
virtual float reco::LeafCandidate::pt ( ) const [inline, virtual]

transverse momentum

Implements reco::Candidate.

Definition at line 153 of file LeafCandidate.h.

References pt_.

Referenced by StKinFitter::addKinFitInfo(), METTester::analyze(), ElectronMcFakeValidator::analyze(), ZMuMuIsolationAnalyzer::analyze(), MuonPFAnalyzer::analyze(), HLTMuonMatchAndPlot::analyze(), GsfElectronDataAnalyzer::analyze(), JetValidation::analyze(), GlbMuQualityCutsAnalysis::analyze(), BeamHaloAnalyzer::analyze(), ErsatzMEt::analyze(), EwkMuLumiMonitorDQM::analyze(), JPTJetTester::analyze(), RPCRecHitProbability::analyze(), ElectronMcSignalValidator::analyze(), ZMuMu_Radiative_analyzer::analyze(), testAnalyzer::analyze(), SUSYDQMAnalyzer::analyze(), RPCMonitorDigi::analyze(), GsfElectronMCFakeAnalyzer::analyze(), FlavorJetCorrectionExample::analyze(), ZToMuMuGammaAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), QcdHighPtDQM::analyze(), PartonJetCorrectionExample::analyze(), JPTJetTesterUnCorr::analyze(), EwkMuDQM::analyze(), IsolatedParticlesGeneratedJets::analyze(), QcdPhotonsDQM::analyze(), GsfElectronMCAnalyzer::analyze(), CMSDAS11DijetAnalyzer::analyze(), PFJetTester::analyze(), HLTTauDQMCaloPlotter::analyze(), JPTJetAnalyzer::analyze(), CaloJetTester::analyze(), gamma_radiative_analyzer::analyze(), EwkElecDQM::analyze(), EwkDQM::analyze(), PFJetTesterUnCorr::analyze(), CaloJetTesterUnCorr::analyze(), MuTriggerAnalyzer::analyze(), HiggsDQM::analyze(), GsfElectronFakeAnalyzer::analyze(), myJetAna::analyze(), JetTagPlotter::analyzeTag(), AlignmentMuonSelector::basicCuts(), ZToMuMuGammaAnalyzer::basicMuonSelection(), FWL1JetParticleProxyBuilder::build(), FWL1EmParticleProxyBuilder::build(), FWL1EtMissParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWPFCandidatesLegoProxyBuilder::build(), HPSPFRecoTauAlgorithm::buildThreeProngs(), reco::helper::JetIDHelper::calculate(), GlobalHaloAlgo::Calculate(), pat::LeptonJetIsolationAngle::calculate(), FWMuonBuilder::calculateField(), PFMETBenchmark::calculateQuantities(), reco::tau::disc::ChargedOutlierPt(), PFAlgo::checkCleaning(), pat::MET::checkUncor_(), PFMuonAlgo::cleanMismeasured(), PFMuonAlgo::cleanPunchThroughAndFakes(), MuonPFAnalyzer::combRelIso(), CMSDAS11DijetAnalyzer::compare_JetPt(), CMSDAS11DijetTestAnalyzer::compare_JetPt(), PileupJetIdAlgo::computeIdVariables(), reco::Jet::constituentEtaPhiSpread(), reco::Jet::constituentPtDistribution(), JetPlusTrackCorrector::correction(), L1FastjetCorrector::correction(), L6SLBCorrector::correction(), L1OffsetCorrector::correction(), LXXXCorrector::correction(), TCMETAlgo::correctSumEtForMuon(), METManager::coutTailEvents(), CutBasedPhotonIDAlgo::decideEB(), CutBasedPhotonIDAlgo::decideEE(), PFCandWithSuperClusterExtractor::depositFromObject(), PFTauDiscriminants::Pt::doComputation(), reco::PFTau::dump(), WZInterestingEventSelector::electronSelection(), reco::tau::disc::EMFraction(), metsig::SignAlgoResolutions::evalPFJet(), MuonVPlusJetsIDSelectionFunctor::fall10Cuts(), PFCandidateManager::fill(), TopSingleLepton::MonitorEnsemble::fill(), RecoMuonValidator::MuonME::fill(), TopHLTSingleLepton::MonitorEnsemble::fill(), TopDiLeptonOffline::MonitorEnsemble::fill(), PFJetMonitor::fill(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), objMon< T >::fillL1MCMatch(), JPTJetTesterUnCorr::fillMatchHists(), CaloJetTesterUnCorr::fillMatchHists(), PFJetTesterUnCorr::fillMatchHists(), objMon< T >::fillMC(), JetMETHLTOfflineSource::fillMEforMonAllTriggerwrtMuonTrigger(), JetMETHLTOfflineSource::fillMEforTriggerNTfired(), MuCorrMETAnalyzer::fillMonitorElement(), PFMETAnalyzer::fillMonitorElement(), METAnalyzer::fillMonitorElement(), TcMETAnalyzer::fillMonitorElement(), CaloMETAnalyzer::fillMonitorElementTriggered(), objMon< T >::fillOffMCMatch(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), PFCandidateBenchmark::fillOne(), HLTOniaSource::fillOniaTriggerMEs(), objMon< T >::fillOnMCMatch(), HSCPTreeBuilder::filter(), WMuNuSelector::filter(), WZInterestingEventSelector::filter(), LeptonRecoSkim::filter(), WMuNuValidator::filter(), reco::tau::RecoTauPhotonFilter::filter(), NJetsMC::filter(), reco::CentralityProducer::filter(), InconsistentMuonPFCandidateFilter::filter(), myFilter::filter(), MuonVPlusJetsIDSelectionFunctor::firstDataCuts(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), getTheElectron(), getTheMuon(), getTheTauJet(), PFCandidateChecker::greaterPt(), PFRootEventManager::highPtPFCandidate(), HLTHcalNoiseFilter::hltFilter(), HLTDiMuonGlbTrkFilter::hltFilter(), HLTMuonTrackMassFilter::hltFilter(), EtaPtBin::inBin(), cms::MuonTCMETValueMapProducer::isGoodCaloMuon(), cms::MuonTCMETValueMapProducer::isGoodMuon(), muon::isGoodMuon(), MuonIdProducer::isGoodRPCMuon(), MuonIdProducer::isGoodTrackerMuon(), HiGammaJetSignalDef::IsIsolated(), MuTriggerAnalyzer::IsMuMatchedToHLTMu(), BPhysicsOniaDQM::isMuonInAccept(), reco::tau::disc::IsolationChargedSumHard(), reco::tau::disc::IsolationChargedSumSoft(), reco::tau::disc::IsolationECALSumHard(), reco::tau::disc::IsolationECALSumSoft(), RecoSelector::isSelected(), McSelector::isSelected(), BTagHLTOfflineSource::isVBTFMuon(), MuonVPlusJetsIDSelectionFunctor::kitQCDCuts(), main(), reco::modules::HICaloCompatibleTrackSelector::matchByDrAllowReuse(), pat::MHT::mht(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), EwkMuLumiMonitorDQM::muIso(), ElectronMVAEstimator::mva(), AntiElectronIDMVA3::MVAValue(), AntiElectronIDMVA2::MVAValue(), reco::tau::disc::NeutralOutlierPt(), SmearedJetProducer_namespace::GenJetMatcherT< pat::Jet >::operator()(), CaloJetSort::operator()(), reco::tau::RecoTauPiZeroStripPlugin2::operator()(), L2TauJetsMerger::SorterByPt::operator()(), AcceptJet::operator()(), TtHadLRJetCombObservables::operator()(), TtSemiLepSignalSelMVATrainer::JetwithHigherPt::operator()(), HPSPFRecoTauAlgorithm::HPSTauPtSorter::operator()(), WMuNuProducer::ComparePt::operator()(), BasicJetSort::operator()(), reco::tau::RecoTauPiZeroStripPlugin::operator()(), MuScleFitUtils::byPt::operator()(), GenParticleCustomSelector::operator()(), GenJetSort::operator()(), WSelector::operator()(), AlignmentMuonSelector::ComparePt::operator()(), reco::TrackSelector::operator()(), WPlusJetsEventSelector::operator()(), CalculateHLT::operator()(), HLTTauDQMCaloPlotter::SorterByPt::operator()(), TtSemiLRJetCombObservables::operator()(), reco::operator<<(), reco::tau::disc::OutlierPt(), muon::overlap(), PhotonSelectorAlgo::passPhotonSelection(), ZToMuMuGammaAnalyzer::photonSelection(), reco::tau::disc::PiZeroPt(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), reco::GenJet::print(), reco::Jet::print(), reco::GenericJet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), PFJetBenchmark::process(), OutsideInMuonSeeder::produce(), QuarkoniaTrackSelector::produce(), JetPartonMatcher::produce(), WMuNuProducer::produce(), AlCaHcalNoiseProducer::produce(), InputGenJetsParticleSelector::produce(), CaloMuonMerger::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), cms::MuonMETValueMapProducer::produce(), SmearedJetProducerT< T, Textractor >::produce(), MuonReSeeder::produce(), ISRWeightProducer::produce(), L2TauJetsProvider::produce(), PileupJetIdProducer::produce(), L1HLTTauMatching::produce(), MuonMETcorrInputProducer::produce(), reco::tau::disc::Pt(), egHLT::OffPho::pt(), reco::tau::qcuts::ptMin(), PFRootEventManager::reconstructGenJets(), ElectronLikelihood::result(), ElectronLikelihood::resultLog(), reco::tau::disc::ScaledOpeningDeltaR(), FWMuonDetailView::setTextInfo(), reco::tau::disc::SignalPtFraction(), MuonVPlusJetsIDSelectionFunctor::spring10Cuts(), PFMuonSelector::spring11Cuts(), MuonVPlusJetsIDSelectionFunctor::summer08Cuts(), reco::tau::sumPFCandPt(), reco::tau::disc::TrackPt(), PFMuonAlgo::tracksWithBetterMET(), pat::MET::uncorrectedPt(), CaloMETAnalyzer::validateMET(), and PFMETAnalyzer::validateMET().

{ return pt_;}
virtual double reco::LeafCandidate::px ( ) const [inline, virtual]

x coordinate of momentum vector

Implements reco::Candidate.

Definition at line 147 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), METTester::analyze(), EwkMuLumiMonitorDQM::analyze(), EwkMuDQM::analyze(), JPTJetAnalyzer::analyze(), EwkElecDQM::analyze(), HiggsDQM::analyze(), myJetAna::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidate3DProxyBuilder::build(), FWPFCandidateWithHitsProxyBuilder::build(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFAlgo::checkCleaning(), PFMuonAlgo::cleanMismeasured(), CorrectedPFMETProducer2::constructP4From(), CorrectedCaloMETProducer2::constructP4From(), JetPlusTrackCorrector::correction(), L1JPTOffsetCorrector::correction(), TCMETAlgo::correctMETforMuon(), SoftPFElectronTagInfoProducer::fillElecProperties(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), MuCorrMETAnalyzer::fillMonitorElement(), METAnalyzer::fillMonitorElement(), PFMETAnalyzer::fillMonitorElement(), TcMETAnalyzer::fillMonitorElement(), CaloMETAnalyzer::fillMonitorElementTriggered(), SoftPFMuonTagInfoProducer::fillMuonProperties(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), HSCPTreeBuilder::filter(), WMuNuSelector::filter(), WMuNuValidator::filter(), TtFullHadKinFitter::fit(), TtSemiLepKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), PFMuonAlgo::getMinMaxMET2(), reco::IsolatedTauTagInfo::leadingSignalTrack(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TtSemiLRSignalSelObservables::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), CalculateHLT::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), METzCalculator::Print(), MEzCalculator::Print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), WMuNuProducer::produce(), JetPlusTrackProducerAA::produce(), JetPlusTrackProducer::produce(), ParticleReplacerClass::produce(), BoostedTopProducer::produce(), MuonMETcorrInputProducer::produce(), METManager::propagateJEC(), TCTauAlgorithm::recalculateEnergy(), pat::MET::setPtPhi_(), reco::MET::significance(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), CaloMETAnalyzer::validateMET(), PFMETAnalyzer::validateMET(), and reco::WMuNuCandidatePtr::WMuNuCandidatePtr().

{ cacheCartesian(); return p4Cartesian_.Px(); }
virtual double reco::LeafCandidate::py ( ) const [inline, virtual]

y coordinate of momentum vector

Implements reco::Candidate.

Definition at line 149 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), METTester::analyze(), ElectronMcFakeValidator::analyze(), GsfElectronDataAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), ElectronMcSignalValidator::analyze(), GsfElectronMCFakeAnalyzer::analyze(), EwkMuDQM::analyze(), GsfElectronMCAnalyzer::analyze(), JPTJetAnalyzer::analyze(), EwkElecDQM::analyze(), HiggsDQM::analyze(), myJetAna::analyze(), GsfElectronFakeAnalyzer::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidate3DProxyBuilder::build(), FWPFCandidateWithHitsProxyBuilder::build(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), PFMETBenchmark::calculateQuantities(), PFAlgo::checkCleaning(), PFMuonAlgo::cleanMismeasured(), CorrectedPFMETProducer2::constructP4From(), CorrectedCaloMETProducer2::constructP4From(), JetPlusTrackCorrector::correction(), L1JPTOffsetCorrector::correction(), TCMETAlgo::correctMETforMuon(), SoftPFElectronTagInfoProducer::fillElecProperties(), EwkMuTauHistManager::fillHistograms(), EwkElecTauHistManager::fillHistograms(), MuCorrMETAnalyzer::fillMonitorElement(), METAnalyzer::fillMonitorElement(), PFMETAnalyzer::fillMonitorElement(), TcMETAnalyzer::fillMonitorElement(), CaloMETAnalyzer::fillMonitorElementTriggered(), SoftPFMuonTagInfoProducer::fillMuonProperties(), MatchMETBenchmark::fillOne(), METBenchmark::fillOne(), PFMETMonitor::fillOne(), FastL1Region::FillTower(), FastL1Region::FillTower_Scaled(), HSCPTreeBuilder::filter(), WMuNuSelector::filter(), WMuNuValidator::filter(), TtFullHadKinFitter::fit(), TtSemiLepKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), PFMuonAlgo::getMinMaxMET2(), reco::IsolatedTauTagInfo::leadingSignalTrack(), reco::WMuNuCandidate::massT(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TtSemiLRSignalSelObservables::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), CalculateHLT::operator()(), hitfit::METTranslatorBase< AMet >::operator()(), PFMuonAlgo::postClean(), PFAlgo::postCleaning(), METzCalculator::Print(), MEzCalculator::Print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), WMuNuProducer::produce(), JetPlusTrackProducerAA::produce(), JetPlusTrackProducer::produce(), ParticleReplacerClass::produce(), BoostedTopProducer::produce(), MuonMETcorrInputProducer::produce(), METManager::propagateJEC(), TCTauAlgorithm::recalculateEnergy(), pat::MET::setPtPhi_(), reco::MET::significance(), ImpactParameterAlgorithm::tag(), PFMuonAlgo::tracksWithBetterMET(), CaloMETAnalyzer::validateMET(), and PFMETAnalyzer::validateMET().

{ cacheCartesian(); return p4Cartesian_.Py(); }
virtual double reco::LeafCandidate::pz ( ) const [inline, virtual]

z coordinate of momentum vector

Implements reco::Candidate.

Definition at line 151 of file LeafCandidate.h.

References cacheCartesian(), and p4Cartesian_.

Referenced by StKinFitter::addKinFitInfo(), TtFullLepKinSolver::addKinSolInfo(), FBaseSimEvent::addParticles(), EwkMuDQM::analyze(), JPTJetAnalyzer::analyze(), EwkElecDQM::analyze(), HiggsDQM::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), FWPFCandidate3DProxyBuilder::build(), FWPFCandidateWithHitsProxyBuilder::build(), reco::FlavorHistoryEvent::cache(), pat::LeptonJetIsolationAngle::calculate(), MEzCalculator::Calculate(), METzCalculator::Calculate(), JetPlusTrackCorrector::correction(), L1JPTOffsetCorrector::correction(), EMEnrichingFilterAlgo::deltaRxyAtEE(), doubleEMEnrichingFilterAlgo::deltaRxyAtEE(), SoftPFElectronTagInfoProducer::fillElecProperties(), SoftPFMuonTagInfoProducer::fillMuonProperties(), HSCPTreeBuilder::filter(), TtFullHadKinFitter::fit(), TtSemiLepKinFitter::fit(), reco::GlobalHaloData::GetCorrectedCaloMET(), reco::IsolatedTauTagInfo::leadingSignalTrack(), MatchJet::matchCollections(), BasicGenParticleValidation::matchParticles(), TtSemiLRSignalSelObservables::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), reco::tau::RecoTauEnergyRecoveryPlugin::operator()(), METzCalculator::Print(), MEzCalculator::Print(), reco::GenericJet::print(), reco::Jet::print(), PFJetBenchmark::printGenJet(), PFJetBenchmark::printPFJet(), WMuNuProducer::produce(), JetPlusTrackProducerAA::produce(), JetPlusTrackProducer::produce(), ParticleReplacerClass::produce(), BoostedTopProducer::produce(), TCTauAlgorithm::recalculateEnergy(), setPz(), and ImpactParameterAlgorithm::tag().

{ cacheCartesian(); return p4Cartesian_.Pz(); }
virtual double reco::LeafCandidate::rapidity ( ) const [inline, virtual]

rapidity

Implements reco::Candidate.

Definition at line 161 of file LeafCandidate.h.

References cachePolar(), and p4Polar_.

Referenced by y().

{ cachePolar(); return p4Polar_.Rapidity(); }
virtual void reco::LeafCandidate::setCharge ( Charge  q) [inline, virtual]
virtual void reco::LeafCandidate::setLongLived ( ) [inline, virtual]

set long lived flag

Implements reco::Candidate.

Definition at line 221 of file LeafCandidate.h.

References longLivedTag, and status_.

virtual void reco::LeafCandidate::setMass ( double  m) [inline, virtual]

set particle mass

Implements reco::Candidate.

Definition at line 186 of file LeafCandidate.h.

References clearCache(), m, and mass_.

Referenced by RecoTauPiZeroProducer::produce().

                                                  {
      mass_ = m;
      clearCache();
    }
virtual void reco::LeafCandidate::setMassConstraint ( ) [inline, virtual]

set mass constraint flag

Implements reco::Candidate.

Definition at line 227 of file LeafCandidate.h.

References massConstraintTag, and status_.

virtual void reco::LeafCandidate::setP4 ( const LorentzVector p4) [inline, virtual]

set 4-momentum

Implements reco::Candidate.

Definition at line 165 of file LeafCandidate.h.

References cacheCartesianFixed_, cachePolarFixed_, eta_, mass_, p4(), p4Cartesian_, p4Polar_, phi_, and pt_.

Referenced by EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), HPSPFRecoTauAlgorithm::buildPFTau(), PFMuonAlgo::changeTrack(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), GenParticleProducer::convertParticle(), TtFullHadKinFitter::KinFit::corJet(), pat::Jet::correctedJet(), pat::Tau::correctedTauJet(), pat::GenericParticle::fillInFrom(), pat::PATMuonProducer::fillMuon(), MuScleFitFilter::filter(), pat::Tau::initializeJEC(), pat::Jet::initializeJEC(), reco::tau::RecoTauPhotonFilter::operator()(), CorrectedMETProducer_namespace::CorrectedMETFactoryT< pat::MET >::operator()(), reco::tau::RecoTauTwoProngFilter::operator()(), reco::PFTauDecayMode::PFTauDecayMode(), GlobalMuonToMuonProducer::produce(), ShiftedPFCandidateProducerForNoPileUpPFMEt::produce(), ShiftedPFCandidateProducerForPFMEtMVA::produce(), DistortedPFCandProducer::produce(), TCRecoTauProducer::produce(), DistortedMuonProducerFromDB::produce(), MuonProducer::produce(), TCTauAlgorithm::recalculateEnergy(), HPSPFRecoTauAlgorithm::refitThreeProng(), reco::PFCandidate::rescaleMomentum(), PFPhotonAlgo::RunPFPhoton(), reco::Jet::scaleEnergy(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), PFCandCommonVertexFitterBase::set(), MEzCalculator::SetLepton(), METzCalculator::SetMET(), MEzCalculator::SetMET(), METzCalculator::SetMuon(), and SelectReplacementCandidates::transformMuMu2TauTau().

                                                                {
      p4Cartesian_ = p4;
      p4Polar_ = p4;
      pt_ = p4Polar_.pt();
      eta_ = p4Polar_.eta();
      phi_ = p4Polar_.phi();
      mass_ = p4Polar_.mass();
      cachePolarFixed_ = true;
      cacheCartesianFixed_ = true;
    }
virtual void reco::LeafCandidate::setP4 ( const PolarLorentzVector p4) [inline, virtual]

set 4-momentum

Implements reco::Candidate.

Definition at line 176 of file LeafCandidate.h.

References cacheCartesianFixed_, cachePolarFixed_, eta_, mass_, p4(), p4Polar_, phi_, and pt_.

                                                                     {
      p4Polar_ = p4;
      pt_ = p4Polar_.pt();
      eta_ = p4Polar_.eta();
      phi_ = p4Polar_.phi();
      mass_ = p4Polar_.mass();
      cachePolarFixed_ = true;
      cacheCartesianFixed_ = false;
    }
virtual void reco::LeafCandidate::setPdgId ( int  pdgId) [inline, virtual]
virtual void reco::LeafCandidate::setPz ( double  pz) [inline, virtual]

Implements reco::Candidate.

Definition at line 190 of file LeafCandidate.h.

References cacheCartesian(), eta_, mass_, p4Cartesian_, p4Polar_, phi_, pt_, and pz().

Referenced by BoostedTopProducer::produce().

                                                 {
      cacheCartesian();
      p4Cartesian_.SetPz(pz);
      p4Polar_ = p4Cartesian_;
      pt_ = p4Polar_.pt();
      eta_ = p4Polar_.eta();
      phi_ = p4Polar_.phi();
      mass_ = p4Polar_.mass();
    }
virtual void reco::LeafCandidate::setStatus ( int  status) [inline, virtual]
virtual void reco::LeafCandidate::setThreeCharge ( Charge  qx3) [inline, virtual]

set electric charge

Implements reco::Candidate.

Definition at line 121 of file LeafCandidate.h.

References qx3_.

Referenced by GenParticleProducer::convertParticle().

{ qx3_ = qx3; }
virtual void reco::LeafCandidate::setVertex ( const Point vertex) [inline, virtual]
virtual CandidatePtr reco::LeafCandidate::sourceCandidatePtr ( size_type  i) const [inline, virtual]

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

Reimplemented from reco::Candidate.

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

Definition at line 110 of file LeafCandidate.h.

                                                                 {
      return CandidatePtr();
    }
virtual int reco::LeafCandidate::status ( ) const [inline, virtual]

status word

Implements reco::Candidate.

Definition at line 215 of file LeafCandidate.h.

References status_.

Referenced by FBaseSimEvent::addParticles(), TTbarSpinCorrHepMCAnalyzer::analyze(), ResolutionCreator::analyze(), JetAnaPythia< Jet >::analyze(), ZMuPtScaleAnalyzer::analyze(), zPdfUnc::analyze(), ZLONLOHistogrammer::analyze(), EWKSystUnc::analyze(), EMEnrichingFilterAlgo::applyBFieldCurv(), doubleEMEnrichingFilterAlgo::applyBFieldCurv(), GeneratorTau::computeDecayMode(), GeneratorTau::computeStableDecayProducts(), GeneratorTau::decayToPDGClassification(), objMon< T >::fillMC(), HSCPTreeBuilder::filter(), HighETPhotonsFilterAlgo::filter(), BCToEFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filter(), doubleEMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterIsoGenPar(), EMEnrichingFilterAlgo::filterPhotonElectronSeed(), doubleEMEnrichingFilterAlgo::filterPhotonElectronSeed(), GenParticlesHelper::findParticles(), InputGenJetsParticleSelector::fromResonance(), pat::PATObject< ObjectType >::genParticleById(), GenParticlesHelper::hasAncestor(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), McSelector::isSelected(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), GenParticleCustomSelector::operator()(), PartonSelector::produce(), JetPartonMatcher::produce(), InputGenJetsParticleSelector::produce(), MCTrackMatcher::produce(), WeakEffectsWeightProducer::produce(), ISRWeightProducer::produce(), ISRGammaWeightProducer::produce(), PdfWeightProducer::produce(), FSRWeightProducer::produce(), PFRootEventManager::reconstructGenJets(), and setStatus().

{ return status_; }
virtual double reco::LeafCandidate::theta ( ) const [inline, virtual]
virtual int reco::LeafCandidate::threeCharge ( ) const [inline, virtual]

electric charge

Implements reco::Candidate.

Definition at line 119 of file LeafCandidate.h.

References qx3_.

Referenced by TopDecaySubset::fillListing().

{ return qx3_; }
virtual const Point& reco::LeafCandidate::vertex ( ) const [inline, virtual]
double LeafCandidate::vertexChi2 ( ) const [virtual]

chi-squares

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate.

Definition at line 83 of file LeafCandidate.cc.

                                       {
  return 0;
}
CovarianceMatrix reco::LeafCandidate::vertexCovariance ( ) const [inline, virtual]

return SMatrix

Reimplemented from reco::Candidate.

Definition at line 250 of file LeafCandidate.h.

References fillVertexCovariance(), and m.

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.

Definition at line 95 of file LeafCandidate.cc.

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

                                                         {
  throw edm::Exception(edm::errors::UnimplementedFeature)
    << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
}
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.

Definition at line 87 of file LeafCandidate.cc.

                                       {
  return 0;
}
double LeafCandidate::vertexNormalizedChi2 ( ) const [virtual]

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

Implements reco::Candidate.

Reimplemented in reco::VertexCompositeCandidate.

Definition at line 91 of file LeafCandidate.cc.

                                                 {
  return 0;
}
virtual double reco::LeafCandidate::vx ( ) const [inline, virtual]
virtual double reco::LeafCandidate::vy ( ) const [inline, virtual]
virtual double reco::LeafCandidate::vz ( ) const [inline, virtual]
virtual double reco::LeafCandidate::y ( ) const [inline, virtual]

rapidity

Implements reco::Candidate.

Definition at line 163 of file LeafCandidate.h.

References rapidity().

{ return rapidity(); }

Friends And Related Function Documentation

friend class ::OverlapChecker [friend]

Reimplemented from reco::Candidate.

Definition at line 364 of file LeafCandidate.h.

friend struct component [friend]

Reimplemented from reco::Candidate.

Reimplemented in reco::RecoCandidate.

Definition at line 363 of file LeafCandidate.h.

friend class ShallowCloneCandidate [friend]

Reimplemented from reco::Candidate.

Definition at line 365 of file LeafCandidate.h.

friend class ShallowClonePtrCandidate [friend]

Reimplemented from reco::Candidate.

Definition at line 366 of file LeafCandidate.h.


Member Data Documentation

bool reco::LeafCandidate::cacheCartesianFixed_ [mutable, protected]

Definition at line 342 of file LeafCandidate.h.

Referenced by cacheCartesian(), clearCache(), and setP4().

bool reco::LeafCandidate::cachePolarFixed_ [mutable, protected]

has cache been set?

Definition at line 342 of file LeafCandidate.h.

Referenced by cachePolar(), clearCache(), and setP4().

float reco::LeafCandidate::eta_ [protected]

Definition at line 330 of file LeafCandidate.h.

Referenced by cachePolar(), eta(), setP4(), and setPz().

const unsigned int reco::LeafCandidate::longLivedTag = 65536 [static]

long lived flag

Definition at line 219 of file LeafCandidate.h.

Referenced by longLived(), and setLongLived().

float reco::LeafCandidate::mass_ [protected]

Definition at line 330 of file LeafCandidate.h.

Referenced by cachePolar(), mass(), massSqr(), setMass(), setP4(), and setPz().

const unsigned int reco::LeafCandidate::massConstraintTag = 131072 [static]

do mass constraint flag

Definition at line 225 of file LeafCandidate.h.

Referenced by massConstraint(), and setMassConstraint().

internal cache for p4

Definition at line 340 of file LeafCandidate.h.

Referenced by boostToCM(), cacheCartesian(), energy(), momentum(), p(), p4(), px(), py(), pz(), setP4(), setPz(), and theta().

internal cache for p4

Definition at line 338 of file LeafCandidate.h.

Referenced by cacheCartesian(), cachePolar(), et(), mt(), mtSqr(), polarP4(), rapidity(), setP4(), and setPz().

int reco::LeafCandidate::pdgId_ [protected]

PDG identifier.

Definition at line 334 of file LeafCandidate.h.

Referenced by reco::PFCandidate::particleId(), pdgId(), and setPdgId().

float reco::LeafCandidate::phi_ [protected]

Definition at line 330 of file LeafCandidate.h.

Referenced by cachePolar(), phi(), setP4(), and setPz().

float reco::LeafCandidate::pt_ [protected]

four-momentum Lorentz vector

Definition at line 330 of file LeafCandidate.h.

Referenced by cachePolar(), pt(), setP4(), and setPz().

electric charge

Definition at line 328 of file LeafCandidate.h.

Referenced by charge(), LeafCandidate(), setCharge(), setThreeCharge(), and threeCharge().

status word

Definition at line 336 of file LeafCandidate.h.

Referenced by longLived(), massConstraint(), setLongLived(), setMassConstraint(), setStatus(), and status().