CMS 3D CMS Logo

Public Member Functions | Private Attributes

EwkMuDQM Class Reference

#include <EwkMuDQM.h>

Inheritance diagram for EwkMuDQM:
edm::EDAnalyzer

List of all members.

Public Member Functions

virtual void analyze (const edm::Event &, const edm::EventSetup &)
virtual void beginJob ()
virtual void beginRun (const edm::Run &, const edm::EventSetup &)
virtual void endJob ()
virtual void endRun (const edm::Run &, const edm::EventSetup &)
 EwkMuDQM (const edm::ParameterSet &)
void init_histograms ()

Private Attributes

MonitorElementacop_after_
MonitorElementacop_before_
double acopCut_
MonitorElementdimuonmass_afterZ_
MonitorElementdimuonmass_before_
double dimuonMassMax_
double dimuonMassMin_
MonitorElementdxy1_afterZ_
MonitorElementdxy2_afterZ_
MonitorElementdxy_after_
MonitorElementdxy_before_
double dxyCut_
double eJetMin_
MonitorElementeta1_afterZ_
MonitorElementeta2_afterZ_
MonitorElementeta_after_
MonitorElementeta_before_
double etaCut_
MonitorElementgoodewkmuon1_afterZ_
MonitorElementgoodewkmuon2_afterZ_
MonitorElementgoodewkmuon_after_
MonitorElementgoodewkmuon_before_
HLTConfigProvider hltConfigProvider_
bool isAlsoTrackerMuon_
bool isCombinedIso_
MonitorElementiso1_afterZ_
MonitorElementiso2_afterZ_
MonitorElementiso_after_
MonitorElementiso_before_
double isoCut03_
bool isRelativeIso_
bool isValidHltConfig_
edm::InputTag jetTag_
MonitorElementleadingjet_eta_after_
MonitorElementleadingjet_eta_afterZ_
MonitorElementleadingjet_eta_before_
MonitorElementleadingjet_pt_after_
MonitorElementleadingjet_pt_afterZ_
MonitorElementleadingjet_pt_before_
MonitorElementmet_after_
MonitorElementmet_afterZ_
MonitorElementmet_before_
double metMax_
double metMin_
edm::InputTag metTag_
MonitorElementmt_after_
MonitorElementmt_before_
double mtMax_
double mtMin_
MonitorElementmuoncharge_after_
MonitorElementmuoncharge_afterZ_
MonitorElementmuoncharge_before_
int muonHitsCut_
edm::InputTag muonTag_
unsigned int nall
MonitorElementngoodmuons_
unsigned int nhlt
unsigned int niso
int nJetMax_
MonitorElementnjets_after_
MonitorElementnjets_afterZ_
MonitorElementnjets_before_
int nMatchesCut_
unsigned int nmet
MonitorElementnmuons_
double normalizedChi2Cut_
MonitorElementnpfph_
MonitorElementnph_
int nPhoMax_
MonitorElementnpvs_after_
MonitorElementnpvs_afterZ_
MonitorElementnpvs_before_
unsigned int nrec
unsigned int nsel
unsigned int nz
MonitorElementpfphEta_
edm::InputTag pfPhoTag_
MonitorElementpfphPt_
MonitorElementphEta_
edm::InputTag phoTag_
MonitorElementphPt_
int pixelHitsCut_
MonitorElementpt1_afterZ_
MonitorElementpt2_afterZ_
MonitorElementpt_after_
MonitorElementpt_before_
double ptCut_
double ptThrForPhoton_
double ptThrForZ1_
double ptThrForZ2_
DQMStoretheDbe
int trackerHitsCut_
MonitorElementtrig_after_
MonitorElementtrig_before_
std::vector< std::string > trigPathNames_
edm::InputTag trigTag_
edm::InputTag vertexTag_
MonitorElementztrig_afterZ_

Detailed Description

DQM offline for EWKMu

Definition at line 19 of file EwkMuDQM.h.


Constructor & Destructor Documentation

EwkMuDQM::EwkMuDQM ( const edm::ParameterSet cfg)

Definition at line 37 of file EwkMuDQM.cc.

References init_histograms(), isValidHltConfig_, cmsCodeRules::cppFunctionSkipper::operator, DQMStore::setCurrentFolder(), and theDbe.

                                             :
      // Input collections
      trigTag_      (cfg.getUntrackedParameter<edm::InputTag> ("TrigTag", edm::InputTag("TriggerResults::HLT"))),
      muonTag_      (cfg.getUntrackedParameter<edm::InputTag> ("MuonTag", edm::InputTag("muons"))),
      metTag_       (cfg.getUntrackedParameter<edm::InputTag> ("METTag", edm::InputTag("pfmet"))),
      jetTag_       (cfg.getUntrackedParameter<edm::InputTag> ("JetTag", edm::InputTag("ak5PFJets"))),
      phoTag_       (cfg.getUntrackedParameter<edm::InputTag> ("phoTag", edm::InputTag("photons"))),
      pfPhoTag_     (cfg.getUntrackedParameter<edm::InputTag> ("pfPhoTag", edm::InputTag("pfPhotonTranslator","pfPhot"))),
      vertexTag_    (cfg.getUntrackedParameter<edm::InputTag> ("VertexTag", edm::InputTag("offlinePrimaryVertices"))),
      trigPathNames_(cfg.getUntrackedParameter<std::vector <std::string> >("TrigPathNames")),           

      // Muon quality cuts
      isAlsoTrackerMuon_(cfg.getUntrackedParameter<bool>("IsAlsoTrackerMuon", true)),  // Glb muon also tracker muon 
      dxyCut_           (cfg.getUntrackedParameter<double>("DxyCut", 0.2)),            // dxy < 0.2 cm 
      normalizedChi2Cut_(cfg.getUntrackedParameter<double>("NormalizedChi2Cut", 10.)), // chi2/ndof (of global fit) <10.0
      trackerHitsCut_   (cfg.getUntrackedParameter<int>("TrackerHitsCut", 11)),        // Tracker Hits >10 
      pixelHitsCut_     (cfg.getUntrackedParameter<int>("PixelHitsCut", 1)),           // Pixel Hits >0
      muonHitsCut_      (cfg.getUntrackedParameter<int>("MuonHitsCut", 1)),            // Valid Muon Hits >0 
      nMatchesCut_      (cfg.getUntrackedParameter<int>("NMatchesCut", 2)),            // At least 2 Chambers with matches 

      // W-boson cuts 
      isRelativeIso_(cfg.getUntrackedParameter<bool>("IsRelativeIso", true)),
      isCombinedIso_(cfg.getUntrackedParameter<bool>("IsCombinedIso", false)),
      isoCut03_     (cfg.getUntrackedParameter<double>("IsoCut03", 0.1)),
      acopCut_      (cfg.getUntrackedParameter<double>("AcopCut", 999.)),
      metMin_       (cfg.getUntrackedParameter<double>("MetMin", -999999.)),
      metMax_       (cfg.getUntrackedParameter<double>("MetMax", 999999.)),
      mtMin_        (cfg.getUntrackedParameter<double>("MtMin", 50.)),
      mtMax_        (cfg.getUntrackedParameter<double>("MtMax", 200.)),
      ptCut_        (cfg.getUntrackedParameter<double>("PtCut", 20.)),
      etaCut_       (cfg.getUntrackedParameter<double>("EtaCut", 2.4)),

      // Z rejection
      ptThrForZ1_  (cfg.getUntrackedParameter<double>("PtThrForZ1", 20.)),
      ptThrForZ2_  (cfg.getUntrackedParameter<double>("PtThrForZ2", 10.)),

      // Z selection
      dimuonMassMin_(cfg.getUntrackedParameter<double>("dimuonMassMin", 80.)),
      dimuonMassMax_(cfg.getUntrackedParameter<double>("dimuonMassMax", 120.)), 

      // Top rejection
      eJetMin_     (cfg.getUntrackedParameter<double>("EJetMin", 999999.)),
      nJetMax_     (cfg.getUntrackedParameter<int>("NJetMax", 999999)), 

      // Photon cuts 
      ptThrForPhoton_(cfg.getUntrackedParameter<double>("ptThrForPhoton",5.)),
      nPhoMax_(cfg.getUntrackedParameter<int>("nPhoMax", 999999)) 
{
  isValidHltConfig_ = false;

  theDbe = Service<DQMStore>().operator->();
  theDbe->setCurrentFolder("Physics/EwkMuDQM");
  init_histograms();

}

Member Function Documentation

void EwkMuDQM::analyze ( const edm::Event ev,
const edm::EventSetup iSet 
) [virtual]

Implements edm::EDAnalyzer.

Definition at line 248 of file EwkMuDQM.cc.

References acop_after_, acop_before_, acopCut_, reco::LeafCandidate::charge(), DeDxDiscriminatorTools::charge(), dimuonmass_afterZ_, dimuonmass_before_, dimuonMassMax_, dimuonMassMin_, dxy1_afterZ_, dxy2_afterZ_, dxy_after_, dxy_before_, dxyCut_, eJetMin_, reco::MuonIsolation::emEt, reco::LeafCandidate::et(), eta(), reco::LeafCandidate::eta(), eta1_afterZ_, eta2_afterZ_, eta_after_, eta_before_, etaCut_, MonitorElement::Fill(), newFWLiteAna::found, edm::Event::getByLabel(), reco::Muon::globalTrack(), goodewkmuon1_afterZ_, goodewkmuon2_afterZ_, goodewkmuon_after_, goodewkmuon_before_, reco::MuonIsolation::hadEt, hltConfigProvider_, i, getHLTprescales::index, reco::Muon::innerTrack(), isCombinedIso_, reco::Muon::isGlobalMuon(), edm::Ref< C, T, F >::isNull(), iso1_afterZ_, iso2_afterZ_, iso_after_, iso_before_, isoCut03_, reco::Muon::isolationR03(), isRelativeIso_, reco::Muon::isTrackerMuon(), reco::Vertex::isValid(), j, metsig::jet, jetTag_, findQualityFiles::jj, leadingjet_eta_after_, leadingjet_eta_afterZ_, leadingjet_eta_before_, leadingjet_pt_after_, leadingjet_pt_afterZ_, leadingjet_pt_before_, LogTrace, M_PI, CaloMET_cfi::met, met_after_, met_afterZ_, met_before_, metMax_, metMin_, metTag_, mt_after_, mt_before_, mtMax_, mtMin_, RPCpg::mu, muoncharge_after_, muoncharge_before_, muonHitsCut_, muonTag_, nall, ngoodmuons_, nJetMax_, njets_after_, njets_afterZ_, njets_before_, nMatchesCut_, nmuons_, normalizedChi2Cut_, nph_, npvs_after_, npvs_before_, reco::Muon::numberOfMatches(), reco::LeafCandidate::p(), reco::LeafCandidate::phi(), phoTag_, phPt_, pixelHitsCut_, HLTConfigProvider::prescaleSize(), HLTConfigProvider::prescaleValue(), reco::LeafCandidate::pt(), pt1_afterZ_, pt2_afterZ_, pt_after_, pt_before_, ptCut_, ptThrForPhoton_, ptThrForZ1_, ptThrForZ2_, reco::LeafCandidate::px(), reco::LeafCandidate::py(), reco::LeafCandidate::pz(), mathSSE::sqrt(), reco::MuonIsolation::sumPt, trackerHitsCut_, trig_after_, trig_before_, edm::TriggerNames::triggerName(), edm::Event::triggerNames(), patRefSel_triggerSelection_cff::triggerResults, trigNames, trigPathNames_, trigTag_, Geom::Phi< T >::value(), GoodVertex_cfg::vertexCollection, vertexTag_, and ztrig_afterZ_.

                                                                 {
      
      // Muon collection
      Handle<View<Muon> > muonCollection;
      if (!ev.getByLabel(muonTag_, muonCollection)) {
        //LogWarning("") << ">>> Muon collection does not exist !!!";
        return;
      }
      unsigned int muonCollectionSize = muonCollection->size();

      // Beam spot
      Handle<reco::BeamSpot> beamSpotHandle;
      if (!ev.getByLabel(InputTag("offlineBeamSpot"), beamSpotHandle)) {
        //LogWarning("") << ">>> No beam spot found !!!";
        return;
      }


      // Loop to reject/control Z->mumu is done separately
      unsigned int nmuonsForZ1 = 0;
      unsigned int nmuonsForZ2 = 0;
      bool cosmic = false;
      for (unsigned int i=0; i<muonCollectionSize; i++) {
            const Muon& mu = muonCollection->at(i);
            if (!mu.isGlobalMuon()) continue;
            double pt = mu.pt();
            double dxy = mu.innerTrack()->dxy(beamSpotHandle->position());

            if (fabs(dxy)>1) { cosmic=true; break;} 

            if (pt>ptThrForZ1_) nmuonsForZ1++;
            if (pt>ptThrForZ2_) nmuonsForZ2++;

            for (unsigned int j=i+1; j<muonCollectionSize; j++) {
                 const Muon& mu2 = muonCollection->at(j);
                 if (mu2.isGlobalMuon() && (mu.charge()*mu2.charge()==-1) ){
                         const math::XYZTLorentzVector ZRecoGlb (mu.px()+mu2.px(), mu.py()+mu2.py() , mu.pz()+mu2.pz(), mu.p()+mu2.p());
                         dimuonmass_before_->Fill(ZRecoGlb.mass());
                 }
            }
      }
     if(cosmic) return;

      LogTrace("") << "> Z rejection: muons above " << ptThrForZ1_ << " [GeV]: " << nmuonsForZ1;
      LogTrace("") << "> Z rejection: muons above " << ptThrForZ2_ << " [GeV]: " << nmuonsForZ2;
      /*nz1_before_->Fill(nmuonsForZ1);
      nz2_before_->Fill(nmuonsForZ2);
      */

      // MET
      Handle<View<MET> > metCollection;
      if (!ev.getByLabel(metTag_, metCollection)) {
        //LogWarning("") << ">>> MET collection does not exist !!!";
        return;
      }
      const MET& met = metCollection->at(0);
      double met_et = met.pt();
      LogTrace("") << ">>> MET, MET_px, MET_py: " << met_et << ", " << met.px() << ", " << met.py() << " [GeV]";
      met_before_->Fill(met_et);

      // Vertices in the event
      Handle<View<reco::Vertex> > vertexCollection;
           if (!ev.getByLabel(vertexTag_, vertexCollection)) {
                 LogError("") << ">>> Vertex collection does not exist !!!";
                 return;
            }
      unsigned int vertexCollectionSize = vertexCollection->size();

      

      int nvvertex = 0;
      for (unsigned int i=0; i<vertexCollectionSize; i++) {
            const Vertex& vertex = vertexCollection->at(i);
            if (vertex.isValid()) nvvertex++;
      }

      npvs_before_->Fill(nvvertex);

      bool trigger_fired = false;
      Handle<TriggerResults> triggerResults;
      if (!ev.getByLabel(trigTag_, triggerResults)) {
        //LogWarning("") << ">>> TRIGGER collection does not exist !!!";
        return;
      }
      const edm::TriggerNames & trigNames = ev.triggerNames(*triggerResults);
      //  LogWarning("")<<"Loop over triggers";


      for (unsigned int i=0; i<triggerResults->size(); i++)
      {
              const std::string trigName = trigNames.triggerName(i);

              bool found=false; 
              for(unsigned int index=0; index<trigPathNames_.size() && found==false; index++) {
                   size_t trigPath = trigName.find(trigPathNames_[index]); // 0 if found, pos if not
                   if (trigPath==0) found=true;
              }
              if(!found) {continue;}
              
              bool prescaled=false;    
              for (unsigned int ps= 0; ps<  hltConfigProvider_.prescaleSize(); ps++){
                  const unsigned int prescaleValue = hltConfigProvider_.prescaleValue(ps, trigName) ;
                  if (prescaleValue != 1) prescaled =true;
              }
            
              if( triggerResults->accept(i) && !prescaled){   trigger_fired=true;}
                        // LogWarning("")<<"TrigNo: "<<i<<"  "<<found<<"  "<<trigName<<" ---> FIRED";}
      }     
      trig_before_->Fill(trigger_fired);

      // Jet collection
      Handle<View<Jet> > jetCollection;
      if (!ev.getByLabel(jetTag_, jetCollection)) {
        //LogError("") << ">>> JET collection does not exist !!!";
        return;
      }
      unsigned int jetCollectionSize = jetCollection->size();
      int njets = 0; int LEADJET=-1;  double max_pt=0;
      for (unsigned int i=0; i<jetCollectionSize; i++) {
            const Jet& jet = jetCollection->at(i);
                  double minDistance=99999; // This is in order to use PFJets
                  for (unsigned int j=0; j<muonCollectionSize; j++) {
                        const Muon& mu = muonCollection->at(j);
                        double distance = sqrt( (mu.eta()-jet.eta())*(mu.eta()-jet.eta()) +(mu.phi()-jet.phi())*(mu.phi()-jet.phi()) );      
                        if (minDistance>distance) minDistance=distance;
                  }
                  if (minDistance<0.3) continue; // 0.3 is the isolation cone around the muon
            if(jet.et()>max_pt) { LEADJET=i; max_pt=jet.et();}
            if (jet.et()>eJetMin_) {njets++;}
      }


      LogTrace("") << ">>> Total number of jets: " << jetCollectionSize;
      LogTrace("") << ">>> Number of jets above " << eJetMin_ << " [GeV]: " << njets;
      njets_before_->Fill(njets);
      double lead_jet_pt=-1;
      double lead_jet_eta=-100;
      if(LEADJET!=-1){
      const Jet& leadJet = jetCollection->at(LEADJET);
      leadingjet_pt_before_->Fill(leadJet.pt());
      leadingjet_eta_before_->Fill(leadJet.eta());
      lead_jet_pt=leadJet.pt();
      lead_jet_eta=leadJet.eta();
      }
      //Photon Collection
      Handle<View<Photon> > photonCollection;
      if(!ev.getByLabel(phoTag_,photonCollection)){
      //LogError("")
      return;
      }
      unsigned int ngam=0;
      
      for (unsigned int i=0; i<photonCollection->size(); i++){
        const Photon &ph = photonCollection->at(i);
        double photonPt = ph.pt();
        if (photonPt> ptThrForPhoton_) ngam++;
        phPt_->Fill(photonPt); 
        }
      nph_->Fill(ngam); 
      LogTrace("") << " >>> N photons " << ngam << std::endl;

      nmuons_->Fill(muonCollectionSize);

      //Handle<View<Photon> > pfPhotonCollection;
      //if(!ev.getByLabel(pfPhoTag_,pfPhotonCollection)){
      //return;
      //}
      //unsigned int npfgam=0;
      //
      //for (unsigned int i=0; i<pfPhotonCollection->size(); i++){
      //        const Photon &ph = pfPhotonCollection->at(i);
      //        double photonPt = ph.pt();
      //        if (photonPt> ptThrForPhoton_) npfgam++;
      //  pfphPt_->Fill(photonPt); 
      //        }
      //npfph_->Fill(npfgam); 
      //LogTrace("") << " >>> N PF photons " << npfgam << std::endl;

      // Start counting
      nall++;

      // Histograms per event should be done only once, so keep track of them
      bool hlt_hist_done = false;
      bool zhlt_hist_done = false;
      bool zjets_hist_done = false;
      bool zfullsel_hist_done = false;
      bool met_hist_done = false;
      //bool nz1_hist_done = false;
      //bool nz2_hist_done = false;
      bool njets_hist_done = false;
      bool wfullsel_hist_done = false;

      // Central W->mu nu selection criteria
      const int NFLAGS = 11;
      bool muon_sel[NFLAGS];
      const int NFLAGSZ = 13;
      bool zmuon_sel[NFLAGSZ];
      bool muon4Z=false;

      double number_of_muons=0;
      double number_of_goodMuons=0;


      for (unsigned int i=0; i<muonCollectionSize; i++) {
            for (int j=0; j<NFLAGS; ++j) {
                  muon_sel[j] = false;
            }

            number_of_muons++;

            const Muon& mu = muonCollection->at(i);
            if (!mu.isGlobalMuon()) continue;
            if (mu.globalTrack().isNull()) continue;
            if (mu.innerTrack().isNull()) continue;

            LogTrace("") << "> Wsel: processing muon number " << i << "...";
            reco::TrackRef gm = mu.globalTrack();
            reco::TrackRef tk = mu.innerTrack();

            // Pt,eta cuts
            double pt = mu.pt();
            double eta = mu.eta();
            LogTrace("") << "\t... pt, eta: " << pt << " [GeV], " << eta;;
            if (pt>ptCut_) muon_sel[0] = true; 
            if (fabs(eta)<etaCut_) muon_sel[1] = true; 

            double charge=mu.charge();

            // d0, chi2, nhits quality cuts
            double dxy = gm->dxy(beamSpotHandle->position());
            double normalizedChi2 = gm->normalizedChi2();
            double trackerHits = tk->hitPattern().numberOfValidTrackerHits();
            int pixelHits = tk->hitPattern().numberOfValidPixelHits();
            int muonHits = gm->hitPattern().numberOfValidMuonHits();
            int nMatches = mu.numberOfMatches();

            LogTrace("") << "\t... dxy, normalizedChi2, trackerHits, isTrackerMuon?: " << dxy << " [cm], " << normalizedChi2 << ", " << trackerHits << ", " << mu.isTrackerMuon();
            if (fabs(dxy)<dxyCut_) muon_sel[2] = true; 

            bool quality=true;
            
            if (normalizedChi2>normalizedChi2Cut_) quality =false; 
            if (trackerHits<trackerHitsCut_) quality =false;
            if (pixelHits<pixelHitsCut_) quality =false;
            if (muonHits<muonHitsCut_) quality=false;;
            if (!mu.isTrackerMuon()) quality=false;
            if (nMatches<nMatchesCut_) quality=false;
            muon_sel[3]=quality;
            if(quality) number_of_goodMuons++;

            pt_before_->Fill(pt);
            eta_before_->Fill(eta);
            dxy_before_->Fill(dxy);
            muoncharge_before_->Fill(charge);
            goodewkmuon_before_->Fill(quality);

            // Isolation cuts
            double isovar = mu.isolationR03().sumPt;
            if (isCombinedIso_) {
                  isovar += mu.isolationR03().emEt;
                  isovar += mu.isolationR03().hadEt;
            }
            if (isRelativeIso_) isovar /= pt;
            if (isovar<isoCut03_) muon_sel[4] = true; 

            LogTrace("") << "\t... isolation value" << isovar <<", isolated? " << muon_sel[6];
            iso_before_->Fill(isovar);


            // HLT (not mtched to muon for the time being)
            if (trigger_fired) muon_sel[5] = true; 

            // For Z:
            if (pt>ptThrForZ1_ && fabs(eta)<etaCut_ && fabs(dxy)<dxyCut_ && quality && trigger_fired && isovar<isoCut03_) { muon4Z = true;}


            // MET/MT cuts
            double w_et = met_et+mu.pt();
            double w_px = met.px()+mu.px();
            double w_py = met.py()+mu.py();
            
            double massT = w_et*w_et - w_px*w_px - w_py*w_py;
            massT = (massT>0) ? sqrt(massT) : 0;

            LogTrace("") << "\t... W mass, W_et, W_px, W_py: " << massT << ", " << w_et << ", " << w_px << ", " << w_py << " [GeV]";
            if (massT>mtMin_ && massT<mtMax_) muon_sel[6] = true; 
            mt_before_->Fill(massT);
            if (met_et>metMin_ && met_et<metMax_) muon_sel[7] = true; 

            // Acoplanarity cuts
            Geom::Phi<double> deltaphi(mu.phi()-atan2(met.py(),met.px()));
            double acop = deltaphi.value();
            if (acop<0) acop = - acop;
            acop = M_PI - acop;
            LogTrace("") << "\t... acoplanarity: " << acop;
            if (acop<acopCut_) muon_sel[8] = true; 
            acop_before_->Fill(acop);

            // Remaining flags (from global event information)
            if (nmuonsForZ1<1 || nmuonsForZ2<2) muon_sel[9] = true; 
            if (njets<=nJetMax_) muon_sel[10] = true; 

            // Collect necessary flags "per muon"
            int flags_passed = 0;
            for (int j=0; j<NFLAGS; ++j) {
              if (muon_sel[j]) flags_passed += 1;
            }

            // Do N-1 histograms now (and only once for global event quantities)
            if (flags_passed >= (NFLAGS-1)) {
                  if (!muon_sel[0] || flags_passed==NFLAGS) 
                        pt_after_->Fill(pt);
                  if (!muon_sel[1] || flags_passed==NFLAGS) 
                        eta_after_->Fill(eta);
                  if (!muon_sel[2] || flags_passed==NFLAGS) 
                        dxy_after_->Fill(dxy);
                  if (!muon_sel[3] || flags_passed==NFLAGS)
                        goodewkmuon_after_->Fill(quality);
                  if (!muon_sel[4] || flags_passed==NFLAGS) 
                        iso_after_->Fill(isovar);
                  if (!muon_sel[5] || flags_passed==NFLAGS) 
                        if (!hlt_hist_done) trig_after_->Fill(trigger_fired);
                        hlt_hist_done = true;
                  if (!muon_sel[6] || flags_passed==NFLAGS) 
                        mt_after_->Fill(massT);
                  if (!muon_sel[7] || flags_passed==NFLAGS) 
                        if (!met_hist_done) met_after_->Fill(met_et);
                        met_hist_done = true;
                  if (!muon_sel[8] || flags_passed==NFLAGS) 
                        acop_after_->Fill(acop);
                  /* Clearing some space
                  if (!muon_sel[9] || flags_passed==NFLAGS) 
                        if (!nz1_hist_done) nz1_after_->Fill(nmuonsForZ1);
                        nz1_hist_done = true;
                  if (!muon_sel[9] || flags_passed==NFLAGS) 
                        if (!nz2_hist_done) nz2_after_->Fill(nmuonsForZ2);
                        nz2_hist_done = true;
                  */
                  if (!muon_sel[10] || flags_passed==NFLAGS) { 
                        if (!njets_hist_done) {
                                    njets_after_->Fill(njets);
                                    leadingjet_pt_after_->Fill(lead_jet_pt);
                                    leadingjet_eta_after_->Fill(lead_jet_eta);
                        }
                        njets_hist_done = true;
                  if( flags_passed==NFLAGS ) {
                        if (!wfullsel_hist_done){
                        npvs_after_->Fill(nvvertex);
                        muoncharge_after_->Fill(charge);
                        }
                        wfullsel_hist_done=true;    
                  } 
                   
            }


            // The cases in which the event is rejected as a Z are considered independently:
            if ( muon4Z &&  !muon_sel[9]){

                   // Plots for 2 muons       
                   for (unsigned int j=i+1; j<muonCollectionSize; j++) {

                         for (int ij=0; ij<NFLAGSZ; ++ij) {
                               zmuon_sel[ij] = false;
                         }

                         for (int ji=0; ji<5; ++ji ) {
                           zmuon_sel[ji] = muon_sel[ji];
                         }

                         const Muon& mu2 = muonCollection->at(j);
                              if (!mu2.isGlobalMuon()) continue;
                              if (mu2.charge() * charge != -1 ) continue;
                                    reco::TrackRef gm2 = mu2.globalTrack();
                                    reco::TrackRef tk2 = mu2.innerTrack();
                                    double pt2 = mu2.pt(); if (pt2>ptThrForZ1_) zmuon_sel[5] = true;
                                    double eta2=mu2.eta(); if (fabs(eta2)<etaCut_) zmuon_sel[6] = true;
                                    double dxy2 = gm2->dxy(beamSpotHandle->position()); if (fabs(dxy2)<dxyCut_) zmuon_sel[7] = true;
                                    double normalizedChi22 = gm2->normalizedChi2();
                                    double trackerHits2    = tk2->hitPattern().numberOfValidTrackerHits();
                                    int    pixelHits2      = tk2->hitPattern().numberOfValidPixelHits();
                                    int    muonHits2       = gm2->hitPattern().numberOfValidMuonHits();
                                    int    nMatches2       = mu2.numberOfMatches();
                                    bool quality2=true;
                                    if (normalizedChi22>normalizedChi2Cut_) quality2 = false; 
                                    if (trackerHits2<trackerHitsCut_)       quality2 = false;
                                    if (pixelHits2<pixelHitsCut_)           quality2 = false;
                                    if (muonHits2<muonHitsCut_)             quality2 = false;
                                    if (!mu2.isTrackerMuon())               quality2 = false;
                                    if (nMatches2<nMatchesCut_)             quality2 = false;
                                    zmuon_sel[8]=quality2;
                                    double isovar2 = mu2.isolationR03().sumPt; 
                                    if (isCombinedIso_) {
                                          isovar2 += mu2.isolationR03().emEt;
                                          isovar2 += mu2.isolationR03().hadEt;
                                    }
                                    if (isRelativeIso_) isovar2 /= pt2;
                                    if (isovar2<isoCut03_) zmuon_sel[9] = true;
                                    if (trigger_fired) zmuon_sel[10] = true; 
                               const math::XYZTLorentzVector ZRecoGlb (mu.px()+mu2.px(), mu.py()+mu2.py() , mu.pz()+mu2.pz(), mu.p()+mu2.p());
                               if (ZRecoGlb.mass()>dimuonMassMin_ && ZRecoGlb.mass()<dimuonMassMax_) zmuon_sel[11] = true; 

                                        //jet flag
                                        if (njets <=nJetMax_) zmuon_sel[12] = true; 

                               // start filling histos: N-1 plots
                               int  flags_passed_z = 0;

                               for (int jj=0; jj<NFLAGSZ; ++jj) {
                                 if (zmuon_sel[jj]) ++flags_passed_z ;
                               }

                               if (flags_passed_z >= (NFLAGSZ-1)) {
                                       if (!zmuon_sel[0]  || flags_passed_z==NFLAGSZ) {pt1_afterZ_->Fill(pt); } 
                                       if (!zmuon_sel[1]  || flags_passed_z==NFLAGSZ) {eta1_afterZ_->Fill(eta); }  
                                       if (!zmuon_sel[2]  || flags_passed_z==NFLAGSZ) {dxy1_afterZ_->Fill(dxy); }  
                                       if (!zmuon_sel[3]  || flags_passed_z==NFLAGSZ) {goodewkmuon1_afterZ_->Fill(quality); }  
                                       if (!zmuon_sel[4]  || flags_passed_z==NFLAGSZ) {iso1_afterZ_->Fill(isovar); }  
                                       if (!zmuon_sel[5]  || flags_passed_z==NFLAGSZ) { pt2_afterZ_->Fill(pt2); }  
                                       if (!zmuon_sel[6]  || flags_passed_z==NFLAGSZ) { eta2_afterZ_->Fill(eta2); }  
                                       if (!zmuon_sel[7]  || flags_passed_z==NFLAGSZ) {dxy2_afterZ_->Fill(dxy2); }  
                                       if (!zmuon_sel[8]  || flags_passed_z==NFLAGSZ) {goodewkmuon2_afterZ_->Fill(quality2); }  
                                       if (!zmuon_sel[9]  || flags_passed_z==NFLAGSZ) {iso2_afterZ_->Fill(isovar2); }   
                                       if (!zmuon_sel[10] || flags_passed_z==NFLAGSZ) { 
                                         if (!zhlt_hist_done) ztrig_afterZ_->Fill(trigger_fired); 
                                          zhlt_hist_done = true; 
                                       }  
                                       if (!zmuon_sel[11] || flags_passed_z==NFLAGSZ) {dimuonmass_afterZ_->Fill(ZRecoGlb.mass()); } 
                                                 if (!zmuon_sel[12] || flags_passed_z==NFLAGSZ ){
                                                            if(!zjets_hist_done){
                                                            njets_afterZ_->Fill(njets);
                                                            leadingjet_pt_afterZ_->Fill(lead_jet_pt);
                                                            leadingjet_eta_afterZ_->Fill(lead_jet_eta);
                                                            }
                                                            zjets_hist_done=true;
                                    }
                               if(flags_passed_z==NFLAGSZ) {met_afterZ_->Fill(met_et);
                                          if(!zfullsel_hist_done){
                                          npvs_after_->Fill(nvvertex);
                                          muoncharge_after_->Fill(charge);
                                          }
                                          zfullsel_hist_done=true;
                               }     
                  }

                               }

                  }
            }

      }

      //nmuons_->Fill(number_of_muons);
      //nmuons_->Fill(muonCollectionSize);
      ngoodmuons_->Fill(number_of_goodMuons);

      return;

}
void EwkMuDQM::beginJob ( void  ) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 110 of file EwkMuDQM.cc.

                        {

}
void EwkMuDQM::beginRun ( const edm::Run iRun,
const edm::EventSetup iSet 
) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 93 of file EwkMuDQM.cc.

References hltConfigProvider_, HLTConfigProvider::init(), isValidHltConfig_, nall, nhlt, niso, nmet, nrec, nsel, and nz.

                                                               {
      nall = 0;
      nsel = 0;
      nz   = 0;

      nrec = 0; 
      niso = 0; 
      nhlt = 0; 
      nmet = 0;

     // passed as parameter to HLTConfigProvider::init(), not yet used
     bool isConfigChanged = false;
     // isValidHltConfig_ used to short-circuit analyze() in case of problems
     isValidHltConfig_ = hltConfigProvider_.init( iRun, iSet, "HLT", isConfigChanged );

}
void EwkMuDQM::endJob ( void  ) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 241 of file EwkMuDQM.cc.

                      {
}
void EwkMuDQM::endRun ( const edm::Run r,
const edm::EventSetup iSet 
) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 244 of file EwkMuDQM.cc.

                                                          {

}
void EwkMuDQM::init_histograms ( )

\ For Z-boson events

Definition at line 114 of file EwkMuDQM.cc.

References acop_after_, acop_before_, DQMStore::book1D(), dimuonmass_afterZ_, dimuonmass_before_, dxy1_afterZ_, dxy2_afterZ_, dxy_after_, dxy_before_, eJetMin_, eta1_afterZ_, eta2_afterZ_, eta_after_, eta_before_, goodewkmuon1_afterZ_, goodewkmuon2_afterZ_, goodewkmuon_after_, goodewkmuon_before_, isCombinedIso_, iso1_afterZ_, iso2_afterZ_, iso_after_, iso_before_, isRelativeIso_, jetTag_, edm::InputTag::label(), leadingjet_eta_after_, leadingjet_eta_afterZ_, leadingjet_eta_before_, leadingjet_pt_after_, leadingjet_pt_afterZ_, leadingjet_pt_before_, M_PI, met_after_, met_afterZ_, met_before_, metTag_, mt_after_, mt_before_, muoncharge_after_, muoncharge_afterZ_, muoncharge_before_, ngoodmuons_, njets_after_, njets_afterZ_, njets_before_, nmuons_, npfph_, nph_, npvs_after_, npvs_afterZ_, npvs_before_, pfphEta_, pfphPt_, phEta_, phPt_, pt1_afterZ_, pt2_afterZ_, pt_after_, pt_before_, theDbe, trig_after_, trig_before_, and ztrig_afterZ_.

Referenced by EwkMuDQM().

                               {

  char chtitle[256] = "";

  pt_before_ = theDbe->book1D("PT_BEFORECUTS","Muon transverse momentum (global muon) [GeV]",100,0.,100.);
  pt_after_ = theDbe->book1D("PT_AFTERWCUTS","Muon transverse momentum (global muon) [GeV]",100,0.,100.);

  eta_before_ = theDbe->book1D("ETA_BEFORECUTS","Muon pseudo-rapidity",50,-2.5,2.5);
  eta_after_ = theDbe->book1D("ETA_AFTERWCUTS","Muon pseudo-rapidity",50,-2.5,2.5);

  dxy_before_ = theDbe->book1D("DXY_BEFORECUTS","Muon transverse distance to beam spot [cm]",1000,-0.5,0.5);
  dxy_after_ = theDbe->book1D("DXY_AFTERWCUTS","Muon transverse distance to beam spot [cm]",1000,-0.5,0.5);

  goodewkmuon_before_ = theDbe->book1D("GOODEWKMUON_BEFORECUTS","Quality-muon flag",2,-0.5,1.5);
  goodewkmuon_after_ = theDbe->book1D("GOODEWKMUON_AFTERWCUTS","Quality-muon flag",2,-0.5,1.5);

  if (isRelativeIso_) {
    if (isCombinedIso_) {
      iso_before_ = theDbe->book1D("ISO_BEFORECUTS","Relative (combined) isolation variable",100, 0., 1.);
      iso_after_ = theDbe->book1D("ISO_AFTERWCUTS","Relative (combined) isolation variable",100, 0., 1.);
    } else {
      iso_before_ = theDbe->book1D("ISO_BEFORECUTS","Relative (tracker) isolation variable",100, 0., 1.);
      iso_after_ = theDbe->book1D("ISO_AFTERWCUTS","Relative (tracker) isolation variable",100, 0., 1.);
    }
  } else {
    if (isCombinedIso_) {
      iso_before_ = theDbe->book1D("ISO_BEFORECUTS","Absolute (combined) isolation variable [GeV]",100, 0., 20.);
      iso_after_ = theDbe->book1D("ISO_AFTERWCUTS","Absolute (combined) isolation variable [GeV]",100, 0., 20.);
    } else {
      iso_before_ = theDbe->book1D("ISO_BEFORECUTS","Absolute (tracker) isolation variable [GeV]",100, 0., 20.);
      iso_after_ = theDbe->book1D("ISO_AFTERWCUTS","Absolute (tracker) isolation variable [GeV]",100, 0., 20.);
    }
  }

  trig_before_ = theDbe->book1D("TRIG_BEFORECUTS","Trigger response (boolean of muon triggers)",2,-0.5,1.5);
  trig_after_ = theDbe->book1D("TRIG_AFTERWCUTS","Trigger response (boolean of muon triggers)",2,-0.5,1.5);

  snprintf(chtitle, 255, "Transverse mass (%s) [GeV]", metTag_.label().data());
  mt_before_ = theDbe->book1D("MT_BEFORECUTS",chtitle,150,0.,300.);
  mt_after_ = theDbe->book1D("MT_AFTERWCUTS",chtitle,150,0.,300.);

  snprintf(chtitle, 255, "Missing transverse energy (%s) [GeV]", metTag_.label().data());
  met_before_ = theDbe->book1D("MET_BEFORECUTS",chtitle,100,0.,200.);
  met_after_ = theDbe->book1D("MET_AFTERWCUTS",chtitle,100,0.,200.);
  met_afterZ_ = theDbe->book1D("MET_AFTERZCUTS",chtitle,100,0.,200.);

  snprintf(chtitle, 255, "MU-MET (%s) acoplanarity", metTag_.label().data());
  acop_before_ = theDbe->book1D("ACOP_BEFORECUTS",chtitle,50,0.,M_PI);
  acop_after_ = theDbe->book1D("ACOP_AFTERWCUTS",chtitle,50,0.,M_PI);

  /* Clearing space:
     snprintf(chtitle, 255, "Z rejection: number of muons above %.2f GeV", ptThrForZ1_);
     nz1_before_ = theDbe->book1D("NZ1_BEFORECUTS",chtitle,10,-0.5,9.5);
     nz1_after_ = theDbe->book1D("NZ1_AFTERWCUTS",chtitle,10,-0.5,9.5);

     snprintf(chtitle, 255, "Z rejection: number of muons above %.2f GeV", ptThrForZ2_);
     nz2_before_ = theDbe->book1D("NZ2_BEFORECUTS",chtitle,10,-0.5,9.5);
     nz2_after_ = theDbe->book1D("NZ2_AFTERWCUTS",chtitle,10,-0.5,9.5);
  */

  snprintf(chtitle, 255, "Number of jets (%s) above %.2f GeV", jetTag_.label().data(), eJetMin_);
  njets_before_ = theDbe->book1D("NJETS_BEFORECUTS",chtitle,10,-0.5,9.5);
  njets_after_ = theDbe->book1D("NJETS_AFTERWCUTS",chtitle,10,-0.5,9.5);
  njets_afterZ_ = theDbe->book1D("NJETS_AFTERZCUTS",chtitle,10,-0.5,9.5);

  leadingjet_pt_before_ = theDbe->book1D("LEADINGJET_PT_BEFORECUTS","Leading Jet transverse momentum",300,0.,300.);
  leadingjet_pt_after_ = theDbe->book1D("LEADINGJET_PT_AFTERWCUTS","Leading Jet transverse momentum",300,0.,300.);
  leadingjet_pt_afterZ_ = theDbe->book1D("LEADINGJET_PT_AFTERZCUTS","Leading Jet transverse momentum",300,0.,300.);

  leadingjet_eta_before_ = theDbe->book1D("LEADINGJET_ETA_BEFORECUTS","Leading Jet pseudo-rapidity",50,-2.5,2.5);
  leadingjet_eta_after_ = theDbe->book1D("LEADINGJET_ETA_AFTERWCUTS","Leading Jet pseudo-rapidity",50,-2.5,2.5);
  leadingjet_eta_afterZ_ = theDbe->book1D("LEADINGJET_ETA_AFTERZCUTS","Leading Jet pseudo-rapidity",50,-2.5,2.5);


  pt1_afterZ_ = theDbe->book1D("PT1_AFTERZCUTS","Muon transverse momentum (global muon) [GeV]",100,0.,100.);
  eta1_afterZ_ = theDbe->book1D("ETA1_AFTERZCUTS","Muon pseudo-rapidity",50,-2.5,2.5);
  dxy1_afterZ_ = theDbe->book1D("DXY1_AFTERZCUTS","Muon transverse distance to beam spot [cm]",1000,-0.5,0.5);
  goodewkmuon1_afterZ_ = theDbe->book1D("GOODEWKMUON1_AFTERZCUTS","Quality-muon flag",2,-0.5,1.5);

  if (isRelativeIso_) {
    if (isCombinedIso_) {
      iso1_afterZ_ = theDbe->book1D("ISO1_AFTERZCUTS","Relative (combined) isolation variable",100, 0., 1.);
      iso2_afterZ_ = theDbe->book1D("ISO2_AFTERZCUTS","Relative (combined) isolation variable",100, 0., 1.);
    } else {
      iso1_afterZ_ = theDbe->book1D("ISO1_AFTERZCUTS","Relative (tracker) isolation variable",100, 0., 1.);
      iso2_afterZ_ = theDbe->book1D("ISO2_AFTERZCUTS","Relative (tracker) isolation variable",100, 0., 1.);
    }
  } else {
    if (isCombinedIso_) {
      iso1_afterZ_ = theDbe->book1D("ISO1_AFTERZCUTS","Absolute (combined) isolation variable [GeV]",100, 0., 20.);
      iso2_afterZ_ = theDbe->book1D("ISO2_AFTERZCUTS","Absolute (combined) isolation variable [GeV]",100, 0., 20.);
    } else {
      iso1_afterZ_ = theDbe->book1D("ISO1_AFTERZCUTS","Absolute (tracker) isolation variable [GeV]",100, 0., 20.);
      iso2_afterZ_ = theDbe->book1D("ISO2_AFTERZCUTS","Absolute (tracker) isolation variable [GeV]",100, 0., 20.);
    }
  }

  pt2_afterZ_ = theDbe->book1D("PT2_AFTERZCUTS","Muon transverse momentum (global muon) [GeV]",100,0.,100.);
  eta2_afterZ_ = theDbe->book1D("ETA2_AFTERZCUTS","Muon pseudo-rapidity",50,-2.5,2.5);
  dxy2_afterZ_ = theDbe->book1D("DXY2_AFTERZCUTS","Muon transverse distance to beam spot [cm]",1000,-0.5,0.5);
  goodewkmuon2_afterZ_ = theDbe->book1D("GOODEWKMUON2_AFTERZCUTS","Quality-muon flag",2,-0.5,1.5);
  ztrig_afterZ_ = theDbe->book1D("ZTRIG_AFTERZCUTS","Trigger response (boolean of muon triggers)",2,-0.5,1.5); 
  dimuonmass_before_= theDbe->book1D("DIMUONMASS_BEFORECUTS","DiMuonMass (2 globals)",100,0,200);
  dimuonmass_afterZ_= theDbe->book1D("DIMUONMASS_AFTERZCUTS","DiMuonMass (2 globals)",100,0,200);
  npvs_before_ = theDbe->book1D("NPVs_BEFORECUTS","Number of Valid Primary Vertices",30,-0.5,29.5);
  npvs_after_ = theDbe->book1D("NPVs_AFTERZCUTS","Number of Valid Primary Vertices",30,-0.5,29.5);
  npvs_afterZ_ = theDbe->book1D("NPVs_AFTERWCUTS","Number of Valid Primary Vertices",30,-0.5,29.5);
  muoncharge_before_ = theDbe->book1D("MUONCHARGE_BEFORECUTS","Muon Charge",3,-1.5,1.5);
  muoncharge_after_ = theDbe->book1D("MUONCHARGE_AFTERZCUTS","Muon Charge",3,-1.5,1.5);
  muoncharge_afterZ_ = theDbe->book1D("MUONCHARGE_AFTERWCUTS","Muon Charge",3,-1.5,1.5);

  // Adding these to replace the NZ ones (more useful, since they are more general?)     
  nmuons_ = theDbe->book1D("NMuons","Number of muons in the event",10,-0.5,9.5);
  ngoodmuons_ = theDbe->book1D("NGoodMuons","Number of muons passing the quality criteria",10,-0.5,9.5);

  nph_ = theDbe->book1D("nph","Number of photons in the event",20,0.,20.); 
  npfph_ = theDbe->book1D("npfph","Number of PF photons in the event",20,0.,20.); 
  phPt_ = theDbe->book1D("phPt","Photon transverse momentum [GeV]",1000,0.,1000.);
  pfphPt_ = theDbe->book1D("pfphPt","PF Photon transverse momentum [GeV]",1000,0.,1000.); 
  phEta_ = theDbe->book1D("phEta","Photon pseudorapidity",100,-2.5,2.5); 
  pfphEta_ = theDbe->book1D("pfphEta","PF Photon pseudorapidity",100,-2.5,2.5); 

}

Member Data Documentation

Definition at line 103 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 102 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::acopCut_ [private]

Definition at line 52 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 129 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 128 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::dimuonMassMax_ [private]

Definition at line 65 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::dimuonMassMin_ [private]

Definition at line 64 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 118 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 123 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 91 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 90 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::dxyCut_ [private]

Definition at line 41 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::eJetMin_ [private]

Definition at line 67 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 117 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 122 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 89 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 88 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::etaCut_ [private]

Definition at line 59 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 119 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 124 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 93 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 92 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 74 of file EwkMuDQM.h.

Referenced by analyze(), and beginRun().

Definition at line 40 of file EwkMuDQM.h.

bool EwkMuDQM::isCombinedIso_ [private]

Definition at line 49 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 120 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 125 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 95 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 94 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::isoCut03_ [private]

Definition at line 50 of file EwkMuDQM.h.

Referenced by analyze().

bool EwkMuDQM::isRelativeIso_ [private]

Definition at line 48 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 73 of file EwkMuDQM.h.

Referenced by beginRun(), and EwkMuDQM().

Definition at line 34 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 112 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 113 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 111 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 109 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 110 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 108 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 101 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 115 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 100 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::metMax_ [private]

Definition at line 54 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::metMin_ [private]

Definition at line 53 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 33 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 99 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 98 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::mtMax_ [private]

Definition at line 56 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::mtMin_ [private]

Definition at line 55 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 136 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 137 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 135 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

int EwkMuDQM::muonHitsCut_ [private]

Definition at line 45 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 32 of file EwkMuDQM.h.

Referenced by analyze().

unsigned int EwkMuDQM::nall [private]

Definition at line 76 of file EwkMuDQM.h.

Referenced by analyze(), and beginRun().

Definition at line 140 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

unsigned int EwkMuDQM::nhlt [private]

Definition at line 79 of file EwkMuDQM.h.

Referenced by beginRun().

unsigned int EwkMuDQM::niso [private]

Definition at line 78 of file EwkMuDQM.h.

Referenced by beginRun().

int EwkMuDQM::nJetMax_ [private]

Definition at line 68 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 106 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 107 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 105 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

int EwkMuDQM::nMatchesCut_ [private]

Definition at line 46 of file EwkMuDQM.h.

Referenced by analyze().

unsigned int EwkMuDQM::nmet [private]

Definition at line 80 of file EwkMuDQM.h.

Referenced by beginRun().

Definition at line 139 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::normalizedChi2Cut_ [private]

Definition at line 42 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 142 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 143 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

int EwkMuDQM::nPhoMax_ [private]

Definition at line 71 of file EwkMuDQM.h.

Definition at line 132 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 133 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 131 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

unsigned int EwkMuDQM::nrec [private]

Definition at line 77 of file EwkMuDQM.h.

Referenced by beginRun().

unsigned int EwkMuDQM::nsel [private]

Definition at line 81 of file EwkMuDQM.h.

Referenced by beginRun().

unsigned int EwkMuDQM::nz [private]

Definition at line 82 of file EwkMuDQM.h.

Referenced by beginRun().

Definition at line 146 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 36 of file EwkMuDQM.h.

Definition at line 144 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 147 of file EwkMuDQM.h.

Referenced by init_histograms().

Definition at line 35 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 145 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

int EwkMuDQM::pixelHitsCut_ [private]

Definition at line 44 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 116 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 121 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 87 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 86 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

double EwkMuDQM::ptCut_ [private]

Definition at line 58 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::ptThrForPhoton_ [private]

Definition at line 70 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::ptThrForZ1_ [private]

Definition at line 61 of file EwkMuDQM.h.

Referenced by analyze().

double EwkMuDQM::ptThrForZ2_ [private]

Definition at line 62 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 84 of file EwkMuDQM.h.

Referenced by EwkMuDQM(), and init_histograms().

Definition at line 43 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 97 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

Definition at line 96 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().

std::vector<std::string> EwkMuDQM::trigPathNames_ [private]

Definition at line 38 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 31 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 37 of file EwkMuDQM.h.

Referenced by analyze().

Definition at line 127 of file EwkMuDQM.h.

Referenced by analyze(), and init_histograms().