323 unsigned int muonCollectionSize = muonCollection->size();
333 unsigned int nmuonsForZ1 = 0;
334 unsigned int nmuonsForZ2 = 0;
336 for (
unsigned int i = 0;
i < muonCollectionSize;
i++) {
337 const Muon&
mu = muonCollection->at(
i);
350 for (
unsigned int j =
i + 1; j < muonCollectionSize; j++) {
351 const Muon& mu2 = muonCollection->at(j);
354 mu.
px() + mu2.
px(), mu.
py() + mu2.
py(), mu.
pz() + mu2.
pz(),
368 <<
" [GeV]: " << nmuonsForZ1;
370 <<
" [GeV]: " << nmuonsForZ2;
378 const MET&
met = metCollection->at(0);
379 double met_et = met.
pt();
380 LogTrace(
"") <<
">>> MET, MET_px, MET_py: " << met_et <<
", " << met.
px()
381 <<
", " << met.
py() <<
" [GeV]";
387 LogError(
"") <<
">>> Vertex collection does not exist !!!";
390 unsigned int vertexCollectionSize = vertexCollection->size();
393 for (
unsigned int i = 0;
i < vertexCollectionSize;
i++) {
394 const Vertex& vertex = vertexCollection->at(
i);
395 if (vertex.
isValid()) nvvertex++;
441 if (prescaleSet == -1) {
442 LogTrace(
"") <<
"Failed to determine prescaleSet\n";
496 unsigned int jetCollectionSize = jetCollection->size();
500 for (
unsigned int i = 0;
i < jetCollectionSize;
i++) {
501 const Jet&
jet = jetCollection->at(
i);
502 double minDistance = 99999;
503 for (
unsigned int j = 0; j < muonCollectionSize; j++) {
504 const Muon& mu = muonCollection->at(j);
507 if (minDistance > distance) minDistance =
distance;
509 if (minDistance < 0.3)
511 if (jet.
et() > max_pt) {
520 LogTrace(
"") <<
">>> Total number of jets: " << jetCollectionSize;
522 <<
" [GeV]: " << njets;
524 double lead_jet_pt = -1;
525 double lead_jet_eta = -100;
527 const Jet& leadJet = jetCollection->at(LEADJET);
530 lead_jet_pt = leadJet.
pt();
531 lead_jet_eta = leadJet.
eta();
539 unsigned int ngam = 0;
541 for (
unsigned int i = 0;
i < photonCollection->size();
i++) {
542 const Photon& ph = photonCollection->at(
i);
543 double photonPt = ph.
pt();
551 LogTrace(
"") <<
" >>> N photons " << ngam << std::endl;
561 bool zjets_hist_done =
false;
562 bool zfullsel_hist_done =
false;
563 bool met_hist_done =
false;
564 bool njets_hist_done =
false;
565 bool wfullsel_hist_done =
false;
568 const int NFLAGS = 10;
569 bool muon_sel[NFLAGS];
570 const int NFLAGSZ = 12;
571 bool zmuon_sel[NFLAGSZ];
574 double number_of_muons = 0;
575 double number_of_goodMuons = 0;
577 for (
unsigned int i = 0;
i < muonCollectionSize;
i++) {
578 for (
int j = 0; j < NFLAGS; ++j) {
584 const Muon& mu = muonCollection->at(
i);
589 LogTrace(
"") <<
"> Wsel: processing muon number " <<
i <<
"...";
596 LogTrace(
"") <<
"\t... pt, eta: " << pt <<
" [GeV], " <<
eta;
598 if (pt >
ptCut_) muon_sel[0] =
true;
599 if (fabs(eta) <
etaCut_) muon_sel[1] =
true;
604 double dxy = gm->dxy(beamSpotHandle->
position());
605 double normalizedChi2 = gm->normalizedChi2();
606 double trackerHits = tk->hitPattern().numberOfValidTrackerHits();
607 int pixelHits = tk->hitPattern().numberOfValidPixelHits();
608 int muonHits = gm->hitPattern().numberOfValidMuonHits();
611 LogTrace(
"") <<
"\t... dxy, normalizedChi2, trackerHits, isTrackerMuon?: " 612 << dxy <<
" [cm], " << normalizedChi2 <<
", " << trackerHits
614 if (fabs(dxy) <
dxyCut_) muon_sel[2] =
true;
626 if (quality) number_of_goodMuons++;
647 if (isovar <
isoCut03_) muon_sel[4] =
true;
649 LogTrace(
"") <<
"\t... isolation value" << isovar <<
", isolated? " 663 double w_et = met_et + mu.
pt();
664 double w_px = met.
px() + mu.
px();
665 double w_py = met.
py() + mu.
py();
667 double massT = w_et * w_et - w_px * w_px - w_py * w_py;
668 massT = (massT > 0) ?
sqrt(massT) : 0;
670 LogTrace(
"") <<
"\t... W mass, W_et, W_px, W_py: " << massT <<
", " << w_et
671 <<
", " << w_px <<
", " << w_py <<
" [GeV]";
672 if (massT >
mtMin_ && massT <
mtMax_) muon_sel[5] =
true;
678 double acop = deltaphi.value();
679 if (acop < 0) acop = -acop;
681 LogTrace(
"") <<
"\t... acoplanarity: " << acop;
682 if (acop <
acopCut_) muon_sel[7] =
true;
686 if (nmuonsForZ1 < 1 || nmuonsForZ2 < 2) muon_sel[8] =
true;
687 if (njets <=
nJetMax_) muon_sel[9] =
true;
690 int flags_passed = 0;
691 for (
int j = 0; j < NFLAGS; ++j) {
692 if (muon_sel[j]) flags_passed += 1;
696 if (flags_passed >= (NFLAGS - 1)) {
697 if (!muon_sel[0] || flags_passed == NFLAGS)
pt_after_->
Fill(pt);
698 if (!muon_sel[1] || flags_passed == NFLAGS)
eta_after_->
Fill(eta);
699 if (!muon_sel[2] || flags_passed == NFLAGS)
dxy_after_->
Fill(dxy);
700 if (!muon_sel[3] || flags_passed == NFLAGS)
702 if (!muon_sel[4] || flags_passed == NFLAGS)
iso_after_->
Fill(isovar);
706 if (!muon_sel[5] || flags_passed == NFLAGS)
mt_after_->
Fill(massT);
707 if (!muon_sel[6] || flags_passed == NFLAGS)
709 met_hist_done =
true;
712 if (!muon_sel[9] || flags_passed == NFLAGS) {
713 if (!njets_hist_done) {
718 njets_hist_done =
true;
720 if (flags_passed == NFLAGS) {
721 if (!wfullsel_hist_done) {
727 wfullsel_hist_done =
true;
733 if (muon4Z && !muon_sel[8]) {
736 for (
unsigned int j =
i + 1; j < muonCollectionSize; j++) {
738 for (
int ij = 0; ij < NFLAGSZ; ++ij) {
739 zmuon_sel[ij] =
false;
742 for (
int ji = 0; ji < 5; ++ji) {
743 zmuon_sel[ji] = muon_sel[ji];
746 const Muon& mu2 = muonCollection->at(j);
748 if (mu2.
charge() * charge != -1)
continue;
751 double pt2 = mu2.
pt();
753 double eta2 = mu2.
eta();
754 if (fabs(eta2) <
etaCut_) zmuon_sel[6] =
true;
755 double dxy2 = gm2->dxy(beamSpotHandle->
position());
756 if (fabs(dxy2) <
dxyCut_) zmuon_sel[7] =
true;
757 double normalizedChi22 = gm2->normalizedChi2();
758 double trackerHits2 = tk2->hitPattern().numberOfValidTrackerHits();
759 int pixelHits2 = tk2->hitPattern().numberOfValidPixelHits();
760 int muonHits2 = gm2->hitPattern().numberOfValidMuonHits();
762 bool quality2 =
true;
769 zmuon_sel[8] = quality2;
776 if (isovar2 <
isoCut03_) zmuon_sel[9] =
true;
779 mu.
px() + mu2.
px(), mu.
py() + mu2.
py(), mu.
pz() + mu2.
pz(),
783 zmuon_sel[10] =
true;
786 if (njets <=
nJetMax_) zmuon_sel[11] =
true;
789 int flags_passed_z = 0;
791 for (
int jj = 0;
jj < NFLAGSZ; ++
jj) {
792 if (zmuon_sel[
jj]) ++flags_passed_z;
795 if (flags_passed_z >= (NFLAGSZ - 1)) {
796 if (!zmuon_sel[0] || flags_passed_z == NFLAGSZ) {
799 if (!zmuon_sel[1] || flags_passed_z == NFLAGSZ) {
802 if (!zmuon_sel[2] || flags_passed_z == NFLAGSZ) {
805 if (!zmuon_sel[3] || flags_passed_z == NFLAGSZ) {
808 if (!zmuon_sel[4] || flags_passed_z == NFLAGSZ) {
811 if (!zmuon_sel[5] || flags_passed_z == NFLAGSZ) {
814 if (!zmuon_sel[6] || flags_passed_z == NFLAGSZ) {
817 if (!zmuon_sel[7] || flags_passed_z == NFLAGSZ) {
820 if (!zmuon_sel[8] || flags_passed_z == NFLAGSZ) {
823 if (!zmuon_sel[9] || flags_passed_z == NFLAGSZ) {
830 if (!zmuon_sel[10] || flags_passed_z == NFLAGSZ) {
833 if (!zmuon_sel[11] || flags_passed_z == NFLAGSZ) {
834 if (!zjets_hist_done) {
839 zjets_hist_done =
true;
841 if (flags_passed_z == NFLAGSZ) {
843 if (!zfullsel_hist_done) {
856 zfullsel_hist_done =
true;
863 if (zfullsel_hist_done) {
MonitorElement * met_before_
MonitorElement * ptDiffPM_afterZ_
MonitorElement * dimuonmass_afterZ_
double eta() const final
momentum pseudorapidity
float sumPt
sum-pt of tracks
MonitorElement * njets_afterZ_
MonitorElement * iso2_afterZ_
MonitorElement * npvs_before_
virtual TrackRef innerTrack() const
bool getByToken(EDGetToken token, Handle< PROD > &result) const
MonitorElement * dxy1_afterZ_
MonitorElement * njets_before_
MonitorElement * dxy_before_
MonitorElement * leadingjet_eta_afterZ_
MonitorElement * muoncharge_before_
bool isValid() const
Tells whether the vertex is valid.
edm::EDGetTokenT< reco::BeamSpot > beamSpotTag_
double px() const final
x coordinate of momentum vector
MonitorElement * eta2_afterZ_
MonitorElement * npvs_afterZ_
MonitorElement * leadingjet_eta_before_
double pt() const final
transverse momentum
int charge() const final
electric charge
MonitorElement * acop_before_
MonitorElement * leadingjet_pt_after_
MonitorElement * goodewkmuon_before_
MonitorElement * eta_after_
MonitorElement * muoncharge_afterZ_
MonitorElement * pt_before_
MonitorElement * dxy2_afterZ_
bool isTrackerMuon() const override
MonitorElement * leadingjet_pt_before_
MonitorElement * goodewkmuon1_afterZ_
int numberOfMatches(unsigned int type=SegmentAndTrackArbitration) const
get number of chambers with matched segments
MonitorElement * iso_before_
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
MonitorElement * npvs_after_
MonitorElement * goodewkmuon2_afterZ_
MonitorElement * njets_after_
MonitorElement * ngoodmuons_
MonitorElement * n_zselPt2thr_
MonitorElement * pt2_afterZ_
double et() const final
transverse energy
bool isGlobalMuon() const override
double pz() const final
z coordinate of momentum vector
MonitorElement * met_afterZ_
MonitorElement * leadingjet_eta_after_
MonitorElement * mt_after_
MonitorElement * goodewkmuon_after_
MonitorElement * muoncharge_after_
MonitorElement * mt_before_
bool isNull() const
Checks for null.
MonitorElement * eta_before_
MonitorElement * iso1_afterZ_
int prescaleSet(const edm::Event &iEvent, const edm::EventSetup &iSetup)
HLTPrescaleProvider hltPrescaleProvider_
double p() const final
magnitude of momentum vector
edm::EDGetTokenT< edm::View< reco::Vertex > > vertexTag_
double normalizedChi2Cut_
MonitorElement * pt_after_
MonitorElement * iso_after_
MonitorElement * eta1_afterZ_
double py() const final
y coordinate of momentum vector
MonitorElement * ptDiffPM_before_
MonitorElement * pt1_afterZ_
edm::EDGetTokenT< edm::View< reco::Jet > > jetToken_
MonitorElement * dxy_after_
const Point & position() const
position
MonitorElement * met_after_
edm::EDGetTokenT< edm::View< reco::Muon > > muonTag_
MonitorElement * n_zselPt1thr_
double phi() const final
momentum azimuthal angle
edm::EDGetTokenT< edm::View< reco::MET > > metToken_
edm::EDGetTokenT< edm::View< reco::Photon > > phoTag_
MonitorElement * dimuonmass_before_
const MuonIsolation & isolationR03() const
virtual TrackRef globalTrack() const
reference to Track reconstructed in both tracked and muon detector
MonitorElement * leadingjet_pt_afterZ_
MonitorElement * acop_after_