CMS 3D CMS Logo

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

#include <IsolatedPixelTrackCandidateL1TProducer.h>

Inheritance diagram for IsolatedPixelTrackCandidateL1TProducer:
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)
 
 IsolatedPixelTrackCandidateL1TProducer (const edm::ParameterSet &ps)
 
void produce (edm::Event &evt, const edm::EventSetup &es) override
 
 ~IsolatedPixelTrackCandidateL1TProducer () 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::EDGetTokenT< trigger::TriggerFilterObjectWithRefstok_hlt_
 
const edm::EDGetTokenT< l1t::TauBxCollectiontok_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 45 of file IsolatedPixelTrackCandidateL1TProducer.h.

Constructor & Destructor Documentation

◆ IsolatedPixelTrackCandidateL1TProducer()

IsolatedPixelTrackCandidateL1TProducer::IsolatedPixelTrackCandidateL1TProducer ( const edm::ParameterSet ps)

Definition at line 35 of file IsolatedPixelTrackCandidateL1TProducer.cc.

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

References GlobalPosition_Frontier_DevDB_cff::tag.

◆ ~IsolatedPixelTrackCandidateL1TProducer()

IsolatedPixelTrackCandidateL1TProducer::~IsolatedPixelTrackCandidateL1TProducer ( )
override

Definition at line 59 of file IsolatedPixelTrackCandidateL1TProducer.cc.

59 {}

Member Function Documentation

◆ beginRun()

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

Definition at line 81 of file IsolatedPixelTrackCandidateL1TProducer.cc.

81  {
83  theEventSetup.get<CaloGeometryRecord>().get(pG);
84 
85  const double rad(dynamic_cast<const EcalBarrelGeometry*>(pG->getSubdetectorGeometry(DetId::Ecal, EcalBarrel))
86  ->avgRadiusXYFrontFaceCenter());
87  const double zz(dynamic_cast<const EcalEndcapGeometry*>(pG->getSubdetectorGeometry(DetId::Ecal, EcalEndcap))
88  ->avgAbsZFrontFaceCenter());
89 
90  rEB_ = rad;
91  zEE_ = zz;
92 
94  theEventSetup.get<IdealMagneticFieldRecord>().get(vbfField);
95  const VolumeBasedMagneticField* vbfCPtr = dynamic_cast<const VolumeBasedMagneticField*>(&(*vbfField));
96  GlobalVector BField = vbfCPtr->inTesla(GlobalPoint(0, 0, 0));
97  bfVal_ = BField.mag();
98  LogTrace("IsoTrack") << "rEB " << rEB_ << " zEE " << zEE_ << " B " << bfVal_ << std::endl;
99 }

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

◆ fillDescriptions()

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

Definition at line 61 of file IsolatedPixelTrackCandidateL1TProducer.cc.

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

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

◆ getDistInCM()

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

Definition at line 281 of file IsolatedPixelTrackCandidateL1TProducer.cc.

281  {
282  double Rec;
283  double theta1 = 2 * atan(exp(-eta1));
284  double theta2 = 2 * atan(exp(-eta2));
285  if (std::abs(eta1) < 1.479)
286  Rec = rEB_; //radius of ECAL barrel
287  else if (std::abs(eta1) > 1.479 && std::abs(eta1) < 7.0)
288  Rec = tan(theta1) * zEE_; //distance from IP to ECAL endcap
289  else
290  return 1000;
291 
292  //|vect| times tg of acos(scalar product)
293  double angle =
294  acos((sin(theta1) * sin(theta2) * (sin(phi1) * sin(phi2) + cos(phi1) * cos(phi2)) + cos(theta1) * cos(theta2)));
295  if (angle < M_PI_2)
296  return std::abs((Rec / sin(theta1)) * tan(angle));
297  else
298  return 1000;
299 }

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 > IsolatedPixelTrackCandidateL1TProducer::GetEtaPhiAtEcal ( double  etaIP,
double  phiIP,
double  pT,
int  charge,
double  vtxZ 
)

Definition at line 301 of file IsolatedPixelTrackCandidateL1TProducer.cc.

302  {
303  double deltaPhi = 0;
304  double etaEC = 100;
305  double phiEC = 100;
306 
307  double Rcurv = 9999999;
308  if (bfVal_ != 0)
309  Rcurv = pT * 33.3 * 100 / (bfVal_ * 10); //r(m)=pT(GeV)*33.3/B(kG)
310 
311  double ecDist = zEE_; //distance to ECAL andcap from IP (cm), 317 - ecal (not preshower), preshower -300
312  double ecRad = rEB_; //radius of ECAL barrel (cm)
313  double theta = 2 * atan(exp(-etaIP));
314  double zNew = 0;
315  if (theta > M_PI_2)
316  theta = M_PI - theta;
317  if (std::abs(etaIP) < ebEtaBoundary_) {
318  if ((0.5 * ecRad / Rcurv) > 1) {
319  etaEC = 10000;
320  deltaPhi = 0;
321  } else {
322  deltaPhi = -charge * asin(0.5 * ecRad / Rcurv);
323  double alpha1 = 2 * asin(0.5 * ecRad / Rcurv);
324  double z = ecRad / tan(theta);
325  if (etaIP > 0)
326  zNew = z * (Rcurv * alpha1) / ecRad + vtxZ; //new z-coordinate of track
327  else
328  zNew = -z * (Rcurv * alpha1) / ecRad + vtxZ; //new z-coordinate of track
329  double zAbs = std::abs(zNew);
330  if (zAbs < ecDist) {
331  etaEC = -log(tan(0.5 * atan(ecRad / zAbs)));
332  deltaPhi = -charge * asin(0.5 * ecRad / Rcurv);
333  }
334  if (zAbs > ecDist) {
335  zAbs = (std::abs(etaIP) / etaIP) * ecDist;
336  double Zflight = std::abs(zAbs - vtxZ);
337  double alpha = (Zflight * ecRad) / (z * Rcurv);
338  double Rec = 2 * Rcurv * sin(alpha / 2);
339  deltaPhi = -charge * alpha / 2;
340  etaEC = -log(tan(0.5 * atan(Rec / ecDist)));
341  }
342  }
343  } else {
344  zNew = (std::abs(etaIP) / etaIP) * ecDist;
345  double Zflight = std::abs(zNew - vtxZ);
346  double Rvirt = std::abs(Zflight * tan(theta));
347  double Rec = 2 * Rcurv * sin(Rvirt / (2 * Rcurv));
348  deltaPhi = -(charge) * (Rvirt / (2 * Rcurv));
349  etaEC = -log(tan(0.5 * atan(Rec / ecDist)));
350  }
351 
352  if (zNew < 0)
353  etaEC = -etaEC;
354  phiEC = phiIP + deltaPhi;
355 
356  if (phiEC < -M_PI)
357  phiEC += M_2_PI;
358  if (phiEC > M_PI)
359  phiEC -= M_2_PI;
360 
361  std::pair<double, double> retVal(etaEC, phiEC);
362  return retVal;
363 }

References funct::abs(), zMuMuMuonUserData::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 IsolatedPixelTrackCandidateL1TProducer::produce ( edm::Event evt,
const edm::EventSetup es 
)
override

Definition at line 101 of file IsolatedPixelTrackCandidateL1TProducer.cc.

101  {
102  auto trackCollection = std::make_unique<reco::IsolatedPixelTrackCandidateCollection>();
103 
104  //create vector of refs from input collections
105  std::vector<reco::TrackRef> pixelTrackRefs;
106 
107  for (unsigned int iPix = 0; iPix < toks_pix_.size(); iPix++) {
109  theEvent.getByToken(toks_pix_[iPix], iPixCol);
110  for (reco::TrackCollection::const_iterator pit = iPixCol->begin(); pit != iPixCol->end(); pit++) {
111  pixelTrackRefs.push_back(reco::TrackRef(iPixCol, pit - iPixCol->begin()));
112  }
113  }
114 
116  theEvent.getByToken(tok_l1_, l1eTauJets);
117 
119  theEvent.getByToken(tok_vert_, pVert);
120 
121  double ptTriggered = -10;
122  double etaTriggered = -100;
123  double phiTriggered = -100;
124 
126  theEvent.getByToken(tok_hlt_, l1trigobj);
127 
128  std::vector<edm::Ref<l1t::TauBxCollection> > l1tauobjref;
129  std::vector<edm::Ref<l1t::JetBxCollection> > l1jetobjref;
130 
131  // l1trigobj->getObjects(trigger::TriggerTau, l1tauobjref);
132  l1trigobj->getObjects(trigger::TriggerL1Tau, l1tauobjref);
133  // l1trigobj->getObjects(trigger::TriggerJet, l1jetobjref);
134  l1trigobj->getObjects(trigger::TriggerL1Jet, l1jetobjref);
135 
136  for (const auto& p : l1tauobjref) {
137  if (p->pt() > ptTriggered) {
138  ptTriggered = p->pt();
139  phiTriggered = p->phi();
140  etaTriggered = p->eta();
141  }
142  }
143  for (const auto& p : l1jetobjref) {
144  if (p->pt() > ptTriggered) {
145  ptTriggered = p->pt();
146  phiTriggered = p->phi();
147  etaTriggered = p->eta();
148  }
149  }
150  LogTrace("IsoTrack") << "Sizes " << l1tauobjref.size() << ":" << l1jetobjref.size() << " Trig " << ptTriggered << ":"
151  << etaTriggered << ":" << phiTriggered << std::endl;
152 
153  double drMaxL1Track_ = tauAssocCone_;
154  int ntr = 0;
155  std::vector<seedAtEC> VecSeedsatEC;
156  //loop to select isolated tracks
157  for (unsigned iS = 0; iS < pixelTrackRefs.size(); iS++) {
158  bool vtxMatch = false;
159  //associate to vertex (in Z)
160  reco::VertexCollection::const_iterator vitSel;
161  double minDZ = 1000;
162  bool found(false);
163  for (reco::VertexCollection::const_iterator vit = pVert->begin(); vit != pVert->end(); vit++) {
164  if (std::abs(pixelTrackRefs[iS]->dz(vit->position())) < minDZ) {
165  minDZ = std::abs(pixelTrackRefs[iS]->dz(vit->position()));
166  vitSel = vit;
167  found = true;
168  }
169  }
170  //cut on dYX:
171  if (found) {
172  if (std::abs(pixelTrackRefs[iS]->dxy(vitSel->position())) < vtxCutSeed_)
173  vtxMatch = true;
174  } else {
175  vtxMatch = true;
176  }
177  LogTrace("IsoTrack") << "minZD " << minDZ << " Found " << found << ":" << vtxMatch << std::endl;
178 
179  //select tracks not matched to triggered L1 jet
180  double R = reco::deltaR(etaTriggered, phiTriggered, pixelTrackRefs[iS]->eta(), pixelTrackRefs[iS]->phi());
181  LogTrace("IsoTrack") << "Distance to L1 " << R << ":" << tauUnbiasCone_ << " Result " << (R < tauUnbiasCone_)
182  << std::endl;
183  if (R < tauUnbiasCone_)
184  continue;
185 
186  //check taujet matching
187  bool tmatch = false;
189  for (l1t::TauBxCollection::const_iterator tj = l1eTauJets->begin(); tj != l1eTauJets->end(); tj++) {
190  if (reco::deltaR(pixelTrackRefs[iS]->momentum().eta(),
191  pixelTrackRefs[iS]->momentum().phi(),
192  tj->momentum().eta(),
193  tj->momentum().phi()) > drMaxL1Track_)
194  continue;
195  selj = tj;
196  tmatch = true;
197  } //loop over L1 tau
198  LogTrace("IsoTrack") << "tMatch " << tmatch << std::endl;
199 
200  //propagate seed track to ECAL surface:
201  std::pair<double, double> seedCooAtEC;
202  // in case vertex is found:
203  if (found)
204  seedCooAtEC = GetEtaPhiAtEcal(pixelTrackRefs[iS]->eta(),
205  pixelTrackRefs[iS]->phi(),
206  pixelTrackRefs[iS]->pt(),
207  pixelTrackRefs[iS]->charge(),
208  vitSel->z());
209  //in case vertex is not found:
210  else
211  seedCooAtEC = GetEtaPhiAtEcal(pixelTrackRefs[iS]->eta(),
212  pixelTrackRefs[iS]->phi(),
213  pixelTrackRefs[iS]->pt(),
214  pixelTrackRefs[iS]->charge(),
215  0);
216  seedAtEC seed(iS, (tmatch || vtxMatch), seedCooAtEC.first, seedCooAtEC.second);
217  VecSeedsatEC.push_back(seed);
218  LogTrace("IsoTrack") << "Seed " << seedCooAtEC.first << seedCooAtEC.second << std::endl;
219  }
220  for (unsigned int i = 0; i < VecSeedsatEC.size(); i++) {
221  unsigned int iSeed = VecSeedsatEC[i].index;
222  if (!VecSeedsatEC[i].ok)
223  continue;
224  if (pixelTrackRefs[iSeed]->p() < minPTrackValue_)
225  continue;
227  for (l1t::TauBxCollection::const_iterator tj = l1eTauJets->begin(); tj != l1eTauJets->end(); tj++) {
228  if (reco::deltaR(pixelTrackRefs[iSeed]->momentum().eta(),
229  pixelTrackRefs[iSeed]->momentum().phi(),
230  tj->momentum().eta(),
231  tj->momentum().phi()) > drMaxL1Track_)
232  continue;
233  selj = tj;
234  } //loop over L1 tau
235  double maxP = 0;
236  double sumP = 0;
237  for (unsigned int j = 0; j < VecSeedsatEC.size(); j++) {
238  if (i == j)
239  continue;
240  unsigned int iSurr = VecSeedsatEC[j].index;
241  //define preliminary cone around seed track impact point from which tracks will be extrapolated:
242  if (reco::deltaR(pixelTrackRefs[iSeed]->eta(),
243  pixelTrackRefs[iSeed]->phi(),
244  pixelTrackRefs[iSurr]->eta(),
245  pixelTrackRefs[iSurr]->phi()) > prelimCone_)
246  continue;
247  double minDZ2(1000);
248  bool found(false);
249  reco::VertexCollection::const_iterator vitSel2;
250  for (reco::VertexCollection::const_iterator vit = pVert->begin(); vit != pVert->end(); vit++) {
251  if (std::abs(pixelTrackRefs[iSurr]->dz(vit->position())) < minDZ2) {
252  minDZ2 = std::abs(pixelTrackRefs[iSurr]->dz(vit->position()));
253  vitSel2 = vit;
254  found = true;
255  }
256  }
257  //cut ot dXY:
258  if (found && std::abs(pixelTrackRefs[iSurr]->dxy(vitSel2->position())) > vtxCutIsol_)
259  continue;
260  //calculate distance at ECAL surface and update isolation:
261  if (getDistInCM(VecSeedsatEC[i].eta, VecSeedsatEC[i].phi, VecSeedsatEC[j].eta, VecSeedsatEC[j].phi) <
263  sumP += pixelTrackRefs[iSurr]->p();
264  if (pixelTrackRefs[iSurr]->p() > maxP)
265  maxP = pixelTrackRefs[iSurr]->p();
266  }
267  }
270  pixelTrackRefs[iSeed], l1t::TauRef(l1eTauJets, selj - l1eTauJets->begin()), maxP, sumP);
271  newCandidate.setEtaPhiEcal(VecSeedsatEC[i].eta, VecSeedsatEC[i].phi);
272  trackCollection->push_back(newCandidate);
273  ntr++;
274  }
275  }
276  LogTrace("IsoTrack") << "Number of Isolated Track " << ntr << "\n";
277  // put the product in the event
278  theEvent.put(std::move(trackCollection));
279 }

References funct::abs(), BXVector< T >::begin(), ALCARECOTkAlJpsiMuMu_cff::charge, reco::deltaR(), PVValHelper::dxy, PVValHelper::dz, BXVector< T >::end(), PVValHelper::eta, newFWLiteAna::found, edm::Event::getByToken(), getDistInCM(), GetEtaPhiAtEcal(), trigger::TriggerRefsCollections::getObjects(), mps_fire::i, dqmiolumiharvest::j, LogTrace, RecoMuonValidator_cfi::maxP, maxPForIsolationValue_, minPTrackValue_, eostools::move(), convertSQLiteXML::ok, AlCaHLTBitMon_ParallelJobs::p, phi, pixelIsolationConeSizeAtEC_, prelimCone_, DiDispStaMuonMonitor_cfi::pt, edm::Event::put(), dttmaxenums::R, fileCollector::seed, reco::IsolatedPixelTrackCandidate::setEtaPhiEcal(), tauAssocCone_, tauUnbiasCone_, tok_hlt_, tok_l1_, tok_vert_, toks_pix_, duplicaterechits_cfi::trackCollection, trigger::TriggerL1Jet, trigger::TriggerL1Tau, vtxCutIsol_, and vtxCutSeed_.

Member Data Documentation

◆ bfield_

const std::string IsolatedPixelTrackCandidateL1TProducer::bfield_
private

Definition at line 71 of file IsolatedPixelTrackCandidateL1TProducer.h.

◆ bfVal_

double IsolatedPixelTrackCandidateL1TProducer::bfVal_
private

Definition at line 85 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by beginRun(), and GetEtaPhiAtEcal().

◆ ebEtaBoundary_

const double IsolatedPixelTrackCandidateL1TProducer::ebEtaBoundary_
private

Definition at line 80 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by GetEtaPhiAtEcal().

◆ maxPForIsolationValue_

const double IsolatedPixelTrackCandidateL1TProducer::maxPForIsolationValue_
private

Definition at line 79 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ minPTrackValue_

const double IsolatedPixelTrackCandidateL1TProducer::minPTrackValue_
private

Definition at line 78 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ pixelIsolationConeSizeAtEC_

const double IsolatedPixelTrackCandidateL1TProducer::pixelIsolationConeSizeAtEC_
private

Definition at line 73 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ prelimCone_

const double IsolatedPixelTrackCandidateL1TProducer::prelimCone_
private

Definition at line 72 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ rEB_

double IsolatedPixelTrackCandidateL1TProducer::rEB_
private

Definition at line 83 of file IsolatedPixelTrackCandidateL1TProducer.h.

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

◆ tauAssocCone_

const double IsolatedPixelTrackCandidateL1TProducer::tauAssocCone_
private

Definition at line 76 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ tauUnbiasCone_

const double IsolatedPixelTrackCandidateL1TProducer::tauUnbiasCone_
private

Definition at line 77 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ tok_hlt_

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

Definition at line 66 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ tok_l1_

const edm::EDGetTokenT<l1t::TauBxCollection> IsolatedPixelTrackCandidateL1TProducer::tok_l1_
private

Definition at line 67 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ tok_vert_

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

Definition at line 68 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ toks_pix_

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

Definition at line 69 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ vtxCutIsol_

const double IsolatedPixelTrackCandidateL1TProducer::vtxCutIsol_
private

Definition at line 75 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ vtxCutSeed_

const double IsolatedPixelTrackCandidateL1TProducer::vtxCutSeed_
private

Definition at line 74 of file IsolatedPixelTrackCandidateL1TProducer.h.

Referenced by produce().

◆ zEE_

double IsolatedPixelTrackCandidateL1TProducer::zEE_
private

Definition at line 84 of file IsolatedPixelTrackCandidateL1TProducer.h.

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

Vector3DBase
Definition: Vector3DBase.h:8
IsolatedPixelTrackCandidateL1TProducer::maxPForIsolationValue_
const double maxPForIsolationValue_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:79
mps_fire.i
i
Definition: mps_fire.py:428
geometryCSVtoXML.zz
zz
Definition: geometryCSVtoXML.py:19
IsolatedPixelTrackCandidateL1TProducer::bfVal_
double bfVal_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:85
DiDispStaMuonMonitor_cfi.pt
pt
Definition: DiDispStaMuonMonitor_cfi.py:39
zMuMuMuonUserData.alpha
alpha
zGenParticlesMatch = cms.InputTag(""),
Definition: zMuMuMuonUserData.py:9
CaloGeometryRecord
Definition: CaloGeometryRecord.h:30
BXVector::const_iterator
std::vector< T >::const_iterator const_iterator
Definition: BXVector.h:18
AlCaHLTBitMon_ParallelJobs.p
p
Definition: AlCaHLTBitMon_ParallelJobs.py:153
IsolatedPixelTrackCandidateL1TProducer::tok_l1_
const edm::EDGetTokenT< l1t::TauBxCollection > tok_l1_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:67
VolumeBasedMagneticField
Definition: VolumeBasedMagneticField.h:18
HLT_FULL_cff.InputTag
InputTag
Definition: HLT_FULL_cff.py:89287
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
reco::IsolatedPixelTrackCandidate
Definition: IsolatedPixelTrackCandidate.h:23
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 >
trigger::TriggerRefsCollections::getObjects
void getObjects(Vids &ids, VRphoton &refs) const
various physics-level getters:
Definition: TriggerRefsCollections.h:452
EcalBarrel
Definition: EcalSubdetector.h:10
IsolatedPixelTrackCandidateL1TProducer::tauUnbiasCone_
const double tauUnbiasCone_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:77
IsolatedPixelTrackCandidateL1TProducer::tok_vert_
const edm::EDGetTokenT< reco::VertexCollection > tok_vert_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:68
edm::Ref< TrackCollection >
funct::sin
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
fileCollector.seed
seed
Definition: fileCollector.py:127
IdealMagneticFieldRecord
Definition: IdealMagneticFieldRecord.h:11
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
funct::cos
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
edm::EventSetup::get
T get() const
Definition: EventSetup.h:80
RecoMuonValidator_cfi.maxP
maxP
Definition: RecoMuonValidator_cfi.py:34
IsolatedPixelTrackCandidateL1TProducer::vtxCutIsol_
const double vtxCutIsol_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:75
edm::ConfigurationDescriptions::add
void add(std::string const &label, ParameterSetDescription const &psetDescription)
Definition: ConfigurationDescriptions.cc:57
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:69
PVValHelper::pT
Definition: PVValidationHelpers.h:70
HLT_FULL_cff.eta2
eta2
Definition: HLT_FULL_cff.py:9542
DDAxes::z
edm::ESHandle< CaloGeometry >
theta
Geom::Theta< T > theta() const
Definition: Basic3DVectorLD.h:150
GlobalPoint
Global3DPoint GlobalPoint
Definition: GlobalPoint.h:10
BXVector::begin
const_iterator begin(int bx) const
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
IsolatedPixelTrackCandidateL1TProducer::rEB_
double rEB_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:83
BXVector::end
const_iterator end(int bx) const
duplicaterechits_cfi.trackCollection
trackCollection
Definition: duplicaterechits_cfi.py:4
trigger::TriggerL1Tau
Definition: TriggerTypeDefs.h:49
IsolatedPixelTrackCandidateL1TProducer::tauAssocCone_
const double tauAssocCone_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:76
IsolatedPixelTrackCandidateL1TProducer::prelimCone_
const double prelimCone_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:72
funct::tan
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
trigger::TriggerL1Jet
Definition: TriggerTypeDefs.h:48
M_PI
#define M_PI
Definition: BXVectorInputProducer.cc:49
IsolatedPixelTrackCandidateL1TProducer::tok_hlt_
const edm::EDGetTokenT< trigger::TriggerFilterObjectWithRefs > tok_hlt_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:66
DetId::Ecal
Definition: DetId.h:27
get
#define get
IsolatedPixelTrackCandidateL1TProducer::pixelIsolationConeSizeAtEC_
const double pixelIsolationConeSizeAtEC_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:73
DDAxes::phi
IsolatedPixelTrackCandidateL1TProducer::getDistInCM
double getDistInCM(double eta1, double phi1, double eta2, double phi2)
Definition: IsolatedPixelTrackCandidateL1TProducer.cc:281
submitPVResolutionJobs.desc
string desc
Definition: submitPVResolutionJobs.py:251
eostools.move
def move(src, dest)
Definition: eostools.py:511
IsolatedPixelTrackCandidateL1TProducer::ebEtaBoundary_
const double ebEtaBoundary_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:80
PVValHelper::dxy
Definition: PVValidationHelpers.h:47
PVValHelper::dz
Definition: PVValidationHelpers.h:50
IsolatedPixelTrackCandidateL1TProducer::vtxCutSeed_
const double vtxCutSeed_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:74
IsolatedPixelTrackCandidateL1TProducer::GetEtaPhiAtEcal
std::pair< double, double > GetEtaPhiAtEcal(double etaIP, double phiIP, double pT, int charge, double vtxZ)
Definition: IsolatedPixelTrackCandidateL1TProducer.cc:301
IsolatedPixelTrackCandidateL1TProducer::bfield_
const std::string bfield_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:71
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
IsolatedPixelTrackCandidateL1TProducer::toks_pix_
const std::vector< edm::EDGetTokenT< reco::TrackCollection > > toks_pix_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:69
M_PI_2
#define M_PI_2
Definition: CSCGattiFunction.cc:6
IsolatedPixelTrackCandidateL1TProducer::zEE_
double zEE_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:84
funct::abs
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
LogTrace
#define LogTrace(id)
Definition: MessageLogger.h:224
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
dttmaxenums::R
Definition: DTTMax.h:29
edm::InputTag
Definition: InputTag.h:15
IsolatedPixelTrackCandidateL1TProducer::minPTrackValue_
const double minPTrackValue_
Definition: IsolatedPixelTrackCandidateL1TProducer.h:78