CMS 3D CMS Logo

List of all members | Classes | Public Member Functions | Static Public Member Functions | Private Attributes
IsolatedPixelTrackCandidateProducer Class Reference

#include <IsolatedPixelTrackCandidateProducer.h>

Inheritance diagram for IsolatedPixelTrackCandidateProducer:
edm::stream::EDProducer<>

Classes

struct  seedAtEC
 

Public Member Functions

void beginRun (const edm::Run &, const edm::EventSetup &) override
 
double getDistInCM (double eta1, double phi1, double eta2, double phi2)
 
std::pair< double, double > GetEtaPhiAtEcal (double etaIP, double phiIP, double pT, int charge, double vtxZ)
 
 IsolatedPixelTrackCandidateProducer (const edm::ParameterSet &ps)
 
void produce (edm::Event &evt, const edm::EventSetup &es) override
 
 ~IsolatedPixelTrackCandidateProducer () override
 
- Public Member Functions inherited from edm::stream::EDProducer<>
 EDProducer ()=default
 
bool hasAbilityToProduceInBeginLumis () const final
 
bool hasAbilityToProduceInBeginProcessBlocks () const final
 
bool hasAbilityToProduceInBeginRuns () const final
 
bool hasAbilityToProduceInEndLumis () const final
 
bool hasAbilityToProduceInEndProcessBlocks () const final
 
bool hasAbilityToProduceInEndRuns () const final
 

Static Public Member Functions

static void fillDescriptions (edm::ConfigurationDescriptions &descriptions)
 

Private Attributes

const std::string bfield_
 
double bfVal_
 
const double ebEtaBoundary_
 
const double maxPForIsolationValue_
 
const double minPTrackValue_
 
const double pixelIsolationConeSizeAtEC_
 
const double prelimCone_
 
double rEB_
 
const double tauAssocCone_
 
const double tauUnbiasCone_
 
const edm::ESGetToken< MagneticField, IdealMagneticFieldRecordtok_bFieldH_
 
const edm::ESGetToken< CaloGeometry, CaloGeometryRecordtok_geom_
 
const edm::EDGetTokenT< trigger::TriggerFilterObjectWithRefstok_hlt_
 
const edm::EDGetTokenT< l1extra::L1JetParticleCollectiontok_l1_
 
const edm::EDGetTokenT< reco::VertexCollectiontok_vert_
 
const std::vector< edm::EDGetTokenT< reco::TrackCollection > > toks_pix_
 
const double vtxCutIsol_
 
const double vtxCutSeed_
 
double zEE_
 

Additional Inherited Members

- Public Types inherited from edm::stream::EDProducer<>
typedef CacheContexts< T... > CacheTypes
 
typedef CacheTypes::GlobalCache GlobalCache
 
typedef AbilityChecker< T... > HasAbility
 
typedef CacheTypes::LuminosityBlockCache LuminosityBlockCache
 
typedef LuminosityBlockContextT< LuminosityBlockCache, RunCache, GlobalCacheLuminosityBlockContext
 
typedef CacheTypes::LuminosityBlockSummaryCache LuminosityBlockSummaryCache
 
typedef CacheTypes::RunCache RunCache
 
typedef RunContextT< RunCache, GlobalCacheRunContext
 
typedef CacheTypes::RunSummaryCache RunSummaryCache
 

Detailed Description

Definition at line 47 of file IsolatedPixelTrackCandidateProducer.h.

Constructor & Destructor Documentation

◆ IsolatedPixelTrackCandidateProducer()

IsolatedPixelTrackCandidateProducer::IsolatedPixelTrackCandidateProducer ( const edm::ParameterSet ps)

Definition at line 31 of file IsolatedPixelTrackCandidateProducer.cc.

32  : tok_hlt_(consumes<trigger::TriggerFilterObjectWithRefs>(config.getParameter<edm::InputTag>("L1GTSeedLabel"))),
33  tok_l1_(consumes<l1extra::L1JetParticleCollection>(config.getParameter<edm::InputTag>("L1eTauJetsSource"))),
34  tok_vert_(consumes<reco::VertexCollection>(config.getParameter<edm::InputTag>("VertexLabel"))),
35  toks_pix_(
36  edm::vector_transform(config.getParameter<std::vector<edm::InputTag> >("PixelTracksSources"),
37  [this](edm::InputTag const& tag) { return consumes<reco::TrackCollection>(tag); })),
38  tok_bFieldH_(esConsumes<MagneticField, IdealMagneticFieldRecord, edm::Transition::BeginRun>()),
39  tok_geom_(esConsumes<CaloGeometry, CaloGeometryRecord, edm::Transition::BeginRun>()),
40  bfield_(config.getParameter<std::string>("MagFieldRecordName")),
41  prelimCone_(config.getParameter<double>("ExtrapolationConeSize")),
42  pixelIsolationConeSizeAtEC_(config.getParameter<double>("PixelIsolationConeSizeAtEC")),
43  vtxCutSeed_(config.getParameter<double>("MaxVtxDXYSeed")),
44  vtxCutIsol_(config.getParameter<double>("MaxVtxDXYIsol")),
45  tauAssocCone_(config.getParameter<double>("tauAssociationCone")),
46  tauUnbiasCone_(config.getParameter<double>("tauUnbiasCone")),
47  minPTrackValue_(config.getParameter<double>("minPTrack")),
48  maxPForIsolationValue_(config.getParameter<double>("maxPTrackForIsolation")),
49  ebEtaBoundary_(config.getParameter<double>("EBEtaBoundary")),
50  rEB_(-1),
51  zEE_(-1),
52  bfVal_(0) {
53  // Register the product
54  produces<reco::IsolatedPixelTrackCandidateCollection>();
55 }

References GlobalPosition_Frontier_DevDB_cff::tag.

◆ ~IsolatedPixelTrackCandidateProducer()

IsolatedPixelTrackCandidateProducer::~IsolatedPixelTrackCandidateProducer ( )
override

Definition at line 57 of file IsolatedPixelTrackCandidateProducer.cc.

57 {}

Member Function Documentation

◆ beginRun()

void IsolatedPixelTrackCandidateProducer::beginRun ( const edm::Run run,
const edm::EventSetup theEventSetup 
)
override

Definition at line 79 of file IsolatedPixelTrackCandidateProducer.cc.

79  {
80  const CaloGeometry* pG = &theEventSetup.getData(tok_geom_);
81 
82  const double rad(dynamic_cast<const EcalBarrelGeometry*>(pG->getSubdetectorGeometry(DetId::Ecal, EcalBarrel))
83  ->avgRadiusXYFrontFaceCenter());
84  const double zz(dynamic_cast<const EcalEndcapGeometry*>(pG->getSubdetectorGeometry(DetId::Ecal, EcalEndcap))
85  ->avgAbsZFrontFaceCenter());
86 
87  rEB_ = rad;
88  zEE_ = zz;
89 
90  const MagneticField* vbfField = &theEventSetup.getData(tok_bFieldH_);
91  const VolumeBasedMagneticField* vbfCPtr = dynamic_cast<const VolumeBasedMagneticField*>(&(*vbfField));
92  GlobalVector BField = vbfCPtr->inTesla(GlobalPoint(0, 0, 0));
93  bfVal_ = BField.mag();
94 }

References ProducerES_cfi::BField, bfVal_, DetId::Ecal, EcalBarrel, EcalEndcap, edm::EventSetup::getData(), CaloGeometry::getSubdetectorGeometry(), VolumeBasedMagneticField::inTesla(), rEB_, tok_bFieldH_, tok_geom_, zEE_, and geometryCSVtoXML::zz.

◆ fillDescriptions()

void IsolatedPixelTrackCandidateProducer::fillDescriptions ( edm::ConfigurationDescriptions descriptions)
static

Definition at line 59 of file IsolatedPixelTrackCandidateProducer.cc.

59  {
61  std::vector<edm::InputTag> tracksrc = {edm::InputTag("hltPixelTracks")};
62  desc.add<edm::InputTag>("L1eTauJetsSource", edm::InputTag("hltCaloStage2Digis", "Tau"));
63  desc.add<double>("tauAssociationCone", 0.0);
64  desc.add<double>("tauUnbiasCone", 1.2);
65  desc.add<std::vector<edm::InputTag> >("PixelTracksSources", tracksrc);
66  desc.add<double>("ExtrapolationConeSize", 1.0);
67  desc.add<double>("PixelIsolationConeSizeAtEC", 40);
68  desc.add<edm::InputTag>("L1GTSeedLabel", edm::InputTag("hltL1sIsoTrack"));
69  desc.add<double>("MaxVtxDXYSeed", 101.0);
70  desc.add<double>("MaxVtxDXYIsol", 101.0);
71  desc.add<edm::InputTag>("VertexLabel", edm::InputTag("hltTrimmedPixelVertices"));
72  desc.add<std::string>("MagFieldRecordName", "VolumeBasedMagneticField");
73  desc.add<double>("minPTrack", 5.0);
74  desc.add<double>("maxPTrackForIsolation", 3.0);
75  desc.add<double>("EBEtaBoundary", 1.479);
76  descriptions.add("isolPixelTrackProd", desc);
77 }

References edm::ConfigurationDescriptions::add(), submitPVResolutionJobs::desc, HLT_FULL_cff::InputTag, AlCaHLTBitMon_QueryRunRegistry::string, and SiPixelMonitorTrack_cfi::tracksrc.

◆ getDistInCM()

double IsolatedPixelTrackCandidateProducer::getDistInCM ( double  eta1,
double  phi1,
double  eta2,
double  phi2 
)

Definition at line 245 of file IsolatedPixelTrackCandidateProducer.cc.

245  {
246  double Rec;
247  double theta1 = 2 * atan(exp(-eta1));
248  double theta2 = 2 * atan(exp(-eta2));
249  if (std::abs(eta1) < 1.479)
250  Rec = rEB_; //radius of ECAL barrel
251  else if (std::abs(eta1) > 1.479 && std::abs(eta1) < 7.0)
252  Rec = tan(theta1) * zEE_; //distance from IP to ECAL endcap
253  else
254  return 1000;
255 
256  //|vect| times tg of acos(scalar product)
257  double angle =
258  acos((sin(theta1) * sin(theta2) * (sin(phi1) * sin(phi2) + cos(phi1) * cos(phi2)) + cos(theta1) * cos(theta2)));
259  if (angle < M_PI_2)
260  return std::abs((Rec / sin(theta1)) * tan(angle));
261  else
262  return 1000;
263 }

References funct::abs(), angle(), funct::cos(), HLT_FULL_cff::eta1, HLT_FULL_cff::eta2, JetChargeProducer_cfi::exp, M_PI_2, rEB_, funct::sin(), funct::tan(), and zEE_.

Referenced by produce().

◆ GetEtaPhiAtEcal()

std::pair< double, double > IsolatedPixelTrackCandidateProducer::GetEtaPhiAtEcal ( double  etaIP,
double  phiIP,
double  pT,
int  charge,
double  vtxZ 
)

Definition at line 265 of file IsolatedPixelTrackCandidateProducer.cc.

266  {
267  double deltaPhi = 0;
268  double etaEC = 100;
269  double phiEC = 100;
270 
271  double Rcurv = 9999999;
272  if (bfVal_ != 0)
273  Rcurv = pT * 33.3 * 100 / (bfVal_ * 10); //r(m)=pT(GeV)*33.3/B(kG)
274 
275  double ecDist = zEE_; //distance to ECAL andcap from IP (cm), 317 - ecal (not preshower), preshower -300
276  double ecRad = rEB_; //radius of ECAL barrel (cm)
277  double theta = 2 * atan(exp(-etaIP));
278  double zNew = 0;
279  if (theta > M_PI_2)
280  theta = M_PI - theta;
281  if (std::abs(etaIP) < ebEtaBoundary_) {
282  if ((0.5 * ecRad / Rcurv) > 1) {
283  etaEC = 10000;
284  deltaPhi = 0;
285  } else {
286  deltaPhi = -charge * asin(0.5 * ecRad / Rcurv);
287  double alpha1 = 2 * asin(0.5 * ecRad / Rcurv);
288  double z = ecRad / tan(theta);
289  if (etaIP > 0)
290  zNew = z * (Rcurv * alpha1) / ecRad + vtxZ; //new z-coordinate of track
291  else
292  zNew = -z * (Rcurv * alpha1) / ecRad + vtxZ; //new z-coordinate of track
293  double zAbs = std::abs(zNew);
294  if (zAbs < ecDist) {
295  etaEC = -log(tan(0.5 * atan(ecRad / zAbs)));
296  deltaPhi = -charge * asin(0.5 * ecRad / Rcurv);
297  }
298  if (zAbs > ecDist) {
299  zAbs = (std::abs(etaIP) / etaIP) * ecDist;
300  double Zflight = std::abs(zAbs - vtxZ);
301  double alpha = (Zflight * ecRad) / (z * Rcurv);
302  double Rec = 2 * Rcurv * sin(alpha / 2);
303  deltaPhi = -charge * alpha / 2;
304  etaEC = -log(tan(0.5 * atan(Rec / ecDist)));
305  }
306  }
307  } else {
308  zNew = (std::abs(etaIP) / etaIP) * ecDist;
309  double Zflight = std::abs(zNew - vtxZ);
310  double Rvirt = std::abs(Zflight * tan(theta));
311  double Rec = 2 * Rcurv * sin(Rvirt / (2 * Rcurv));
312  deltaPhi = -(charge) * (Rvirt / (2 * Rcurv));
313  etaEC = -log(tan(0.5 * atan(Rec / ecDist)));
314  }
315 
316  if (zNew < 0)
317  etaEC = -etaEC;
318  phiEC = phiIP + deltaPhi;
319 
320  if (phiEC < -M_PI)
321  phiEC += M_2_PI;
322  if (phiEC > M_PI)
323  phiEC -= M_2_PI;
324 
325  std::pair<double, double> retVal(etaEC, phiEC);
326  return retVal;
327 }

References funct::abs(), alpha, bfVal_, ALCARECOTkAlJpsiMuMu_cff::charge, SiPixelRawToDigiRegional_cfi::deltaPhi, ebEtaBoundary_, JetChargeProducer_cfi::exp, dqm-mbProfile::log, M_PI, M_PI_2, PVValHelper::pT, rEB_, funct::sin(), funct::tan(), theta(), z, and zEE_.

Referenced by produce().

◆ produce()

void IsolatedPixelTrackCandidateProducer::produce ( edm::Event evt,
const edm::EventSetup es 
)
override

Definition at line 96 of file IsolatedPixelTrackCandidateProducer.cc.

96  {
97  auto trackCollection = std::make_unique<reco::IsolatedPixelTrackCandidateCollection>();
98 
99  //create vector of refs from input collections
100  std::vector<reco::TrackRef> pixelTrackRefs;
101 #ifdef EDM_ML_DEBUG
102  edm::LogVerbatim("HcalIsoTrack") << "IsolatedPixelTrakCandidate: with" << toks_pix_.size()
103  << " candidates to start with\n";
104 #endif
105  for (unsigned int iPix = 0; iPix < toks_pix_.size(); iPix++) {
107  theEvent.getByToken(toks_pix_[iPix], iPixCol);
108  for (reco::TrackCollection::const_iterator pit = iPixCol->begin(); pit != iPixCol->end(); pit++) {
109  pixelTrackRefs.push_back(reco::TrackRef(iPixCol, pit - iPixCol->begin()));
110  }
111  }
112 
114  theEvent.getByToken(tok_l1_, l1eTauJets);
115 
117  theEvent.getByToken(tok_vert_, pVert);
118 
119  double drMaxL1Track_ = tauAssocCone_;
120 
121  int ntr = 0;
122  std::vector<seedAtEC> VecSeedsatEC;
123  //loop to select isolated tracks
124  for (unsigned iS = 0; iS < pixelTrackRefs.size(); iS++) {
125  bool vtxMatch = false;
126  //associate to vertex (in Z)
127  reco::VertexCollection::const_iterator vitSel;
128  double minDZ = 1000;
129  bool found(false);
130  for (reco::VertexCollection::const_iterator vit = pVert->begin(); vit != pVert->end(); vit++) {
131  if (std::abs(pixelTrackRefs[iS]->dz(vit->position())) < minDZ) {
132  minDZ = std::abs(pixelTrackRefs[iS]->dz(vit->position()));
133  vitSel = vit;
134  found = true;
135  }
136  }
137  //cut on dYX:
138  if (found) {
139  if (std::abs(pixelTrackRefs[iS]->dxy(vitSel->position())) < vtxCutSeed_)
140  vtxMatch = true;
141  } else {
142  vtxMatch = true;
143  }
144 
145  //check taujet matching
146  bool tmatch = false;
147  l1extra::L1JetParticleCollection::const_iterator selj;
148  for (l1extra::L1JetParticleCollection::const_iterator tj = l1eTauJets->begin(); tj != l1eTauJets->end(); tj++) {
149  if (reco::deltaR(pixelTrackRefs[iS]->momentum().eta(),
150  pixelTrackRefs[iS]->momentum().phi(),
151  tj->momentum().eta(),
152  tj->momentum().phi()) > drMaxL1Track_)
153  continue;
154  selj = tj;
155  tmatch = true;
156  } //loop over L1 tau
157 
158  //propagate seed track to ECAL surface:
159  std::pair<double, double> seedCooAtEC;
160  // in case vertex is found:
161  if (found)
162  seedCooAtEC = GetEtaPhiAtEcal(pixelTrackRefs[iS]->eta(),
163  pixelTrackRefs[iS]->phi(),
164  pixelTrackRefs[iS]->pt(),
165  pixelTrackRefs[iS]->charge(),
166  vitSel->z());
167  //in case vertex is not found:
168  else
169  seedCooAtEC = GetEtaPhiAtEcal(pixelTrackRefs[iS]->eta(),
170  pixelTrackRefs[iS]->phi(),
171  pixelTrackRefs[iS]->pt(),
172  pixelTrackRefs[iS]->charge(),
173  0);
174  seedAtEC seed(iS, (tmatch || vtxMatch), seedCooAtEC.first, seedCooAtEC.second);
175  VecSeedsatEC.push_back(seed);
176  }
177 #ifdef EDM_ML_DEBUG
178  edm::LogVerbatim("HcalIsoTrack") << "IsolatedPixelTrakCandidate: " << VecSeedsatEC.size()
179  << " seeds after propagation\n";
180 #endif
181 
182  for (unsigned int i = 0; i < VecSeedsatEC.size(); i++) {
183  unsigned int iSeed = VecSeedsatEC[i].index;
184  if (!VecSeedsatEC[i].ok)
185  continue;
186  if (pixelTrackRefs[iSeed]->p() < minPTrackValue_)
187  continue;
188  l1extra::L1JetParticleCollection::const_iterator selj;
189  for (l1extra::L1JetParticleCollection::const_iterator tj = l1eTauJets->begin(); tj != l1eTauJets->end(); tj++) {
190  if (reco::deltaR(pixelTrackRefs[iSeed]->momentum().eta(),
191  pixelTrackRefs[iSeed]->momentum().phi(),
192  tj->momentum().eta(),
193  tj->momentum().phi()) > drMaxL1Track_)
194  continue;
195  selj = tj;
196  } //loop over L1 tau
197  double maxP = 0;
198  double sumP = 0;
199  for (unsigned int j = 0; j < VecSeedsatEC.size(); j++) {
200  if (i == j)
201  continue;
202  unsigned int iSurr = VecSeedsatEC[j].index;
203  //define preliminary cone around seed track impact point from which tracks will be extrapolated:
204  if (reco::deltaR(pixelTrackRefs[iSeed]->eta(),
205  pixelTrackRefs[iSeed]->phi(),
206  pixelTrackRefs[iSurr]->eta(),
207  pixelTrackRefs[iSurr]->phi()) > prelimCone_)
208  continue;
209  double minDZ2(1000);
210  bool found(false);
211  reco::VertexCollection::const_iterator vitSel2;
212  for (reco::VertexCollection::const_iterator vit = pVert->begin(); vit != pVert->end(); vit++) {
213  if (std::abs(pixelTrackRefs[iSurr]->dz(vit->position())) < minDZ2) {
214  minDZ2 = std::abs(pixelTrackRefs[iSurr]->dz(vit->position()));
215  vitSel2 = vit;
216  found = true;
217  }
218  }
219  //cut ot dXY:
220  if (found && std::abs(pixelTrackRefs[iSurr]->dxy(vitSel2->position())) > vtxCutIsol_)
221  continue;
222  //calculate distance at ECAL surface and update isolation:
223  if (getDistInCM(VecSeedsatEC[i].eta, VecSeedsatEC[i].phi, VecSeedsatEC[j].eta, VecSeedsatEC[j].phi) <
225  sumP += pixelTrackRefs[iSurr]->p();
226  if (pixelTrackRefs[iSurr]->p() > maxP)
227  maxP = pixelTrackRefs[iSurr]->p();
228  }
229  }
232  pixelTrackRefs[iSeed], l1extra::L1JetParticleRef(l1eTauJets, selj - l1eTauJets->begin()), maxP, sumP);
233  newCandidate.setEtaPhiEcal(VecSeedsatEC[i].eta, VecSeedsatEC[i].phi);
234  trackCollection->push_back(newCandidate);
235  ntr++;
236  }
237  }
238  // put the product in the event
239  theEvent.put(std::move(trackCollection));
240 #ifdef EDM_ML_DEBUG
241  edm::LogVerbatim("HcalIsoTrack") << "IsolatedPixelTrackCandidate: Final # of candiates " << ntr << "\n";
242 #endif
243 }

References funct::abs(), ALCARECOTkAlJpsiMuMu_cff::charge, reco::deltaR(), PVValHelper::dxy, PVValHelper::dz, PVValHelper::eta, newFWLiteAna::found, edm::Event::getByToken(), getDistInCM(), GetEtaPhiAtEcal(), mps_fire::i, dqmiolumiharvest::j, RecoMuonValidator_cfi::maxP, maxPForIsolationValue_, minPTrackValue_, eostools::move(), convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, phi, pixelIsolationConeSizeAtEC_, prelimCone_, DiDispStaMuonMonitor_cfi::pt, edm::Event::put(), fileCollector::seed, reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), tauAssocCone_, tok_l1_, tok_vert_, toks_pix_, duplicaterechits_cfi::trackCollection, vtxCutIsol_, and vtxCutSeed_.

Member Data Documentation

◆ bfield_

const std::string IsolatedPixelTrackCandidateProducer::bfield_
private

Definition at line 75 of file IsolatedPixelTrackCandidateProducer.h.

◆ bfVal_

double IsolatedPixelTrackCandidateProducer::bfVal_
private

Definition at line 89 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by beginRun(), and GetEtaPhiAtEcal().

◆ ebEtaBoundary_

const double IsolatedPixelTrackCandidateProducer::ebEtaBoundary_
private

Definition at line 84 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by GetEtaPhiAtEcal().

◆ maxPForIsolationValue_

const double IsolatedPixelTrackCandidateProducer::maxPForIsolationValue_
private

Definition at line 83 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ minPTrackValue_

const double IsolatedPixelTrackCandidateProducer::minPTrackValue_
private

Definition at line 82 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ pixelIsolationConeSizeAtEC_

const double IsolatedPixelTrackCandidateProducer::pixelIsolationConeSizeAtEC_
private

Definition at line 77 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ prelimCone_

const double IsolatedPixelTrackCandidateProducer::prelimCone_
private

Definition at line 76 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ rEB_

double IsolatedPixelTrackCandidateProducer::rEB_
private

Definition at line 87 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by beginRun(), getDistInCM(), and GetEtaPhiAtEcal().

◆ tauAssocCone_

const double IsolatedPixelTrackCandidateProducer::tauAssocCone_
private

Definition at line 80 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ tauUnbiasCone_

const double IsolatedPixelTrackCandidateProducer::tauUnbiasCone_
private

Definition at line 81 of file IsolatedPixelTrackCandidateProducer.h.

◆ tok_bFieldH_

const edm::ESGetToken<MagneticField, IdealMagneticFieldRecord> IsolatedPixelTrackCandidateProducer::tok_bFieldH_
private

Definition at line 72 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by beginRun().

◆ tok_geom_

const edm::ESGetToken<CaloGeometry, CaloGeometryRecord> IsolatedPixelTrackCandidateProducer::tok_geom_
private

Definition at line 73 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by beginRun().

◆ tok_hlt_

const edm::EDGetTokenT<trigger::TriggerFilterObjectWithRefs> IsolatedPixelTrackCandidateProducer::tok_hlt_
private

Definition at line 68 of file IsolatedPixelTrackCandidateProducer.h.

◆ tok_l1_

const edm::EDGetTokenT<l1extra::L1JetParticleCollection> IsolatedPixelTrackCandidateProducer::tok_l1_
private

Definition at line 69 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ tok_vert_

const edm::EDGetTokenT<reco::VertexCollection> IsolatedPixelTrackCandidateProducer::tok_vert_
private

Definition at line 70 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ toks_pix_

const std::vector<edm::EDGetTokenT<reco::TrackCollection> > IsolatedPixelTrackCandidateProducer::toks_pix_
private

Definition at line 71 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ vtxCutIsol_

const double IsolatedPixelTrackCandidateProducer::vtxCutIsol_
private

Definition at line 79 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ vtxCutSeed_

const double IsolatedPixelTrackCandidateProducer::vtxCutSeed_
private

Definition at line 78 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by produce().

◆ zEE_

double IsolatedPixelTrackCandidateProducer::zEE_
private

Definition at line 88 of file IsolatedPixelTrackCandidateProducer.h.

Referenced by beginRun(), getDistInCM(), and GetEtaPhiAtEcal().

Vector3DBase
Definition: Vector3DBase.h:8
IsolatedPixelTrackCandidateProducer::minPTrackValue_
const double minPTrackValue_
Definition: IsolatedPixelTrackCandidateProducer.h:82
mps_fire.i
i
Definition: mps_fire.py:428
geometryCSVtoXML.zz
zz
Definition: geometryCSVtoXML.py:19
IsolatedPixelTrackCandidateProducer::zEE_
double zEE_
Definition: IsolatedPixelTrackCandidateProducer.h:88
IsolatedPixelTrackCandidateProducer::getDistInCM
double getDistInCM(double eta1, double phi1, double eta2, double phi2)
Definition: IsolatedPixelTrackCandidateProducer.cc:245
IsolatedPixelTrackCandidateProducer::vtxCutSeed_
const double vtxCutSeed_
Definition: IsolatedPixelTrackCandidateProducer.h:78
DiDispStaMuonMonitor_cfi.pt
pt
Definition: DiDispStaMuonMonitor_cfi.py:39
IsolatedPixelTrackCandidateProducer::rEB_
double rEB_
Definition: IsolatedPixelTrackCandidateProducer.h:87
AlCaHLTBitMon_ParallelJobs.p
p
Definition: AlCaHLTBitMon_ParallelJobs.py:153
VolumeBasedMagneticField
Definition: VolumeBasedMagneticField.h:18
HLT_FULL_cff.InputTag
InputTag
Definition: HLT_FULL_cff.py:89281
edm::ParameterSetDescription
Definition: ParameterSetDescription.h:52
CaloGeometry::getSubdetectorGeometry
const CaloSubdetectorGeometry * getSubdetectorGeometry(const DetId &id) const
access the subdetector geometry for the given subdetector directly
Definition: CaloGeometry.cc:34
alpha
float alpha
Definition: AMPTWrapper.h:105
reco::IsolatedPixelTrackCandidate
Definition: IsolatedPixelTrackCandidate.h:23
IsolatedPixelTrackCandidateProducer::GetEtaPhiAtEcal
std::pair< double, double > GetEtaPhiAtEcal(double etaIP, double phiIP, double pT, int charge, double vtxZ)
Definition: IsolatedPixelTrackCandidateProducer.cc:265
ProducerES_cfi.BField
BField
Definition: ProducerES_cfi.py:83
convertSQLiteXML.ok
bool ok
Definition: convertSQLiteXML.py:98
newFWLiteAna.found
found
Definition: newFWLiteAna.py:118
edm::Handle< reco::TrackCollection >
EcalBarrel
Definition: EcalSubdetector.h:10
edm::Ref< TrackCollection >
funct::sin
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
fileCollector.seed
seed
Definition: fileCollector.py:127
config
Definition: config.py:1
VolumeBasedMagneticField::inTesla
GlobalVector inTesla(const GlobalPoint &g) const override
Field value ad specified global point, in Tesla.
Definition: VolumeBasedMagneticField.cc:40
CaloGeometry
Definition: CaloGeometry.h:21
IsolatedPixelTrackCandidateProducer::tok_geom_
const edm::ESGetToken< CaloGeometry, CaloGeometryRecord > tok_geom_
Definition: IsolatedPixelTrackCandidateProducer.h:73
funct::cos
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
RecoMuonValidator_cfi.maxP
maxP
Definition: RecoMuonValidator_cfi.py:34
edm::ConfigurationDescriptions::add
void add(std::string const &label, ParameterSetDescription const &psetDescription)
Definition: ConfigurationDescriptions.cc:57
IsolatedPixelTrackCandidateProducer::vtxCutIsol_
const double vtxCutIsol_
Definition: IsolatedPixelTrackCandidateProducer.h:79
SiPixelRawToDigiRegional_cfi.deltaPhi
deltaPhi
Definition: SiPixelRawToDigiRegional_cfi.py:9
GlobalPosition_Frontier_DevDB_cff.tag
tag
Definition: GlobalPosition_Frontier_DevDB_cff.py:11
PVValHelper::eta
Definition: PVValidationHelpers.h:70
PVValHelper::pT
Definition: PVValidationHelpers.h:71
IsolatedPixelTrackCandidateProducer::tok_hlt_
const edm::EDGetTokenT< trigger::TriggerFilterObjectWithRefs > tok_hlt_
Definition: IsolatedPixelTrackCandidateProducer.h:68
HLT_FULL_cff.eta2
eta2
Definition: HLT_FULL_cff.py:9542
DDAxes::z
theta
Geom::Theta< T > theta() const
Definition: Basic3DVectorLD.h:150
GlobalPoint
Global3DPoint GlobalPoint
Definition: GlobalPoint.h:10
IsolatedPixelTrackCandidateProducer::ebEtaBoundary_
const double ebEtaBoundary_
Definition: IsolatedPixelTrackCandidateProducer.h:84
IsolatedPixelTrackCandidateProducer::tok_bFieldH_
const edm::ESGetToken< MagneticField, IdealMagneticFieldRecord > tok_bFieldH_
Definition: IsolatedPixelTrackCandidateProducer.h:72
AlCaHLTBitMon_QueryRunRegistry.string
string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
edm::vector_transform
auto vector_transform(std::vector< InputType > const &input, Function predicate) -> std::vector< typename std::remove_cv< typename std::remove_reference< decltype(predicate(input.front()))>::type >::type >
Definition: transform.h:11
EcalEndcap
Definition: EcalSubdetector.h:10
HLT_FULL_cff.eta1
eta1
Definition: HLT_FULL_cff.py:9541
ALCARECOTkAlJpsiMuMu_cff.charge
charge
Definition: ALCARECOTkAlJpsiMuMu_cff.py:47
IsolatedPixelTrackCandidateProducer::prelimCone_
const double prelimCone_
Definition: IsolatedPixelTrackCandidateProducer.h:76
duplicaterechits_cfi.trackCollection
trackCollection
Definition: duplicaterechits_cfi.py:4
IsolatedPixelTrackCandidateProducer::bfield_
const std::string bfield_
Definition: IsolatedPixelTrackCandidateProducer.h:75
IsolatedPixelTrackCandidateProducer::tauAssocCone_
const double tauAssocCone_
Definition: IsolatedPixelTrackCandidateProducer.h:80
IsolatedPixelTrackCandidateProducer::tok_vert_
const edm::EDGetTokenT< reco::VertexCollection > tok_vert_
Definition: IsolatedPixelTrackCandidateProducer.h:70
funct::tan
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
IsolatedPixelTrackCandidateProducer::bfVal_
double bfVal_
Definition: IsolatedPixelTrackCandidateProducer.h:89
M_PI
#define M_PI
Definition: BXVectorInputProducer.cc:49
DetId::Ecal
Definition: DetId.h:27
edm::EventSetup::getData
bool getData(T &iHolder) const
Definition: EventSetup.h:127
IsolatedPixelTrackCandidateProducer::pixelIsolationConeSizeAtEC_
const double pixelIsolationConeSizeAtEC_
Definition: IsolatedPixelTrackCandidateProducer.h:77
DDAxes::phi
submitPVResolutionJobs.desc
string desc
Definition: submitPVResolutionJobs.py:251
eostools.move
def move(src, dest)
Definition: eostools.py:511
PVValHelper::dxy
Definition: PVValidationHelpers.h:48
PVValHelper::dz
Definition: PVValidationHelpers.h:51
edm::LogVerbatim
Log< level::Info, true > LogVerbatim
Definition: MessageLogger.h:128
angle
T angle(T x1, T y1, T z1, T x2, T y2, T z2)
Definition: angle.h:11
reco::deltaR
constexpr auto deltaR(const T1 &t1, const T2 &t2) -> decltype(t1.eta())
Definition: deltaR.h:30
dqm-mbProfile.log
log
Definition: dqm-mbProfile.py:17
IsolatedPixelTrackCandidateProducer::maxPForIsolationValue_
const double maxPForIsolationValue_
Definition: IsolatedPixelTrackCandidateProducer.h:83
IsolatedPixelTrackCandidateProducer::tauUnbiasCone_
const double tauUnbiasCone_
Definition: IsolatedPixelTrackCandidateProducer.h:81
M_PI_2
#define M_PI_2
Definition: CSCGattiFunction.cc:6
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
IsolatedPixelTrackCandidateProducer::tok_l1_
const edm::EDGetTokenT< l1extra::L1JetParticleCollection > tok_l1_
Definition: IsolatedPixelTrackCandidateProducer.h:69
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
JetChargeProducer_cfi.exp
exp
Definition: JetChargeProducer_cfi.py:6
SiPixelMonitorTrack_cfi.tracksrc
tracksrc
Definition: SiPixelMonitorTrack_cfi.py:12
MagneticField
Definition: MagneticField.h:19
edm::InputTag
Definition: InputTag.h:15
IsolatedPixelTrackCandidateProducer::toks_pix_
const std::vector< edm::EDGetTokenT< reco::TrackCollection > > toks_pix_
Definition: IsolatedPixelTrackCandidateProducer.h:71