#include <DataFormats/MuonReco/interface/Muon.h>
Public Member Functions | |
const Track * | bestTrack () const override |
TrackBaseRef | bestTrackRef () const override |
best track RefToBase More... | |
MuonEnergy | calEnergy () const |
get energy deposition information More... | |
float | caloCompatibility () const |
Muon * | clone () const override |
create a clone More... | |
TrackRef | combinedMuon () const override |
reference to a stand-alone muon Track More... | |
MuonQuality | combinedQuality () const |
get energy deposition information More... | |
float | dDxDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | dDyDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | dX (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | dY (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
virtual TrackRef | dytTrack () const |
unsigned int | expectedNnumberOfMatchedStations (float minDistanceFromEdge=10.0) const |
virtual TrackRef | globalTrack () const |
reference to Track reconstructed in both tracked and muon detector More... | |
bool | hasShowerInStation (int station, int muonSubdetId, int nDtDigisCut=20, int nCscDigisCut=36) const |
tag a shower in a given station layer More... | |
virtual TrackRef | innerTrack () const |
bool | isAValidMuonTrack (const MuonTrackType &type) const |
bool | isCaloCompatibilityValid () const |
bool | isCaloMuon () const override |
bool | isEnergyValid () const |
bool | isGEMMuon () const |
bool | isGlobalMuon () const override |
bool | isIsolationValid () const |
bool | isMatchesValid () const |
bool | isME0Muon () const |
bool | isMuon () const override |
const MuonIsolation & | isolationR03 () const |
const MuonIsolation & | isolationR05 () const |
bool | isPFIsolationValid () const |
bool | isPFMuon () const |
bool | isQualityValid () const |
bool | isRPCMuon () const |
bool | isStandAloneMuon () const override |
bool | isTimeValid () const |
bool | isTrackerMuon () const override |
std::vector< MuonChamberMatch > & | matches () |
get muon matching information More... | |
const std::vector< MuonChamberMatch > & | matches () const |
Muon () | |
Muon (Charge, const LorentzVector &, const Point &=Point(0, 0, 0)) | |
constructor from values More... | |
virtual TrackRef | muonBestTrack () const |
virtual MuonTrackType | muonBestTrackType () const |
TrackRef | muonTrack (const MuonTrackType &) const |
TrackRef | muonTrackFromMap (const MuonTrackType &type) const |
int | nDigisInStation (int station, int muonSubdetId) const |
int | numberOfChambers () const |
int | numberOfChambersCSCorDT () const |
number of chambers CSC or DT matches only (MuonChamberMatches include RPC rolls) More... | |
int | numberOfMatchedRPCLayers (ArbitrationType type=RPCHitAndTrackArbitration) const |
int | numberOfMatchedStations (ArbitrationType type=SegmentAndTrackArbitration) const |
int | numberOfMatches (ArbitrationType type=SegmentAndTrackArbitration) const |
get number of chambers with matched segments More... | |
int | numberOfSegments (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
get number of segments More... | |
int | numberOfShowers (int nDtDigisCut=20, int nCscDigisCut=36) const |
count the number of showers along a muon track More... | |
virtual TrackRef | outerTrack () const |
reference to Track reconstructed in the muon detector only More... | |
bool | passed (Selector selection) const |
bool | passed (uint64_t selection) const |
const MuonPFIsolation & | pfIsolationR03 () const |
const MuonPFIsolation & | pfIsolationR04 () const |
const MuonPFIsolation & | pfMeanDRIsoProfileR03 () const |
const MuonPFIsolation & | pfMeanDRIsoProfileR04 () const |
reco::Candidate::LorentzVector | pfP4 () const |
const MuonPFIsolation & | pfSumDRIsoProfileR03 () const |
const MuonPFIsolation & | pfSumDRIsoProfileR04 () const |
virtual TrackRef | pickyTrack () const |
float | pullDxDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration, bool includeSegmentError=true) const |
float | pullDyDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration, bool includeSegmentError=true) const |
float | pullX (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration, bool includeSegmentError=true) const |
float | pullY (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration, bool includeSegmentError=true) const |
unsigned int | RPClayerMask (ArbitrationType type=RPCHitAndTrackArbitration) const |
MuonTime | rpcTime () const |
get RPC timing information More... | |
float | segmentDxDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentDxDzErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentDyDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentDyDzErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentX (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentXErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentY (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | segmentYErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
uint64_t | selectors () const |
virtual void | setBestTrack (MuonTrackType muonType) |
void | setCalEnergy (const MuonEnergy &calEnergy) |
set energy deposition information More... | |
void | setCaloCompatibility (float input) |
virtual void | setCombined (const TrackRef &t) |
void | setCombinedQuality (const MuonQuality &combinedQuality) |
set energy deposition information More... | |
virtual void | setGlobalTrack (const TrackRef &t) |
set reference to Track More... | |
virtual void | setInnerTrack (const TrackRef &t) |
set reference to Track More... | |
void | setIsolation (const MuonIsolation &isoR03, const MuonIsolation &isoR05) |
void | setMatches (const std::vector< MuonChamberMatch > &matches) |
set muon matching information More... | |
void | setMuonTrack (const MuonTrackType &, const TrackRef &) |
virtual void | setOuterTrack (const TrackRef &t) |
set reference to Track More... | |
void | setPFIsolation (const std::string &label, const reco::MuonPFIsolation &deposit) |
virtual void | setPFP4 (const reco::Candidate::LorentzVector &p4_) |
void | setRPCTime (const MuonTime &time) |
set RPC timing information More... | |
void | setSelector (Selector selector, bool passed) |
void | setSelectors (uint64_t selectors) |
virtual void | setStandAlone (const TrackRef &t) |
void | setTime (const MuonTime &time) |
set DT/CSC combined timing information More... | |
virtual void | setTrack (const TrackRef &t) |
virtual void | setTunePBestTrack (MuonTrackType muonType) |
void | setType (unsigned int type) |
TrackRef | standAloneMuon () const override |
reference to a stand-alone muon Track More... | |
unsigned int | stationGapMaskDistance (float distanceCut=10.) const |
unsigned int | stationGapMaskPull (float sigmaCut=3.) const |
same as above for given number of sigmas More... | |
unsigned int | stationMask (ArbitrationType type=SegmentAndTrackArbitration) const |
float | t0 (int n=0) |
MuonTime | time () const |
get DT/CSC combined timing information More... | |
virtual TrackRef | tpfmsTrack () const |
TrackRef | track () const override |
reference to a Track More... | |
float | trackDist (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackDistErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackDxDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackDxDzErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackDyDz (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackDyDzErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackEdgeX (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackEdgeY (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackX (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackXErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackY (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
float | trackYErr (int station, int muonSubdetId, ArbitrationType type=SegmentAndTrackArbitration) const |
virtual TrackRef | tunePMuonBestTrack () const |
virtual MuonTrackType | tunePMuonBestTrackType () const |
unsigned int | type () const |
Public Member Functions inherited from reco::RecoCandidate | |
const Track * | bestTrack () const override |
best track pointer More... | |
virtual TrackType | bestTrackType () const |
track type More... | |
virtual CaloTowerRef | caloTower () const |
reference to a CaloTower More... | |
RecoCandidate * | clone () const override |
returns a clone of the Candidate object More... | |
float | dxyError () const override |
uncertainty on dxy More... | |
float | dzError () const override |
uncertainty on dz More... | |
virtual reco::GsfTrackRef | gsfTrack () const |
reference to a GsfTrack More... | |
virtual size_t | numberOfTracks () const |
number of multiple Tracks More... | |
RecoCandidate () | |
default constructor More... | |
template<typename P4 > | |
RecoCandidate (Charge q, const P4 &p4, const Point &vtx=Point(0, 0, 0), int pdgId=0, int status=0) | |
constructor from values More... | |
virtual reco::SuperClusterRef | superCluster () const |
reference to a SuperCluster More... | |
virtual reco::TrackRef | track (size_t) const |
reference to one of multiple Tracks More... | |
~RecoCandidate () override | |
destructor More... | |
Public Member Functions inherited from reco::LeafCandidate | |
Vector | boostToCM () const final |
int | charge () const final |
electric charge More... | |
void | construct (int qx3, float pt, float eta, float phi, float mass, const Point &vtx, int pdgId, int status) |
const Candidate * | daughter (const std::string &s) const override |
return daughter with a specified role name More... | |
Candidate * | daughter (const std::string &s) override |
return daughter with a specified role name More... | |
const Candidate * | daughter (size_type) const override |
return daughter at a given position (throws an exception) More... | |
Candidate * | daughter (size_type) override |
return daughter at a given position (throws an exception) More... | |
double | energy () const final |
energy More... | |
double | et () const final |
transverse energy More... | |
double | et2 () const final |
transverse energy squared (use this for cut!) More... | |
double | eta () const final |
momentum pseudorapidity More... | |
void | fillVertexCovariance (CovarianceMatrix &v) const override |
fill SMatrix More... | |
template<typename T > | |
T | get () const |
get a component More... | |
template<typename T , typename Tag > | |
T | get () const |
get a component More... | |
template<typename T > | |
T | get (size_type i) const |
get a component More... | |
template<typename T , typename Tag > | |
T | get (size_type i) const |
get a component More... | |
bool | hasMasterClone () const override |
bool | hasMasterClonePtr () const override |
bool | isConvertedPhoton () const override |
bool | isElectron () const override |
bool | isJet () const override |
bool | isPhoton () const override |
LeafCandidate () | |
template<typename... Args> | |
LeafCandidate (Args &&... args) | |
LeafCandidate (const Candidate &c) | |
LeafCandidate (LeafCandidate &&)=default | |
LeafCandidate (LeafCandidate &rh) | |
LeafCandidate (LeafCandidate const &)=default | |
bool | longLived () const final |
is long lived? More... | |
double | mass () const final |
mass More... | |
bool | massConstraint () const final |
do mass constraint? More... | |
double | massSqr () const final |
mass squared More... | |
const CandidateBaseRef & | masterClone () const override |
const CandidatePtr & | masterClonePtr () const override |
template<typename Ref > | |
Ref | masterRef () const |
cast master clone reference to a concrete type More... | |
Vector | momentum () const final |
spatial momentum vector More... | |
const Candidate * | mother (size_type) const override |
return mother at a given position (throws an exception) More... | |
double | mt () const final |
transverse mass More... | |
double | mtSqr () const final |
transverse mass squared More... | |
template<typename T > | |
size_type | numberOf () const |
number of components More... | |
template<typename T , typename Tag > | |
size_type | numberOf () const |
number of components More... | |
size_t | numberOfDaughters () const override |
number of daughters More... | |
size_t | numberOfMothers () const override |
number of mothers More... | |
size_t | numberOfSourceCandidatePtrs () const override |
LeafCandidate & | operator= (LeafCandidate &&)=default |
LeafCandidate & | operator= (LeafCandidate const &)=default |
double | p () const final |
magnitude of momentum vector More... | |
const LorentzVector & | p4 () const final |
four-momentum Lorentz vector More... | |
int | pdgId () const final |
PDG identifier. More... | |
double | phi () const final |
momentum azimuthal angle More... | |
const PolarLorentzVector & | polarP4 () const final |
four-momentum Lorentz vector More... | |
double | pt () const final |
transverse momentum More... | |
double | px () const final |
x coordinate of momentum vector More... | |
double | py () const final |
y coordinate of momentum vector More... | |
double | pz () const final |
z coordinate of momentum vector More... | |
double | rapidity () const final |
rapidity More... | |
void | setCharge (Charge q) final |
set electric charge More... | |
void | setLongLived () final |
void | setMass (double m) final |
set particle mass More... | |
void | setMassConstraint () final |
void | setP4 (const LorentzVector &p4) final |
set 4-momentum More... | |
void | setP4 (const PolarLorentzVector &p4) final |
set 4-momentum More... | |
void | setPdgId (int pdgId) final |
void | setPz (double pz) final |
void | setStatus (int status) final |
set status word More... | |
void | setThreeCharge (Charge qx3) final |
set electric charge More... | |
void | setVertex (const Point &vertex) override |
set vertex More... | |
CandidatePtr | sourceCandidatePtr (size_type i) const override |
int | status () const final |
status word More... | |
double | theta () const final |
momentum polar angle More... | |
int | threeCharge () const final |
electric charge More... | |
const Point & | vertex () const override |
vertex position (overwritten by PF...) More... | |
double | vertexChi2 () const override |
chi-squares More... | |
CovarianceMatrix | vertexCovariance () const final |
return SMatrix More... | |
double | vertexCovariance (int i, int j) const override |
(i, j)-th element of error matrix, i, j = 0, ... 2 More... | |
double | vertexNdof () const override |
double | vertexNormalizedChi2 () const override |
chi-squared divided by n.d.o.f. More... | |
double | vx () const override |
x coordinate of vertex position More... | |
double | vy () const override |
y coordinate of vertex position More... | |
double | vz () const override |
z coordinate of vertex position More... | |
double | y () const final |
rapidity More... | |
~LeafCandidate () override | |
destructor More... | |
Public Member Functions inherited from reco::Candidate | |
iterator | begin () |
first daughter iterator More... | |
const_iterator | begin () const |
first daughter const_iterator More... | |
Candidate () | |
default constructor More... | |
iterator | end () |
last daughter iterator More... | |
const_iterator | end () const |
last daughter const_iterator More... | |
template<typename T > | |
T | get () const |
get a component More... | |
template<typename T , typename Tag > | |
T | get () const |
get a component More... | |
template<typename T > | |
T | get (size_type i) const |
get a component More... | |
template<typename T , typename Tag > | |
T | get (size_type i) const |
get a component More... | |
template<typename Ref > | |
Ref | masterRef () const |
cast master clone reference to a concrete type More... | |
template<typename T > | |
size_type | numberOf () const |
number of components More... | |
template<typename T , typename Tag > | |
size_type | numberOf () const |
number of components More... | |
virtual void | setSourceCandidatePtr (const CandidatePtr &ptr) |
Set the ptr to the source Candidate. More... | |
virtual | ~Candidate () |
destructor More... | |
Static Public Attributes | |
static const unsigned int | CaloMuon = 1 << 4 |
static const unsigned int | GEMMuon = 1 << 7 |
static const unsigned int | GlobalMuon = 1 << 1 |
static const unsigned int | ME0Muon = 1 << 8 |
static const unsigned int | PFMuon = 1 << 5 |
static const unsigned int | RPCMuon = 1 << 6 |
static const unsigned int | StandAloneMuon = 1 << 3 |
static const unsigned int | TrackerMuon = 1 << 2 |
Private Member Functions | |
const std::vector< const MuonChamberMatch * > | chambers (int station, int muonSubdetId) const |
get vector of muon chambers for given station and detector More... | |
bool | overlap (const Candidate &) const override |
check overlap with another candidate More... | |
std::pair< const MuonChamberMatch *, const MuonSegmentMatch * > | pair (const std::vector< const MuonChamberMatch * > &, ArbitrationType type=SegmentAndTrackArbitration) const |
get pointers to best segment and corresponding chamber in vector of chambers More... | |
Private Attributes | |
MuonTrackType | bestTrackType_ |
reference to the Track chosen to assign the momentum value to the muon More... | |
MuonTrackType | bestTunePTrackType_ |
reference to the Track chosen to assign the momentum value to the muon by PF More... | |
MuonEnergy | calEnergy_ |
energy deposition More... | |
float | caloCompatibility_ |
muon hypothesis compatibility with observer calorimeter energy More... | |
MuonQuality | combinedQuality_ |
quality block More... | |
bool | energyValid_ |
TrackRef | globalTrack_ |
reference to Track reconstructed in both tracked and muon detector More... | |
TrackRef | innerTrack_ |
reference to Track reconstructed in the tracker only More... | |
MuonIsolation | isolationR03_ |
Isolation information for two cones with dR=0.3 and dR=0.5. More... | |
MuonIsolation | isolationR05_ |
bool | isolationValid_ |
bool | matchesValid_ |
std::vector< MuonChamberMatch > | muMatches_ |
Information on matching between tracks and segments. More... | |
TrackRef | outerTrack_ |
reference to Track reconstructed in the muon detector only More... | |
MuonPFIsolation | pfIsolationR03_ |
PF Isolation information for two cones with dR=0.3 and dR=0.4. More... | |
MuonPFIsolation | pfIsolationR04_ |
bool | pfIsolationValid_ |
MuonPFIsolation | pfIsoMeanDRR03_ |
MuonPFIsolation | pfIsoMeanDRR04_ |
MuonPFIsolation | pfIsoSumDRR03_ |
MuonPFIsolation | pfIsoSumDRR04_ |
reco::Candidate::LorentzVector | pfP4_ |
bool | qualityValid_ |
MuonTrackRefMap | refittedTrackMap_ |
reference to the Global Track refitted with dedicated TeV reconstructors More... | |
MuonTime | rpcTime_ |
uint64_t | selectors_ |
selector bitmap More... | |
MuonTime | time_ |
timing More... | |
unsigned int | type_ |
muon type mask More... | |
Additional Inherited Members | |
Protected Member Functions inherited from reco::RecoCandidate | |
template<typename R > | |
bool | checkOverlap (const R &r1, const R &r2) const |
check if two components overlap More... | |
A reconstructed Muon. contains reference to three fits:
typedef std::map<MuonTrackType, reco::TrackRef> reco::Muon::MuonTrackRefMap |
typedef std::pair<TrackRef, Muon::MuonTrackType> reco::Muon::MuonTrackTypePair |
enum reco::Muon::Selector |
====================== STANDARD SELECTORS ===========================
Definition at line 201 of file Muon.h.
reco::Muon::Muon | ( | ) |
reco::Muon::Muon | ( | Charge | , |
const LorentzVector & | , | ||
const Point & | = Point(0, 0, 0) |
||
) |
constructor from values
|
inlineoverridevirtual |
Reimplemented from reco::Candidate.
Reimplemented in pat::Muon.
Definition at line 58 of file Muon.h.
References bestTrackType_, edm::Ref< C, T, F >::get(), and muonTrack().
Referenced by PileupJetIdAlgo::computeIdVariables(), and Muon.Muon::ptErr().
|
inlineoverridevirtual |
best track RefToBase
Reimplemented from reco::RecoCandidate.
Definition at line 59 of file Muon.h.
References bestTrackType_, and muonTrack().
|
inline |
get energy deposition information
Definition at line 106 of file Muon.h.
References calEnergy_.
Referenced by FWMuonDetailView::build(), FWMuonLegoProxyBuilder::build(), MuonCaloCompatibility::evaluate(), MuonMETAlgo::GetMuDepDeltas(), and setCalEnergy().
|
inline |
====================== MUON COMPATIBILITY BLOCK ===========================
Relative likelihood based on ECAL, HCAL, HO energy defined as L_muon/(L_muon+L_not_muon)
Definition at line 158 of file Muon.h.
References caloCompatibility_.
|
private |
get vector of muon chambers for given station and detector
|
overridevirtual |
create a clone
Reimplemented from reco::LeafCandidate.
Reimplemented in pat::Muon, and pat::Lepton< reco::Muon >.
|
inlineoverridevirtual |
reference to a stand-alone muon Track
Reimplemented from reco::RecoCandidate.
Reimplemented in pat::Muon.
Definition at line 52 of file Muon.h.
References globalTrack().
Referenced by AlignmentMuonSelector::basicCuts(), and MuonIdProducer::fillGlbQuality().
|
inline |
get energy deposition information
Definition at line 119 of file Muon.h.
References combinedQuality_.
Referenced by MuonIdProducer::fillGlbQuality(), MuonIdProducer::fillTrackerKink(), isMediumMuonCustom(), and setCombinedQuality().
float reco::Muon::dDxDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::dDyDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::dX | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
get deltas between (best) segment and track If no chamber or no segment returns 999999
float reco::Muon::dY | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 56 of file Muon.h.
References DYT, and muonTrackFromMap().
unsigned int reco::Muon::expectedNnumberOfMatchedStations | ( | float | minDistanceFromEdge = 10.0 | ) | const |
expected number of stations with matching segments based on the absolute distance from the edge of a chamber
|
inlinevirtual |
reference to Track reconstructed in both tracked and muon detector
Reimplemented in pat::Muon.
Definition at line 51 of file Muon.h.
References globalTrack_.
Referenced by EwkMuDQM::analyze(), TrackSplittingMonitor::analyze(), CosmicSplitterValidation::analyze(), MuonToSimAssociatorByHits::associateMuons(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), combinedMuon(), MuonMETAlgo::GetMuDepDeltas(), isMediumMuonCustom(), isTightMuonCustom(), Muon.Muon::muonID(), helper::MuonCollectionStoreManager::processMuon(), and BPhysicsOniaDQM::selGlobalMuon().
bool reco::Muon::hasShowerInStation | ( | int | station, |
int | muonSubdetId, | ||
int | nDtDigisCut = 20 , |
||
int | nCscDigisCut = 36 |
||
) | const |
tag a shower in a given station layer
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 45 of file Muon.h.
References innerTrack_.
Referenced by EwkMuDQM::analyze(), HLTMuonMatchAndPlot::analyze(), FWMuonBuilder::calculateField(), MuonIdProducer::fillTrackerKink(), MuonMETAlgo::GetMuDepDeltas(), isMediumMuonCustom(), isTightMuonCustom(), Lepton.Lepton::lostInner(), Muon.Muon::muonID(), MuonResidualsFromTrack::MuonResidualsFromTrack(), helper::MuonCollectionStoreManager::processMuon(), Onia2MuMuPAT::produce(), BPhysicsOniaDQM::selGlobalMuon(), BPhysicsOniaDQM::selTrackerMuon(), and track().
bool reco::Muon::isAValidMuonTrack | ( | const MuonTrackType & | type | ) | const |
Referenced by pat::PATMuonProducer::fillMuon().
|
inline |
|
inlineoverridevirtual |
|
inline |
====================== ENERGY BLOCK ===========================
energy deposition
Definition at line 104 of file Muon.h.
References energyValid_.
Referenced by FWMuonDetailView::build(), and FWMuonLegoProxyBuilder::build().
|
inline |
Definition at line 305 of file Muon.h.
References GEMMuon, and type_.
Referenced by MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), and MuonMETAlgo::GetMuDepDeltas().
|
inlineoverridevirtual |
Reimplemented from reco::LeafCandidate.
Definition at line 299 of file Muon.h.
References GlobalMuon, and type_.
Referenced by RPCRecHitProbability::analyze(), RPCMonitorDigi::analyze(), EwkMuDQM::analyze(), HiggsDQM::analyze(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), MuonIdProducer::fillGlbQuality(), EwkMuTauHistManager::fillHistograms(), pat::PATMuonProducer::fillMuon(), MuonMETAlgo::GetMuDepDeltas(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), isLooseMuonCustom(), isMediumMuonCustom(), isTightMuonCustom(), Muon.Muon::muonID(), MuonProducer::produce(), and MuScleFitMuonSelector::selectMuons().
|
inline |
Definition at line 177 of file Muon.h.
References isolationValid_.
Referenced by MuonMETAlgo::GetMuDepDeltas().
|
inline |
====================== MUON MATCH BLOCK ===========================
Definition at line 143 of file Muon.h.
References matchesValid_.
|
inline |
Definition at line 306 of file Muon.h.
References ME0Muon, and type_.
Referenced by MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), and MuonMETAlgo::GetMuDepDeltas().
|
inlineoverridevirtual |
Reimplemented from reco::LeafCandidate.
Definition at line 298 of file Muon.h.
Referenced by MuonToTrackingParticleAssociatorByHitsImpl::associateMuons().
|
inline |
====================== ISOLATION BLOCK ===========================
Summary of muon isolation information
Definition at line 166 of file Muon.h.
References isolationR03_.
Referenced by EwkMuDQM::analyze(), ZToMuMuGammaAnalyzer::analyze(), pat::Muon::ecalIso(), MuonMETAlgo::GetMuDepDeltas(), pat::Muon::hcalIso(), and pat::Muon::trackIso().
|
inline |
Definition at line 167 of file Muon.h.
References isolationR05_.
Referenced by EwkMuTauHistManager::fillHistograms().
|
inline |
|
inline |
Definition at line 303 of file Muon.h.
Referenced by MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), heppy::CMGMuonCleanerBySegmentsAlgo::clean(), isLooseMuonCustom(), isTightMuonCustom(), and MuonProducer::produce().
|
inline |
====================== Quality BLOCK ===========================
energy deposition
Definition at line 117 of file Muon.h.
References qualityValid_.
Referenced by MuonIdProducer::fillTrackerKink().
|
inline |
Definition at line 304 of file Muon.h.
References RPCMuon, and type_.
Referenced by MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), MuonIdProducer::fillMuonId(), and MuonMETAlgo::GetMuDepDeltas().
|
inlineoverridevirtual |
Reimplemented from reco::LeafCandidate.
Definition at line 301 of file Muon.h.
References StandAloneMuon, and type_.
Referenced by HLTMuonMatchAndPlot::analyze(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), and MuonProducer::produce().
|
inline |
|
inlineoverridevirtual |
Reimplemented from reco::LeafCandidate.
Definition at line 300 of file Muon.h.
References TrackerMuon, and type_.
Referenced by EwkMuDQM::analyze(), HiggsDQM::analyze(), HLTMuonMatchAndPlot::analyze(), MuonToSimAssociatorByHits::associateMuons(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), EwkMuTauHistManager::fillHistograms(), MuonIdProducer::fillMuonId(), MuonMETAlgo::GetMuDepDeltas(), isLooseMuonCustom(), MuonResidualsFromTrack::MuonResidualsFromTrack(), MuonProducer::produce(), and MuScleFitMuonSelector::selectMuons().
|
inline |
get muon matching information
Definition at line 145 of file Muon.h.
References muMatches_.
Referenced by pat::PATMuonProducer::fillL1TriggerInfo(), MuonIdProducer::fillMuonId(), MuonResidualsFromTrack::MuonResidualsFromTrack(), muon::overlap(), setMatches(), muon::sharedSegments(), and MuonIdTruthInfo::truthMatchMuon().
|
inline |
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 60 of file Muon.h.
References bestTrackType_, and muonTrack().
Referenced by isTightMuonCustom().
|
inlinevirtual |
TrackRef reco::Muon::muonTrack | ( | const MuonTrackType & | ) | const |
Referenced by bestTrack(), bestTrackRef(), muonBestTrack(), and tunePMuonBestTrack().
|
inline |
Definition at line 68 of file Muon.h.
References refittedTrackMap_.
Referenced by dytTrack(), pickyTrack(), and tpfmsTrack().
int reco::Muon::nDigisInStation | ( | int | station, |
int | muonSubdetId | ||
) | const |
|
inline |
====================== USEFUL METHODs ===========================
number of chambers (MuonChamberMatches include RPC rolls, GEM and ME0 segments)
Definition at line 253 of file Muon.h.
References muMatches_.
int reco::Muon::numberOfChambersCSCorDT | ( | ) | const |
number of chambers CSC or DT matches only (MuonChamberMatches include RPC rolls)
int reco::Muon::numberOfMatchedRPCLayers | ( | ArbitrationType | type = RPCHitAndTrackArbitration | ) | const |
get bit map of stations with tracks within given distance (in cm) of chamber edges bit assignments are same as above
int reco::Muon::numberOfMatchedStations | ( | ArbitrationType | type = SegmentAndTrackArbitration | ) | const |
get number of stations with matched segments just adds the bits returned by stationMask
Referenced by isTightMuonCustom(), and Muon.Muon::muonID().
int reco::Muon::numberOfMatches | ( | ArbitrationType | type = SegmentAndTrackArbitration | ) | const |
get number of chambers with matched segments
Referenced by EwkMuDQM::analyze(), MuonCosmicCompatibilityFiller::checkMuonSegments(), heppy::CMGMuonCleanerBySegmentsAlgo::clean(), MuonIdProducer::fillMuonId(), heppy::CMGMuonCleanerBySegmentsAlgo::isBetterMuon(), and muon::overlap().
int reco::Muon::numberOfSegments | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
get number of segments
int reco::Muon::numberOfShowers | ( | int | nDtDigisCut = 20 , |
int | nCscDigisCut = 36 |
||
) | const |
count the number of showers along a muon track
|
inlinevirtual |
reference to Track reconstructed in the muon detector only
Reimplemented in pat::Muon.
Definition at line 48 of file Muon.h.
References outerTrack_.
Referenced by RPCRecHitProbability::analyze(), RPCMonitorDigi::analyze(), CosmicSplitterValidation::analyze(), HLTMuonMatchAndPlot::analyze(), MuonToSimAssociatorByHits::associateMuons(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), FWMuonBuilder::calculateField(), MuonMETAlgo::GetMuDepDeltas(), CosmicSplitterValidation::is_gold_muon(), and standAloneMuon().
|
overrideprivatevirtual |
check overlap with another candidate
Implements reco::RecoCandidate.
|
private |
get pointers to best segment and corresponding chamber in vector of chambers
|
inline |
|
inline |
Definition at line 238 of file Muon.h.
References corrVsCorr::selection, and selectors_.
Referenced by setSelector().
|
inline |
|
inline |
|
inline |
|
inline |
|
inline |
set reference to PFCandidate
====================== PF BLOCK ===========================
Definition at line 97 of file Muon.h.
References pfP4_.
Referenced by RecoMuonValidator::MuonME::fill(), and MuonProducer::produce().
|
inline |
|
inline |
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 55 of file Muon.h.
References muonTrackFromMap(), and Picky.
float reco::Muon::pullDxDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration , |
||
bool | includeSegmentError = true |
||
) | const |
float reco::Muon::pullDyDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration , |
||
bool | includeSegmentError = true |
||
) | const |
float reco::Muon::pullX | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration , |
||
bool | includeSegmentError = true |
||
) | const |
float reco::Muon::pullY | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration , |
||
bool | includeSegmentError = true |
||
) | const |
unsigned int reco::Muon::RPClayerMask | ( | ArbitrationType | type = RPCHitAndTrackArbitration | ) | const |
|
inline |
float reco::Muon::segmentDxDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentDxDzErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentDyDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentDyDzErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentX | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
get (best) segment information If no segment returns 999999
float reco::Muon::segmentXErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentY | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::segmentYErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
|
inline |
|
inlinevirtual |
Definition at line 86 of file Muon.h.
References bestTrackType_.
Referenced by MuonIdProducer::makeMuon(), and MuonProducer::produce().
|
inline |
set energy deposition information
Definition at line 108 of file Muon.h.
References calEnergy(), calEnergy_, and energyValid_.
Referenced by MuonIdProducer::fillMuonId().
|
inline |
|
virtual |
|
inline |
set energy deposition information
Definition at line 121 of file Muon.h.
References combinedQuality(), combinedQuality_, and qualityValid_.
Referenced by MuonIdProducer::fillGlbQuality(), and MuonIdProducer::fillTrackerKink().
|
virtual |
set reference to Track
Referenced by MuonIdProducer::makeMuon().
|
virtual |
set reference to Track
Referenced by MuonIdProducer::makeMuon().
void reco::Muon::setIsolation | ( | const MuonIsolation & | isoR03, |
const MuonIsolation & | isoR05 | ||
) |
Referenced by MuonIdProducer::fillMuonIsolation().
|
inline |
set muon matching information
Definition at line 148 of file Muon.h.
References matches(), matchesValid_, and muMatches_.
Referenced by MuonIdProducer::fillMuonId().
void reco::Muon::setMuonTrack | ( | const MuonTrackType & | , |
const TrackRef & | |||
) |
Referenced by MuonIdProducer::makeMuon().
|
virtual |
set reference to Track
Referenced by MuonIdProducer::makeMuon().
void reco::Muon::setPFIsolation | ( | const std::string & | label, |
const reco::MuonPFIsolation & | deposit | ||
) |
|
virtual |
Referenced by MuonProducer::produce().
|
inline |
|
inline |
Definition at line 242 of file Muon.h.
References passed(), and selectors_.
|
inline |
Definition at line 241 of file Muon.h.
References selectors(), and selectors_.
Referenced by MuonProducer::produce(), and pat::LeptonUpdater< T >::recomputeMuonBasicSelectors().
|
virtual |
|
inline |
|
virtual |
|
inlinevirtual |
Definition at line 88 of file Muon.h.
References bestTunePTrackType_.
Referenced by MuonIdProducer::makeMuon().
|
inline |
|
inlineoverridevirtual |
reference to a stand-alone muon Track
Reimplemented from reco::RecoCandidate.
Reimplemented in pat::Muon.
Definition at line 49 of file Muon.h.
References outerTrack().
Referenced by AlignmentMuonSelector::basicCuts(), FWMuonLegoProxyBuilder::build(), MuonCaloCompatibility::evaluate(), MuonIdProducer::fillMuonId(), and MuonIdProducer::fillMuonIsolation().
unsigned int reco::Muon::stationGapMaskDistance | ( | float | distanceCut = 10. | ) | const |
unsigned int reco::Muon::stationGapMaskPull | ( | float | sigmaCut = 3. | ) | const |
same as above for given number of sigmas
unsigned int reco::Muon::stationMask | ( | ArbitrationType | type = SegmentAndTrackArbitration | ) | const |
get bit map of stations with matched segments bits 0-1-2-3 = DT stations 1-2-3-4 bits 4-5-6-7 = CSC stations 1-2-3-4
|
inline |
Definition at line 420 of file Muon.h.
References relativeConstraints::chamber, mps_fire::i, createfilelist::int, muMatches_, and dqmiodumpmetadata::n.
|
inline |
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 54 of file Muon.h.
References muonTrackFromMap(), and TPFMS.
|
inlineoverridevirtual |
reference to a Track
Reimplemented from reco::RecoCandidate.
Reimplemented in pat::Muon.
Definition at line 46 of file Muon.h.
References innerTrack().
Referenced by MuonToSimAssociatorByHits::associateMuons(), MuonToTrackingParticleAssociatorByHitsImpl::associateMuons(), AlignmentMuonSelector::basicCuts(), FWMuonLegoProxyBuilder::build(), MuonCaloCompatibility::evaluate(), RecoMuonValidator::MuonME::fill(), MuonIdProducer::fillMuonId(), MuonIdProducer::fillMuonIsolation(), Onia2MuMuPAT::produce(), and MuonIdTruthInfo::truthMatchMuon().
float reco::Muon::trackDist | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackDistErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackDxDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackDxDzErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackDyDz | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackDyDzErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackEdgeX | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
get track information in chamber that contains (best) segment If no segment, get track information in chamber that has the most negative distance between the track and the nearest chamber edge (the chamber with the deepest track) If no chamber returns 999999
float reco::Muon::trackEdgeY | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackX | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackXErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackY | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
float reco::Muon::trackYErr | ( | int | station, |
int | muonSubdetId, | ||
ArbitrationType | type = SegmentAndTrackArbitration |
||
) | const |
|
inlinevirtual |
Reimplemented in pat::Muon.
Definition at line 62 of file Muon.h.
References bestTunePTrackType_, and muonTrack().
|
inlinevirtual |
|
inline |
Definition at line 295 of file Muon.h.
References type_.
Referenced by pat::Muon::setDB(), pat::Muon::setExtSimType(), pat::Muon::setSimType(), and setType().
|
private |
reference to the Track chosen to assign the momentum value to the muon
Definition at line 320 of file Muon.h.
Referenced by bestTrack(), bestTrackRef(), muonBestTrack(), muonBestTrackType(), and setBestTrack().
|
private |
reference to the Track chosen to assign the momentum value to the muon by PF
Definition at line 322 of file Muon.h.
Referenced by setTunePBestTrack(), tunePMuonBestTrack(), and tunePMuonBestTrackType().
|
private |
energy deposition
Definition at line 325 of file Muon.h.
Referenced by calEnergy(), and setCalEnergy().
|
private |
muon hypothesis compatibility with observer calorimeter energy
Definition at line 339 of file Muon.h.
Referenced by caloCompatibility(), isCaloCompatibilityValid(), and setCaloCompatibility().
|
static |
Definition at line 288 of file Muon.h.
Referenced by isCaloMuon(), MuonTypeByOrCut::MuonTypeByOrCut(), and CaloMuonMerger::produce().
|
private |
quality block
Definition at line 327 of file Muon.h.
Referenced by combinedQuality(), and setCombinedQuality().
|
private |
Definition at line 333 of file Muon.h.
Referenced by isEnergyValid(), and setCalEnergy().
|
static |
Definition at line 291 of file Muon.h.
Referenced by MuonIdProducer::getSegmentMatches(), isGEMMuon(), and MuonIdProducer::produce().
|
static |
muon type - type of the algorithm that reconstructed this muon multiple algorithms can reconstruct the same muon
Definition at line 285 of file Muon.h.
Referenced by isGlobalMuon(), MuonTypeByOrCut::MuonTypeByOrCut(), and MuonIdProducer::produce().
|
private |
reference to Track reconstructed in both tracked and muon detector
Definition at line 316 of file Muon.h.
Referenced by globalTrack().
|
private |
reference to Track reconstructed in the tracker only
Definition at line 312 of file Muon.h.
Referenced by innerTrack().
|
private |
Isolation information for two cones with dR=0.3 and dR=0.5.
Definition at line 341 of file Muon.h.
Referenced by isolationR03().
|
private |
Definition at line 342 of file Muon.h.
Referenced by isolationR05().
|
private |
Definition at line 335 of file Muon.h.
Referenced by isIsolationValid().
|
private |
Definition at line 334 of file Muon.h.
Referenced by isMatchesValid(), and setMatches().
|
static |
Definition at line 292 of file Muon.h.
Referenced by MuonIdProducer::getSegmentMatches(), isME0Muon(), and MuonIdProducer::produce().
|
private |
Information on matching between tracks and segments.
Definition at line 329 of file Muon.h.
Referenced by matches(), numberOfChambers(), setMatches(), and t0().
|
private |
reference to Track reconstructed in the muon detector only
Definition at line 314 of file Muon.h.
Referenced by outerTrack().
|
private |
PF Isolation information for two cones with dR=0.3 and dR=0.4.
Definition at line 345 of file Muon.h.
Referenced by pfIsolationR03().
|
private |
Definition at line 348 of file Muon.h.
Referenced by pfIsolationR04().
|
private |
Definition at line 336 of file Muon.h.
Referenced by isPFIsolationValid().
|
private |
Definition at line 346 of file Muon.h.
Referenced by pfMeanDRIsoProfileR03().
|
private |
Definition at line 349 of file Muon.h.
Referenced by pfMeanDRIsoProfileR04().
|
private |
Definition at line 347 of file Muon.h.
Referenced by pfSumDRIsoProfileR03().
|
private |
Definition at line 350 of file Muon.h.
Referenced by pfSumDRIsoProfileR04().
|
static |
Definition at line 289 of file Muon.h.
Referenced by MuonIdProducer::arbitrateMuons(), isPFMuon(), and MuonTypeByOrCut::MuonTypeByOrCut().
|
private |
|
private |
Definition at line 337 of file Muon.h.
Referenced by isQualityValid(), and setCombinedQuality().
|
private |
reference to the Global Track refitted with dedicated TeV reconstructors
Definition at line 318 of file Muon.h.
Referenced by muonTrackFromMap().
|
static |
Definition at line 290 of file Muon.h.
Referenced by isRPCMuon(), MuonTypeByOrCut::MuonTypeByOrCut(), and MuonIdProducer::produce().
|
private |
Definition at line 332 of file Muon.h.
Referenced by rpcTime(), and setRPCTime().
|
private |
selector bitmap
Definition at line 366 of file Muon.h.
Referenced by passed(), selectors(), setSelector(), and setSelectors().
|
static |
Definition at line 287 of file Muon.h.
Referenced by isStandAloneMuon(), MuonTypeByOrCut::MuonTypeByOrCut(), and MuonIdProducer::produce().
|
private |
|
static |
Definition at line 286 of file Muon.h.
Referenced by MuonIdProducer::arbitrateMuons(), MuonIdProducer::fillArbitrationInfo(), MuonIdProducer::getSegmentMatches(), isTrackerMuon(), MuonTypeByOrCut::MuonTypeByOrCut(), and MuonIdProducer::produce().
|
private |
muon type mask
Definition at line 353 of file Muon.h.
Referenced by Modules.Service::__str__(), Modules.Service::_placeImpl(), Modules.ESSource::_placeImpl(), Modules.ESProducer::_placeImpl(), Modules.ESPrefer::copy(), Mixins._TypedParameterizable::dumpPython(), Modules.ESPrefer::dumpPythonAs(), Modules.Service::dumpSequencePython(), RandomRunSource.RandomRunSource::insertInto(), Modules.Service::insertInto(), ExternalGeneratorFilter.ExternalGeneratorFilter::insertInto(), Mixins._TypedParameterizable::insertInto(), isCaloMuon(), isGEMMuon(), isGlobalMuon(), isME0Muon(), isPFMuon(), isRPCMuon(), isStandAloneMuon(), isTrackerMuon(), Modules.ESSource::moduleLabel_(), Modules.ESProducer::moduleLabel_(), Modules.ESSource::nameInProcessDesc_(), Modules.ESProducer::nameInProcessDesc_(), Modules.ESPrefer::nameInProcessDesc_(), setType(), and type().