CMS 3D CMS Logo

Classes | Enumerations | Functions

/data/refman/pasoursint/CMSSW_6_1_2_SLHC4_patch1/src/DQM/Physics/src/EwkTauDQM.h File Reference

#include "FWCore/Framework/interface/EDAnalyzer.h"
#include "DQMServices/Core/interface/DQMStore.h"
#include <string>
#include <Math/VectorUtil.h>
#include "FWCore/Framework/interface/Event.h"
#include "FWCore/Framework/interface/EventSetup.h"
#include "FWCore/ParameterSet/interface/ParameterSet.h"
#include "FWCore/Utilities/interface/InputTag.h"
#include "DQMServices/Core/interface/MonitorElement.h"
#include "DataFormats/Candidate/interface/Candidate.h"
#include "DataFormats/EgammaCandidates/interface/GsfElectron.h"
#include "DataFormats/EgammaCandidates/interface/GsfElectronFwd.h"
#include "DataFormats/MuonReco/interface/Muon.h"
#include "DataFormats/MuonReco/interface/MuonFwd.h"
#include "DataFormats/TauReco/interface/PFTau.h"
#include "DataFormats/TauReco/interface/PFTauFwd.h"
#include "DataFormats/VertexReco/interface/Vertex.h"
#include "DataFormats/BeamSpot/interface/BeamSpot.h"

Go to the source code of this file.

Classes

class  EwkElecTauHistManager
class  EwkMuTauHistManager
class  EwkTauDQM

Enumerations

enum  { kAbsoluteIso, kRelativeIso, kUndefinedIso }

Functions

double calcDeltaPhi (double, double)
double calcMt (double, double, double, double)
double calcPzeta (const reco::Candidate::LorentzVector &, const reco::Candidate::LorentzVector &, double, double)
int getIsoMode (const std::string &, int &)
const reco::GsfElectrongetTheElectron (const reco::GsfElectronCollection &, double, double)
const reco::MuongetTheMuon (const reco::MuonCollection &, double, double)
const reco::PFTaugetTheTauJet (const reco::PFTauCollection &, double, double, int &)
double getVertexD0 (const reco::Vertex &, const reco::BeamSpot &)
bool passesElectronId (const reco::GsfElectron &)
bool passesElectronPreId (const reco::GsfElectron &)
template<typename T >
void readEventData (const edm::Event &evt, const edm::InputTag &src, edm::Handle< T > &handle, long &numWarnings, int maxNumWarnings, bool &error, const char *errorMessage)

Enumeration Type Documentation

anonymous enum

Auxiliary functions to compute quantities used by EWK Tau DQM (shared by different channels)

Author:
Joshua Swanson
Version:
Revision:
1.4
Id:
EwkTauDQM.h,v 1.4 2010/10/01 10:05:20 lusito Exp
Enumerator:
kAbsoluteIso 
kRelativeIso 
kUndefinedIso 

Definition at line 370 of file EwkTauDQM.h.


Function Documentation

double calcDeltaPhi ( double  ,
double   
)

Definition at line 972 of file EwkTauDQM.cc.

References SiPixelRawToDigiRegional_cfi::deltaPhi, and Pi.

Referenced by EwkDQM::analyze(), EwkMuTauHistManager::fillHistograms(), and EwkElecTauHistManager::fillHistograms().

{
  double deltaPhi = phi1 - phi2;

  if ( deltaPhi < 0. ) deltaPhi = -deltaPhi;

  if ( deltaPhi > TMath::Pi() ) deltaPhi = 2*TMath::Pi() - deltaPhi;

  return deltaPhi;
}
double calcMt ( double  ,
double  ,
double  ,
double   
)

Definition at line 983 of file EwkTauDQM.cc.

Referenced by EwkMuTauHistManager::fillHistograms(), and EwkElecTauHistManager::fillHistograms().

{
  double pt1 = TMath::Sqrt(px1*px1 + py1*py1);
  double pt2 = TMath::Sqrt(px2*px2 + py2*py2);

  double p1Dotp2 = px1*px2 + py1*py2;
  double cosAlpha = p1Dotp2/(pt1*pt2);

  return TMath::Sqrt(2*pt1*pt2*(1 - cosAlpha));
}
double calcPzeta ( const reco::Candidate::LorentzVector ,
const reco::Candidate::LorentzVector ,
double  ,
double   
)

Definition at line 994 of file EwkTauDQM.cc.

References funct::cos(), and funct::sin().

{
  double cosPhi1 = cos(p1.phi());
  double sinPhi1 = sin(p1.phi());
  double cosPhi2 = cos(p2.phi());
  double sinPhi2 = sin(p2.phi());
  double zetaX = cosPhi1 + cosPhi2;
  double zetaY = sinPhi1 + sinPhi2;
  double zetaR = TMath::Sqrt(zetaX*zetaX + zetaY*zetaY);
  if ( zetaR > 0. ) {
    zetaX /= zetaR;
    zetaY /= zetaR;
  }

  double pxVis = p1.px() + p2.px();
  double pyVis = p1.py() + p2.py();
  double pZetaVis = pxVis*zetaX + pyVis*zetaY;

  double px = pxVis + pxMEt;
  double py = pyVis + pyMEt;
  double pZeta = px*zetaX + py*zetaY;

  return pZeta - 1.5*pZetaVis;
}
int getIsoMode ( const std::string &  ,
int &   
)

Definition at line 953 of file EwkTauDQM.cc.

References kAbsoluteIso, kRelativeIso, and kUndefinedIso.

Referenced by EwkElecTauHistManager::EwkElecTauHistManager(), and EwkMuTauHistManager::EwkMuTauHistManager().

{
  int isoMode_int;
  if ( isoMode_string == "absoluteIso" ) {
    isoMode_int = kAbsoluteIso;
  } else if ( isoMode_string == "relativeIso" ) {
    isoMode_int = kRelativeIso;
  } else { 
    edm::LogError ("getIsoMode") << " Failed to decode isoMode string = " << isoMode_string << " !!";
    isoMode_int = kUndefinedIso;
    error = 1;
  }
  return isoMode_int;
}
const reco::GsfElectron* getTheElectron ( const reco::GsfElectronCollection ,
double  ,
double   
)

Definition at line 1056 of file EwkTauDQM.cc.

References metsig::electron, passesElectronPreId(), and reco::LeafCandidate::pt().

Referenced by EwkElecTauHistManager::fillHistograms().

{
  const reco::GsfElectron* theElectron = 0;
  
  for ( reco::GsfElectronCollection::const_iterator electron = electrons.begin();
        electron != electrons.end(); ++electron ) {
    if ( TMath::Abs(electron->eta()) < electronEtaCut && electron->pt() > electronPtCut && passesElectronPreId(*electron) ) {
      if ( theElectron == 0 || electron->pt() > theElectron->pt() ) theElectron = &(*electron);
    }
  }
  
  return theElectron;
}
const reco::Muon* getTheMuon ( const reco::MuonCollection ,
double  ,
double   
)

Definition at line 1073 of file EwkTauDQM.cc.

References metsig::muon, and reco::LeafCandidate::pt().

Referenced by EwkMuTauHistManager::fillHistograms().

{
  const reco::Muon* theMuon = 0;

  for ( reco::MuonCollection::const_iterator muon = muons.begin();
        muon != muons.end(); ++muon ) {
    if ( TMath::Abs(muon->eta()) < muonEtaCut && muon->pt() > muonPtCut ) {
      if ( theMuon == 0 || muon->pt() > theMuon->pt() ) theMuon = &(*muon);
    }
  }

  return theMuon;
}
const reco::PFTau* getTheTauJet ( const reco::PFTauCollection ,
double  ,
double  ,
int &   
)

Definition at line 1087 of file EwkTauDQM.cc.

References reco::LeafCandidate::eta(), reco::LeafCandidate::pt(), and reco::Candidate::size.

Referenced by EwkMuTauHistManager::fillHistograms(), and EwkElecTauHistManager::fillHistograms().

{
  const reco::PFTau* theTauJet = 0;
  theTauJetIndex = -1;

  int numTauJets = tauJets.size();
  for ( int iTauJet = 0; iTauJet < numTauJets; ++iTauJet ) {
    const reco::PFTau& tauJet = tauJets.at(iTauJet);

    if ( fabs(tauJet.eta()) < tauJetEtaCut && tauJet.pt() > tauJetPtCut ) {
      if ( theTauJet == 0 || tauJet.pt() > theTauJet->pt() ) {
        theTauJet = &tauJet;
        theTauJetIndex = iTauJet;
      }
    }
  }

  return theTauJet;
}
double getVertexD0 ( const reco::Vertex ,
const reco::BeamSpot  
)

Definition at line 1111 of file EwkTauDQM.cc.

References reco::Vertex::x(), reco::BeamSpot::x0(), reco::Vertex::y(), and reco::BeamSpot::y0().

{
  double dX = vertex.x() - beamSpot.x0();
  double dY = vertex.y() - beamSpot.y0();
  return TMath::Sqrt(dX*dX + dY*dY);
}
bool passesElectronId ( const reco::GsfElectron )

Definition at line 1035 of file EwkTauDQM.cc.

References reco::GsfElectron::deltaEtaSuperClusterTrackAtVtx(), reco::GsfElectron::deltaPhiSuperClusterTrackAtVtx(), reco::LeafCandidate::eta(), reco::GsfElectron::hcalOverEcal(), passesElectronPreId(), and reco::GsfElectron::sigmaEtaEta().

Referenced by EwkElecTauHistManager::fillHistograms().

{
  if ( passesElectronPreId(electron) &&
       ((TMath::Abs(electron.eta()) > 1.566 && // electron reconstructed in ECAL endcap
         electron.sigmaEtaEta() < 0.03 && electron.hcalOverEcal() < 0.05 && 
         TMath::Abs(electron.deltaEtaSuperClusterTrackAtVtx()) < 0.009 && 
         TMath::Abs(electron.deltaPhiSuperClusterTrackAtVtx()) < 0.7 ) ||
        (TMath::Abs(electron.eta()) < 1.479 && // electron reconstructed in ECAL barrel
         electron.sigmaEtaEta() < 0.01 && electron.hcalOverEcal() < 0.12 && 
         TMath::Abs(electron.deltaEtaSuperClusterTrackAtVtx()) < 0.007 && 
         TMath::Abs(electron.deltaPhiSuperClusterTrackAtVtx()) < 0.8)) ) {
    return true;
  } else {
    return false;
  }
}
bool passesElectronPreId ( const reco::GsfElectron )

Definition at line 1023 of file EwkTauDQM.cc.

References reco::GsfElectron::deltaEtaSuperClusterTrackAtVtx(), reco::GsfElectron::deltaPhiSuperClusterTrackAtVtx(), reco::LeafCandidate::eta(), and reco::GsfElectron::sigmaIetaIeta().

Referenced by getTheElectron(), and passesElectronId().

{
  if ( (TMath::Abs(electron.eta()) < 1.479 || TMath::Abs(electron.eta()) > 1.566) && // cut ECAL barrel/endcap crack
       electron.deltaPhiSuperClusterTrackAtVtx() < 0.8 &&
       electron.deltaEtaSuperClusterTrackAtVtx() < 0.01 &&
       electron.sigmaIetaIeta() < 0.03 ) {
    return true;
  } else {
    return false;
  }
}
template<typename T >
void readEventData ( const edm::Event evt,
const edm::InputTag src,
edm::Handle< T > &  handle,
long &  numWarnings,
int  maxNumWarnings,
bool &  error,
const char *  errorMessage 
)

Definition at line 373 of file EwkTauDQM.h.

References edm::Event::getByLabel().

Referenced by EwkMuTauHistManager::fillHistograms(), and EwkElecTauHistManager::fillHistograms().

{
  if ( !evt.getByLabel(src, handle) ) {
    if ( numWarnings < maxNumWarnings || maxNumWarnings == -1 )
      edm::LogWarning ("readEventData") << errorMessage << " !!";
    ++numWarnings;
    error = true;
  }
}