CMS 3D CMS Logo

List of all members | Public Member Functions
ntupleDataFormat.Track Class Reference
Inheritance diagram for ntupleDataFormat.Track:
ntupleDataFormat._Object ntupleDataFormat._RecoHitAdaptor ntupleDataFormat._TrackingParticleMatchAdaptor

Public Member Functions

def __init__ (self, tree, index)
 
def dxyPull (self)
 
def dzPull (self)
 
def phiPull (self)
 
def ptPull (self)
 
def seed (self)
 
def thetaPull (self)
 
def vertex (self)
 
- Public Member Functions inherited from ntupleDataFormat._Object
def __getattr__ (self, attr)
 
def __init__ (self, tree, index, prefix)
 
def index (self)
 
def isValid (self)
 
- Public Member Functions inherited from ntupleDataFormat._RecoHitAdaptor
def __init__ (self)
 
def gluedHits (self)
 
def hits (self)
 
def invalidHits (self)
 
def phase2OTHits (self)
 
def pixelHits (self)
 
def stripHits (self)
 
- Public Member Functions inherited from ntupleDataFormat._TrackingParticleMatchAdaptor
def __init__ (self)
 
def bestMatchingTrackingParticle (self)
 
def bestMatchingTrackingParticleFromFirstHit (self)
 
def bestMatchingTrackingParticleFromFirstHitNormalizedChi2 (self)
 
def bestMatchingTrackingParticleFromFirstHitShareFrac (self)
 
def bestMatchingTrackingParticleFromFirstHitShareFracSimClusterDenom (self)
 
def bestMatchingTrackingParticleFromFirstHitShareFracSimDenom (self)
 
def bestMatchingTrackingParticleNormalizedChi2 (self)
 
def bestMatchingTrackingParticleShareFrac (self)
 
def bestMatchingTrackingParticleShareFracSimClusterDenom (self)
 
def bestMatchingTrackingParticleShareFracSimDenom (self)
 
def matchedTrackingParticleInfos (self)
 
def nMatchedTrackingParticles (self)
 

Detailed Description

Class presenting a track.

Definition at line 668 of file ntupleDataFormat.py.

Constructor & Destructor Documentation

◆ __init__()

def ntupleDataFormat.Track.__init__ (   self,
  tree,
  index 
)
Constructor.

Arguments:
tree  -- TTree object
index -- Index of the track

Definition at line 670 of file ntupleDataFormat.py.

670  def __init__(self, tree, index):
671  """Constructor.
672 
673  Arguments:
674  tree -- TTree object
675  index -- Index of the track
676  """
677  super(Track, self).__init__(tree, index, "trk")
678 
def __init__(self, dataset, job_number, job_id, job_name, isDA, isMC, applyBOWS, applyEXTRACOND, extraconditions, runboundary, lumilist, intlumi, maxevents, gt, allFromGT, alignmentDB, alignmentTAG, apeDB, apeTAG, bowDB, bowTAG, vertextype, tracktype, refittertype, ttrhtype, applyruncontrol, ptcut, CMSSW_dir, the_dir)

Member Function Documentation

◆ dxyPull()

def ntupleDataFormat.Track.dxyPull (   self)

◆ dzPull()

def ntupleDataFormat.Track.dzPull (   self)

Definition at line 713 of file ntupleDataFormat.py.

References ntupleDataFormat._TrackingParticleMatchAdaptor.bestMatchingTrackingParticle(), btagbtvdeep::TrackPairFeatures.dz, btagbtvdeep::SeedingTrackFeatures.dz, hi::TrackStructure.dz, egammaisolation::EgammaTrackSelector.dz, RigidBodyAlignmentParameters.dz, DetGeometry::DirectionData.dz, btagbtvdeep::SeedingTrackInfoBuilder.dz(), BowedSurfaceAlignmentDerivatives.dz, btagbtvdeep::ChargedCandidateFeatures.dz, BowedSurfaceAlignmentParameters.dz, DTMuonSLToSL.dz, DDHCalXtalAlgo.dz, PreshowerStrip.dz(), IdealZDCTrapezoid.dz(), DDHCalTestBeamAlgo.dz, HGCalParameters::hgtrap.dz, IdealObliquePrism.dz(), IdealZPrism.dz(), Tau.Tau.dz(), IdealCastorTrapezoid.dz(), FlatHexagon.dz(), pat::VertexAssociation.dz(), DTMuonMillepede.dz, ScoutingElectron.dz(), PrimaryVertexMonitor.dz, Run3ScoutingParticle.dz(), Muon.Muon.dz(), FlatTrd.dz(), TopMonitor::PVcut.dz, BTagAndProbe::PVcut.dz, EcalTrapezoidParameters.dz(), Run3ScoutingElectron.dz(), TrackerValidationVariables::AVTrackStruct.dz, pat::IsolatedTrack.dz(), ScoutingMuon.dz(), TrackStruct::TrackParameterStruct.dz, reco::Conversion.dz(), MuonGeometryArrange::MGACollection.dz, trklet::IMATH_TrackletCalculatorDisk.dz, trklet::IMATH_TrackletCalculatorOverlap.dz, trklet::IMATH_TrackletCalculator.dz, CosmicRateAnalyzer.dz, TrackingParticle.dz(), reco::TrackBase.dz(), pat::PackedGenParticle.dz(), Electron.Electron.dz(), pat::PackedCandidate.dz(), PrimaryVertexMonitor.dzErr, and TrackStruct::TrackParameterStruct.dzErr.

713  def dzPull(self):
714  tp = self.bestMatchingTrackingParticle()
715  if tp is None:
716  return None
717  return (self.dz() - tp.pca_dz())/self.dzErr()
718 

◆ phiPull()

def ntupleDataFormat.Track.phiPull (   self)

Definition at line 701 of file ntupleDataFormat.py.

References ntupleDataFormat._TrackingParticleMatchAdaptor.bestMatchingTrackingParticle(), PuppiCandidate.phi, eetest::CandForTest.phi(), btagbtvdeep::JetFeatures.phi, btagbtvdeep::TrackPairFeatures.phi, hi::TrackStructure.phi, TrackingRecHitGlobalState.phi, btagbtvdeep::SeedingTrackFeatures.phi, omtf::DtDataWord64.phi(), res::HelperElectron.phi(), res::HelperMuon.phi(), omtf::MuonDataWord64.phi(), res::HelperJet.phi(), CalibratedPFCluster.phi(), EtaPhiBin.phi, HcalCellType::HcalCell.phi, TwoBodyDecayParameters.phi, res::HelperMET.phi(), TwoBodyDecayDerivatives.phi, AnnealingSchedule.phi(), SimG4HcalHitCluster.phi(), CommonMETData.phi, ScoutingParticle.phi(), ThirdHitPredictionFromCircle.phi(), Geom::Polar2Cartesian< T >.phi(), GoldenPatternResult.phi, l1thgcfirmware::HGCalTower.phi(), ConfigurableAnnealing.phi(), jetData.phi, HcalNumberingFromDDD::HcalID.phi, CaloHit.phi(), GeometricAnnealing.phi(), HcalChannelId.phi, DeterministicAnnealing.phi(), SuperClusterHelper.phi(), RecoObj.phi, ScoutingPhoton.phi(), btagbtvdeep::SeedingTrackInfoBuilder.phi(), RecHitsSortedInPhi::HitWithPhi.phi(), MatchStruct.phi, trklet::L1SimTrack.phi(), L1Analysis::L1AnalysisRecoClusterDataFormat.phi, L2TauPixelTrackMatch::TinyTrack.phi, l1tpf_calo::Grid.phi(), HcalDDDRecConstants::HcalID.phi, L1GctMet::etmiss_vec.phi, reco::MuonRecHitCluster.phi(), l1ct::tdr_regionizer::RegionInfo.phi, EcalClusterEnergyDeposition.phi, ImpactPoint.phi, PtEtaPhiMass.phi(), reco::isodeposit::Direction.phi(), correctionValue_class.phi, ticl::PatternRecognitionbyCLUE3D< TILES >::ClustersOnLayer.phi, MTDTrackQualityMVA.phi, DDHCalEndcapModuleAlgo::HcalEndcapPar.phi, EleRelPoint.phi(), HLTGenValObject.phi(), egHLT::BinData.phi, LMapRow.phi, DDTrackerPhiAlgo.phi, L1Analysis::L1AnalysisL1CaloClusterDataFormat.phi, DTMuonLocalAlignment.phi, HEChannel.phi, l1thgcfirmware::HGCalCluster.phi(), DDHCalTestBeamAlgo.phi, GloballyPositioned< float >.phi(), GloballyPositioned< align::Scalar >.phi(), GloballyPositioned< T >.phi(), RotationType.phi(), GloballyPositioned< U >.phi(), Phase2L1GMT::ConvertedTTTrack.phi(), l1thgcfirmware::HGCalTriggerCell.phi(), DDCutTubsFromPoints::Section.phi, DDTrackerLinear.phi, Geom::Cylindrical2Cartesian< T >.phi(), l1thgcfirmware::HGCalTowerCoord.phi, VectorHitBuilderAlgorithm::CurvatureAndPhi.phi, antiElecIDMVA6_blocks::TauVars.phi, L1Analysis::L1AnalysisL1CaloTowerDataFormat.phi, L1Analysis::L1AnalysisRecoTauDataFormat.phi, ResonanceBuilder.Resonance.phi(), HcalGeomCheck::hitsinfo.phi, HGCalRecHitValidation::HitsInfo.phi, HcalTestHistoClass::Hit.phi, HGCalSimHitStudy::hitsinfo.phi, PatTrackAnalyzer::Plots.phi, l1t::HGCalTowerCoord.phi, L1MuDTChambPhDigi.phi(), L1Analysis::L1AnalysisRecoElectronDataFormat.phi, tt::SensorModule.phi(), PHcalTB04Info.phi(), Phase2L1GMT::PreTrackMatchedMuon.phi(), HcalFlexiHardcodeGeometryLoader::HBHOCellParameters.phi, Vector2DBase< T, Frame >.phi(), PV2DBase< float, PointTag, LocalTag >.phi(), LASCoordinateSet.phi, PV2DBase< T, VectorTag, FrameTag >.phi(), PV2DBase< float, VectorTag, GlobalTag >.phi(), PV2DBase< T, PointTag, FrameTag >.phi(), PV2DBase< T, PVType, FrameType >.phi(), Point2DBase< Scalar, LocalTag >.phi(), Point2DBase< U, FrameTag >.phi(), Vector2DBase< U, FrameTag >.phi(), Point2DBase< T, Frame >.phi(), Vector2DBase< U, Frame >.phi(), L1Analysis::L1AnalysisRecoMuon2DataFormat.phi, Point2DBase< U, Frame >.phi(), Point2DBase< T, FrameTag >.phi(), PV2DBase< double, PointTag, LocalTag >.phi(), Vector2DBase< T, FrameTag >.phi(), BeamProfileVtxGenerator.phi(), PHcalTB06Info::Hit.phi, cms::MinBias.phi, L1Phase2MuDTPhDigi.phi(), l1gt::ThreeVector.phi, reco::GhostTrackPrediction.phi(), HGCalSimHitValidation::hitsinfo.phi, CSCSP_MBblock.phi(), FWPFCandidateDetailView.phi(), trigger::TriggerObject.phi(), RhoEtaPhi.phi(), reco::CastorCell.phi(), l1t::emtf::RPC.phi, HLTJetsCleanedFromLeadingLeptons< JetType >::EtaPhiE.phi(), HLLHCEvtVtxGenerator.phi, TrackerValidationVariables::AVHitStruct.phi, PGlobalSimHit::CalHit.phi, reco::PFRecTrack.phi(), HCalEndcapModuleAlgo::HcalEndcapPar.phi, l1tVertexFinder::Stub.phi(), MuonPath.phi(), SimpleL1MuGMTCand.phi(), metsig::SigInputObj.phi, XMLProcessor::_LMapRowHBEF.phi, L1TPFCaloProducer::SimpleHGCTC.phi, MuScleFitMuon.phi(), PerigeeTrajectoryParameters.phi(), L1GctEtMiss.phi(), CSCSP_SPblock.phi(), LMapDetId.phi, trklet::Stub.phi(), QcdLowPtDQM::Pixel.phi(), reco::CaloMuon.phi(), TrajSeedMatcher::SCHitMatch.phi, TauL1TPair.phi(), PGlobalSimHit::FwdHit.phi, PHcalTB06Info.phi(), l1tVertexFinder::VertexNTupler::GenJetsBranchData.phi, Run3ScoutingCaloJet.phi(), ScoutingElectron.phi(), ScoutingCaloJet.phi(), EtaPhiTower.phi, trklet::L1TStub.phi(), L1GctHtMiss.phi(), HTrackVariables.phi(), PV3DBase< float, VectorTag, LocalTag >.phi(), PV3DBase< float, PointTag, LocalTag >.phi(), PV3DBase< Scalar, VectorTag, GlobalTag >.phi(), PV3DBase< T, VectorTag, FrameTag >.phi(), PV3DBase< Scalar, PointTag, GlobalTag >.phi(), PV3DBase< T, PointTag, FrameTag >.phi(), PV3DBase< align::Scalar, PointTag, GlobalTag >.phi(), PV3DBase< long double, PointTag, GlobalTag >.phi(), PV3DBase< T, PVType, FrameType >.phi(), Vector3DBase< U, LocalTag >.phi(), Point3DBase< U, GlobalTag >.phi(), Vector3DBase< U, GlobalTag >.phi(), Point3DBase< U, FrameTag >.phi(), Vector3DBase< U, FrameTag >.phi(), Point3DBase< T, Frame >.phi(), Vector3DBase< U, Frame >.phi(), Point3DBase< U, Frame >.phi(), Vector3DBase< T, FrameTag >.phi(), Vector3DBase< float, GlobalTag >.phi(), Vector3DBase< T, Frame >.phi(), Vector3DBase< double, LocalTag >.phi(), Point3DBase< U, LocalTag >.phi(), PV3DBase< T, PointTag, GlobalTag >.phi(), PV3DBase< float, PointTag, GlobalTag >.phi(), reco::PattRecoPeak< float >.phi(), TrackJetEmulationEtaPhiBin.phi, reco::PattRecoPeak< Real >.phi(), Run3ScoutingParticle.phi(), Thrust::ThetaPhi.phi, Geom::Spherical2Cartesian< T >.phi(), PattRecoPeak< Real >.phi(), Run3ScoutingPhoton.phi(), L1MuDTTrack.phi(), CurvilinearTrajectoryParameters.phi(), ValidationMisalignedTracker.phi, EopElecVariables.phi, L1MuKBMTCombinedStub.phi(), GEMVFAT.phi(), PGlobalSimHit::BrlHit.phi, HGCalTriggerModuleDetId.phi(), L1MuBMTrack.phi(), PixelUnpackingRegions::Module.phi, antiElecIDMVA6_blocks::ElecVars.phi, TrackSoAHeterogeneousT< S >.phi(), reco::CastorEgamma.phi(), reco::CastorJet.phi(), reco::IsoDeposit.phi(), PdtPdgMini.phi, Basic2DVector< double > thc.phi(), Geom::Phi< float >.phi(), Basic2DVector< double >.phi(), Basic2DVector< float >.phi(), Phi< double >.phi(), Phi< double > deltaphi double.phi(), Phi< T1, Range >.phi(), Phi< double, Geom::MinusPiToPi >.phi(), Basic2DVector< T >.phi(), Basic2DVector< U >.phi(), Phi< float, Geom::MinusPiToPi >.phi(), Phi< U >.phi(), BPhysicsValidation::ParticleMonitor.phi, Phi< T >.phi(), Geom::Phi< T1, Range >.phi(), Basic2DVector< Scalar >.phi(), l1tVertexFinder::VertexNTupler::GenParticlesBranchData.phi, L1TDEMON.phi, L1TPhase2CorrelatorOffline::SimpleObject.phi, HcalFlexiHardcodeGeometryLoader::HECellParameters.phi, EgammaTowerIsolationNew< NC >.phi, L1GctMet::etmiss_internal.phi, IsolatedPixelTrackCandidateProducer::seedAtEC.phi, EcalTrapezoidParameters.phi(), Lepton.phi, IsolatedPixelTrackCandidateL1TProducer::seedAtEC.phi, HcalTB02HistoClass.phi(), L1Analysis::L1AnalysisRecoJetDataFormat.phi, Run3ScoutingPFJet.phi(), VectorHit.phi(), ScoutingPFJet.phi(), Run3ScoutingElectron.phi(), RecHitsSortedInPhi.phi(), L1TdeGCT.phi, HcalTB02Analysis.phi, L1MuDTTrackSegPhi.phi(), TrackerValidationVariables::AVTrackStruct.phi, L1GctInternJetData.phi(), reco::Candidate.phi(), DDTrap.phi(), GeometricTimingDet.phi(), L1MuBMTrackSegPhi.phi(), GeometricDet.phi(), AnalyzerMinbias.phi, cms::Analyzer_minbias.phi, TTTrack< Ref_Phase2TrackerDigi_ > aTrack unsigned int.phi(), TTTrack< Ref_Phase2TrackerDigi_ > ttTrack.phi(), TTTrack< Ref_Phase2TrackerDigi_ >.phi(), DTChambPhSegm.phi(), TTTrack< T >.phi(), l1tVertexFinder::VertexNTupler::RecoTracksBranchData.phi, tmtt::Stub.phi(), egHLT::OffPho.phi(), PhotonIDSimpleAnalyzer::struct_recPhoton.phi, l1tpf_calo::GridData< int >.phi(), l1tpf_calo::GridData< PreCluster >.phi(), GridData< T >.phi(), l1tpf_calo::GridData< float >.phi(), l1tpf_calo::GridData< T >.phi(), Basic3DVector< long double >.phi(), ScoutingMuon.phi(), reco::CastorCluster.phi(), DTSectCollPhSegm.phi(), DTRecSegment4D.phi, trklet::TrackletConfigBuilder.phi(), reco::Particle.phi(), cmsdt::metaPrimitive.phi, SingleParticleEvent.phi(), egHLT::OffEle.phi(), EcalTestPulseAnalyzer.phi, EcalABAnalyzer.phi, TrackStruct::TrackParameterStruct.phi, MuonGeometryArrange::MGACollection.phi, Basic3DVector< float > pos GlobalPoint.phi(), Basic3DVector< Scalar >.phi(), Basic3DVector< align::Scalar >.phi(), Basic3DVector< float > seedCentre float.phi(), Basic3DVector< double > momAtVtx Basic3DVector< double > vert.phi(), Basic3DVector< float >.phi(), Basic3DVector< float > seedCentre.phi(), Basic3DVector< float > constituentCentre Basic3DVector< float >.phi(), Basic3DVector< T >.phi(), Basic3DVector< double > momAtVtx Basic3DVector< double >.phi(), pair< bool, reco::TrackBase::ParameterVector >.phi(), Basic3DVector< float > mom GlobalVector.phi(), Basic3DVector< U >.phi(), Basic3DVector< float > tcCentre float.phi(), Basic3DVector< double >.phi(), RegionalOutput< T >.phi(), l1t::RegionalOutput< T >.phi(), EcalPerEvtLaserAnalyzer.phi, CaloParticle.phi(), l1tVertexFinder::VertexNTupler::TrueTracksBranchData.phi, reco::ParticleState.phi(), SimCluster.phi(), JetAnalyzer_HeavyIons_matching::MyJet.phi, GenMuonGMTPair.phi(), reco::LeafCandidate.phi(), HGCalClusterT< C >.phi(), TrackingParticle.phi(), CandidateWithRef< Ref >.phi(), AlignmentMonitorMuonSystemMap1D::MyResidual.phi, reco::IsoDeposit::const_iterator.phi(), HitDoublets.phi(), mkfit::LayerOfHits::HitInfo.phi, L1Analysis::L1AnalysisRecoMuonDataFormat.phi, l1tpf_calo::Cluster.phi, HcalLogicalMapGenerator.phi, HGCalCLUEAlgoT< TILE >::CellsOnLayer.phi, mkfit::Hit.phi(), reco::CaloCluster.phi(), Run3ScoutingMuon.phi(), EcalLaserAnalyzer.phi, CosmicRateAnalyzer.phi, EcalLaserAnalyzer2.phi, MuonGmtPair.phi(), SiPixelErrorEstimation.phi, L1TPhase2CorrelatorOffline::McVars.phi, pat::MET::Vector2.phi(), RawParticle.phi(), reco::TrackBase.phi(), pat::PackedGenParticle.phi(), L1CaloJetProducer::simpleL1obj.phi(), EcalClusterToolsT< noZS >::EcalClusterEnergyDeposition.phi, l1ct::OutputBoard.phi, EcalSelectiveReadoutValidation::energiesEb_t.phi, DDParallelepiped.phi(), EcalSelectiveReadoutValidation::energiesEe_t.phi, SiPixelTrackingRecHitsValid.phi, pat::PackedCandidate.phi(), trackerTFP::StubPP.phi(), trackerTFP::StubGP.phi(), trackerTFP::StubHT.phi(), trackerTFP::StubMHT.phi(), CellIndex.phi, trackerTFP::StubZHT.phi(), trackerTFP::StubKFin.phi(), trackerTFP::StubKF.phi(), PMuonSimHit::Trk.phi, PTrackerSimHit::Trk.phi, CMTRawAnalyzer.phi, and TrackStruct::TrackParameterStruct.phiErr.

701  def phiPull(self):
702  tp = self.bestMatchingTrackingParticle()
703  if tp is None:
704  return None
705  return (self.phi() - tp.pca_phi())/self.phiErr()
706 

◆ ptPull()

def ntupleDataFormat.Track.ptPull (   self)

Definition at line 689 of file ntupleDataFormat.py.

References ntupleDataFormat._TrackingParticleMatchAdaptor.bestMatchingTrackingParticle(), PuppiCandidate.pt, eetest::CandForTest.pt(), btagbtvdeep::SecondaryVertexFeatures.pt, btagbtvdeep::TrackPairFeatures.pt, btagbtvdeep::JetFeatures.pt, mypt.pt, btagbtvdeep::SeedingTrackFeatures.pt, res::HelperElectron.pt(), res::HelperMuon.pt(), hi::TrackStructure.pt, res::HelperJet.pt(), ScoutingParticle.pt(), reco::VoronoiBackground.pt(), L1MuCSCPtLut.pt(), l1t::Vertex.pt(), Phase2L1GMT::MuonROI.pt(), PtHatReweightUserHook.pt, l1tVertexFinder::L1Track.pt(), ScoutingPhoton.pt(), MatchStruct.pt, btagbtvdeep::SeedingTrackInfoBuilder.pt(), ALILine.pt(), trklet::L1SimTrack.pt(), RecoObj.pt, PtEtaPhiMass.pt(), L2TauPixelTrackMatch::TinyTrack.pt, reco::MuonMETCorrectionData.pt(), P2L1HTMHTEmu::PtPxPy.pt, ResonanceBuilder.Resonance.pt(), HLTGenValObject.pt(), MTDTrackQualityMVA.pt, Phase2L1GMT::ConvertedTTTrack.pt(), DTMuonLocalAlignment.pt, mkfit::IdxChi2List.pt, l1thgcfirmware::HGCalCluster.pt(), antiElecIDMVA6_blocks::TauVars.pt, L1Analysis::L1AnalysisRecoTauDataFormat.pt, l1thgcfirmware::HGCalTriggerCell.pt(), L1Analysis::L1AnalysisRecoElectronDataFormat.pt, Phase2L1GMT::PreTrackMatchedMuon.pt(), PatTrackAnalyzer::Plots.pt, L1Analysis::L1AnalysisRecoMuon2DataFormat.pt, PGlobalSimHit::Trk.pt, HepLine3D.pt(), tmtt::TP.pt(), l1gt::ThreeVector.pt, trigger::TriggerObject.pt(), PhysicsObjectsMonitor.pt, jpt::Map.pt(), trklet::Track.pt(), RecoVertex< L1Track >.pt(), RecoVertex<>.pt(), l1tVertexFinder::RecoVertex< T >.pt(), reco::CaloMuon.pt(), TtFullHadSignalSel.pt(), BSTrkParameters.pt(), MuScleFitMuon.pt(), PTrajectoryStateOnDet.pt(), trklet::L1TStub.pt(), l1tVertexFinder::VertexNTupler::GenJetsBranchData.pt, reco::ForwardProton.pt(), Run3ScoutingCaloJet.pt(), ScoutingCaloJet.pt(), ScoutingElectron.pt(), SiStripLAProfileBooker.pt, Run3ScoutingParticle.pt(), TauL1TPair.pt(), SimpleL1MuGMTCand.pt(), Run3ScoutingPhoton.pt(), L1MuDTTrack.pt(), EopElecVariables.pt, HTrackVariables.pt(), L1MuBMTrack.pt(), ValidationMisalignedTracker.pt, susybsm::HSCParticle.pt(), TrackSoAHeterogeneousT< S >.pt, QualityCutsAnalyzer::histogram_element_t.pt, l1tVertexFinder::VertexNTupler::GenParticlesBranchData.pt, TrajectoryStateClosestToPoint.pt(), BPhysicsValidation::ParticleMonitor.pt, L1TPhase2CorrelatorOffline::SimpleObject.pt, reco::PreId.pt(), Lepton.pt, Run3ScoutingPFJet.pt(), ScoutingPFJet.pt(), Run3ScoutingElectron.pt(), TrackerValidationVariables::AVTrackStruct.pt, reco::Candidate.pt(), l1tVertexFinder::VertexNTupler::RecoTracksBranchData.pt, egHLT::OffPho.pt(), MuonResidualsFitter::MuonAlignmentTreeRow.pt, ScoutingMuon.pt(), reco::PFCluster.pt(), tmtt::KFTrackletTrack.pt(), PrimaryVertexAnalyzer4PUSlimmed::recoPrimaryVertex.pt, reco::Particle.pt(), contrib::CMSBoostedTauSeedingAlgorithmStructure.pt(), l1t::TkJetWord.pt(), TrackStruct::TrackParameterStruct.pt, CaloParticle.pt(), Primary4DVertexValidation::recoPrimaryVertex.pt, l1tVertexFinder::VertexNTupler::TrueTracksBranchData.pt, SimCluster.pt(), reco::ParticleState.pt(), JetAnalyzer_HeavyIons_matching::MyJet.pt, GenMuonGMTPair.pt(), AlignmentMonitorMuonSystemMap1D::MyTrack.pt, TrackingParticle.pt(), CandidateWithRef< Ref >.pt(), HGCalClusterT< C >.pt(), reco::LeafCandidate.pt(), tmtt::L1track3D.pt(), L1Analysis::L1AnalysisRecoMuonDataFormat.pt, l1t::VertexWord.pt(), PtHatRapReweightUserHook.pt, Run3ScoutingMuon.pt(), CosmicRateAnalyzer.pt, MuonGmtPair.pt(), L1TPhase2CorrelatorOffline::McVars.pt, pat::MET::Vector2.pt(), RawParticle.pt(), l1t::EMTFTrack.pt, L1TPhase2CorrelatorOffline::RecoVars.pt, tmtt::L1fittedTrack.pt(), reco::TrackBase.pt(), pat::PackedGenParticle.pt(), L1CaloJetProducer::simpleL1obj.pt(), L1EGCrystalClusterEmulatorProducer::SimpleCaloHit.pt(), pat::PackedCandidate.pt(), PMuonSimHit::Trk.pt, PTrackerSimHit::Trk.pt, PatTrackAnalyzer::Plots.ptErr, TrackStruct::TrackParameterStruct.ptErr, Muon.Muon.ptErr(), and Electron.Electron.ptErr().

689  def ptPull(self):
690  tp = self.bestMatchingTrackingParticle()
691  if tp is None:
692  return None
693  return (self.pt() - tp.pca_pt())/self.ptErr()
694 

◆ seed()

def ntupleDataFormat.Track.seed (   self)
Returns Seed of the track.

Definition at line 679 of file ntupleDataFormat.py.

References ntupleDataFormat._Object._checkIsValid(), SeedingNode< DATA >._index, lhef::H5Handler._index, RPCMuonExtraStruct._index, ntupleDataFormat._Object._index, python.cmstools.EventTree._index, python.cmstools.EventBranch._index, html.HtmlReport._index, ntupleDataFormat._Collection._tree, ntupleDataFormat._Object._tree, and python.cmstools.EventTree._tree.

679  def seed(self):
680  """Returns Seed of the track."""
681  self._checkIsValid()
682  return Seed(self._tree, self._tree.trk_seedIdx[self._index])
683 

◆ thetaPull()

def ntupleDataFormat.Track.thetaPull (   self)

Definition at line 695 of file ntupleDataFormat.py.

References ntupleDataFormat._TrackingParticleMatchAdaptor.bestMatchingTrackingParticle().

695  def thetaPull(self):
696  tp = self.bestMatchingTrackingParticle()
697  if tp is None:
698  return None
699  return (getattr(self, "lambda")() - tp.pca_lambda())/self.lambdaErr() # as in MTV
700 

◆ vertex()

def ntupleDataFormat.Track.vertex (   self)
Returns Vertex that used this track in its fit.

Definition at line 684 of file ntupleDataFormat.py.

References ntupleDataFormat._Object._checkIsValid(), SeedingNode< DATA >._index, lhef::H5Handler._index, RPCMuonExtraStruct._index, ntupleDataFormat._Object._index, python.cmstools.EventTree._index, python.cmstools.EventBranch._index, html.HtmlReport._index, ntupleDataFormat._Collection._tree, ntupleDataFormat._Object._tree, and python.cmstools.EventTree._tree.

Referenced by Tau.Tau.dxy().

684  def vertex(self):
685  """Returns Vertex that used this track in its fit."""
686  self._checkIsValid()
687  return Vertex(self._tree, self._tree.trk_vtxIdx[self._index])
688