CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Public Types | Public Member Functions | Static Public Attributes | Protected Types | Protected Member Functions | Protected Attributes | Friends
pat::PackedCandidate Class Reference

#include <PackedCandidate.h>

Inheritance diagram for pat::PackedCandidate:
reco::Candidate

Public Types

typedef reco::CandidateCollection daughters
 collection of daughter candidates More...
 
typedef unsigned int index
 
typedef math::XYZTLorentzVector LorentzVector
 Lorentz vector. More...
 
enum  LostInnerHits { validHitInFirstPixelBarrelLayer =-1, noLostInnerHits =0, oneLostInnerHit =1, moreLostInnerHits =2 }
 Enumerator specifying the. More...
 
typedef math::XYZPoint Point
 point in the space More...
 
typedef
math::PtEtaPhiMLorentzVector 
PolarLorentzVector
 Lorentz vector. More...
 
enum  PVAssoc { NoPV =0, PVLoose =1, PVTight =2, PVUsedInFit =3 }
 This refers to the association to PV=ipv. >=PVLoose corresponds to JME definition, >=PVTight to isolation definition. More...
 
enum  PVAssociationQuality {
  NotReconstructedPrimary =0, OtherDeltaZ =1, CompatibilityBTag =4, CompatibilityDz =5,
  UsedInFitLoose =6, UsedInFitTight =7
}
 
typedef math::XYZVector Vector
 point in the space More...
 
- Public Types inherited from reco::Candidate
enum  { dimension = 3 }
 
enum  { size = dimension * (dimension + 1)/2 }
 matix size More...
 
typedef int Charge
 electric charge type More...
 
typedef candidate::const_iterator const_iterator
 
typedef math::Error< dimension >
::type 
CovarianceMatrix
 covariance error matrix (3x3) More...
 
typedef unsigned int index
 index type More...
 
typedef candidate::iterator iterator
 
typedef math::XYZTLorentzVector LorentzVector
 Lorentz vector. More...
 
typedef math::XYZPoint Point
 point in the space More...
 
typedef
math::PtEtaPhiMLorentzVector 
PolarLorentzVector
 Lorentz vector. More...
 
typedef size_t size_type
 
typedef math::XYZVector Vector
 point in the space More...
 

Public Member Functions

virtual const reco::TrackbestTrack () const
 return a pointer to the track if present. otherwise, return a null pointer More...
 
virtual Vector boostToCM () const
 
virtual int charge () const
 electric charge More...
 
virtual PackedCandidateclone () const
 returns a clone of the Candidate object More...
 
virtual const reco::Candidatedaughter (size_type) const
 return daughter at a given position (throws an exception) More...
 
virtual reco::Candidatedaughter (size_type)
 return daughter at a given position (throws an exception) More...
 
virtual reco::Candidatedaughter (const std::string &s)
 return daughter with a specified role name More...
 
virtual const reco::Candidatedaughter (const std::string &s) const
 return daughter with a specified role name More...
 
virtual float dxy () const
 dxy with respect to the PV ref More...
 
virtual float dxy (const Point &p) const
 dxy with respect to another point More...
 
virtual float dxyError () const
 uncertainty on dxy More...
 
virtual float dz (size_t ipv=0) const
 dz with respect to the PV[ipv] More...
 
virtual float dz (const Point &p) const
 dz with respect to another point More...
 
virtual float dzAssociatedPV () const
 dz with respect to the PV ref More...
 
virtual float dzError () const
 uncertainty on dz More...
 
virtual double energy () const
 energy More...
 
double et () const
 transverse energy More...
 
double et2 () const
 transverse energy squared (use this for cuts)! More...
 
virtual double eta () const
 momentum pseudorapidity More...
 
virtual void fillVertexCovariance (CovarianceMatrix &v) const
 fill SMatrix More...
 
const PVAssoc fromPV (size_t ipv=0) const
 
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
 
virtual bool longLived () const
 is long lived? More...
 
LostInnerHits lostInnerHits () const
 
virtual double mass () const
 mass More...
 
virtual bool massConstraint () const
 do mass constraint? More...
 
virtual double massSqr () const
 mass squared More...
 
virtual const
reco::CandidateBaseRef
masterClone () const
 
virtual const reco::CandidatePtrmasterClonePtr () const
 
template<typename Ref >
Ref masterRef () const
 cast master clone reference to a concrete type More...
 
virtual Vector momentum () const
 spatial momentum vector More...
 
virtual const reco::Candidatemother (size_type) const
 return mother at a given position (throws an exception) More...
 
virtual double mt () const
 transverse mass More...
 
virtual double mtSqr () const
 transverse mass squared More...
 
virtual size_t numberOfDaughters () const
 number of daughters More...
 
int numberOfHits () const
 
virtual size_t numberOfMothers () const
 number of mothers More...
 
int numberOfPixelHits () const
 
virtual size_t numberOfSourceCandidatePtrs () const
 
virtual double p () const
 magnitude of momentum vector More...
 
virtual const LorentzVectorp4 () const
 four-momentum Lorentz vecto r More...
 
 PackedCandidate ()
 default constructor More...
 
 PackedCandidate (const reco::Candidate &c, const reco::VertexRefProd &pvRefProd, reco::VertexRef::key_type pvRefKey)
 
 PackedCandidate (const PolarLorentzVector &p4, const Point &vtx, float phiAtVtx, int pdgId, const reco::VertexRefProd &pvRefProd, reco::VertexRef::key_type pvRefKey)
 
 PackedCandidate (const LorentzVector &p4, const Point &vtx, float phiAtVtx, int pdgId, const reco::VertexRefProd &pvRefProd, reco::VertexRef::key_type pvRefKey)
 
virtual int pdgId () const
 PDG identifier. More...
 
virtual double phi () const
 momentum azimuthal angle More...
 
virtual float phiAtVtx () const
 momentum azimuthal angle from the track (normally identical to phi()) More...
 
virtual const PolarLorentzVectorpolarP4 () const
 four-momentum Lorentz vector More...
 
virtual const reco::TrackpseudoTrack () const
 Return reference to a pseudo track made with candidate kinematics, parameterized error for eta,phi,pt and full IP covariance. More...
 
virtual double pt () const
 transverse momentum More...
 
float puppiWeight () const
 Set both weights at once (with option for only full PUPPI) More...
 
float puppiWeightNoLep () const
 Weight from full PUPPI. More...
 
const PVAssociationQuality pvAssociationQuality () const
 
virtual double px () const
 x coordinate of momentum vector More...
 
virtual double py () const
 y coordinate of momentum vector More...
 
virtual double pz () const
 z coordinate of momentum vector More...
 
virtual double rapidity () const
 rapidity More...
 
void setAssociationQuality (PVAssociationQuality q)
 
virtual void setCharge (int charge)
 set electric charge More...
 
virtual void setLongLived ()
 set long lived flag More...
 
void setLostInnerHits (LostInnerHits hits)
 
virtual void setMass (double m)
 set particle mass More...
 
virtual void setMassConstraint ()
 set mass constraint flag More...
 
void setMuonID (bool isStandAlone, bool isGlobal)
 
virtual void setP4 (const LorentzVector &p4)
 set 4-momentum More...
 
virtual void setP4 (const PolarLorentzVector &p4)
 set 4-momentum More...
 
virtual void setPdgId (int pdgId)
 
void setPuppiWeight (float p, float p_nolep=0.0)
 
virtual void setPz (double pz)
 
virtual void setStatus (int status)
 set status word More...
 
virtual void setThreeCharge (int threecharge)
 set electric charge More...
 
void setTrackHighPurity (bool highPurity)
 set to true if the track had the highPurity quality bit More...
 
virtual void setTrackProperties (const reco::Track &tk, const reco::Track::CovarianceMatrix &covariance)
 set impact parameters covariance More...
 
virtual void setTrackProperties (const reco::Track &tk)
 
virtual void setVertex (const Point &vertex)
 set vertex More...
 
virtual reco::CandidatePtr sourceCandidatePtr (size_type i) const
 
virtual int status () const
 status word More...
 
virtual double theta () const
 momentum polar angle More...
 
virtual int threeCharge () const
 electric charge More...
 
bool trackHighPurity () const
 true if the track had the highPurity quality bit More...
 
virtual const Pointvertex () const
 vertex position More...
 
virtual double vertexChi2 () const
 chi-squares More...
 
virtual double vertexCovariance (int i, int j) const
 (i, j)-th element of error matrix, i, j = 0, ... 2 More...
 
CovarianceMatrix vertexCovariance () const
 return SMatrix More...
 
virtual double vertexNdof () const
 
virtual double vertexNormalizedChi2 () const
 chi-squared divided by n.d.o.f. More...
 
const reco::VertexRef vertexRef () const
 
virtual double vx () const
 x coordinate of vertex position More...
 
virtual double vy () const
 y coordinate of vertex position More...
 
virtual double vz () const
 z coordinate of vertex position More...
 
virtual double y () const
 rapidity More...
 
virtual ~PackedCandidate ()
 destructor More...
 
- Public Member Functions inherited from reco::Candidate
const_iterator begin () const
 first daughter const_iterator More...
 
iterator begin ()
 first daughter iterator More...
 
 Candidate ()
 default constructor More...
 
const_iterator end () const
 last daughter const_iterator More...
 
iterator end ()
 last daughter iterator More...
 
template<typename T >
T get () const
 get a component More...
 
template<typename T , typename Tag >
T get () const
 get a component More...
 
template<typename T >
T get (size_type i) const
 get a component More...
 
template<typename T , typename Tag >
T get (size_type i) const
 get a component More...
 
template<typename Ref >
Ref masterRef () const
 cast master clone reference to a concrete type More...
 
template<typename T >
size_type numberOf () const
 number of components More...
 
template<typename T , typename Tag >
size_type numberOf () const
 number of components More...
 
virtual void setP4 (const PolarLorentzVector &p4)=0
 set 4-momentum More...
 
virtual void setSourceCandidatePtr (const CandidatePtr &ptr)
 Set the ptr to the source Candidate. More...
 
virtual void setVertex (const Point &vertex)=0
 set vertex More...
 
virtual ~Candidate ()
 destructor More...
 

Static Public Attributes

static const unsigned int longLivedTag = 0
 long lived flag More...
 
static const unsigned int massConstraintTag = 0
 do mass constraint flag More...
 

Protected Types

enum  qualityFlagsShiftsAndMasks {
  assignmentQualityMask = 0x7, assignmentQualityShift = 0, trackHighPurityMask = 0x8, trackHighPurityShift =3,
  lostInnerHitsMask = 0x30, lostInnerHitsShift =4, muonFlagsMask = 0x0600, muonFlagsShift =9
}
 

Protected Member Functions

void maybeUnpackBoth () const
 
virtual bool overlap (const reco::Candidate &) const
 check overlap with another Candidate More...
 
void pack (bool unpackAfterwards=true)
 
void packBoth ()
 
void packVtx (bool unpackAfterwards=true)
 
void unpack () const
 
void unpackTrk () const
 
void unpackVtx () const
 

Protected Attributes

float detadeta_
 
float dlambdadz_
 
float dphi_
 
float dphidphi_
 
float dphidxy_
 
float dptdpt_
 
float dxy_
 
float dxydxy_
 IP covariance. More...
 
float dxydz_
 
float dz_
 
float dzdz_
 
uint8_t normalizedChi2_
 track quality information More...
 
PolarLorentzVector p4_
 the four vector More...
 
LorentzVector p4c_
 
int8_t packedCovarianceDetaDeta_
 
int8_t packedCovarianceDlambdaDz_
 
int8_t packedCovarianceDphiDphi_
 
int8_t packedCovarianceDphiDxy_
 
int8_t packedCovarianceDptDpt_
 
uint16_t packedCovarianceDxyDxy_
 
uint16_t packedCovarianceDxyDz_
 
uint16_t packedCovarianceDzDz_
 
uint16_t packedDPhi_
 
uint16_t packedDxy_
 
uint16_t packedDz_
 
uint16_t packedEta_
 
uint8_t packedHits_
 
uint16_t packedM_
 
uint16_t packedPhi_
 
uint16_t packedPt_
 Weight from PUPPI removing leptons. More...
 
int8_t packedPuppiweight_
 
int8_t packedPuppiweightNoLepDiff_
 
int pdgId_
 PDG identifier. More...
 
reco::VertexRef::key_type pvRefKey_
 
reco::VertexRefProd pvRefProd_
 Use these to build a Ref to primary vertex. More...
 
uint16_t qualityFlags_
 
reco::Track track_
 reco::Track More...
 
bool unpacked_
 
bool unpackedTrk_
 
bool unpackedVtx_
 
Point vertex_
 vertex position More...
 

Friends

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

Detailed Description

Definition at line 14 of file PackedCandidate.h.

Member Typedef Documentation

collection of daughter candidates

Definition at line 17 of file PackedCandidate.h.

typedef unsigned int pat::PackedCandidate::index

Definition at line 27 of file PackedCandidate.h.

Lorentz vector.

Definition at line 19 of file PackedCandidate.h.

point in the space

Definition at line 23 of file PackedCandidate.h.

Lorentz vector.

Definition at line 21 of file PackedCandidate.h.

point in the space

Definition at line 25 of file PackedCandidate.h.

Member Enumeration Documentation

Enumerator specifying the.

Enumerator
validHitInFirstPixelBarrelLayer 
noLostInnerHits 
oneLostInnerHit 
moreLostInnerHits 

Definition at line 287 of file PackedCandidate.h.

This refers to the association to PV=ipv. >=PVLoose corresponds to JME definition, >=PVTight to isolation definition.

Enumerator
NoPV 
PVLoose 
PVTight 
PVUsedInFit 

Definition at line 233 of file PackedCandidate.h.

The following contains information about how the association to the PV, given in vertexRef, is obtained.

Enumerator
NotReconstructedPrimary 
OtherDeltaZ 
CompatibilityBTag 
CompatibilityDz 
UsedInFitLoose 
UsedInFitTight 

Definition at line 245 of file PackedCandidate.h.

Constructor & Destructor Documentation

pat::PackedCandidate::PackedCandidate ( )
inline

default constructor

Definition at line 30 of file PackedCandidate.h.

Referenced by clone().

30  :
31  p4_(0,0,0,0), p4c_(0,0,0,0), vertex_(0,0,0), dphi_(0), pdgId_(0),
33  unpacked_(false), unpackedVtx_(true), unpackedTrk_(false), dxydxy_(0),
34  dzdz_(0),dxydz_(0),dlambdadz_(0), dphidxy_(0),dptdpt_(0),detadeta_(0),
reco::VertexRef::key_type pvRefKey_
PolarLorentzVector p4_
the four vector
static key_type invalidKey()
Definition: Ref.h:172
Point vertex_
vertex position
uint8_t normalizedChi2_
track quality information
float dxydxy_
IP covariance.
int pdgId_
PDG identifier.
pat::PackedCandidate::PackedCandidate ( const reco::Candidate c,
const reco::VertexRefProd pvRefProd,
reco::VertexRef::key_type  pvRefKey 
)
inlineexplicit

Definition at line 37 of file PackedCandidate.h.

References packBoth().

39  :
40  p4_(c.pt(), c.eta(), c.phi(), c.mass()), p4c_(p4_), vertex_(c.vertex()),
41  dphi_(0), pdgId_(c.pdgId()), qualityFlags_(0), pvRefProd_(pvRefProd),
42  pvRefKey_(pvRefKey), unpacked_(true), unpackedVtx_(true),
43  unpackedTrk_(false), dxydxy_(0),dzdz_(0),dxydz_(0), dlambdadz_(0),
45  normalizedChi2_(0) {
46  packBoth();
47  }
virtual double pt() const =0
transverse momentum
reco::VertexRef::key_type pvRefKey_
virtual double mass() const =0
mass
PolarLorentzVector p4_
the four vector
virtual const Point & vertex() const =0
vertex position
Point vertex_
vertex position
virtual int pdgId() const =0
PDG identifier.
uint8_t normalizedChi2_
track quality information
float dxydxy_
IP covariance.
int pdgId_
PDG identifier.
virtual double phi() const =0
momentum azimuthal angle
virtual double eta() const =0
momentum pseudorapidity
reco::VertexRefProd pvRefProd_
Use these to build a Ref to primary vertex.
pat::PackedCandidate::PackedCandidate ( const PolarLorentzVector p4,
const Point vtx,
float  phiAtVtx,
int  pdgId,
const reco::VertexRefProd pvRefProd,
reco::VertexRef::key_type  pvRefKey 
)
inlineexplicit

Definition at line 49 of file PackedCandidate.h.

References packBoth().

52  :
53  p4_(p4), p4c_(p4_), vertex_(vtx),
55  qualityFlags_(0), pvRefProd_(pvRefProd), pvRefKey_(pvRefKey),
56  unpacked_(true), unpackedVtx_(true), unpackedTrk_(false),
57  dxydxy_(0),dzdz_(0),dxydz_(0),dlambdadz_(0),dphidxy_(0),dptdpt_(0),
59  packBoth();
60  }
reco::VertexRef::key_type pvRefKey_
PolarLorentzVector p4_
the four vector
Point vertex_
vertex position
double deltaPhi(double phi1, double phi2)
Definition: deltaPhi.h:12
uint8_t normalizedChi2_
track quality information
float dxydxy_
IP covariance.
virtual float phiAtVtx() const
momentum azimuthal angle from the track (normally identical to phi())
int pdgId_
PDG identifier.
virtual const LorentzVector & p4() const
four-momentum Lorentz vecto r
virtual int pdgId() const
PDG identifier.
reco::VertexRefProd pvRefProd_
Use these to build a Ref to primary vertex.
pat::PackedCandidate::PackedCandidate ( const LorentzVector p4,
const Point vtx,
float  phiAtVtx,
int  pdgId,
const reco::VertexRefProd pvRefProd,
reco::VertexRef::key_type  pvRefKey 
)
inlineexplicit

Definition at line 62 of file PackedCandidate.h.

References packBoth().

65  :
66  p4_(p4.Pt(), p4.Eta(), p4.Phi(), p4.M()), p4c_(p4), vertex_(vtx),
68  pvRefProd_(pvRefProd), pvRefKey_(pvRefKey), unpacked_(true),
69  unpackedVtx_(true), unpackedTrk_(false), dxydxy_(0),dzdz_(0),dxydz_(0),
72  packBoth();
73  }
reco::VertexRef::key_type pvRefKey_
PolarLorentzVector p4_
the four vector
Point vertex_
vertex position
double deltaPhi(double phi1, double phi2)
Definition: deltaPhi.h:12
uint8_t normalizedChi2_
track quality information
float dxydxy_
IP covariance.
virtual float phiAtVtx() const
momentum azimuthal angle from the track (normally identical to phi())
int pdgId_
PDG identifier.
virtual const LorentzVector & p4() const
four-momentum Lorentz vecto r
virtual int pdgId() const
PDG identifier.
reco::VertexRefProd pvRefProd_
Use these to build a Ref to primary vertex.
pat::PackedCandidate::~PackedCandidate ( )
virtual

destructor

Definition at line 117 of file PackedCandidate.cc.

117 { }

Member Function Documentation

virtual const reco::Track* pat::PackedCandidate::bestTrack ( ) const
inlinevirtual

return a pointer to the track if present. otherwise, return a null pointer

Reimplemented from reco::Candidate.

Definition at line 272 of file PackedCandidate.h.

References packedHits_, track_, unpackedTrk_, and unpackTrk().

272  {
273  if (packedHits_!=0) {
274  if (!unpackedTrk_) unpackTrk();
275  return &track_;
276  }
277  else
278  return nullptr;
279  }
reco::Track track_
reco::Track
virtual Vector pat::PackedCandidate::boostToCM ( ) const
inlinevirtual

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

Implements reco::Candidate.

Definition at line 125 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

125 { if (!unpacked_) unpack(); return p4c_.BoostToCM(); }
virtual int pat::PackedCandidate::charge ( ) const
inlinevirtual

electric charge

Implements reco::Candidate.

Definition at line 101 of file PackedCandidate.h.

References funct::abs(), and pdgId_.

Referenced by pat::PATPackedCandidateProducer::candsOrdering(), pat::PATTrackAndVertexUnpacker::produce(), and threeCharge().

101  {
102  switch (abs(pdgId_)) {
103  case 211: return (pdgId_>0)-(pdgId_<0);
104  case 11: return (-1)*(pdgId_>0)+(pdgId_<0); //e
105  case 13: return (-1)*(pdgId_>0)+(pdgId_<0); //mu
106  case 15: return (-1)*(pdgId_>0)+(pdgId_<0); //tau
107  case 24: return (pdgId_>0)-(pdgId_<0); //W
108  default: return 0; //FIXME: charge is not defined
109  }
110  }
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
int pdgId_
PDG identifier.
virtual PackedCandidate* pat::PackedCandidate::clone ( void  ) const
inlinevirtual

returns a clone of the Candidate object

Implements reco::Candidate.

Definition at line 329 of file PackedCandidate.h.

References PackedCandidate().

329  {
330  return new PackedCandidate( *this );
331  }
PackedCandidate()
default constructor
const reco::Candidate * pat::PackedCandidate::daughter ( size_type  ) const
virtual

return daughter at a given position (throws an exception)

Implements reco::Candidate.

Definition at line 224 of file PackedCandidate.cc.

224  {
225  return 0;
226 }
reco::Candidate * pat::PackedCandidate::daughter ( size_type  )
virtual

return daughter at a given position (throws an exception)

Implements reco::Candidate.

Definition at line 246 of file PackedCandidate.cc.

246  {
247  return 0;
248 }
reco::Candidate * pat::PackedCandidate::daughter ( const std::string &  s)
virtual

return daughter with a specified role name

Implements reco::Candidate.

Definition at line 238 of file PackedCandidate.cc.

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

238  {
240  << "This Candidate type does not implement daughter(std::string). "
241  << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
242 }
const reco::Candidate * pat::PackedCandidate::daughter ( const std::string &  s) const
virtual

return daughter with a specified role name

Implements reco::Candidate.

Definition at line 232 of file PackedCandidate.cc.

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

232  {
234  << "This Candidate type does not implement daughter(std::string). "
235  << "Please use CompositeCandidate or NamedCompositeCandidate.\n";
236 }
virtual float pat::PackedCandidate::dxy ( ) const
inlinevirtual

dxy with respect to the PV ref

Definition at line 252 of file PackedCandidate.h.

References dxy_, and maybeUnpackBoth().

Referenced by PuppiProducer::produce().

252 { maybeUnpackBoth(); return dxy_; }
void maybeUnpackBoth() const
float pat::PackedCandidate::dxy ( const Point p) const
virtual

dxy with respect to another point

Definition at line 120 of file PackedCandidate.cc.

References funct::cos(), and funct::sin().

120  {
121  maybeUnpackBoth();
122  return -(vertex_.X()-p.X()) * std::sin(float(p4_.Phi())) + (vertex_.Y()-p.Y()) * std::cos(float(p4_.Phi()));
123 }
void maybeUnpackBoth() const
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
PolarLorentzVector p4_
the four vector
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
Point vertex_
vertex position
virtual double p() const
magnitude of momentum vector
virtual float pat::PackedCandidate::dxyError ( ) const
inlinevirtual

uncertainty on dxy

Reimplemented from reco::Candidate.

Definition at line 265 of file PackedCandidate.h.

References dxydxy_, maybeUnpackBoth(), and mathSSE::sqrt().

265 { maybeUnpackBoth(); return sqrt(dxydxy_); }
void maybeUnpackBoth() const
T sqrt(T t)
Definition: SSEVec.h:48
float dxydxy_
IP covariance.
virtual float pat::PackedCandidate::dz ( size_t  ipv = 0) const
inlinevirtual

dz with respect to the PV[ipv]

Definition at line 254 of file PackedCandidate.h.

References dz_, maybeUnpackBoth(), and pvRefKey_.

Referenced by reco::PFMETProducerMVA::chargedFracInCone(), reco::PFMETProducerMVA::computePFCandidateInfo(), fromPV(), and PuppiProducer::produce().

254 { maybeUnpackBoth(); return dz_ + (*pvRefProd_)[pvRefKey_].position().z()-(*pvRefProd_)[ipv].position().z(); }
reco::VertexRef::key_type pvRefKey_
void maybeUnpackBoth() const
float pat::PackedCandidate::dz ( const Point p) const
virtual

dz with respect to another point

Definition at line 124 of file PackedCandidate.cc.

References funct::cos(), and funct::sin().

124  {
125  maybeUnpackBoth();
126  return (vertex_.Z()-p.Z()) - ((vertex_.X()-p.X()) * std::cos(float(p4_.Phi())) + (vertex_.Y()-p.Y()) * std::sin(float(p4_.Phi()))) * p4_.Pz()/p4_.Pt();
127 }
void maybeUnpackBoth() const
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
PolarLorentzVector p4_
the four vector
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
Point vertex_
vertex position
virtual double p() const
magnitude of momentum vector
virtual float pat::PackedCandidate::dzAssociatedPV ( ) const
inlinevirtual

dz with respect to the PV ref

Definition at line 256 of file PackedCandidate.h.

References dz_, and maybeUnpackBoth().

Referenced by fromPV().

256 { maybeUnpackBoth(); return dz_; }
void maybeUnpackBoth() const
virtual float pat::PackedCandidate::dzError ( ) const
inlinevirtual

uncertainty on dz

Reimplemented from reco::Candidate.

Definition at line 263 of file PackedCandidate.h.

References dzdz_, maybeUnpackBoth(), and mathSSE::sqrt().

263 { maybeUnpackBoth(); return sqrt(dzdz_); }
void maybeUnpackBoth() const
T sqrt(T t)
Definition: SSEVec.h:48
virtual double pat::PackedCandidate::energy ( ) const
inlinevirtual

energy

Implements reco::Candidate.

Definition at line 129 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

Referenced by PuppiProducer::produce().

129 { if (!unpacked_) unpack(); return p4c_.E(); }
double pat::PackedCandidate::et ( ) const
inlinevirtual

transverse energy

Implements reco::Candidate.

Definition at line 131 of file PackedCandidate.h.

References p4c_, and pt().

131 { return (pt()<=0) ? 0 : p4c_.Et(); }
virtual double pt() const
transverse momentum
double pat::PackedCandidate::et2 ( ) const
inlinevirtual

transverse energy squared (use this for cuts)!

Implements reco::Candidate.

Definition at line 133 of file PackedCandidate.h.

References p4c_, and pt().

133 { return (pt()<=0) ? 0 : p4c_.Et2(); }
virtual double pt() const
transverse momentum
virtual double pat::PackedCandidate::eta ( ) const
inlinevirtual

momentum pseudorapidity

Implements reco::Candidate.

Definition at line 164 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

Referenced by Particle.Particle::__str__(), Muon.Muon::absEffAreaIso(), pat::PATPackedCandidateProducer::candsOrdering(), Jet.Jet::jetID(), and Jet.Jet::puJetId().

164 { if (!unpacked_) unpack(); return p4_.Eta(); }
PolarLorentzVector p4_
the four vector
void pat::PackedCandidate::fillVertexCovariance ( CovarianceMatrix v) const
virtual

fill SMatrix

Implements reco::Candidate.

Definition at line 267 of file PackedCandidate.cc.

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

Referenced by vertexCovariance().

267  {
269  << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
270 }
const PVAssoc pat::PackedCandidate::fromPV ( size_t  ipv = 0) const
inline

Definition at line 234 of file PackedCandidate.h.

References funct::abs(), CompatibilityBTag, dz(), dzAssociatedPV(), edm::Ref< C, T, F >::key(), NoPV, or, pdgId(), pvAssociationQuality(), PVLoose, PVTight, PVUsedInFit, UsedInFitLoose, UsedInFitTight, and vertexRef().

Referenced by PileupJetIdAlgo::computeIdVariables(), pat::PATTrackAndVertexUnpacker::produce(), PuppiProducer::produce(), and CandidateBoostedDoubleSecondaryVertexComputer::setTracksPV().

234  {
235  reco::VertexRef pvRef = vertexRef();
236  if(pvAssociationQuality()==UsedInFitTight and pvRef.key()==ipv) return PVUsedInFit;
237  if(pvRef.key()==ipv or abs(pdgId())==13 or abs(pdgId())==11 ) return PVTight;
238  if(pvAssociationQuality() == CompatibilityBTag and std::abs(dzAssociatedPV()) > std::abs(dz(ipv))) return PVTight; // it is not closest, but at least prevents the B assignment stealing
239  if(pvAssociationQuality() < UsedInFitLoose or pvRef->ndof() < 4.0 ) return PVLoose;
240  return NoPV;
241  }
virtual float dz(size_t ipv=0) const
dz with respect to the PV[ipv]
The Signals That Services Can Subscribe To This is based on ActivityRegistry and is current per Services can connect to the signals distributed by the ActivityRegistry in order to monitor the activity of the application Each possible callback has some defined which we here list in angle e< void, edm::EventIDconst &, edm::Timestampconst & > We also list in braces which AR_WATCH_USING_METHOD_ is used for those or
Definition: Activities.doc:12
key_type key() const
Accessor for product key.
Definition: Ref.h:264
const reco::VertexRef vertexRef() const
const PVAssociationQuality pvAssociationQuality() const
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
virtual float dzAssociatedPV() const
dz with respect to the PV ref
virtual int pdgId() const
PDG identifier.
bool pat::PackedCandidate::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.

Definition at line 196 of file PackedCandidate.cc.

196  {
197  return false;
198 }
bool pat::PackedCandidate::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.

Definition at line 200 of file PackedCandidate.cc.

200  {
201  return false;
202 }
virtual bool pat::PackedCandidate::isCaloMuon ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 373 of file PackedCandidate.h.

373 { return false; }
virtual bool pat::PackedCandidate::isConvertedPhoton ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 375 of file PackedCandidate.h.

375 { return false; }
virtual bool pat::PackedCandidate::isElectron ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 368 of file PackedCandidate.h.

368 { return false; }
virtual bool pat::PackedCandidate::isGlobalMuon ( ) const
inlinevirtual
virtual bool pat::PackedCandidate::isJet ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 376 of file PackedCandidate.h.

376 { return false; }
virtual bool pat::PackedCandidate::isMuon ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 369 of file PackedCandidate.h.

369 { return false; }
virtual bool pat::PackedCandidate::isPhoton ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 374 of file PackedCandidate.h.

374 { return false; }
virtual bool pat::PackedCandidate::isStandAloneMuon ( ) const
inlinevirtual
virtual bool pat::PackedCandidate::isTrackerMuon ( ) const
inlinevirtual

Implements reco::Candidate.

Definition at line 372 of file PackedCandidate.h.

372 { return false; }
bool pat::PackedCandidate::longLived ( ) const
virtual

is long lived?

Implements reco::Candidate.

Definition at line 273 of file PackedCandidate.cc.

273 {return false;}
LostInnerHits pat::PackedCandidate::lostInnerHits ( ) const
inline
virtual double pat::PackedCandidate::mass ( ) const
inlinevirtual

mass

Implements reco::Candidate.

Definition at line 135 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

Referenced by Particle.Particle::__str__(), and DiObject.DiMuon::__str__().

135 { if (!unpacked_) unpack(); return p4_.M(); }
PolarLorentzVector p4_
the four vector
bool pat::PackedCandidate::massConstraint ( ) const
virtual

do mass constraint?

Implements reco::Candidate.

Definition at line 275 of file PackedCandidate.cc.

275 {return false;}
virtual double pat::PackedCandidate::massSqr ( ) const
inlinevirtual

mass squared

Implements reco::Candidate.

Definition at line 137 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

137 { if (!unpacked_) unpack(); return p4_.M()*p4_.M(); }
PolarLorentzVector p4_
the four vector
const reco::CandidateBaseRef & pat::PackedCandidate::masterClone ( ) const
virtual

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

Implements reco::Candidate.

Definition at line 190 of file PackedCandidate.cc.

References Exception.

Referenced by masterRef().

190  {
191  throw cms::Exception("Invalid Reference")
192  << "this Candidate has no master clone reference."
193  << "Can't call masterClone() method.\n";
194 }
const reco::CandidatePtr & pat::PackedCandidate::masterClonePtr ( ) const
virtual

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

Implements reco::Candidate.

Definition at line 205 of file PackedCandidate.cc.

References Exception.

205  {
206  throw cms::Exception("Invalid Reference")
207  << "this Candidate has no master clone ptr."
208  << "Can't call masterClonePtr() method.\n";
209 }
template<typename Ref >
Ref pat::PackedCandidate::masterRef ( ) const
inline

cast master clone reference to a concrete type

Definition at line 366 of file PackedCandidate.h.

References masterClone().

366 { return masterClone().template castTo<Ref>(); }
virtual const reco::CandidateBaseRef & masterClone() const
void pat::PackedCandidate::maybeUnpackBoth ( ) const
inlineprotected
virtual Vector pat::PackedCandidate::momentum ( ) const
inlinevirtual

spatial momentum vector

Implements reco::Candidate.

Definition at line 122 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

122 { if (!unpacked_) unpack(); return p4c_.Vect(); }
const reco::Candidate * pat::PackedCandidate::mother ( size_type  ) const
virtual

return mother at a given position (throws an exception)

Implements reco::Candidate.

Definition at line 228 of file PackedCandidate.cc.

228  {
229  return 0;
230 }
virtual double pat::PackedCandidate::mt ( ) const
inlinevirtual

transverse mass

Implements reco::Candidate.

Definition at line 140 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

140 { if (!unpacked_) unpack(); return p4_.Mt(); }
PolarLorentzVector p4_
the four vector
virtual double pat::PackedCandidate::mtSqr ( ) const
inlinevirtual

transverse mass squared

Implements reco::Candidate.

Definition at line 142 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

142 { if (!unpacked_) unpack(); return p4_.Mt2(); }
PolarLorentzVector p4_
the four vector
size_t pat::PackedCandidate::numberOfDaughters ( ) const
virtual

number of daughters

Implements reco::Candidate.

Definition at line 211 of file PackedCandidate.cc.

211  {
212  return 0;
213 }
int pat::PackedCandidate::numberOfHits ( ) const
inline

Definition at line 219 of file PackedCandidate.h.

References numberOfPixelHits(), and packedHits_.

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

219 { return (packedHits_ >> 3) + numberOfPixelHits(); }
int numberOfPixelHits() const
size_t pat::PackedCandidate::numberOfMothers ( ) const
virtual

number of mothers

Implements reco::Candidate.

Definition at line 215 of file PackedCandidate.cc.

215  {
216  return 0;
217 }
int pat::PackedCandidate::numberOfPixelHits ( ) const
inline

Definition at line 218 of file PackedCandidate.h.

References packedHits_.

Referenced by numberOfHits().

218 { return packedHits_ & 0x7; }
virtual size_t pat::PackedCandidate::numberOfSourceCandidatePtrs ( ) const
inlinevirtual

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

Implements reco::Candidate.

Definition at line 93 of file PackedCandidate.h.

93 {return 0;}
bool pat::PackedCandidate::overlap ( const reco::Candidate o) const
protectedvirtual

check overlap with another Candidate

Implements reco::Candidate.

Definition at line 219 of file PackedCandidate.cc.

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

219  {
220  return p4() == o.p4() && vertex() == o.vertex() && charge() == o.charge();
221 // return p4() == o.p4() && charge() == o.charge();
222 }
virtual int charge() const
electric charge
virtual const Point & vertex() const =0
vertex position
virtual int charge() const =0
electric charge
virtual const Point & vertex() const
vertex position
virtual const LorentzVector & p4() const
four-momentum Lorentz vecto r
virtual const LorentzVector & p4() const =0
four-momentum Lorentz vector
virtual double pat::PackedCandidate::p ( ) const
inlinevirtual

magnitude of momentum vector

Implements reco::Candidate.

Definition at line 127 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

127 { if (!unpacked_) unpack(); return p4c_.P(); }
virtual const LorentzVector& pat::PackedCandidate::p4 ( ) const
inlinevirtual

four-momentum Lorentz vecto r

Implements reco::Candidate.

Definition at line 118 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

Referenced by Tau.Tau::dxy_approx(), Tau.Tau::dz(), Jet.Jet::jetID(), and setP4().

118 { if (!unpacked_) unpack(); return p4c_; }
void pat::PackedCandidate::pack ( bool  unpackAfterwards = true)
protected

Definition at line 10 of file PackedCandidate.cc.

References MiniFloatConverter::float32to16(), bookConverter::max, and timeUnitHelper::unpack().

Referenced by pyrootRender.interactiveRender::draw(), packBoth(), and setMass().

10  {
12  packedEta_ = int16_t(std::round(p4_.Eta()/6.0f*std::numeric_limits<int16_t>::max()));
13  packedPhi_ = int16_t(std::round(p4_.Phi()/3.2f*std::numeric_limits<int16_t>::max()));
15  if (unpackAfterwards) unpack(); // force the values to match with the packed ones
16 }
uint16_t packedPt_
Weight from PUPPI removing leptons.
PolarLorentzVector p4_
the four vector
static uint16_t float32to16(float x)
Definition: libminifloat.h:15
void pat::PackedCandidate::packBoth ( )
inlineprotected

Definition at line 394 of file PackedCandidate.h.

References pack(), packVtx(), unpack(), and unpackVtx().

Referenced by PackedCandidate(), setP4(), setPz(), and setTrackProperties().

394 { pack(false); packVtx(false); unpack(); unpackVtx(); } // do it this way, so that we don't loose precision on the angles before computing dxy,dz
void unpackVtx() const
void packVtx(bool unpackAfterwards=true)
void pack(bool unpackAfterwards=true)
void pat::PackedCandidate::packVtx ( bool  unpackAfterwards = true)
protected

Definition at line 18 of file PackedCandidate.cc.

References EnergyCorrector::c, funct::cos(), f, MiniFloatConverter::float32to16(), edm::Ref< C, T, F >::isNonnull(), bookConverter::max, logintpack::pack8log(), logintpack::pack8logCeil(), MetAnalyzer::pv(), alignCSCRings::s, and funct::sin().

Referenced by packBoth(), and setVertex().

18  {
19  reco::VertexRef pvRef = vertexRef();
20  Point pv = pvRef.isNonnull() ? pvRef->position() : Point();
21  float dxPV = vertex_.X() - pv.X(), dyPV = vertex_.Y() - pv.Y(); //, rPV = std::hypot(dxPV, dyPV);
22  float s = std::sin(float(p4_.Phi())+dphi_), c = std::cos(float(p4_.Phi()+dphi_)); // not the fastest option, but we're in reduced precision already, so let's avoid more roundoffs
23  dxy_ = - dxPV * s + dyPV * c;
24  // if we want to go back to the full x,y,z we need to store also
25  // float dl = dxPV * c + dyPV * s;
26  // float xRec = - dxy_ * s + dl * c, yRec = dxy_ * c + dl * s;
27  float pzpt = p4_.Pz()/p4_.Pt();
28  dz_ = vertex_.Z() - pv.Z() - (dxPV*c + dyPV*s) * pzpt;
30  packedDz_ = pvRef.isNonnull() ? MiniFloatConverter::float32to16(dz_*100) : int16_t(std::round(dz_/40.f*std::numeric_limits<int16_t>::max()));
31  packedDPhi_ = int16_t(std::round(dphi_/3.2f*std::numeric_limits<int16_t>::max()));
35 // packedCovarianceDxyDxy_ = pack8log(dxydxy_,-15,-1); // MiniFloatConverter::float32to16(dxydxy_*10000.);
36 // packedCovarianceDxyDz_ = pack8log(dxydz_,-20,-1); //MiniFloatConverter::float32to16(dxydz_*10000.);
37 // packedCovarianceDzDz_ = pack8log(dzdz_,-13,-1); //MiniFloatConverter::float32to16(dzdz_*10000.);
38 
42  packedCovarianceDphiDxy_ = pack8log(dphidxy_,-17,-4); // MiniFloatConverter::float32to16(dphidxy_*10000.);
43  packedCovarianceDlambdaDz_ = pack8log(dlambdadz_,-17,-4); // MiniFloatConverter::float32to16(dlambdadz_*10000.);
44 
45  /*packedCovarianceDptDpt_ = pack8logCeil(dptdpt_,-15,5,32);
46  packedCovarianceDetaDeta_ = pack8logCeil(detadeta_,-20,0,32);
47  packedCovarianceDphiDphi_ = pack8logCeil(dphidphi_,-15,5,32);
48  packedCovarianceDphiDxy_ = pack8log(dphidxy_,-17,-4); // MiniFloatConverter::float32to16(dphidxy_*10000.);
49  packedCovarianceDlambdaDz_ = pack8log(dlambdadz_,-17,-4); // MiniFloatConverter::float32to16(dlambdadz_*10000.);
50 
51 */
52 /* packedCovarianceDphiDxy_ = MiniFloatConverter::float32to16(dphidxy_*10000.);
53  packedCovarianceDlambdaDz_ = MiniFloatConverter::float32to16(dlambdadz_*10000.);
54  packedCovarianceDetaDeta_ = MiniFloatConverter::float32to16(detadeta_*10000.);
55  packedCovarianceDphiDphi_ = MiniFloatConverter::float32to16(dphidphi_*10000.);
56  packedCovarianceDptDpt_ = MiniFloatConverter::float32to16(dptdpt_*10000.);
57 */
58 // packedCovarianceDphiDxy_ = pack8log(dphidxy_,-17,-4); // MiniFloatConverter::float32to16(dphidxy_*10000.);
59 // packedCovarianceDlambdaDz_ = pack8log(dlambdadz_,-17,-4); // MiniFloatConverter::float32to16(dlambdadz_*10000.);
60 
61  if (unpackAfterwards) unpackVtx();
62 }
bool isNonnull() const
Checks for non-null.
Definition: Ref.h:252
int8_t pack8log(double x, double lmin, double lmax, uint8_t base=128)
Definition: liblogintpack.h:20
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
math::XYZPoint Point
point in the space
const reco::VertexRef vertexRef() const
void unpackVtx() const
PolarLorentzVector p4_
the four vector
int8_t pack8logCeil(double x, double lmin, double lmax, uint8_t base=128)
Definition: liblogintpack.h:8
static uint16_t float32to16(float x)
Definition: libminifloat.h:15
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
math::XYZPoint Point
double f[11][100]
Point vertex_
vertex position
float dxydxy_
IP covariance.
uint16_t packedCovarianceDxyDxy_
virtual int pat::PackedCandidate::pdgId ( ) const
inlinevirtual

PDG identifier.

Implements reco::Candidate.

Definition at line 308 of file PackedCandidate.h.

References pdgId_.

Referenced by Particle.Particle::__str__(), fromPV(), and setPdgId().

308 { return pdgId_; }
int pdgId_
PDG identifier.
virtual double pat::PackedCandidate::phi ( ) const
inlinevirtual

momentum azimuthal angle

Implements reco::Candidate.

Definition at line 152 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

Referenced by Particle.Particle::__str__().

152 { if (!unpacked_) unpack(); return p4_.Phi(); }
PolarLorentzVector p4_
the four vector
virtual float pat::PackedCandidate::phiAtVtx ( ) const
inlinevirtual

momentum azimuthal angle from the track (normally identical to phi())

Definition at line 154 of file PackedCandidate.h.

References dphi_, M_PI, maybeUnpackBoth(), p4_, and run_regression::ret.

154  {
155  maybeUnpackBoth();
156  float ret = p4_.Phi() + dphi_;
157  while (ret > float(M_PI)) ret -= 2*float(M_PI);
158  while (ret < -float(M_PI)) ret += 2*float(M_PI);
159  return ret;
160  }
void maybeUnpackBoth() const
PolarLorentzVector p4_
the four vector
#define M_PI
virtual const PolarLorentzVector& pat::PackedCandidate::polarP4 ( ) const
inlinevirtual

four-momentum Lorentz vector

Implements reco::Candidate.

Definition at line 120 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

120 { if (!unpacked_) unpack(); return p4_; }
PolarLorentzVector p4_
the four vector
virtual const reco::Track& pat::PackedCandidate::pseudoTrack ( ) const
inlinevirtual

Return reference to a pseudo track made with candidate kinematics, parameterized error for eta,phi,pt and full IP covariance.

Definition at line 269 of file PackedCandidate.h.

References track_, unpackedTrk_, and unpackTrk().

Referenced by PileupJetIdAlgo::computeIdVariables(), and pat::PATTrackAndVertexUnpacker::produce().

269 { if (!unpackedTrk_) unpackTrk(); return track_; }
reco::Track track_
reco::Track
virtual double pat::PackedCandidate::pt ( void  ) const
inlinevirtual
float pat::PackedCandidate::puppiWeight ( ) const

Set both weights at once (with option for only full PUPPI)

Definition at line 284 of file PackedCandidate.cc.

References logintpack::unpack8logClosed().

Referenced by PuppiProducer::produce().

284 { return unpack8logClosed(packedPuppiweight_,-2,0,64)/2. + 0.5;}
double unpack8logClosed(int8_t i, double lmin, double lmax, uint8_t base=128)
reverse of pack8logClosed
Definition: liblogintpack.h:57
float pat::PackedCandidate::puppiWeightNoLep ( ) const

Weight from full PUPPI.

Definition at line 286 of file PackedCandidate.cc.

References logintpack::unpack8logClosed().

double unpack8logClosed(int8_t i, double lmin, double lmax, uint8_t base=128)
reverse of pack8logClosed
Definition: liblogintpack.h:57
const PVAssociationQuality pat::PackedCandidate::pvAssociationQuality ( ) const
inline
virtual double pat::PackedCandidate::px ( ) const
inlinevirtual

x coordinate of momentum vector

Implements reco::Candidate.

Definition at line 144 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

Referenced by PuppiProducer::produce().

144 { if (!unpacked_) unpack(); return p4c_.Px(); }
virtual double pat::PackedCandidate::py ( ) const
inlinevirtual

y coordinate of momentum vector

Implements reco::Candidate.

Definition at line 146 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

Referenced by PuppiProducer::produce().

146 { if (!unpacked_) unpack(); return p4c_.Py(); }
virtual double pat::PackedCandidate::pz ( ) const
inlinevirtual

z coordinate of momentum vector

Implements reco::Candidate.

Definition at line 148 of file PackedCandidate.h.

References p4c_, unpack(), and unpacked_.

Referenced by PuppiProducer::produce(), and setPz().

148 { if (!unpacked_) unpack(); return p4c_.Pz(); }
virtual double pat::PackedCandidate::rapidity ( ) const
inlinevirtual

rapidity

Implements reco::Candidate.

Definition at line 166 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

166 { if (!unpacked_) unpack(); return p4_.Rapidity(); }
PolarLorentzVector p4_
the four vector
void pat::PackedCandidate::setAssociationQuality ( PVAssociationQuality  q)
inline
virtual void pat::PackedCandidate::setCharge ( int  charge)
inlinevirtual

set electric charge

Implements reco::Candidate.

Definition at line 112 of file PackedCandidate.h.

112 {}
virtual void pat::PackedCandidate::setLongLived ( )
inlinevirtual

set long lived flag

Implements reco::Candidate.

Definition at line 318 of file PackedCandidate.h.

318 {} /*FIXME*/
void pat::PackedCandidate::setLostInnerHits ( LostInnerHits  hits)
inline

Definition at line 296 of file PackedCandidate.h.

References lostInnerHitsMask, lostInnerHitsShift, and qualityFlags_.

296  {
297  int lost = hits; if (lost > 2) lost = 2; // protection against misuse
298  lost++; // shift so it's 0 .. 3 instead of (-1) .. 2
300  }
virtual void pat::PackedCandidate::setMass ( double  m)
inlinevirtual

set particle mass

Implements reco::Candidate.

Definition at line 182 of file PackedCandidate.h.

References visualization-live-secondInstance_cfg::m, p4_, pack(), unpack(), and unpacked_.

182  {
183  if (!unpacked_) unpack();
184  p4_ = PolarLorentzVector(p4_.Pt(), p4_.Eta(), p4_.Phi(), m);
185  pack();
186  }
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
PolarLorentzVector p4_
the four vector
void pack(bool unpackAfterwards=true)
virtual void pat::PackedCandidate::setMassConstraint ( )
inlinevirtual

set mass constraint flag

Implements reco::Candidate.

Definition at line 324 of file PackedCandidate.h.

324 {} /*FIXME*/
void pat::PackedCandidate::setMuonID ( bool  isStandAlone,
bool  isGlobal 
)
inline

Definition at line 302 of file PackedCandidate.h.

References muonFlagsMask, muonFlagsShift, and qualityFlags_.

302  {
303  int16_t muonFlags = isStandAlone | (2*isGlobal);
305  }
virtual void pat::PackedCandidate::setP4 ( const LorentzVector p4)
inlinevirtual

set 4-momentum

Implements reco::Candidate.

Definition at line 170 of file PackedCandidate.h.

References maybeUnpackBoth(), p4_, and packBoth().

170  {
171  maybeUnpackBoth(); // changing px,py,pz changes also mapping between dxy,dz and x,y,z
172  p4_ = PolarLorentzVector(p4.Pt(), p4.Eta(), p4.Phi(), p4.M());
173  packBoth();
174  }
void maybeUnpackBoth() const
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
PolarLorentzVector p4_
the four vector
virtual const LorentzVector & p4() const
four-momentum Lorentz vecto r
virtual void pat::PackedCandidate::setP4 ( const PolarLorentzVector p4)
inlinevirtual

set 4-momentum

Definition at line 176 of file PackedCandidate.h.

References maybeUnpackBoth(), p4(), p4_, and packBoth().

176  {
177  maybeUnpackBoth(); // changing px,py,pz changes also mapping between dxy,dz and x,y,z
178  p4_ = p4;
179  packBoth();
180  }
void maybeUnpackBoth() const
PolarLorentzVector p4_
the four vector
virtual const LorentzVector & p4() const
four-momentum Lorentz vecto r
virtual void pat::PackedCandidate::setPdgId ( int  pdgId)
inlinevirtual

Implements reco::Candidate.

Definition at line 310 of file PackedCandidate.h.

References pdgId(), and pdgId_.

310 { pdgId_ = pdgId; }
int pdgId_
PDG identifier.
virtual int pdgId() const
PDG identifier.
void pat::PackedCandidate::setPuppiWeight ( float  p,
float  p_nolep = 0.0 
)

Definition at line 278 of file PackedCandidate.cc.

References logintpack::pack8logClosed().

278  {
279  // Set both weights at once to avoid misconfigured weights if called in the wrong order
280  packedPuppiweight_ = pack8logClosed((p-0.5)*2,-2,0,64);
282 }
int8_t pack8logClosed(double x, double lmin, double lmax, uint8_t base=128)
Definition: liblogintpack.h:34
virtual double p() const
magnitude of momentum vector
virtual void pat::PackedCandidate::setPz ( double  pz)
inlinevirtual

Implements reco::Candidate.

Definition at line 187 of file PackedCandidate.h.

References maybeUnpackBoth(), p4_, p4c_, packBoth(), and pz().

187  {
188  maybeUnpackBoth(); // changing px,py,pz changes also mapping between dxy,dz and x,y,z
189  p4c_ = LorentzVector(p4c_.Px(), p4c_.Py(), pz, p4c_.E());
190  p4_ = PolarLorentzVector(p4c_.Pt(), p4c_.Eta(), p4c_.Phi(), p4c_.M());
191  packBoth();
192  }
void maybeUnpackBoth() const
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
PolarLorentzVector p4_
the four vector
math::XYZTLorentzVector LorentzVector
Lorentz vector.
virtual double pz() const
z coordinate of momentum vector
virtual void pat::PackedCandidate::setStatus ( int  status)
inlinevirtual

set status word

Implements reco::Candidate.

Definition at line 314 of file PackedCandidate.h.

314 {} /*FIXME*/
virtual void pat::PackedCandidate::setThreeCharge ( int  threecharge)
inlinevirtual

set electric charge

Implements reco::Candidate.

Definition at line 116 of file PackedCandidate.h.

116 {}
void pat::PackedCandidate::setTrackHighPurity ( bool  highPurity)
inline
virtual void pat::PackedCandidate::setTrackProperties ( const reco::Track tk,
const reco::Track::CovarianceMatrix covariance 
)
inlinevirtual

set impact parameters covariance

Definition at line 195 of file PackedCandidate.h.

References detadeta_, dlambdadz_, dphidphi_, dphidxy_, dptdpt_, dxydxy_, dxydz_, dzdz_, reco::TrackBase::hitPattern(), reco::TrackBase::normalizedChi2(), normalizedChi2_, reco::HitPattern::numberOfValidHits(), reco::HitPattern::numberOfValidPixelHits(), packBoth(), packedHits_, and pt().

Referenced by setTrackProperties().

195  {
196  dxydxy_ = covariance(3,3);
197  dxydz_ = covariance(3,4);
198  dzdz_ = covariance(4,4);
199  dphidxy_ = covariance(2,3);
200  dlambdadz_ = covariance(1,4);
201  dptdpt_ = covariance(0,0)*pt()*pt();
202  detadeta_ = covariance(1,1);
203  dphidphi_ = covariance(2,2)*pt()*pt();
204 
206  int numberOfPixelHits_ = tk.hitPattern().numberOfValidPixelHits();
207  if (numberOfPixelHits_ > 7) numberOfPixelHits_ = 7;
208  int numberOfStripHits_ = tk.hitPattern().numberOfValidHits() - numberOfPixelHits_;
209  if (numberOfStripHits_ > 31) numberOfStripHits_ = 31;
210  packedHits_ = (numberOfPixelHits_&0x7) | (numberOfStripHits_ << 3);
211  packBoth();
212  }
double normalizedChi2() const
chi-squared divided by n.d.o.f. (or chi-squared * 1e6 if n.d.o.f. is zero)
Definition: TrackBase.h:524
int numberOfValidHits() const
Definition: HitPattern.h:734
virtual double pt() const
transverse momentum
uint8_t normalizedChi2_
track quality information
const HitPattern & hitPattern() const
Access the hit pattern, indicating in which Tracker layers the track has hits.
Definition: TrackBase.h:421
float dxydxy_
IP covariance.
int numberOfValidPixelHits() const
Definition: HitPattern.h:749
virtual void pat::PackedCandidate::setTrackProperties ( const reco::Track tk)
inlinevirtual

Definition at line 214 of file PackedCandidate.h.

References reco::TrackBase::covariance(), and setTrackProperties().

214  {
216  }
virtual void setTrackProperties(const reco::Track &tk, const reco::Track::CovarianceMatrix &covariance)
set impact parameters covariance
CovarianceMatrix covariance() const
return track covariance matrix
Definition: TrackBase.h:694
virtual void pat::PackedCandidate::setVertex ( const Point vertex)
inlinevirtual

set vertex

Definition at line 230 of file PackedCandidate.h.

References maybeUnpackBoth(), packVtx(), vertex(), and vertex_.

void maybeUnpackBoth() const
Point vertex_
vertex position
virtual const Point & vertex() const
vertex position
void packVtx(bool unpackAfterwards=true)
virtual reco::CandidatePtr pat::PackedCandidate::sourceCandidatePtr ( size_type  i) const
inlinevirtual

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

Reimplemented from reco::Candidate.

Definition at line 96 of file PackedCandidate.h.

96  {
97  return reco::CandidatePtr();
98  }
edm::Ptr< Candidate > CandidatePtr
persistent reference to an object in a collection of Candidate objects
Definition: CandidateFwd.h:25
virtual int pat::PackedCandidate::status ( ) const
inlinevirtual

status word

Implements reco::Candidate.

Definition at line 312 of file PackedCandidate.h.

References qualityFlags_.

312 { return qualityFlags_; } /*FIXME*/
virtual double pat::PackedCandidate::theta ( ) const
inlinevirtual

momentum polar angle

Implements reco::Candidate.

Definition at line 162 of file PackedCandidate.h.

References p4_, unpack(), and unpacked_.

Referenced by Tau.Tau::zImpact().

162 { if (!unpacked_) unpack(); return p4_.Theta(); }
PolarLorentzVector p4_
the four vector
virtual int pat::PackedCandidate::threeCharge ( ) const
inlinevirtual

electric charge

Implements reco::Candidate.

Definition at line 114 of file PackedCandidate.h.

References charge().

114 {return charge()*3;}
virtual int charge() const
electric charge
bool pat::PackedCandidate::trackHighPurity ( ) const
inline
void pat::PackedCandidate::unpack ( ) const
protected

Definition at line 64 of file PackedCandidate.cc.

References f, MiniFloatConverter::float16to32(), bookConverter::max, phi(), EnergyCorrector::pt, edm::shift, and jetcorrextractor::sign().

Referenced by boostToCM(), energy(), eta(), mass(), massSqr(), maybeUnpackBoth(), momentum(), mt(), mtSqr(), p(), p4(), packBoth(), phi(), polarP4(), pt(), px(), py(), pz(), rapidity(), setMass(), theta(), and y().

64  {
66  double shift = (pt<1. ? 0.1*pt : 0.1/pt); // shift particle phi to break degeneracies in angular separations
67  double sign = ( ( int(pt*10) % 2 == 0 ) ? 1 : -1 ); // introduce a pseudo-random sign of the shift
68  double phi = int16_t(packedPhi_)*3.2f/std::numeric_limits<int16_t>::max() + sign*shift*3.2/std::numeric_limits<int16_t>::max();
71  phi,
73  p4c_ = p4_;
74  unpacked_ = true;
75 }
double sign(double x)
virtual double pt() const
transverse momentum
static float float16to32(uint16_t h)
Definition: libminifloat.h:10
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
uint16_t packedPt_
Weight from PUPPI removing leptons.
PolarLorentzVector p4_
the four vector
virtual double phi() const
momentum azimuthal angle
double f[11][100]
static unsigned int const shift
void pat::PackedCandidate::unpackTrk ( ) const
protected

Definition at line 129 of file PackedCandidate.cc.

References reco::TrackBase::appendHitPattern(), RecoTauCleanerPlugins::charge, reco::TrackBase::highPurity, AnalysisDataFormats_SUSYBSMObjects::hp, i, reco::TrackBase::loose, visualization-live-secondInstance_cfg::m, TrackingRecHit::missing_inner, ndof, p3, EnergyCorrector::pt, reco::TrackBase::undefAlgorithm, and TrackingRecHit::valid.

Referenced by bestTrack(), and pseudoTrack().

129  {
130  maybeUnpackBoth();
132 // m(0,0)=0.5e-4/pt()/pt(); //TODO: tune
133 // m(1,1)=6e-6; //TODO: tune
134 // m(2,2)=1.5e-5/pt()/pt(); //TODO: tune
135  m(0,0)=dptdpt_/pt()/pt(); //TODO: tune
136  m(1,1)=detadeta_; //TODO: tune
137  m(2,2)=dphidphi_/pt()/pt(); //TODO: tune
138  m(2,3)=dphidxy_;
139  m(3,2)=dphidxy_;
140  m(4,1)=dlambdadz_;
141  m(1,4)=dlambdadz_;
142  m(3,3)=dxydxy_;
143  m(3,4)=dxydz_;
144  m(4,3)=dxydz_;
145  m(4,4)=dzdz_;
146  math::RhoEtaPhiVector p3(p4_.pt(),p4_.eta(),phiAtVtx());
147  int numberOfPixelHits_ = packedHits_ & 0x7 ;
148  int numberOfHits_ = (packedHits_>>3) + numberOfPixelHits_;
149 
150  int ndof = numberOfHits_+numberOfPixelHits_-5;
151  reco::HitPattern hp, hpExpIn;
152  int i=0;
153  LostInnerHits innerLost = lostInnerHits();
154 
156 
157  if(innerLost == validHitInFirstPixelBarrelLayer){
159  i++;
160  }
161  for(;i<numberOfPixelHits_; i++) {
162  track_.appendHitPattern(PXBDetId(i > 1 ? 3 : 2, 0, 0), TrackingRecHit::valid);
163  }
164 
165  for(;i<numberOfHits_;i++) {
167  }
168 
169  switch (innerLost) {
171  break;
172  case noLostInnerHits:
173  break;
174  case oneLostInnerHit:
176  break;
177  case moreLostInnerHits:
180  break;
181  };
182 
184 
185  unpackedTrk_ = true;
186 }
int i
Definition: DBlmapReader.cc:9
void setQuality(const TrackQuality)
Definition: TrackBase.h:486
void maybeUnpackBoth() const
virtual double pt() const
transverse momentum
RhoEtaPhiVectorD RhoEtaPhiVector
spatial vector with cylindrical internal representation using pseudorapidity
Definition: Vector3D.h:32
PolarLorentzVector p4_
the four vector
reco::Track track_
reco::Track
susybsm::HSCParticleRefProd hp
Definition: classes.h:27
bool trackHighPurity() const
true if the track had the highPurity quality bit
LostInnerHits lostInnerHits() const
virtual int charge() const
electric charge
bool appendHitPattern(const TrackingRecHit &hit)
append a single hit to the HitPattern
Definition: TrackBase.h:431
Point vertex_
vertex position
LostInnerHits
Enumerator specifying the.
uint8_t normalizedChi2_
track quality information
float dxydxy_
IP covariance.
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:30
virtual float phiAtVtx() const
momentum azimuthal angle from the track (normally identical to phi())
math::Error< dimension >::type CovarianceMatrix
5 parameter covariance matrix
Definition: TrackBase.h:77
double p3[4]
Definition: TauolaWrapper.h:91
void pat::PackedCandidate::unpackVtx ( ) const
protected

Definition at line 76 of file PackedCandidate.cc.

References EnergyCorrector::c, funct::cos(), MiniFloatConverter::float16to32(), edm::Ref< C, T, F >::isNonnull(), bookConverter::max, phi(), MetAnalyzer::pv(), alignCSCRings::s, funct::sin(), and logintpack::unpack8log().

Referenced by maybeUnpackBoth(), and packBoth().

76  {
77  reco::VertexRef pvRef = vertexRef();
81  Point pv = pvRef.isNonnull() ? pvRef->position() : Point();
82  float phi = p4_.Phi()+dphi_, s = std::sin(phi), c = std::cos(phi);
83  vertex_ = Point(pv.X() - dxy_ * s,
84  pv.Y() + dxy_ * c,
85  pv.Z() + dz_ ); // for our choice of using the PCA to the PV, by definition the remaining term -(dx*cos(phi) + dy*sin(phi))*(pz/pt) is zero
86 // dxydxy_ = unpack8log(packedCovarianceDxyDxy_,-15,-1);
87 // dxydz_ = unpack8log(packedCovarianceDxyDz_,-20,-1);
88 // dzdz_ = unpack8log(packedCovarianceDzDz_,-13,-1);
94 /*
95  dphidxy_ = unpack8log(packedCovarianceDphiDxy_,-17,-4);
96  dlambdadz_ = unpack8log(packedCovarianceDlambdaDz_,-17,-4);
97  dptdpt_ = unpack8log(packedCovarianceDptDpt_,-15,5,32);
98  detadeta_ = unpack8log(packedCovarianceDetaDeta_,-20,0,32);
99  dphidphi_ = unpack8log(packedCovarianceDphiDphi_,-15,5,32);
100 */
101 
102 /* dphidxy_ = MiniFloatConverter::float16to32(packedCovarianceDphiDxy_)/10000.;
103  dlambdadz_ = MiniFloatConverter::float16to32(packedCovarianceDlambdaDz_)/10000.;
104  dptdpt_ = MiniFloatConverter::float16to32(packedCovarianceDptDpt_)/10000.;
105  detadeta_ = MiniFloatConverter::float16to32(packedCovarianceDetaDeta_)/10000.;
106  dphidphi_ = MiniFloatConverter::float16to32(packedCovarianceDphiDphi_)/10000.;
107 */
111 /* dphidxy_ = MiniFloatConverter::float16to32(packedCovarianceDphiDxy_)/10000.;
112  dlambdadz_ =MiniFloatConverter::float16to32(packedCovarianceDlambdaDz_)/10000.;
113 */
114  unpackedVtx_ = true;
115 }
bool isNonnull() const
Checks for non-null.
Definition: Ref.h:252
double unpack8log(int8_t i, double lmin, double lmax, uint8_t base=128)
Definition: liblogintpack.h:47
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
math::XYZPoint Point
point in the space
const reco::VertexRef vertexRef() const
static float float16to32(uint16_t h)
Definition: libminifloat.h:10
PolarLorentzVector p4_
the four vector
virtual double phi() const
momentum azimuthal angle
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
math::XYZPoint Point
Point vertex_
vertex position
float dxydxy_
IP covariance.
uint16_t packedCovarianceDxyDxy_
virtual const Point& pat::PackedCandidate::vertex ( ) const
inlinevirtual

vertex position

Implements reco::Candidate.

Definition at line 222 of file PackedCandidate.h.

References maybeUnpackBoth(), and vertex_.

Referenced by Tau.Tau::dxy(), and setVertex().

222 { maybeUnpackBoth(); return vertex_; }//{ if (fromPV_) return Point(0,0,0); else return Point(0,0,100); }
void maybeUnpackBoth() const
Point vertex_
vertex position
double pat::PackedCandidate::vertexChi2 ( ) const
virtual

chi-squares

Implements reco::Candidate.

Definition at line 250 of file PackedCandidate.cc.

250  {
251  return 0;
252 }
double pat::PackedCandidate::vertexCovariance ( int  i,
int  j 
) const
virtual

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

Implements reco::Candidate.

Definition at line 262 of file PackedCandidate.cc.

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

262  {
264  << "reco::ConcreteCandidate does not implement vertex covariant matrix.\n";
265 }
CovarianceMatrix pat::PackedCandidate::vertexCovariance ( ) const
inlinevirtual

return SMatrix

Reimplemented from reco::Candidate.

Definition at line 347 of file PackedCandidate.h.

References fillVertexCovariance(), and visualization-live-secondInstance_cfg::m.

double pat::PackedCandidate::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.

Definition at line 254 of file PackedCandidate.cc.

254  {
255  return 0;
256 }
double pat::PackedCandidate::vertexNormalizedChi2 ( ) const
virtual

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

Implements reco::Candidate.

Definition at line 258 of file PackedCandidate.cc.

258  {
259  return 0;
260 }
const reco::VertexRef pat::PackedCandidate::vertexRef ( ) const
inline

Definition at line 249 of file PackedCandidate.h.

References pvRefKey_, and pvRefProd_.

Referenced by pat::PATPackedCandidateProducer::candsOrdering(), fromPV(), and PuppiProducer::produce().

reco::VertexRef::key_type pvRefKey_
edm::Ref< VertexCollection > VertexRef
persistent reference to a Vertex
Definition: VertexFwd.h:13
reco::VertexRefProd pvRefProd_
Use these to build a Ref to primary vertex.
virtual double pat::PackedCandidate::vx ( ) const
inlinevirtual

x coordinate of vertex position

Implements reco::Candidate.

Definition at line 224 of file PackedCandidate.h.

References maybeUnpackBoth(), and vertex_.

224 { maybeUnpackBoth(); return vertex_.X(); }//{ return 0; }
void maybeUnpackBoth() const
Point vertex_
vertex position
virtual double pat::PackedCandidate::vy ( ) const
inlinevirtual

y coordinate of vertex position

Implements reco::Candidate.

Definition at line 226 of file PackedCandidate.h.

References maybeUnpackBoth(), and vertex_.

226 { maybeUnpackBoth(); return vertex_.Y(); }//{ return 0; }
void maybeUnpackBoth() const
Point vertex_
vertex position
virtual double pat::PackedCandidate::vz ( ) const
inlinevirtual

z coordinate of vertex position

Implements reco::Candidate.

Definition at line 228 of file PackedCandidate.h.

References maybeUnpackBoth(), and vertex_.

228 { maybeUnpackBoth(); return vertex_.Z(); }//{ if (fromPV_) return 0; else return 100; }
void maybeUnpackBoth() const
Point vertex_
vertex position
virtual double pat::PackedCandidate::y ( ) const
inlinevirtual

Friends And Related Function Documentation

friend class ::OverlapChecker
friend

Definition at line 430 of file PackedCandidate.h.

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

Definition at line 429 of file PackedCandidate.h.

friend class ShallowCloneCandidate
friend

Definition at line 431 of file PackedCandidate.h.

friend class ShallowClonePtrCandidate
friend

Definition at line 432 of file PackedCandidate.h.

Member Data Documentation

float pat::PackedCandidate::detadeta_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dlambdadz_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dphi_
mutableprotected

Definition at line 404 of file PackedCandidate.h.

Referenced by phiAtVtx().

float pat::PackedCandidate::dphidphi_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dphidxy_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dptdpt_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dxy_
mutableprotected

Definition at line 404 of file PackedCandidate.h.

Referenced by dxy().

float pat::PackedCandidate::dxydxy_
mutableprotected

IP covariance.

Definition at line 420 of file PackedCandidate.h.

Referenced by dxyError(), and setTrackProperties().

float pat::PackedCandidate::dxydz_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by setTrackProperties().

float pat::PackedCandidate::dz_
mutableprotected

Definition at line 404 of file PackedCandidate.h.

Referenced by dz(), and dzAssociatedPV().

float pat::PackedCandidate::dzdz_
mutableprotected

Definition at line 420 of file PackedCandidate.h.

Referenced by dzError(), and setTrackProperties().

const unsigned int pat::PackedCandidate::longLivedTag = 0
static

long lived flag

Definition at line 316 of file PackedCandidate.h.

const unsigned int pat::PackedCandidate::massConstraintTag = 0
static

do mass constraint flag

Definition at line 322 of file PackedCandidate.h.

uint8_t pat::PackedCandidate::normalizedChi2_
protected

track quality information

Definition at line 423 of file PackedCandidate.h.

Referenced by setTrackProperties().

PolarLorentzVector pat::PackedCandidate::p4_
mutableprotected

the four vector

Definition at line 400 of file PackedCandidate.h.

Referenced by eta(), mass(), massSqr(), mt(), mtSqr(), phi(), phiAtVtx(), polarP4(), pt(), rapidity(), setMass(), setP4(), setPz(), theta(), and y().

LorentzVector pat::PackedCandidate::p4c_
mutableprotected

Definition at line 401 of file PackedCandidate.h.

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

int8_t pat::PackedCandidate::packedCovarianceDetaDeta_
protected

Definition at line 388 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedCovarianceDlambdaDz_
protected

Definition at line 387 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedCovarianceDphiDphi_
protected

Definition at line 388 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedCovarianceDphiDxy_
protected

Definition at line 387 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedCovarianceDptDpt_
protected

Definition at line 388 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedCovarianceDxyDxy_
protected

Definition at line 386 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedCovarianceDxyDz_
protected

Definition at line 386 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedCovarianceDzDz_
protected

Definition at line 386 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedDPhi_
protected

Definition at line 385 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedDxy_
protected

Definition at line 385 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedDz_
protected

Definition at line 385 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedEta_
protected

Definition at line 384 of file PackedCandidate.h.

uint8_t pat::PackedCandidate::packedHits_
protected

Definition at line 421 of file PackedCandidate.h.

Referenced by bestTrack(), numberOfHits(), numberOfPixelHits(), and setTrackProperties().

uint16_t pat::PackedCandidate::packedM_
protected

Definition at line 384 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedPhi_
protected

Definition at line 384 of file PackedCandidate.h.

uint16_t pat::PackedCandidate::packedPt_
protected

Weight from PUPPI removing leptons.

Definition at line 384 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedPuppiweight_
protected

Definition at line 397 of file PackedCandidate.h.

int8_t pat::PackedCandidate::packedPuppiweightNoLepDiff_
protected

Definition at line 398 of file PackedCandidate.h.

int pat::PackedCandidate::pdgId_
protected

PDG identifier.

Definition at line 408 of file PackedCandidate.h.

Referenced by charge(), pdgId(), and setPdgId().

reco::VertexRef::key_type pat::PackedCandidate::pvRefKey_
protected

Definition at line 412 of file PackedCandidate.h.

Referenced by dz(), and vertexRef().

reco::VertexRefProd pat::PackedCandidate::pvRefProd_
protected

Use these to build a Ref to primary vertex.

Definition at line 411 of file PackedCandidate.h.

Referenced by vertexRef().

uint16_t pat::PackedCandidate::qualityFlags_
protected
reco::Track pat::PackedCandidate::track_
mutableprotected

reco::Track

Definition at line 406 of file PackedCandidate.h.

Referenced by bestTrack(), and pseudoTrack().

bool pat::PackedCandidate::unpacked_
mutableprotected
bool pat::PackedCandidate::unpackedTrk_
mutableprotected

Definition at line 418 of file PackedCandidate.h.

Referenced by bestTrack(), and pseudoTrack().

bool pat::PackedCandidate::unpackedVtx_
mutableprotected

Definition at line 416 of file PackedCandidate.h.

Referenced by maybeUnpackBoth().

Point pat::PackedCandidate::vertex_
mutableprotected

vertex position

Definition at line 403 of file PackedCandidate.h.

Referenced by setVertex(), vertex(), vx(), vy(), and vz().