CMS 3D CMS Logo

reco::GsfElectron Class Reference

#include <DataFormats/EgammaCandidates/interface/GsfElectron.h>

Inheritance diagram for reco::GsfElectron:

reco::RecoCandidate reco::LeafCandidate reco::Candidate reco::Particle pat::PATObject< reco::GsfElectron > pat::Lepton< reco::GsfElectron >

List of all members.

Public Member Functions

basicCluster_iterator basicClustersBegin () const
 array of pointers to the related brem clusters
basicCluster_iterator basicClustersEnd () const
float caloEnergy () const
 the super cluster energy corrected by EnergyScaleFactor
float caloEnergyError () const
 the errors on the supercluster energy and track momentum
math::XYZPoint caloPosition () const
 the super cluster position
int classification () const
 The electron classification.
void classifyElectron (const int myclass)
 determine the class of the electron
GsfElectronclone () const
 returns a clone of the Candidate object
void correctElectronEnergyScale (const float newEnergy)
 handle electron supercluster energy scale correction.
void correctElectronFourMomentum (const math::XYZTLorentzVectorD &momentum, float &enErr, float &tMerr)
 handle electron energy correction.
float deltaEtaSeedClusterTrackAtCalo () const
 the seed cluster eta - track eta at calo from outermost state
float deltaEtaSuperClusterTrackAtVtx () const
 the supercluster eta - track eta from helix extrapolation from impact point
float deltaPhiSeedClusterTrackAtCalo () const
 the seed cluster phi - track phi at calo from outermost state
float deltaPhiSuperClusterTrackAtVtx () const
 the supercluster phi - track phi from helix extrapolation from impact point
float eSeedClusterOverPout () const
 the seed cluster energy / track momentum at calo from outermost state
float eSuperClusterOverP () const
 the supercluster energy / track momentum at impact point
 GsfElectron (const LorentzVector &p4, const SuperClusterRef scl, const GsfTrackRef gsft, const GlobalPoint tssuperPos, const GlobalVector tssuperMom, const GlobalPoint tsseedPos, const GlobalVector tsseedMom, const GlobalPoint innPos, const GlobalVector innMom, const GlobalPoint vtxPos, const GlobalVector vtxMom, const GlobalPoint outPos, const GlobalVector outMom, double HoE)
 GsfElectron ()
reco::GsfTrackRef gsfTrack () const
 get associated GsfTrack pointer
float hadronicOverEm () const
 the hadronic over electromagnetic fraction
bool isElectron () const
bool isEnergyScaleCorrected () const
 tell if class dependant escale correction have been applied
bool isMomentumCorrected () const
 tell if class dependant E-p combination has been determined
int numberOfClusters () const
 number of related brem clusters
void setDeltaEtaSuperClusterAtVtx (float de)
void setDeltaPhiSuperClusterAtVtx (float dphi)
void setGsfTrack (const reco::GsfTrackRef &t)
void setSuperCluster (const reco::SuperClusterRef &scl)
SuperClusterRef superCluster () const
 get associated superCluster Pointer
reco::TrackRef track () const
 reference to a Track
math::XYZVector trackMomentumAtCalo () const
 the track momentum extrapolated at the supercluster position
math::XYZVector trackMomentumAtVtx () const
 the track momentum at vertex
float trackMomentumError () const
math::XYZVector trackMomentumOut () const
 the track momentum extrapolated from outermost position at the seed cluster position
math::XYZVector TrackPositionAtCalo () const
 the track extrapolated position at min distance to the supercluster position
math::XYZVector TrackPositionAtVtx () const
 the track impact point state position
virtual ~GsfElectron ()

Private Member Functions

virtual bool overlap (const Candidate &) const
 check overlap with another candidate

Private Attributes

float deltaEtaSeedClusterAtCalo_
float deltaEtaSuperClusterAtVtx_
float deltaPhiSeedClusterAtCalo_
float deltaPhiSuperClusterAtVtx_
int electronClass_
float energyError_
bool energyScaleCorrected_
float eSeedClusterOverPout_
float eSuperClusterOverP_
float hadOverEm_
bool momentumFromEpCombination_
reco::SuperClusterRef superCluster_
float superClusterEnergy_
reco::GsfTrackRef track_
math::XYZVector trackMomentumAtCalo_
math::XYZVector trackMomentumAtVtx_
float trackMomentumError_
math::XYZVector trackMomentumOut_
math::XYZVector trackPositionAtCalo_
math::XYZVector trackPositionAtVtx_


Detailed Description

Definition at line 66 of file GsfElectron.h.


Constructor & Destructor Documentation

reco::GsfElectron::GsfElectron (  )  [inline]

Definition at line 70 of file GsfElectron.h.

Referenced by clone().

00070 { } 

GsfElectron::GsfElectron ( const LorentzVector p4,
const SuperClusterRef  scl,
const GsfTrackRef  gsft,
const GlobalPoint  tssuperPos,
const GlobalVector  tssuperMom,
const GlobalPoint  tsseedPos,
const GlobalVector  tsseedMom,
const GlobalPoint  innPos,
const GlobalVector  innMom,
const GlobalPoint  vtxPos,
const GlobalVector  vtxMom,
const GlobalPoint  outPos,
const GlobalVector  outMom,
double  HoE 
)

Definition at line 12 of file GsfElectron.cc.

References reco::Particle::charge(), deltaEtaSeedClusterAtCalo_, deltaPhiSeedClusterAtCalo_, energyScaleCorrected_, eSeedClusterOverPout_, eSuperClusterOverP_, PV3DBase< T, PVType, FrameType >::eta(), PV3DBase< T, PVType, FrameType >::mag(), momentumFromEpCombination_, PV3DBase< T, PVType, FrameType >::phi(), pi, pi2, reco::Particle::setCharge(), reco::Particle::setP4(), reco::Particle::setPdgId(), reco::Particle::setVertex(), superCluster_, superClusterEnergy_, track_, trackMomentumAtCalo_, trackMomentumAtVtx_, trackMomentumError_, trackMomentumOut_, trackPositionAtCalo_, trackPositionAtVtx_, PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().

00020                                                                :
00021   hadOverEm_(HoE), superCluster_(scl), track_(gsft)
00022  {
00023   //
00024   // electron particle quantities
00025   //
00026 
00027   //Initialise to E from cluster + direction from track
00028 //   double scale = superCluster_->energy()/vtxMom.mag();    
00029 //   math::XYZTLorentzVectorD momentum= math::XYZTLorentzVector(vtxMom.x()*scale,
00030 //                           vtxMom.y()*scale,
00031 //                           vtxMom.z()*scale,
00032 //                        superCluster_->energy());
00033    setCharge(track_->charge());
00034    setP4(p4);
00035    setVertex(Point(vtxPos));
00036    setPdgId( -11 * charge());
00037 
00038   trackPositionAtVtx_=math::XYZVector(vtxPos.x(),vtxPos.y(),vtxPos.z());
00039   trackPositionAtCalo_=math::XYZVector(tssuperPos.x(),
00040                                        tssuperPos.y(),
00041                                        tssuperPos.z());
00042   trackMomentumAtCalo_=math::XYZVector(tssuperMom.x(),
00043                                        tssuperMom.y(),
00044                                        tssuperMom.z());
00045   trackMomentumAtVtx_=math::XYZVector(vtxMom.x(),
00046                                       vtxMom.y(),
00047                                       vtxMom.z());
00048   trackMomentumOut_=math::XYZVector(tsseedMom.x(),
00049                                         tsseedMom.y(),
00050                                         tsseedMom.z());
00051   //
00052   // supercluster - track at impact match parameters
00053   //
00054   superClusterEnergy_=superCluster_->energy();
00055   eSuperClusterOverP_=-1;
00056   //  if (innMom.R()!=0) eSuperClusterOverP_= superCluster_->energy()/innMom.R();
00057   if (innMom.mag()!=0) eSuperClusterOverP_= superCluster_->energy()/innMom.mag();
00058 //   float trackEta = ecalEta(
00059 //                                                track_->innerMomentum().eta(),
00060 //                                                   track_->innerPosition().z(),
00061 //                                                   track_->innerPosition().Rho());
00062 
00063 //   float trackPhi = ecalPhi(
00064 //                                                track_->innerMomentum().Rho(),
00065 //                                                   track_->innerMomentum().eta(),
00066 //                                                   track_->innerMomentum().phi(),
00067 //                                                track_->charge(),
00068 //                                                   track_->innerPosition().Rho());
00069 
00070 //   deltaEtaSuperClusterAtVtx_=superCluster_->position().eta() - trackEta;
00071 //   float dphi                =superCluster_->position().phi() - trackPhi;
00072 //   if (fabs(dphi)>pi)
00073 //       dphi = dphi < 0? pi2 + dphi : dphi - pi2;
00074 //   deltaPhiSuperClusterAtVtx_ = dphi;
00075 
00076   // 
00077   // seed cluster - track at calo match quantities
00078   //
00079 
00080   const BasicClusterRef seedClus = superCluster_->seed();
00081   eSeedClusterOverPout_ = -1;
00082   //  if (tsseed.globalMomentum().mag() > 0.)
00083   //    eSeedClusterOverPout_ = seedClus->energy()/tsseed.globalMomentum().mag();
00084   //  GlobalPoint tsseedPos=seedTsos.globalPosition();
00085   //  GlobalVector tsseedMom=seedTsos.globalMomentum();
00086   if (tsseedMom.mag() > 0.)
00087     eSeedClusterOverPout_ = seedClus->energy()/tsseedMom.mag();
00088 
00089   deltaEtaSeedClusterAtCalo_ = seedClus->eta() - tsseedPos.eta();
00090   float dphi                       = seedClus->phi() - tsseedPos.phi();
00091   if (fabs(dphi)>pi)
00092     dphi = dphi < 0? pi2 + dphi : dphi - pi2;
00093   deltaPhiSeedClusterAtCalo_ = dphi;
00094 
00095   //
00096   // other quantities
00097   //
00098   energyScaleCorrected_=false;
00099   momentumFromEpCombination_=false;
00100   trackMomentumError_=0;
00101   
00102   //FIXME  hadOverEm_ = superCluster_->seed()->getHoe();
00103   //FIXME  hadOverEm_ *= seedClus->energy()/superCluster_->energy();
00104 
00105 }

virtual reco::GsfElectron::~GsfElectron (  )  [inline, virtual]

Definition at line 82 of file GsfElectron.h.

00082 {};


Member Function Documentation

basicCluster_iterator reco::GsfElectron::basicClustersBegin (  )  const [inline]

array of pointers to the related brem clusters

Definition at line 165 of file GsfElectron.h.

References superCluster_.

00165 { return superCluster_->clustersBegin(); }

basicCluster_iterator reco::GsfElectron::basicClustersEnd (  )  const [inline]

Definition at line 166 of file GsfElectron.h.

References superCluster_.

00166 { return superCluster_->clustersEnd(); }

float reco::GsfElectron::caloEnergy (  )  const [inline]

the super cluster energy corrected by EnergyScaleFactor

Definition at line 107 of file GsfElectron.h.

References superClusterEnergy_.

Referenced by GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), EgHLTOffEle::caloEnergy(), ElectronMomentumCorrector::correct(), pat::ElectronSelector::customSelection_(), EgammaObjects::findRecoMass(), EgHLTOffEle::invEOverInvP(), and PTDRElectronID::result().

00107 {return superClusterEnergy_;}

float reco::GsfElectron::caloEnergyError (  )  const [inline]

the errors on the supercluster energy and track momentum

Definition at line 151 of file GsfElectron.h.

References energyError_.

00151 {return energyError_;}

math::XYZPoint reco::GsfElectron::caloPosition (  )  const [inline]

the super cluster position

Definition at line 109 of file GsfElectron.h.

References superCluster().

Referenced by ElectronClassification::classify(), EgammaObjects::findRecoMass(), and ElectronEnergyCorrector::setNewEnergy().

00109 {return superCluster()->position();}

int reco::GsfElectron::classification (  )  const [inline]

The electron classification.

barrel : 0: golden, 10: bigbrem, 20: narrow, 30-34: showering, (30: showering nbrem=0, 31: showering nbrem=1, 32: showering nbrem=2 ,33: showering nbrem=3, 34: showering nbrem>=4) 40: crack endcaps : 100: golden, 110: bigbrem, 120: narrow, 130-134: showering (130: showering nbrem=0, 131: showering nbrem=1, 132: showering nbrem=2 ,133: showering nbrem=3, 134: showering nbrem>=4)

Definition at line 94 of file GsfElectron.h.

References electronClass_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), EgHLTOffEle::classification(), ElectronMomentumCorrector::correct(), ZeePlots::fillEleClassesPlots(), ZeeCalibration::getEtaCorrection(), ElectronLikelihood::result(), PTDRElectronID::result(), and ElectronEnergyCorrector::setNewEnergy().

00094 {return electronClass_;}

void GsfElectron::classifyElectron ( const int  myclass  ) 

determine the class of the electron

Definition at line 137 of file GsfElectron.cc.

References electronClass_.

Referenced by ElectronClassification::correct().

00138 {
00139   electronClass_ = myclass;
00140 }

GsfElectron * GsfElectron::clone ( void   )  const [virtual]

returns a clone of the Candidate object

Reimplemented from reco::LeafCandidate.

Reimplemented in pat::Lepton< reco::GsfElectron >.

Definition at line 151 of file GsfElectron.cc.

References GsfElectron().

00151                                        { 
00152   return new GsfElectron( * this ); 
00153 }

void GsfElectron::correctElectronEnergyScale ( const float  newEnergy  ) 

handle electron supercluster energy scale correction.

Propagates new energy value to all electron attributes and sets energyScaleCorrected_ to true

Definition at line 107 of file GsfElectron.cc.

References energyScaleCorrected_, eSuperClusterOverP_, hadOverEm_, reco::Particle::momentum(), reco::Particle::p4(), reco::Particle::setP4(), and superClusterEnergy_.

Referenced by ElectronEnergyCorrector::correct().

00107                                                                   {
00108   
00109   //   float newEnergy = thecorr->getCorrectedEnergy();
00110  
00111   //momentum_*=newEnergy/momentum_.e();
00112   math::XYZTLorentzVectorD momentum=p4();
00113   momentum*=newEnergy/momentum.e();
00114   setP4(momentum);
00115   hadOverEm_ *=superClusterEnergy_/newEnergy; 
00116   eSuperClusterOverP_*=newEnergy/superClusterEnergy_;
00117   superClusterEnergy_=newEnergy;
00118  
00119   energyScaleCorrected_=true;    
00120 }

void GsfElectron::correctElectronFourMomentum ( const math::XYZTLorentzVectorD momentum,
float &  enErr,
float &  tMerr 
)

handle electron energy correction.

Rescales 4 momentum from corrected energy value and sets momentumFromEpCombination_ to true

Definition at line 123 of file GsfElectron.cc.

References energyError_, momentumFromEpCombination_, reco::Particle::setP4(), and trackMomentumError_.

Referenced by ElectronMomentumCorrector::correct().

00123                                                                                                                   {
00124  
00125   //   momentum_ = thecorr->getBestMomentum();
00126   setP4(momentum);
00127   //   energyError_ = thecorr->getSCEnergyError();
00128   energyError_ = enErr;
00129   //   trackMomentumError_ = thecorr->getTrackMomentumError();
00130   trackMomentumError_ = tmErr;
00131 
00132   momentumFromEpCombination_=true;
00133 }

float reco::GsfElectron::deltaEtaSeedClusterTrackAtCalo (  )  const [inline]

the seed cluster eta - track eta at calo from outermost state

Definition at line 127 of file GsfElectron.h.

References deltaEtaSeedClusterAtCalo_.

Referenced by GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), and ElectronLikelihood::getInputVar().

float reco::GsfElectron::deltaEtaSuperClusterTrackAtVtx (  )  const [inline]

the supercluster eta - track eta from helix extrapolation from impact point

Definition at line 125 of file GsfElectron.h.

References deltaEtaSuperClusterAtVtx_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), pat::ElectronSelector::customSelection_(), EgHLTOffEle::dEtaIn(), PTDRElectronID::result(), and CutBasedElectronID::result().

float reco::GsfElectron::deltaPhiSeedClusterTrackAtCalo (  )  const [inline]

the seed cluster phi - track phi at calo from outermost state

Definition at line 131 of file GsfElectron.h.

References deltaPhiSeedClusterAtCalo_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), pat::ElectronSelector::customSelection_(), EgHLTOffEle::dPhiOut(), and PTDRElectronID::result().

float reco::GsfElectron::deltaPhiSuperClusterTrackAtVtx (  )  const [inline]

the supercluster phi - track phi from helix extrapolation from impact point

Definition at line 129 of file GsfElectron.h.

References deltaPhiSuperClusterAtVtx_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), pat::ElectronSelector::customSelection_(), EgHLTOffEle::dPhiIn(), ElectronLikelihood::getInputVar(), PTDRElectronID::result(), and CutBasedElectronID::result().

float reco::GsfElectron::eSeedClusterOverPout (  )  const [inline]

the seed cluster energy / track momentum at calo from outermost state

Definition at line 123 of file GsfElectron.h.

References eSeedClusterOverPout_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), EgHLTOffEle::epOut(), ElectronLikelihood::getInputVar(), and PTDRElectronID::result().

00123 {return eSeedClusterOverPout_;}

float reco::GsfElectron::eSuperClusterOverP (  )  const [inline]

the supercluster energy / track momentum at impact point

Definition at line 121 of file GsfElectron.h.

References eSuperClusterOverP_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), CutBasedElectronID::classify(), pat::ElectronSelector::customSelection_(), EgHLTOffEle::epIn(), PTDRElectronID::result(), and CutBasedElectronID::result().

00121 {return eSuperClusterOverP_;}

reco::GsfTrackRef reco::GsfElectron::gsfTrack (  )  const [inline, virtual]

get associated GsfTrack pointer

Reimplemented from reco::RecoCandidate.

Definition at line 158 of file GsfElectron.h.

References track_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), ElectronClassification::classify(), HLTTauRefProducer::ElectronTrkIsolation(), pat::Electron::embedGsfTrack(), ElectronTkIsolation::getIso(), pat::Electron::gsfTrack(), and overlap().

00158 { return track_; } 

float reco::GsfElectron::hadronicOverEm (  )  const [inline]

the hadronic over electromagnetic fraction

Definition at line 134 of file GsfElectron.h.

References hadOverEm_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), pat::ElectronSelector::customSelection_(), ElectronLikelihood::getInputVar(), EgHLTOffEle::hOverE(), PTDRElectronID::result(), and CutBasedElectronID::result().

00134 {return hadOverEm_;}

bool GsfElectron::isElectron (  )  const [virtual]

Reimplemented from reco::Candidate.

Definition at line 155 of file GsfElectron.cc.

00155                                    {
00156   return true;
00157 }

bool reco::GsfElectron::isEnergyScaleCorrected (  )  const [inline]

tell if class dependant escale correction have been applied

Definition at line 138 of file GsfElectron.h.

References energyScaleCorrected_.

Referenced by ElectronEnergyCorrector::correct().

00138 {return energyScaleCorrected_;}

bool reco::GsfElectron::isMomentumCorrected (  )  const [inline]

tell if class dependant E-p combination has been determined

Definition at line 140 of file GsfElectron.h.

References momentumFromEpCombination_.

Referenced by ElectronMomentumCorrector::correct().

int reco::GsfElectron::numberOfClusters (  )  const [inline]

number of related brem clusters

Definition at line 162 of file GsfElectron.h.

References superCluster_.

Referenced by ElectronClassification::classify().

00162 {return superCluster_->clustersSize();}

bool GsfElectron::overlap ( const Candidate c  )  const [private, virtual]

check overlap with another candidate

Implements reco::RecoCandidate.

Definition at line 142 of file GsfElectron.cc.

References reco::RecoCandidate::checkOverlap(), gsfTrack(), reco::RecoCandidate::gsfTrack(), superCluster(), and reco::RecoCandidate::superCluster().

00142                                                      {
00143   const RecoCandidate * o = dynamic_cast<const RecoCandidate *>( & c );
00144   return ( o != 0 && 
00145            ( checkOverlap( gsfTrack(), o->gsfTrack() ) ||
00146              checkOverlap( superCluster(), o->superCluster() ) ) 
00147            );
00148   return false;
00149 }

void reco::GsfElectron::setDeltaEtaSuperClusterAtVtx ( float  de  )  [inline]

Definition at line 99 of file GsfElectron.h.

References deltaEtaSuperClusterAtVtx_.

Referenced by GsfElectronAlgo::createElectron(), and GlobalGsfElectronAlgo::createElectron().

void reco::GsfElectron::setDeltaPhiSuperClusterAtVtx ( float  dphi  )  [inline]

Definition at line 100 of file GsfElectron.h.

References deltaPhiSuperClusterAtVtx_.

Referenced by GsfElectronAlgo::createElectron(), and GlobalGsfElectronAlgo::createElectron().

void reco::GsfElectron::setGsfTrack ( const reco::GsfTrackRef t  )  [inline]

Definition at line 103 of file GsfElectron.h.

References track_.

Referenced by ElectronRecalibSuperClusterAssociator::produce().

00103 { track_=t;}

void reco::GsfElectron::setSuperCluster ( const reco::SuperClusterRef scl  )  [inline]

Definition at line 102 of file GsfElectron.h.

References superCluster_.

Referenced by ElectronRecalibSuperClusterAssociator::produce().

00102 {superCluster_=scl;}

SuperClusterRef reco::GsfElectron::superCluster (  )  const [inline, virtual]

get associated superCluster Pointer

Reimplemented from reco::RecoCandidate.

Definition at line 155 of file GsfElectron.h.

References superCluster_.

Referenced by ZIterativeAlgorithmWithFit::addEvent(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), EgammaObjects::analyzeElectrons(), ElectronLikelihood::CalculateFisher(), caloPosition(), ElectronClassification::classify(), pat::Electron::embedSuperCluster(), EgHLTOffEle::etaSC(), EgHLTOffEle::etSC(), ZeeCalibration::fillEleInfo(), calib::CalibElectron::getCalibModulesWeights(), ZeeCalibration::getEtaCorrection(), ElectronLikelihood::getInputVar(), ZIterativeAlgorithmWithFit::getWeight(), overlap(), EgHLTOffEle::phiSC(), ElectronLikelihood::result(), PTDRElectronID::result(), CutBasedElectronID::result(), ElectronEnergyCorrector::setNewEnergy(), and pat::Electron::superCluster().

00155 { return superCluster_; } 

reco::TrackRef reco::GsfElectron::track ( void   )  const [inline, virtual]

reference to a Track

Reimplemented from reco::RecoCandidate.

Definition at line 159 of file GsfElectron.h.

Referenced by pat::Electron::embedTrack().

00159 {return TrackRef();} 

math::XYZVector reco::GsfElectron::trackMomentumAtCalo (  )  const [inline]

the track momentum extrapolated at the supercluster position

Definition at line 115 of file GsfElectron.h.

References trackMomentumAtCalo_.

Referenced by ElectronCalibrationUniv::analyze(), ElectronCalibration::analyze(), EgHLTOffEle::pCalo(), and EgHLTOffEle::ptCalo().

00115 {return trackMomentumAtCalo_;}

math::XYZVector reco::GsfElectron::trackMomentumAtVtx (  )  const [inline]

the track momentum at vertex

Definition at line 111 of file GsfElectron.h.

References trackMomentumAtVtx_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), GsfElectronFakeAnalyzer::analyze(), ElectronCalibration::analyze(), ElectronClassification::classify(), CutBasedElectronID::classify(), ElectronMomentumCorrector::correct(), pat::ElectronSelector::customSelection_(), HLTTauRefProducer::ElectronTrkIsolation(), EgHLTOffEle::invEOverInvP(), EgHLTOffEle::ptVtx(), EgHLTOffEle::pVtx(), PTDRElectronID::result(), and CutBasedElectronID::result().

00111 {return trackMomentumAtVtx_;}

float reco::GsfElectron::trackMomentumError (  )  const [inline]

Definition at line 152 of file GsfElectron.h.

References trackMomentumError_.

Referenced by ElectronCalibrationUniv::analyze(), and ElectronCalibration::analyze().

00152 {return trackMomentumError_;}

math::XYZVector reco::GsfElectron::trackMomentumOut (  )  const [inline]

the track momentum extrapolated from outermost position at the seed cluster position

Definition at line 117 of file GsfElectron.h.

References trackMomentumOut_.

Referenced by ElectronAnalyzer::analyze(), GsfElectronDataAnalyzer::analyze(), ElectronCalibrationUniv::analyze(), GsfElectronMCAnalyzer::analyze(), ElectronCalibration::analyze(), GsfElectronFakeAnalyzer::analyze(), ElectronClassification::classify(), CutBasedElectronID::classify(), pat::ElectronSelector::customSelection_(), PTDRElectronID::result(), and CutBasedElectronID::result().

00117 {return trackMomentumOut_;}

math::XYZVector reco::GsfElectron::TrackPositionAtCalo (  )  const [inline]

the track extrapolated position at min distance to the supercluster position

Definition at line 119 of file GsfElectron.h.

References trackPositionAtCalo_.

00119 {return trackPositionAtCalo_;}

math::XYZVector reco::GsfElectron::TrackPositionAtVtx (  )  const [inline]

the track impact point state position

Definition at line 113 of file GsfElectron.h.

References trackPositionAtVtx_.

Referenced by EgHLTOffEle::zVtx().

00113 {return trackPositionAtVtx_;}


Member Data Documentation

float reco::GsfElectron::deltaEtaSeedClusterAtCalo_ [private]

Definition at line 192 of file GsfElectron.h.

Referenced by deltaEtaSeedClusterTrackAtCalo(), and GsfElectron().

float reco::GsfElectron::deltaEtaSuperClusterAtVtx_ [private]

Definition at line 191 of file GsfElectron.h.

Referenced by deltaEtaSuperClusterTrackAtVtx(), and setDeltaEtaSuperClusterAtVtx().

float reco::GsfElectron::deltaPhiSeedClusterAtCalo_ [private]

Definition at line 194 of file GsfElectron.h.

Referenced by deltaPhiSeedClusterTrackAtCalo(), and GsfElectron().

float reco::GsfElectron::deltaPhiSuperClusterAtVtx_ [private]

Definition at line 193 of file GsfElectron.h.

Referenced by deltaPhiSuperClusterTrackAtVtx(), and setDeltaPhiSuperClusterAtVtx().

int reco::GsfElectron::electronClass_ [private]

Definition at line 185 of file GsfElectron.h.

Referenced by classification(), and classifyElectron().

float reco::GsfElectron::energyError_ [private]

Definition at line 182 of file GsfElectron.h.

Referenced by caloEnergyError(), and correctElectronFourMomentum().

bool reco::GsfElectron::energyScaleCorrected_ [private]

Definition at line 201 of file GsfElectron.h.

Referenced by correctElectronEnergyScale(), GsfElectron(), and isEnergyScaleCorrected().

float reco::GsfElectron::eSeedClusterOverPout_ [private]

Definition at line 189 of file GsfElectron.h.

Referenced by eSeedClusterOverPout(), and GsfElectron().

float reco::GsfElectron::eSuperClusterOverP_ [private]

Definition at line 188 of file GsfElectron.h.

Referenced by correctElectronEnergyScale(), eSuperClusterOverP(), and GsfElectron().

float reco::GsfElectron::hadOverEm_ [private]

Definition at line 196 of file GsfElectron.h.

Referenced by correctElectronEnergyScale(), and hadronicOverEm().

bool reco::GsfElectron::momentumFromEpCombination_ [private]

Definition at line 202 of file GsfElectron.h.

Referenced by correctElectronFourMomentum(), GsfElectron(), and isMomentumCorrected().

reco::SuperClusterRef reco::GsfElectron::superCluster_ [private]

Definition at line 198 of file GsfElectron.h.

Referenced by basicClustersBegin(), basicClustersEnd(), GsfElectron(), numberOfClusters(), setSuperCluster(), and superCluster().

float reco::GsfElectron::superClusterEnergy_ [private]

Definition at line 187 of file GsfElectron.h.

Referenced by caloEnergy(), correctElectronEnergyScale(), and GsfElectron().

reco::GsfTrackRef reco::GsfElectron::track_ [private]

Definition at line 199 of file GsfElectron.h.

Referenced by GsfElectron(), gsfTrack(), and setGsfTrack().

math::XYZVector reco::GsfElectron::trackMomentumAtCalo_ [private]

Definition at line 178 of file GsfElectron.h.

Referenced by GsfElectron(), and trackMomentumAtCalo().

math::XYZVector reco::GsfElectron::trackMomentumAtVtx_ [private]

Definition at line 176 of file GsfElectron.h.

Referenced by GsfElectron(), and trackMomentumAtVtx().

float reco::GsfElectron::trackMomentumError_ [private]

Definition at line 183 of file GsfElectron.h.

Referenced by correctElectronFourMomentum(), GsfElectron(), and trackMomentumError().

math::XYZVector reco::GsfElectron::trackMomentumOut_ [private]

Definition at line 180 of file GsfElectron.h.

Referenced by GsfElectron(), and trackMomentumOut().

math::XYZVector reco::GsfElectron::trackPositionAtCalo_ [private]

Definition at line 179 of file GsfElectron.h.

Referenced by GsfElectron(), and TrackPositionAtCalo().

math::XYZVector reco::GsfElectron::trackPositionAtVtx_ [private]

Definition at line 177 of file GsfElectron.h.

Referenced by GsfElectron(), and TrackPositionAtVtx().


The documentation for this class was generated from the following files:
Generated on Tue Jun 9 18:51:07 2009 for CMSSW by  doxygen 1.5.4