CMS 3D CMS Logo

List of all members | Classes | Public Member Functions | Private Member Functions | Private Attributes
AlignmentMonitorMuonSystemMap1D Class Reference
Inheritance diagram for AlignmentMonitorMuonSystemMap1D:
AlignmentMonitorBase

Classes

class  MuonSystemMapPlot1D
 
struct  MyCSCDetId
 
struct  MyResidual
 
struct  MyTrack
 

Public Member Functions

void afterAlignment () override
 
 AlignmentMonitorMuonSystemMap1D (const edm::ParameterSet &cfg, edm::ConsumesCollector iC)
 
void book () override
 Book or retrieve histograms; MUST be reimplemented. More...
 
void event (const edm::Event &iEvent, const edm::EventSetup &iSetup, const ConstTrajTrackPairCollection &iTrajTracks) override
 Called for each event (by "run()"): may be reimplemented. More...
 
void processMuonResidualsFromTrack (MuonResidualsFromTrack &mrft, const edm::Event &iEvent)
 
 ~AlignmentMonitorMuonSystemMap1D () override
 
- Public Member Functions inherited from AlignmentMonitorBase
 AlignmentMonitorBase (const AlignmentMonitorBase &)=delete
 
 AlignmentMonitorBase (const edm::ParameterSet &cfg, const edm::ConsumesCollector &iC, std::string name)
 Constructor. More...
 
void beginOfJob (AlignableTracker *pTracker, AlignableMuon *pMuon, AlignmentParameterStore *pStore)
 Called at beginning of job: don't reimplement. More...
 
void duringLoop (const edm::Event &iEvent, const edm::EventSetup &iSetup, const ConstTrajTrackPairCollection &iTrajTracks)
 Called for each event: don't reimplement. More...
 
void endOfJob ()
 Called at end of processing: don't implement. More...
 
void endOfLoop ()
 Called at end of loop: don't reimplement. More...
 
const AlignmentMonitorBaseoperator= (const AlignmentMonitorBase &)=delete
 
void startingNewLoop ()
 Called at beginning of loop: don't reimplement. More...
 
virtual ~AlignmentMonitorBase ()
 Destructor. More...
 

Private Member Functions

std::string num02d (int num)
 

Private Attributes

bool m_allowTIDTEC
 
long m_counter_13numhits
 
long m_counter_2numhits
 
long m_counter_csc
 
long m_counter_cscnumhits
 
long m_counter_dt
 
long m_counter_event
 
long m_counter_track
 
long m_counter_trackdxy
 
long m_counter_trackmoment
 
long m_counter_trackokay
 
bool m_createNtuple
 
TTree * m_cscnt
 
MuonSystemMapPlot1Dm_CSCvsphi_me [2][4][3]
 
MuonSystemMapPlot1Dm_CSCvsr_me [2][4][36]
 
bool m_doCSC
 
bool m_doDT
 
MuonSystemMapPlot1Dm_DTvsphi_station [4][5]
 
MuonSystemMapPlot1Dm_DTvsz_station [4][14]
 
const edm::ESGetToken< DetIdAssociator, DetIdAssociatorRecordm_esTokenDetId
 
const edm::ESGetToken< GlobalTrackingGeometry, GlobalTrackingGeometryRecordm_esTokenGBTGeom
 
const edm::ESGetToken< MagneticField, IdealMagneticFieldRecordm_esTokenMF
 
const edm::ESGetToken< Propagator, TrackingComponentsRecordm_esTokenProp
 
MyCSCDetId m_id
 
double m_maxDxy
 
double m_maxTrackerRedChi2
 
double m_maxTrackP
 
double m_maxTrackPt
 
int m_minCSCHits
 
int m_minDT13Hits
 
int m_minDT2Hits
 
int m_minNCrossedChambers
 
int m_minTrackerHits
 
double m_minTrackP
 
double m_minTrackPt
 
edm::InputTag m_muonCollectionTag
 
std::vector< MuonSystemMapPlot1D * > m_plots
 
MyResidual m_re
 
UInt_t m_run
 
MyTrack m_tr
 
bool m_useStubPosition
 

Additional Inherited Members

- Public Types inherited from AlignmentMonitorBase
typedef std::pair< const Trajectory *, const reco::Track * > ConstTrajTrackPair
 
typedef std::vector< ConstTrajTrackPairConstTrajTrackPairCollection
 
- Protected Member Functions inherited from AlignmentMonitorBase
TH1F * book1D (std::string dir, std::string name, std::string title, int nchX, double lowX, double highX)
 
TH2F * book2D (std::string dir, std::string name, std::string title, int nchX, double lowX, double highX, int nchY, double lowY, double highY)
 
TProfile * bookProfile (std::string dir, std::string name, std::string title, int nchX, double lowX, double highX, int nchY=1, double lowY=0., double highY=0., const char *option="s")
 
TFileDirectorydirectory (std::string dir)
 
int iteration ()
 
AlignableMuonpMuon ()
 
AlignableNavigatorpNavigator ()
 
AlignmentParameterStorepStore ()
 
AlignableTrackerpTracker ()
 
- Protected Attributes inherited from AlignmentMonitorBase
const edm::InputTag m_beamSpotTag
 

Detailed Description

Definition at line 34 of file AlignmentMonitorMuonSystemMap1D.cc.

Constructor & Destructor Documentation

◆ AlignmentMonitorMuonSystemMap1D()

AlignmentMonitorMuonSystemMap1D::AlignmentMonitorMuonSystemMap1D ( const edm::ParameterSet cfg,
edm::ConsumesCollector  iC 
)

Definition at line 151 of file AlignmentMonitorMuonSystemMap1D.cc.

153  : AlignmentMonitorBase(cfg, iC, "AlignmentMonitorMuonSystemMap1D"),
155  m_esTokenDetId(iC.esConsumes(edm::ESInputTag("", "MuonDetIdAssociator"))),
156  m_esTokenProp(iC.esConsumes(edm::ESInputTag("", "SteppingHelixPropagatorAny"))),
157  m_esTokenMF(iC.esConsumes()),
158  m_muonCollectionTag(cfg.getParameter<edm::InputTag>("muonCollectionTag")),
159  m_minTrackPt(cfg.getParameter<double>("minTrackPt")),
160  m_maxTrackPt(cfg.getParameter<double>("maxTrackPt")),
161  m_minTrackP(cfg.getParameter<double>("minTrackP")),
162  m_maxTrackP(cfg.getParameter<double>("maxTrackP")),
163  m_maxDxy(cfg.getParameter<double>("maxDxy")),
164  m_minTrackerHits(cfg.getParameter<int>("minTrackerHits")),
165  m_maxTrackerRedChi2(cfg.getParameter<double>("maxTrackerRedChi2")),
166  m_allowTIDTEC(cfg.getParameter<bool>("allowTIDTEC")),
167  m_minNCrossedChambers(cfg.getParameter<int>("minNCrossedChambers")),
168  m_minDT13Hits(cfg.getParameter<int>("minDT13Hits")),
169  m_minDT2Hits(cfg.getParameter<int>("minDT2Hits")),
170  m_minCSCHits(cfg.getParameter<int>("minCSCHits")),
171  m_doDT(cfg.getParameter<bool>("doDT")),
172  m_doCSC(cfg.getParameter<bool>("doCSC")),
173  m_useStubPosition(cfg.getParameter<bool>("useStubPosition")),
174  m_createNtuple(cfg.getParameter<bool>("createNtuple")) {
175  if (m_createNtuple) {
177  m_cscnt = fs->make<TTree>("mualNtuple", "mualNtuple");
178  m_cscnt->Branch("id", &m_id.e, "e/S:s:r:c:t");
179  m_cscnt->Branch("tr", &m_tr.q, "q/I:pt/F:pz");
180  m_cscnt->Branch("re", &m_re.res, "res/F:slope:rho:phi:z");
181  m_cscnt->Branch("run", &m_run, "run/i");
182  }
183 }

References AlignmentMonitorMuonSystemMap1D::MyCSCDetId::e, m_createNtuple, m_cscnt, m_id, m_re, m_run, m_tr, TFileService::make(), AlignmentMonitorMuonSystemMap1D::MyTrack::q, and AlignmentMonitorMuonSystemMap1D::MyResidual::res.

◆ ~AlignmentMonitorMuonSystemMap1D()

AlignmentMonitorMuonSystemMap1D::~AlignmentMonitorMuonSystemMap1D ( )
inlineoverride

Definition at line 37 of file AlignmentMonitorMuonSystemMap1D.cc.

37 {}

Member Function Documentation

◆ afterAlignment()

void AlignmentMonitorMuonSystemMap1D::afterAlignment ( )
overridevirtual

Called after updating AlignableTracker and AlignableMuon (by "endOfLoop()"): may be reimplemented

Reimplemented from AlignmentMonitorBase.

Definition at line 488 of file AlignmentMonitorMuonSystemMap1D.cc.

488  {
489  std::cout << "AlignmentMonitorMuonSystemMap1D counters:" << std::endl;
490  std::cout << " monitor m_counter_event = " << m_counter_event << std::endl;
491  std::cout << " monitor m_counter_track = " << m_counter_track << std::endl;
492  std::cout << " monitor m_counter_trackppt = " << m_counter_trackmoment << std::endl;
493  std::cout << " monitor m_counter_trackdxy = " << m_counter_trackdxy << std::endl;
494  std::cout << " monitor m_counter_trackokay = " << m_counter_trackokay << std::endl;
495  std::cout << " monitor m_counter_dt = " << m_counter_dt << std::endl;
496  std::cout << " monitor m_counter_13numhits = " << m_counter_13numhits << std::endl;
497  std::cout << " monitor m_counter_2numhits = " << m_counter_2numhits << std::endl;
498  std::cout << " monitor m_counter_csc = " << m_counter_csc << std::endl;
499  std::cout << " monitor m_counter_cscnumhits = " << m_counter_cscnumhits << std::endl;
500 }

References gather_cfg::cout, m_counter_13numhits, m_counter_2numhits, m_counter_csc, m_counter_cscnumhits, m_counter_dt, m_counter_event, m_counter_track, m_counter_trackdxy, m_counter_trackmoment, and m_counter_trackokay.

◆ book()

void AlignmentMonitorMuonSystemMap1D::book ( )
overridevirtual

Book or retrieve histograms; MUST be reimplemented.

Implements AlignmentMonitorBase.

Definition at line 192 of file AlignmentMonitorMuonSystemMap1D.cc.

192  {
193  std::string wheel_label[5] = {"A", "B", "C", "D", "E"};
194 
195  for (unsigned char station = 1; station <= 4; station++) {
196  std::string s_station = std::to_string(station);
197 
198  bool do_y = true;
199  if (station == 4)
200  do_y = false;
201 
202  // *** DT ***
203  if (m_doDT)
204  for (int sector = 1; sector <= 14; sector++) {
205  if ((station < 4 && sector <= 12) || station == 4) {
206  m_DTvsz_station[station - 1][sector - 1] = new MuonSystemMapPlot1D(
207  "DTvsz_st" + s_station + "sec" + num02d(sector), this, 60, -660., 660., do_y, false);
208  m_plots.push_back(m_DTvsz_station[station - 1][sector - 1]);
209  }
210  }
211 
212  if (m_doDT)
213  for (int wheel = -2; wheel <= 2; wheel++) {
214  m_DTvsphi_station[station - 1][wheel + 2] = new MuonSystemMapPlot1D(
215  "DTvsphi_st" + s_station + "wh" + wheel_label[wheel + 2], this, 180, -M_PI, M_PI, do_y, false);
216  m_plots.push_back(m_DTvsphi_station[station - 1][wheel + 2]);
217  }
218 
219  // *** CSC ***
220  if (m_doCSC)
221  for (int endcap = 1; endcap <= 2; endcap++) {
222  std::string s_endcap("m");
223  if (endcap == 1)
224  s_endcap = "p";
225 
226  for (int chamber = 1; chamber <= 36; chamber++) {
227  m_CSCvsr_me[endcap - 1][station - 1][chamber - 1] = new MuonSystemMapPlot1D(
228  "CSCvsr_me" + s_endcap + s_station + "ch" + num02d(chamber), this, 60, 100., 700., false, false);
229  m_plots.push_back(m_CSCvsr_me[endcap - 1][station - 1][chamber - 1]);
230  }
231 
232  for (int ring = 1; ring <= 3; ring++) // the ME1/a (ring4) is not independent from ME1/b (ring1)
233  {
234  std::string s_ring = std::to_string(ring);
235  if ((station > 1 && ring <= 2) || station == 1) {
236  m_CSCvsphi_me[endcap - 1][station - 1][ring - 1] =
237  new MuonSystemMapPlot1D("CSCvsphi_me" + s_endcap + s_station + s_ring,
238  this,
239  180,
240  -M_PI / 180. * 5.,
241  M_PI * (2. - 5. / 180.),
242  false,
243  true);
244  m_plots.push_back(m_CSCvsphi_me[endcap - 1][station - 1][ring - 1]);
245  }
246  }
247  } // endcaps
248  } // stations
249 
250  m_counter_event = 0;
251  m_counter_track = 0;
253  m_counter_trackdxy = 0;
255  m_counter_dt = 0;
257  m_counter_2numhits = 0;
258  m_counter_csc = 0;
260 }

References relativeConstraints::chamber, makeMuonMisalignmentScenario::endcap, m_counter_13numhits, m_counter_2numhits, m_counter_csc, m_counter_cscnumhits, m_counter_dt, m_counter_event, m_counter_track, m_counter_trackdxy, m_counter_trackmoment, m_counter_trackokay, m_CSCvsphi_me, m_CSCvsr_me, m_doCSC, m_doDT, m_DTvsphi_station, m_DTvsz_station, M_PI, m_plots, num02d(), relativeConstraints::ring, relativeConstraints::station, AlCaHLTBitMon_QueryRunRegistry::string, and makeMuonMisalignmentScenario::wheel.

◆ event()

void AlignmentMonitorMuonSystemMap1D::event ( const edm::Event iEvent,
const edm::EventSetup iSetup,
const ConstTrajTrackPairCollection iTrajTracks 
)
overridevirtual

Called for each event (by "run()"): may be reimplemented.

Reimplemented from AlignmentMonitorBase.

Definition at line 262 of file AlignmentMonitorMuonSystemMap1D.cc.

264  {
265  m_counter_event++;
266 
268  iEvent.getByLabel(m_beamSpotTag, beamSpot);
269 
270  const GlobalTrackingGeometry *globalGeometry = &iSetup.getData(m_esTokenGBTGeom);
271  const DetIdAssociator *muonDetIdAssociator_ = &iSetup.getData(m_esTokenDetId);
272  const Propagator *prop = &iSetup.getData(m_esTokenProp);
274 
275  if (m_muonCollectionTag.label().empty()) // use trajectories
276  {
277  for (ConstTrajTrackPairCollection::const_iterator trajtrack = trajtracks.begin(); trajtrack != trajtracks.end();
278  ++trajtrack) {
279  m_counter_track++;
280  const Trajectory *traj = (*trajtrack).first;
281  const reco::Track *track = (*trajtrack).second;
282 
283  if (m_minTrackPt < track->pt() && track->pt() < m_maxTrackPt && m_minTrackP < track->p() &&
284  track->p() < m_maxTrackP) {
286  if (fabs(track->dxy(beamSpot->position())) < m_maxDxy) {
288 
289  MuonResidualsFromTrack muonResidualsFromTrack(
290  iSetup, magneticField, globalGeometry, muonDetIdAssociator_, prop, traj, track, pNavigator(), 1000.);
291  processMuonResidualsFromTrack(muonResidualsFromTrack, iEvent);
292  }
293  } // end if track has acceptable momentum
294  } // end loop over tracks
295  } else {
297  iEvent.getByLabel(m_muonCollectionTag, muons);
298 
299  for (reco::MuonCollection::const_iterator muon = muons->begin(); muon != muons->end(); ++muon) {
300  if (!(muon->isTrackerMuon() && muon->innerTrack().isNonnull()))
301  continue;
302 
303  m_counter_track++;
304 
305  if (m_minTrackPt < muon->pt() && muon->pt() < m_maxTrackPt && m_minTrackP < muon->p() &&
306  muon->p() < m_maxTrackP) {
308  if (fabs(muon->innerTrack()->dxy(beamSpot->position())) < m_maxDxy) {
310 
311  MuonResidualsFromTrack muonResidualsFromTrack(globalGeometry, &(*muon), pNavigator(), 100.);
312  processMuonResidualsFromTrack(muonResidualsFromTrack, iEvent);
313  }
314  }
315  }
316  }
317 }

References pwdgSkimBPark_cfi::beamSpot, edm::EventSetup::getData(), iEvent, edm::InputTag::label(), AlignmentMonitorBase::m_beamSpotTag, m_counter_event, m_counter_track, m_counter_trackdxy, m_counter_trackmoment, m_esTokenDetId, m_esTokenGBTGeom, m_esTokenMF, m_esTokenProp, m_maxDxy, m_maxTrackP, m_maxTrackPt, m_minTrackP, m_muonCollectionTag, HLT_FULL_cff::magneticField, HLT_FULL_cff::muon, PDWG_BPHSkim_cff::muons, AlignmentMonitorBase::pNavigator(), processMuonResidualsFromTrack(), DiDispStaMuonMonitor_cfi::pt, and HLT_FULL_cff::track.

Referenced by Types.EventID::cppID().

◆ num02d()

std::string AlignmentMonitorMuonSystemMap1D::num02d ( int  num)
private

Definition at line 185 of file AlignmentMonitorMuonSystemMap1D.cc.

185  {
186  assert(num >= 0 && num < 100);
187  char tmp[4];
188  sprintf(tmp, "%02d", num);
189  return std::string(tmp);
190 }

References cms::cuda::assert(), EgammaValidation_cff::num, AlCaHLTBitMon_QueryRunRegistry::string, and createJobs::tmp.

Referenced by book().

◆ processMuonResidualsFromTrack()

void AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack ( MuonResidualsFromTrack mrft,
const edm::Event iEvent 
)

Definition at line 319 of file AlignmentMonitorMuonSystemMap1D.cc.

320  {
321  if (mrft.trackerNumHits() < m_minTrackerHits)
322  return;
323  if (!m_allowTIDTEC && mrft.contains_TIDTEC())
324  return;
325  if (mrft.normalizedChi2() > m_maxTrackerRedChi2)
326  return;
327 
328  int nMuChambers = 0;
329  std::vector<DetId> chamberIds = mrft.chamberIds();
330  for (unsigned ch = 0; ch < chamberIds.size(); ch++)
331  if (chamberIds[ch].det() == DetId::Muon)
332  nMuChambers++;
333  if (nMuChambers < m_minNCrossedChambers)
334  return;
335 
336  char charge = (mrft.getTrack()->charge() > 0 ? 1 : -1);
337  // double qoverpt = track->charge() / track->pt();
338  // double qoverpz = track->charge() / track->pz();
339 
341 
342  for (std::vector<DetId>::const_iterator chamberId = chamberIds.begin(); chamberId != chamberIds.end(); ++chamberId) {
343  if (chamberId->det() != DetId::Muon)
344  continue;
345 
346  if (m_doDT && chamberId->subdetId() == MuonSubdetId::DT) {
349  DTChamberId id(chamberId->rawId());
350 
351  m_counter_dt++;
352 
353  if (id.station() < 4 && dt13 != nullptr && dt13->numHits() >= m_minDT13Hits && dt2 != nullptr &&
354  dt2->numHits() >= m_minDT2Hits && (dt2->chi2() / double(dt2->ndof())) < 2.0) {
356 
357  double residual = dt13->global_residual();
358  double resslope = dt13->global_resslope();
359  double chi2 = dt13->chi2();
360  int dof = dt13->ndof();
361 
362  align::GlobalPoint gpos;
363  if (m_useStubPosition)
364  gpos = dt13->global_stubpos();
365  else
366  gpos = dt13->global_trackpos();
367  double phi = atan2(gpos.y(), gpos.x());
368  double z = gpos.z();
369 
370  assert(1 <= id.sector() && id.sector() <= 14);
371 
372  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_x(charge, z, residual, chi2, dof);
373  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_dxdz(charge, z, resslope, chi2, dof);
374  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_x(charge, phi, residual, chi2, dof);
375  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_dxdz(charge, phi, resslope, chi2, dof);
376 
378 
379  residual = dt2->global_residual();
380  resslope = dt2->global_resslope();
381  chi2 = dt2->chi2();
382  dof = dt2->ndof();
383 
384  if (m_useStubPosition)
385  gpos = dt2->global_stubpos();
386  else
387  gpos = dt2->global_trackpos();
388  phi = atan2(gpos.y(), gpos.x());
389  z = gpos.z();
390 
391  assert(1 <= id.sector() && id.sector() <= 14);
392 
393  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_y(charge, z, residual, chi2, dof);
394  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_dydz(charge, z, resslope, chi2, dof);
395  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_y(charge, phi, residual, chi2, dof);
396  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_dydz(charge, phi, resslope, chi2, dof);
397  }
398 
399  if (id.station() == 4 && dt13 != nullptr && dt13->numHits() >= m_minDT13Hits) {
401 
402  double residual = dt13->global_residual();
403  double resslope = dt13->global_resslope();
404  double chi2 = dt13->chi2();
405  int dof = dt13->ndof();
406 
407  align::GlobalPoint gpos;
408  if (m_useStubPosition)
409  gpos = dt13->global_stubpos();
410  else
411  gpos = dt13->global_trackpos();
412  double phi = atan2(gpos.y(), gpos.x());
413  double z = gpos.z();
414 
415  assert(1 <= id.sector() && id.sector() <= 14);
416 
417  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_x(charge, z, residual, chi2, dof);
418  m_DTvsz_station[id.station() - 1][id.sector() - 1]->fill_dxdz(charge, z, resslope, chi2, dof);
419  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_x(charge, phi, residual, chi2, dof);
420  m_DTvsphi_station[id.station() - 1][id.wheel() + 2]->fill_dxdz(charge, phi, resslope, chi2, dof);
421  }
422  }
423 
424  else if (m_doCSC && chamberId->subdetId() == MuonSubdetId::CSC) {
426  CSCDetId id(chamberId->rawId());
427 
428  int ring = id.ring();
429  if (id.ring() == 4)
430  ring = 1; // combine ME1/a + ME1/b
431 
432  m_counter_csc++;
433 
434  if (csc != nullptr && csc->numHits() >= m_minCSCHits) {
436 
437  double residual = csc->global_residual();
438  double resslope = csc->global_resslope();
439  double chi2 = csc->chi2();
440  int dof = csc->ndof();
441 
442  align::GlobalPoint gpos;
443  if (m_useStubPosition)
444  gpos = csc->global_stubpos();
445  else
446  gpos = csc->global_trackpos();
447  double phi = atan2(gpos.y(), gpos.x());
448  // start phi from -5deg
449  if (phi < -M_PI / 180. * 5.)
450  phi += 2. * M_PI;
451  double R = sqrt(pow(gpos.x(), 2) + pow(gpos.y(), 2));
452 
453  int chamber = id.chamber() - 1;
454  if (id.station() > 1 && ring == 1)
455  chamber *= 2;
456 
457  assert(1 <= id.endcap() && id.endcap() <= 2 && 0 <= chamber && chamber <= 35);
458 
459  if (R > 0.)
460  m_CSCvsphi_me[id.endcap() - 1][id.station() - 1][ring - 1]->fill_x_1d(residual / R, chi2, dof);
461 
462  m_CSCvsr_me[id.endcap() - 1][id.station() - 1][chamber]->fill_x(charge, R, residual, chi2, dof);
463  m_CSCvsr_me[id.endcap() - 1][id.station() - 1][chamber]->fill_dxdz(charge, R, resslope, chi2, dof);
464  m_CSCvsphi_me[id.endcap() - 1][id.station() - 1][ring - 1]->fill_x(charge, phi, residual, chi2, dof);
465  m_CSCvsphi_me[id.endcap() - 1][id.station() - 1][ring - 1]->fill_dxdz(charge, phi, resslope, chi2, dof);
466 
467  if (m_createNtuple && chi2 > 0.) // && TMath::Prob(chi2, dof) < 0.95)
468  {
469  m_id.init(id);
470  m_tr.q = charge;
471  m_tr.pt = mrft.getTrack()->pt();
472  m_tr.pz = mrft.getTrack()->pz();
473  m_re.res = residual;
474  m_re.slope = resslope;
475  m_re.rho = R;
476  m_re.phi = phi;
477  m_re.z = gpos.z();
478  m_run = iEvent.id().run();
479  m_cscnt->Fill();
480  }
481  }
482  }
483 
484  //else { assert(false); }
485  } // end loop over chambers
486 }

References cms::cuda::assert(), relativeConstraints::chamber, MuonResidualsFromTrack::chamberIds(), MuonResidualsFromTrack::chamberResidual(), ALCARECOTkAlJpsiMuMu_cff::charge, reco::TrackBase::charge(), hltPixelTracks_cff::chi2, MuonChamberResidual::chi2(), MuonResidualsFromTrack::contains_TIDTEC(), MuonSubdetId::CSC, MuonSubdetId::DT, makeMuonMisalignmentScenario::endcap, AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_dxdz(), AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_dydz(), AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_x(), AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_x_1d(), AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_y(), MuonResidualsFromTrack::getTrack(), MuonChamberResidual::global_residual(), MuonChamberResidual::global_resslope(), MuonChamberResidual::global_stubpos(), MuonChamberResidual::global_trackpos(), triggerObjects_cff::id, iEvent, AlignmentMonitorMuonSystemMap1D::MyCSCDetId::init(), MuonChamberResidual::kCSC, MuonChamberResidual::kDT13, MuonChamberResidual::kDT2, m_allowTIDTEC, m_counter_13numhits, m_counter_2numhits, m_counter_csc, m_counter_cscnumhits, m_counter_dt, m_counter_trackokay, m_createNtuple, m_cscnt, m_CSCvsphi_me, m_CSCvsr_me, m_doCSC, m_doDT, m_DTvsphi_station, m_DTvsz_station, m_id, m_maxTrackerRedChi2, m_minCSCHits, m_minDT13Hits, m_minDT2Hits, m_minNCrossedChambers, m_minTrackerHits, M_PI, m_re, m_run, m_tr, m_useStubPosition, DetId::Muon, MuonChamberResidual::ndof(), MuonResidualsFromTrack::normalizedChi2(), MuonChamberResidual::numHits(), phi, AlignmentMonitorMuonSystemMap1D::MyResidual::phi, funct::pow(), AlignmentMonitorMuonSystemMap1D::MyTrack::pt, reco::TrackBase::pt(), AlignmentMonitorMuonSystemMap1D::MyTrack::pz, reco::TrackBase::pz(), AlignmentMonitorMuonSystemMap1D::MyTrack::q, dttmaxenums::R, AlignmentMonitorMuonSystemMap1D::MyResidual::res, AlignmentMonitorMuonSystemMap1D::MyResidual::rho, relativeConstraints::ring, AlignmentMonitorMuonSystemMap1D::MyResidual::slope, mathSSE::sqrt(), relativeConstraints::station, MuonResidualsFromTrack::trackerNumHits(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), z, PV3DBase< T, PVType, FrameType >::z(), and AlignmentMonitorMuonSystemMap1D::MyResidual::z.

Referenced by event().

Member Data Documentation

◆ m_allowTIDTEC

bool AlignmentMonitorMuonSystemMap1D::m_allowTIDTEC
private

Definition at line 64 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_counter_13numhits

long AlignmentMonitorMuonSystemMap1D::m_counter_13numhits
private

◆ m_counter_2numhits

long AlignmentMonitorMuonSystemMap1D::m_counter_2numhits
private

◆ m_counter_csc

long AlignmentMonitorMuonSystemMap1D::m_counter_csc
private

◆ m_counter_cscnumhits

long AlignmentMonitorMuonSystemMap1D::m_counter_cscnumhits
private

◆ m_counter_dt

long AlignmentMonitorMuonSystemMap1D::m_counter_dt
private

◆ m_counter_event

long AlignmentMonitorMuonSystemMap1D::m_counter_event
private

Definition at line 75 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by afterAlignment(), book(), and event().

◆ m_counter_track

long AlignmentMonitorMuonSystemMap1D::m_counter_track
private

Definition at line 76 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by afterAlignment(), book(), and event().

◆ m_counter_trackdxy

long AlignmentMonitorMuonSystemMap1D::m_counter_trackdxy
private

Definition at line 78 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by afterAlignment(), book(), and event().

◆ m_counter_trackmoment

long AlignmentMonitorMuonSystemMap1D::m_counter_trackmoment
private

Definition at line 77 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by afterAlignment(), book(), and event().

◆ m_counter_trackokay

long AlignmentMonitorMuonSystemMap1D::m_counter_trackokay
private

◆ m_createNtuple

bool AlignmentMonitorMuonSystemMap1D::m_createNtuple
private

◆ m_cscnt

TTree* AlignmentMonitorMuonSystemMap1D::m_cscnt
private

◆ m_CSCvsphi_me

MuonSystemMapPlot1D* AlignmentMonitorMuonSystemMap1D::m_CSCvsphi_me[2][4][3]
private

Definition at line 115 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_CSCvsr_me

MuonSystemMapPlot1D* AlignmentMonitorMuonSystemMap1D::m_CSCvsr_me[2][4][36]
private

Definition at line 113 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_doCSC

bool AlignmentMonitorMuonSystemMap1D::m_doCSC
private

Definition at line 70 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_doDT

bool AlignmentMonitorMuonSystemMap1D::m_doDT
private

Definition at line 69 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_DTvsphi_station

MuonSystemMapPlot1D* AlignmentMonitorMuonSystemMap1D::m_DTvsphi_station[4][5]
private

Definition at line 114 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_DTvsz_station

MuonSystemMapPlot1D* AlignmentMonitorMuonSystemMap1D::m_DTvsz_station[4][14]
private

Definition at line 112 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book(), and processMuonResidualsFromTrack().

◆ m_esTokenDetId

const edm::ESGetToken<DetIdAssociator, DetIdAssociatorRecord> AlignmentMonitorMuonSystemMap1D::m_esTokenDetId
private

Definition at line 51 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_esTokenGBTGeom

const edm::ESGetToken<GlobalTrackingGeometry, GlobalTrackingGeometryRecord> AlignmentMonitorMuonSystemMap1D::m_esTokenGBTGeom
private

Definition at line 50 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_esTokenMF

const edm::ESGetToken<MagneticField, IdealMagneticFieldRecord> AlignmentMonitorMuonSystemMap1D::m_esTokenMF
private

Definition at line 53 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_esTokenProp

const edm::ESGetToken<Propagator, TrackingComponentsRecord> AlignmentMonitorMuonSystemMap1D::m_esTokenProp
private

Definition at line 52 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_id

MyCSCDetId AlignmentMonitorMuonSystemMap1D::m_id
private

◆ m_maxDxy

double AlignmentMonitorMuonSystemMap1D::m_maxDxy
private

Definition at line 61 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_maxTrackerRedChi2

double AlignmentMonitorMuonSystemMap1D::m_maxTrackerRedChi2
private

Definition at line 63 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_maxTrackP

double AlignmentMonitorMuonSystemMap1D::m_maxTrackP
private

Definition at line 60 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_maxTrackPt

double AlignmentMonitorMuonSystemMap1D::m_maxTrackPt
private

Definition at line 58 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_minCSCHits

int AlignmentMonitorMuonSystemMap1D::m_minCSCHits
private

Definition at line 68 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_minDT13Hits

int AlignmentMonitorMuonSystemMap1D::m_minDT13Hits
private

Definition at line 66 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_minDT2Hits

int AlignmentMonitorMuonSystemMap1D::m_minDT2Hits
private

Definition at line 67 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_minNCrossedChambers

int AlignmentMonitorMuonSystemMap1D::m_minNCrossedChambers
private

Definition at line 65 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_minTrackerHits

int AlignmentMonitorMuonSystemMap1D::m_minTrackerHits
private

Definition at line 62 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

◆ m_minTrackP

double AlignmentMonitorMuonSystemMap1D::m_minTrackP
private

Definition at line 59 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_minTrackPt

double AlignmentMonitorMuonSystemMap1D::m_minTrackPt
private

Definition at line 57 of file AlignmentMonitorMuonSystemMap1D.cc.

◆ m_muonCollectionTag

edm::InputTag AlignmentMonitorMuonSystemMap1D::m_muonCollectionTag
private

Definition at line 56 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by event().

◆ m_plots

std::vector<MuonSystemMapPlot1D *> AlignmentMonitorMuonSystemMap1D::m_plots
private

Definition at line 117 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by book().

◆ m_re

MyResidual AlignmentMonitorMuonSystemMap1D::m_re
private

◆ m_run

UInt_t AlignmentMonitorMuonSystemMap1D::m_run
private

◆ m_tr

MyTrack AlignmentMonitorMuonSystemMap1D::m_tr
private

◆ m_useStubPosition

bool AlignmentMonitorMuonSystemMap1D::m_useStubPosition
private

Definition at line 71 of file AlignmentMonitorMuonSystemMap1D.cc.

Referenced by processMuonResidualsFromTrack().

AlignmentMonitorMuonSystemMap1D::m_minCSCHits
int m_minCSCHits
Definition: AlignmentMonitorMuonSystemMap1D.cc:68
AlignmentMonitorMuonSystemMap1D::m_plots
std::vector< MuonSystemMapPlot1D * > m_plots
Definition: AlignmentMonitorMuonSystemMap1D.cc:117
PDWG_BPHSkim_cff.muons
muons
Definition: PDWG_BPHSkim_cff.py:47
AlignmentMonitorMuonSystemMap1D::m_minNCrossedChambers
int m_minNCrossedChambers
Definition: AlignmentMonitorMuonSystemMap1D.cc:65
MuonSubdetId::CSC
static constexpr int CSC
Definition: MuonSubdetId.h:12
AlignmentMonitorMuonSystemMap1D::m_counter_2numhits
long m_counter_2numhits
Definition: AlignmentMonitorMuonSystemMap1D.cc:82
AlignmentMonitorMuonSystemMap1D::m_counter_trackdxy
long m_counter_trackdxy
Definition: AlignmentMonitorMuonSystemMap1D.cc:78
DOFs::dof
dof
Definition: AlignPCLThresholdsWriter.cc:37
edm::ESInputTag
Definition: ESInputTag.h:87
pwdgSkimBPark_cfi.beamSpot
beamSpot
Definition: pwdgSkimBPark_cfi.py:5
AlignmentMonitorMuonSystemMap1D::m_minDT2Hits
int m_minDT2Hits
Definition: AlignmentMonitorMuonSystemMap1D.cc:67
HLT_FULL_cff.track
track
Definition: HLT_FULL_cff.py:11724
AlignmentMonitorMuonSystemMap1D::m_esTokenProp
const edm::ESGetToken< Propagator, TrackingComponentsRecord > m_esTokenProp
Definition: AlignmentMonitorMuonSystemMap1D.cc:52
AlignmentMonitorMuonSystemMap1D::MyTrack::pt
Float_t pt
Definition: AlignmentMonitorMuonSystemMap1D.cc:139
muon
Definition: MuonCocktails.h:17
PV3DBase::x
T x() const
Definition: PV3DBase.h:59
AlignmentMonitorMuonSystemMap1D::m_counter_13numhits
long m_counter_13numhits
Definition: AlignmentMonitorMuonSystemMap1D.cc:81
DiDispStaMuonMonitor_cfi.pt
pt
Definition: DiDispStaMuonMonitor_cfi.py:39
AlignmentMonitorMuonSystemMap1D::m_minTrackerHits
int m_minTrackerHits
Definition: AlignmentMonitorMuonSystemMap1D.cc:62
relativeConstraints.station
station
Definition: relativeConstraints.py:67
AlignmentMonitorMuonSystemMap1D::m_minTrackPt
double m_minTrackPt
Definition: AlignmentMonitorMuonSystemMap1D.cc:57
AlignmentMonitorMuonSystemMap1D::m_counter_cscnumhits
long m_counter_cscnumhits
Definition: AlignmentMonitorMuonSystemMap1D.cc:84
gather_cfg.cout
cout
Definition: gather_cfg.py:144
AlignmentMonitorMuonSystemMap1D::m_id
MyCSCDetId m_id
Definition: AlignmentMonitorMuonSystemMap1D.cc:135
MuonResidualsFromTrack::chamberResidual
MuonChamberResidual * chamberResidual(DetId chamberId, int type)
Definition: MuonResidualsFromTrack.cc:735
AlignmentMonitorMuonSystemMap1D::m_maxTrackP
double m_maxTrackP
Definition: AlignmentMonitorMuonSystemMap1D.cc:60
MuonResidualsFromTrack::trackerNumHits
int trackerNumHits() const
Definition: MuonResidualsFromTrack.h:78
AlignmentMonitorMuonSystemMap1D::processMuonResidualsFromTrack
void processMuonResidualsFromTrack(MuonResidualsFromTrack &mrft, const edm::Event &iEvent)
Definition: AlignmentMonitorMuonSystemMap1D.cc:319
cms::cuda::assert
assert(be >=bs)
AlignmentMonitorMuonSystemMap1D::m_counter_event
long m_counter_event
Definition: AlignmentMonitorMuonSystemMap1D.cc:75
hltPixelTracks_cff.chi2
chi2
Definition: hltPixelTracks_cff.py:25
makeMuonMisalignmentScenario.endcap
endcap
Definition: makeMuonMisalignmentScenario.py:320
HLT_FULL_cff.magneticField
magneticField
Definition: HLT_FULL_cff.py:348
AlignmentMonitorMuonSystemMap1D::num02d
std::string num02d(int num)
Definition: AlignmentMonitorMuonSystemMap1D.cc:185
createJobs.tmp
tmp
align.sh
Definition: createJobs.py:716
edm::ConsumesCollector::esConsumes
auto esConsumes()
Definition: ConsumesCollector.h:97
edm::Handle< reco::BeamSpot >
AlignmentMonitorMuonSystemMap1D::MyResidual::rho
Float_t rho
Definition: AlignmentMonitorMuonSystemMap1D.cc:144
MuonChamberResidual::global_stubpos
align::GlobalPoint global_stubpos()
Definition: MuonChamberResidual.cc:45
AlignmentMonitorBase::pNavigator
AlignableNavigator * pNavigator()
Definition: AlignmentMonitorBase.h:115
AlignmentMonitorMuonSystemMap1D::m_CSCvsphi_me
MuonSystemMapPlot1D * m_CSCvsphi_me[2][4][3]
Definition: AlignmentMonitorMuonSystemMap1D.cc:115
PV3DBase::z
T z() const
Definition: PV3DBase.h:61
AlignmentMonitorMuonSystemMap1D::m_maxTrackPt
double m_maxTrackPt
Definition: AlignmentMonitorMuonSystemMap1D.cc:58
MuonChamberResidual::global_residual
double global_residual() const
Definition: MuonChamberResidual.cc:49
reco::TrackBase::pt
double pt() const
track transverse momentum
Definition: TrackBase.h:637
AlignmentMonitorMuonSystemMap1D::m_counter_csc
long m_counter_csc
Definition: AlignmentMonitorMuonSystemMap1D.cc:83
edm::InputTag::label
std::string const & label() const
Definition: InputTag.h:36
Propagator
Definition: Propagator.h:44
csc
Definition: L1Track.h:19
AlignmentMonitorMuonSystemMap1D::MyTrack::pz
Float_t pz
Definition: AlignmentMonitorMuonSystemMap1D.cc:139
GlobalTrackingGeometry
Definition: GlobalTrackingGeometry.h:20
HLT_FULL_cff.muon
muon
Definition: HLT_FULL_cff.py:11725
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
DDAxes::z
reco::Track
Definition: Track.h:27
MuonResidualsFromTrack
Definition: MuonResidualsFromTrack.h:52
MuonResidualsFromTrack::getTrack
const reco::Track * getTrack()
Definition: MuonResidualsFromTrack.h:75
AlignmentMonitorMuonSystemMap1D::MyResidual::phi
Float_t phi
Definition: AlignmentMonitorMuonSystemMap1D.cc:144
MuonChamberResidual::chi2
double chi2() const
Definition: MuonChamberResidual.h:59
MuonResidualsFromTrack::chamberIds
const std::vector< DetId > chamberIds() const
Definition: MuonResidualsFromTrack.h:86
AlignmentMonitorMuonSystemMap1D::m_counter_trackmoment
long m_counter_trackmoment
Definition: AlignmentMonitorMuonSystemMap1D.cc:77
reco::TrackBase::charge
int charge() const
track electric charge
Definition: TrackBase.h:596
MuonSubdetId::DT
static constexpr int DT
Definition: MuonSubdetId.h:11
Point3DBase< Scalar, GlobalTag >
MuonResidualsFromTrack::normalizedChi2
double normalizedChi2() const
Definition: MuonResidualsFromTrack.cc:729
AlignmentMonitorMuonSystemMap1D::m_esTokenMF
const edm::ESGetToken< MagneticField, IdealMagneticFieldRecord > m_esTokenMF
Definition: AlignmentMonitorMuonSystemMap1D.cc:53
AlignmentMonitorMuonSystemMap1D::m_doCSC
bool m_doCSC
Definition: AlignmentMonitorMuonSystemMap1D.cc:70
DetIdAssociator
Definition: DetIdAssociator.h:45
ALCARECOTkAlJpsiMuMu_cff.charge
charge
Definition: ALCARECOTkAlJpsiMuMu_cff.py:47
MuonChamberResidual::kDT2
Definition: MuonChamberResidual.h:28
AlignmentMonitorMuonSystemMap1D::m_minDT13Hits
int m_minDT13Hits
Definition: AlignmentMonitorMuonSystemMap1D.cc:66
MuonChamberResidual::numHits
int numHits() const
Definition: MuonChamberResidual.h:52
AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_x
void fill_x(char charge, double abscissa, double residx, double chi2, int dof)
Definition: AlignmentMonitorMuonSystemMap1D.cc:538
AlignmentMonitorMuonSystemMap1D::m_re
MyResidual m_re
Definition: AlignmentMonitorMuonSystemMap1D.cc:146
AlignmentMonitorMuonSystemMap1D::m_doDT
bool m_doDT
Definition: AlignmentMonitorMuonSystemMap1D.cc:69
AlignmentMonitorMuonSystemMap1D::m_cscnt
TTree * m_cscnt
Definition: AlignmentMonitorMuonSystemMap1D.cc:122
AlignmentMonitorMuonSystemMap1D::m_muonCollectionTag
edm::InputTag m_muonCollectionTag
Definition: AlignmentMonitorMuonSystemMap1D.cc:56
AlignmentMonitorMuonSystemMap1D::m_CSCvsr_me
MuonSystemMapPlot1D * m_CSCvsr_me[2][4][36]
Definition: AlignmentMonitorMuonSystemMap1D.cc:113
AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_dxdz
void fill_dxdz(char charge, double abscissa, double slopex, double chi2, int dof)
Definition: AlignmentMonitorMuonSystemMap1D.cc:556
CSCDetId
Definition: CSCDetId.h:26
AlignmentMonitorMuonSystemMap1D::m_run
UInt_t m_run
Definition: AlignmentMonitorMuonSystemMap1D.cc:148
AlignmentMonitorMuonSystemMap1D::MyResidual::slope
Float_t slope
Definition: AlignmentMonitorMuonSystemMap1D.cc:144
PV3DBase::y
T y() const
Definition: PV3DBase.h:60
makeMuonMisalignmentScenario.wheel
wheel
Definition: makeMuonMisalignmentScenario.py:319
edm::Service< TFileService >
MuonChamberResidual
Definition: MuonChamberResidual.h:26
iEvent
int iEvent
Definition: GenABIO.cc:224
AlignmentMonitorMuonSystemMap1D::MyTrack::q
Int_t q
Definition: AlignmentMonitorMuonSystemMap1D.cc:138
AlignmentMonitorMuonSystemMap1D::MyResidual::z
Float_t z
Definition: AlignmentMonitorMuonSystemMap1D.cc:144
AlignmentMonitorMuonSystemMap1D::MyCSCDetId::e
Short_t e
Definition: AlignmentMonitorMuonSystemMap1D.cc:132
AlignmentMonitorMuonSystemMap1D::m_useStubPosition
bool m_useStubPosition
Definition: AlignmentMonitorMuonSystemMap1D.cc:71
M_PI
#define M_PI
Definition: BXVectorInputProducer.cc:49
MuonResidualsFromTrack::contains_TIDTEC
bool contains_TIDTEC() const
Definition: MuonResidualsFromTrack.h:84
AlignmentMonitorMuonSystemMap1D::MyResidual::res
Float_t res
Definition: AlignmentMonitorMuonSystemMap1D.cc:144
AlignmentMonitorBase::m_beamSpotTag
const edm::InputTag m_beamSpotTag
Definition: AlignmentMonitorBase.h:117
AlignmentMonitorMuonSystemMap1D::m_counter_dt
long m_counter_dt
Definition: AlignmentMonitorMuonSystemMap1D.cc:80
MuonChamberResidual::kCSC
Definition: MuonChamberResidual.h:28
AlignmentMonitorMuonSystemMap1D::m_allowTIDTEC
bool m_allowTIDTEC
Definition: AlignmentMonitorMuonSystemMap1D.cc:64
TFileService::make
T * make(const Args &...args) const
make new ROOT object
Definition: TFileService.h:64
AlCaHLTBitMon_QueryRunRegistry.string
string string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
EgammaValidation_cff.num
num
Definition: EgammaValidation_cff.py:33
AlignmentMonitorMuonSystemMap1D::m_maxDxy
double m_maxDxy
Definition: AlignmentMonitorMuonSystemMap1D.cc:61
MuonChamberResidual::global_trackpos
align::GlobalPoint global_trackpos()
Definition: MuonChamberResidual.cc:41
edm::EventSetup::getData
bool getData(T &iHolder) const
Definition: EventSetup.h:127
looper.cfg
cfg
Definition: looper.py:296
AlignmentMonitorMuonSystemMap1D::m_esTokenDetId
const edm::ESGetToken< DetIdAssociator, DetIdAssociatorRecord > m_esTokenDetId
Definition: AlignmentMonitorMuonSystemMap1D.cc:51
DDAxes::phi
AlignmentMonitorMuonSystemMap1D::m_createNtuple
bool m_createNtuple
Definition: AlignmentMonitorMuonSystemMap1D.cc:72
AlignmentMonitorMuonSystemMap1D::m_tr
MyTrack m_tr
Definition: AlignmentMonitorMuonSystemMap1D.cc:141
Trajectory
Definition: Trajectory.h:38
triggerObjects_cff.id
id
Definition: triggerObjects_cff.py:29
AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_x_1d
void fill_x_1d(double residx, double chi2, int dof)
Definition: AlignmentMonitorMuonSystemMap1D.cc:530
AlignmentMonitorMuonSystemMap1D::m_maxTrackerRedChi2
double m_maxTrackerRedChi2
Definition: AlignmentMonitorMuonSystemMap1D.cc:63
relativeConstraints.ring
ring
Definition: relativeConstraints.py:68
AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_y
void fill_y(char charge, double abscissa, double residy, double chi2, int dof)
Definition: AlignmentMonitorMuonSystemMap1D.cc:547
relativeConstraints.chamber
chamber
Definition: relativeConstraints.py:53
AlignmentMonitorMuonSystemMap1D::m_DTvsphi_station
MuonSystemMapPlot1D * m_DTvsphi_station[4][5]
Definition: AlignmentMonitorMuonSystemMap1D.cc:114
AlignmentMonitorMuonSystemMap1D::MuonSystemMapPlot1D::fill_dydz
void fill_dydz(char charge, double abscissa, double slopey, double chi2, int dof)
Definition: AlignmentMonitorMuonSystemMap1D.cc:565
funct::pow
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
reco::TrackBase::pz
double pz() const
z coordinate of momentum vector
Definition: TrackBase.h:646
DetId::Muon
Definition: DetId.h:26
MuonChamberResidual::ndof
int ndof() const
Definition: MuonChamberResidual.h:60
DTChamberId
Definition: DTChamberId.h:14
AlignmentMonitorMuonSystemMap1D::m_counter_track
long m_counter_track
Definition: AlignmentMonitorMuonSystemMap1D.cc:76
AlignmentMonitorMuonSystemMap1D::m_DTvsz_station
MuonSystemMapPlot1D * m_DTvsz_station[4][14]
Definition: AlignmentMonitorMuonSystemMap1D.cc:112
MuonChamberResidual::kDT13
Definition: MuonChamberResidual.h:28
AlignmentMonitorMuonSystemMap1D::m_esTokenGBTGeom
const edm::ESGetToken< GlobalTrackingGeometry, GlobalTrackingGeometryRecord > m_esTokenGBTGeom
Definition: AlignmentMonitorMuonSystemMap1D.cc:50
MagneticField
Definition: MagneticField.h:19
AlignmentMonitorMuonSystemMap1D::MyCSCDetId::init
void init(CSCDetId &id)
Definition: AlignmentMonitorMuonSystemMap1D.cc:125
MuonChamberResidual::global_resslope
double global_resslope() const
Definition: MuonChamberResidual.cc:51
dttmaxenums::R
Definition: DTTMax.h:29
edm::InputTag
Definition: InputTag.h:15
AlignmentMonitorMuonSystemMap1D::m_minTrackP
double m_minTrackP
Definition: AlignmentMonitorMuonSystemMap1D.cc:59
AlignmentMonitorMuonSystemMap1D::m_counter_trackokay
long m_counter_trackokay
Definition: AlignmentMonitorMuonSystemMap1D.cc:79
AlignmentMonitorBase::AlignmentMonitorBase
AlignmentMonitorBase(const edm::ParameterSet &cfg, const edm::ConsumesCollector &iC, std::string name)
Constructor.
Definition: AlignmentMonitorBase.cc:20