CMS 3D CMS Logo

Public Member Functions | Private Member Functions | Private Attributes

TkAlCaRecoMonitor Class Reference

#include <DQM/TrackerMonitorTrack/src/TkAlCaRecoMonitor.cc>

Inheritance diagram for TkAlCaRecoMonitor:
edm::EDAnalyzer

List of all members.

Public Member Functions

virtual void analyze (const edm::Event &, const edm::EventSetup &)
virtual void beginJob ()
virtual void endJob (void)
 TkAlCaRecoMonitor (const edm::ParameterSet &)
 ~TkAlCaRecoMonitor ()

Private Member Functions

void fillHitmaps (const reco::Track &track, const TrackerGeometry &geometry)
void fillRawIdMap (const TrackerGeometry &geometry)

Private Attributes

MonitorElementAlCaRecoTrackEfficiency_
std::map< int, int > binByRawId_
edm::ParameterSet conf_
double daughterMass_
DQMStoredqmStore_
bool fillInvariantMass_
bool fillRawIdMap_
MonitorElementHits_perDetId_
MonitorElementHits_XvsY_
MonitorElementHits_ZvsR_
MonitorElementinvariantMass_
MonitorElementjetPt_
double maxJetPt_
MonitorElementminJetDeltaR_
MonitorElementminTrackDeltaR_
edm::InputTag referenceTrackProducer_
bool runsOnReco_
MonitorElementsumCharge_
MonitorElementTrackCurvature_
edm::InputTag trackProducer_
MonitorElementTrackPtNegative_
MonitorElementTrackPtPositive_
MonitorElementTrackQuality_
bool useSignedR_

Detailed Description

Monitoring special quantities related to Tracker Alignment AlCaReco Production.

Definition at line 28 of file TkAlCaRecoMonitor.h.


Constructor & Destructor Documentation

TkAlCaRecoMonitor::TkAlCaRecoMonitor ( const edm::ParameterSet iConfig) [explicit]
TkAlCaRecoMonitor::~TkAlCaRecoMonitor ( )

Definition at line 33 of file TkAlCaRecoMonitor.cc.

{ } 

Member Function Documentation

void TkAlCaRecoMonitor::analyze ( const edm::Event iEvent,
const edm::EventSetup iSetup 
) [virtual]

Implements edm::EDAnalyzer.

Definition at line 184 of file TkAlCaRecoMonitor.cc.

References AlCaRecoTrackEfficiency_, binByRawId_, conf_, daughterMass_, deltaR(), ExpressReco_HICollisions_FallBack::e, MonitorElement::Fill(), fillHitmaps(), fillInvariantMass_, fillRawIdMap(), fillRawIdMap_, geometry, edm::EventSetup::get(), edm::Event::getByLabel(), edm::ParameterSet::getParameter(), i, invariantMass_, edm::ESHandleBase::isValid(), edm::HandleBase::isValid(), jetPt_, analyzePatCleaning_cfg::jets, maxJetPt_, minJetDeltaR_, minTrackDeltaR_, reco::TrackBase::qualitySize, referenceTrackProducer_, runsOnReco_, mathSSE::sqrt(), sumCharge_, ExpressReco_HICollisions_FallBack::track, ExpressReco_HICollisions_FallBack::trackCollection, TrackCurvature_, trackProducer_, TrackPtNegative_, TrackPtPositive_, and TrackQuality_.

                                                                                   {

  edm::Handle<reco::TrackCollection> trackCollection;
  iEvent.getByLabel(trackProducer_, trackCollection);
  if (!trackCollection.isValid()){
    edm::LogError("Alignment")<<"invalid trackcollection encountered!";
    return;
  }

  edm::Handle<reco::TrackCollection> referenceTrackCollection;
  iEvent.getByLabel(referenceTrackProducer_, referenceTrackCollection);
  if (!trackCollection.isValid()){
    edm::LogError("Alignment")<<"invalid reference track-collection encountered!";
    return;
  }

  edm::ESHandle<TrackerGeometry> geometry;
  iSetup.get<TrackerDigiGeometryRecord>().get(geometry);
  if(! geometry.isValid()){
    edm::LogError("Alignment")<<"invalid geometry found in event setup!";
  }

  edm::ESHandle<MagneticField> magneticField;
  iSetup.get<IdealMagneticFieldRecord>().get(magneticField);
  if (!magneticField.isValid()){
    edm::LogError("Alignment")<<"invalid magnetic field configuration encountered!";
    return;
  }

  edm::Handle<reco::CaloJetCollection> jets;
  if(runsOnReco_){
    edm::InputTag jetCollection = conf_.getParameter<edm::InputTag>("CaloJetCollection");
    iEvent.getByLabel(jetCollection, jets);
    if(! jets.isValid()){
      edm::LogError("Alignment")<<"no jet collection found in event!";
    }
  }
  // fill only once - not yet in beginJob since no access to geometry
  if (fillRawIdMap_ && binByRawId_.empty()) this->fillRawIdMap(*geometry);

  AlCaRecoTrackEfficiency_->Fill( static_cast<double>((*trackCollection).size()) / (*referenceTrackCollection).size() );
  
  double sumOfCharges = 0;
  for( reco::TrackCollection::const_iterator track = (*trackCollection).begin(); track < (*trackCollection).end(); ++track ){
    double dR = 0;  
    if(runsOnReco_){
      double minJetDeltaR = 10; // some number > 2pi
      for(reco::CaloJetCollection::const_iterator itJet = jets->begin(); itJet != jets->end() ; ++itJet) {
        jetPt_->Fill( (*itJet).pt() );
        dR = deltaR((*track),(*itJet));
        if((*itJet).pt() > maxJetPt_ && dR < minJetDeltaR)
          minJetDeltaR = dR; 
        
        //edm::LogInfo("Alignment") <<">  isolated: "<< isolated << " jetPt "<< (*itJet).pt() <<" deltaR: "<< deltaR(*(*it),(*itJet)) ;
      }
      minJetDeltaR_->Fill( minJetDeltaR );
    }
    
    double minTrackDeltaR = 10; // some number > 2pi
    for( reco::TrackCollection::const_iterator track2 = (*trackCollection).begin(); track2 < (*trackCollection).end(); ++track2 ){
      dR = deltaR((*track),(*track2));
      if(dR < minTrackDeltaR && dR > 1e-6)
        minTrackDeltaR = dR;
    }

    for ( int i = 0; i<reco::TrackBase::qualitySize; ++i){
      if( (*track).quality( reco::TrackBase::TrackQuality(i) ) ){
        TrackQuality_->Fill( i );
      }
    }
    
    GlobalPoint gPoint((*track).vx(), (*track).vy(), (*track).vz());
    double B = magneticField->inTesla(gPoint).z();
    double curv = -(*track).charge()*0.002998*B/(*track).pt();
    TrackCurvature_->Fill( curv );

    if( (*track).charge() > 0 )
      TrackPtPositive_->Fill( (*track).pt() );
    if( (*track).charge() < 0 )
      TrackPtNegative_->Fill( (*track).pt() );

    minTrackDeltaR_->Fill( minTrackDeltaR );
    fillHitmaps( *track, *geometry );
    sumOfCharges += (*track).charge();
  }

  sumCharge_->Fill( sumOfCharges );

  if(fillInvariantMass_){
    if((*trackCollection).size() == 2){
      TLorentzVector track0((*trackCollection).at(0).px(),(*trackCollection).at(0).py(),(*trackCollection).at(0).pz(),
                            sqrt(((*trackCollection).at(0).p()*(*trackCollection).at(0).p())+daughterMass_*daughterMass_));
      TLorentzVector track1((*trackCollection).at(1).px(),(*trackCollection).at(1).py(),(*trackCollection).at(1).pz(),
                            sqrt(((*trackCollection).at(1).p()*(*trackCollection).at(1).p())+daughterMass_*daughterMass_));
      TLorentzVector mother = track0+track1;
      
      invariantMass_->Fill( mother.M() );
    }else{
      edm::LogInfo("Alignment")<<"wrong number of tracks trackcollection encountered: "<<(*trackCollection).size();
    }
  }
}
void TkAlCaRecoMonitor::beginJob ( void  ) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 35 of file TkAlCaRecoMonitor.cc.

References AlCaRecoTrackEfficiency_, ExpressReco_HICollisions_FallBack::AlgoName, DQMStore::book1D(), DQMStore::book2D(), conf_, daughterMass_, dqmStore_, fillInvariantMass_, fillRawIdMap_, edm::ParameterSet::getParameter(), MonitorElement::getTH1(), Hits_perDetId_, Hits_XvsY_, Hits_ZvsR_, i, invariantMass_, jetPt_, ExpressReco_HICollisions_FallBack::JetPtBin, ExpressReco_HICollisions_FallBack::JetPtMax, ExpressReco_HICollisions_FallBack::JetPtMin, edm::InputTag::label(), ExpressReco_HICollisions_FallBack::MassBin, ExpressReco_HICollisions_FallBack::MassMax, ExpressReco_HICollisions_FallBack::MassMin, maxJetPt_, minJetDeltaR_, ExpressReco_HICollisions_FallBack::MinJetDeltaRBin, ExpressReco_HICollisions_FallBack::MinJetDeltaRMax, ExpressReco_HICollisions_FallBack::MinJetDeltaRMin, minTrackDeltaR_, ExpressReco_HICollisions_FallBack::MinTrackDeltaRBin, ExpressReco_HICollisions_FallBack::MinTrackDeltaRMax, ExpressReco_HICollisions_FallBack::MinTrackDeltaRMin, NULL, reco::TrackBase::qualityName(), reco::TrackBase::qualitySize, referenceTrackProducer_, runsOnReco_, MonitorElement::setAxisTitle(), DQMStore::setCurrentFolder(), sumCharge_, ExpressReco_HICollisions_FallBack::SumChargeBin, ExpressReco_HICollisions_FallBack::SumChargeMax, ExpressReco_HICollisions_FallBack::SumChargeMin, TrackCurvature_, ExpressReco_HICollisions_FallBack::TrackCurvatureBin, ExpressReco_HICollisions_FallBack::TrackCurvatureMax, ExpressReco_HICollisions_FallBack::TrackCurvatureMin, ExpressReco_HICollisions_FallBack::TrackEfficiencyBin, ExpressReco_HICollisions_FallBack::TrackEfficiencyMax, ExpressReco_HICollisions_FallBack::TrackEfficiencyMin, trackProducer_, TrackPtNegative_, TrackPtPositive_, TrackQuality_, and useSignedR_.

                                 {

  std::string histname;  //for naming the histograms according to algorithm used

  trackProducer_ = conf_.getParameter<edm::InputTag>("TrackProducer");
  referenceTrackProducer_ = conf_.getParameter<edm::InputTag>("ReferenceTrackProducer");

  std::string AlgoName     = conf_.getParameter<std::string>("AlgoName");
  std::string MEFolderName = conf_.getParameter<std::string>("FolderName"); 

  daughterMass_ = conf_.getParameter<double>("daughterMass");

  maxJetPt_ = conf_.getParameter<double>("maxJetPt");

  dqmStore_->setCurrentFolder(MEFolderName+"/TkAlignmentSpecific");
  fillInvariantMass_ = conf_.getParameter<bool>("fillInvariantMass");
  runsOnReco_ = conf_.getParameter<bool>("runsOnReco");
  useSignedR_ = conf_.getParameter<bool>("useSignedR");
  fillRawIdMap_ = conf_.getParameter<bool>("fillRawIdMap");

  //    
  unsigned int MassBin = conf_.getParameter<unsigned int>("MassBin");
  double MassMin = conf_.getParameter<double>("MassMin");
  double MassMax = conf_.getParameter<double>("MassMax");

  if(fillInvariantMass_){
    histname = "InvariantMass_";
    invariantMass_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, MassBin, MassMin, MassMax);
    invariantMass_->setAxisTitle("invariant Mass / GeV");
  }else{
    invariantMass_ = 0;
  }

  unsigned int TrackPtPositiveBin = conf_.getParameter<unsigned int>("TrackPtBin");
  double TrackPtPositiveMin = conf_.getParameter<double>("TrackPtMin");
  double TrackPtPositiveMax = conf_.getParameter<double>("TrackPtMax");

  histname = "TrackPtPositive_";
  TrackPtPositive_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, TrackPtPositiveBin, TrackPtPositiveMin, TrackPtPositiveMax);
  TrackPtPositive_->setAxisTitle("p_{T} of tracks charge > 0");

  unsigned int TrackPtNegativeBin = conf_.getParameter<unsigned int>("TrackPtBin");
  double TrackPtNegativeMin = conf_.getParameter<double>("TrackPtMin");
  double TrackPtNegativeMax = conf_.getParameter<double>("TrackPtMax");

  histname = "TrackPtNegative_";
  TrackPtNegative_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, TrackPtNegativeBin, TrackPtNegativeMin, TrackPtNegativeMax);
  TrackPtNegative_->setAxisTitle("p_{T} of tracks charge < 0");

  histname = "TrackQuality_";
  TrackQuality_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, 
                                 reco::TrackBase::qualitySize, -0.5, reco::TrackBase::qualitySize-0.5);
  TrackQuality_->setAxisTitle("quality");
  for ( int i = 0; i<reco::TrackBase::qualitySize; ++i){
    TrackQuality_->getTH1()->GetXaxis()->SetBinLabel(i+1,
                    reco::TrackBase::qualityName( reco::TrackBase::TrackQuality(i) ).c_str());
  } 

  unsigned int SumChargeBin = conf_.getParameter<unsigned int>("SumChargeBin");
  double SumChargeMin = conf_.getParameter<double>("SumChargeMin");
  double SumChargeMax = conf_.getParameter<double>("SumChargeMax");

  histname = "SumCharge_";
  sumCharge_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, SumChargeBin, SumChargeMin, SumChargeMax);
  sumCharge_->setAxisTitle("#SigmaCharge");

  unsigned int TrackCurvatureBin = conf_.getParameter<unsigned int>("TrackCurvatureBin");
  double TrackCurvatureMin = conf_.getParameter<double>("TrackCurvatureMin");
  double TrackCurvatureMax = conf_.getParameter<double>("TrackCurvatureMax");
  
  histname = "TrackCurvature_";
  TrackCurvature_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, TrackCurvatureBin, TrackCurvatureMin, TrackCurvatureMax);
  TrackCurvature_->setAxisTitle("#kappa track");

  if( runsOnReco_ ){

    unsigned int    JetPtBin = conf_.getParameter<unsigned int>("JetPtBin");
    double JetPtMin = conf_.getParameter<double>("JetPtMin");
    double JetPtMax = conf_.getParameter<double>("JetPtMax");

    histname = "JetPt_";
    jetPt_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, JetPtBin, JetPtMin, JetPtMax);
    jetPt_->setAxisTitle("jet p_{T} / GeV");

    unsigned int    MinJetDeltaRBin = conf_.getParameter<unsigned int>("MinJetDeltaRBin");
    double MinJetDeltaRMin = conf_.getParameter<double>("MinJetDeltaRMin");
    double MinJetDeltaRMax = conf_.getParameter<double>("MinJetDeltaRMax");

    histname = "MinJetDeltaR_";
    minJetDeltaR_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, MinJetDeltaRBin, MinJetDeltaRMin, MinJetDeltaRMax);
    minJetDeltaR_->setAxisTitle("minimal Jet #DeltaR / rad");
  }else{
    jetPt_ = NULL;
    minJetDeltaR_ = NULL;
  }

  unsigned int    MinTrackDeltaRBin = conf_.getParameter<unsigned int>("MinTrackDeltaRBin");
  double MinTrackDeltaRMin = conf_.getParameter<double>("MinTrackDeltaRMin");
  double MinTrackDeltaRMax = conf_.getParameter<double>("MinTrackDeltaRMax");

  histname = "MinTrackDeltaR_";
  minTrackDeltaR_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, MinTrackDeltaRBin, MinTrackDeltaRMin, MinTrackDeltaRMax);
  minTrackDeltaR_->setAxisTitle("minimal Track #DeltaR / rad");

  unsigned int TrackEfficiencyBin = conf_.getParameter<unsigned int>("TrackEfficiencyBin");
  double TrackEfficiencyMin = conf_.getParameter<double>("TrackEfficiencyMin");
  double TrackEfficiencyMax = conf_.getParameter<double>("TrackEfficiencyMax");

  histname = "AlCaRecoTrackEfficiency_";
  AlCaRecoTrackEfficiency_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, TrackEfficiencyBin, TrackEfficiencyMin, TrackEfficiencyMax);
  AlCaRecoTrackEfficiency_->setAxisTitle("n("+trackProducer_.label()+") / n("+referenceTrackProducer_.label()+")");

  int zBin =  conf_.getParameter<unsigned int>("HitMapsZBin"); //300
  double zMax = conf_.getParameter<double>("HitMapZMax"); //300.0; //cm
  
  int rBin = conf_.getParameter<unsigned int>("HitMapsRBin");//120;
  double rMax = conf_.getParameter<double>("HitMapRMax"); //120.0; //cm

  histname = "Hits_ZvsR_";
  double rMin = 0.0;
  if( useSignedR_ )
    rMin = -rMax;

  Hits_ZvsR_ = dqmStore_->book2D(histname+AlgoName, histname+AlgoName, zBin, -zMax, zMax, rBin, rMin, rMax);

  histname = "Hits_XvsY_";
  Hits_XvsY_ = dqmStore_->book2D(histname+AlgoName, histname+AlgoName, rBin, -rMax, rMax, rBin, -rMax, rMax);

  if( fillRawIdMap_){
    histname = "Hits_perDetId_";
    
    //leads to differences in axsis between samples??
    //int nModules = binByRawId_.size();
    //Hits_perDetId_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, nModules, static_cast<double>(nModules) -0.5, static_cast<double>(nModules) -0.5);
    Hits_perDetId_ = dqmStore_->book1D(histname+AlgoName, histname+AlgoName, 16601,-0.5, 16600.5 );
    Hits_perDetId_->setAxisTitle("rawId Bins");

    //  std::stringstream binLabel;
    //  for( std::map<int,int>::iterator it = binByRawId_.begin(); it != binByRawId_.end(); ++it ){
    //    binLabel.str() = "";
    //    binLabel << (*it).first;
    //    Hits_perDetId_->getTH1()->GetXaxis()->SetBinLabel( (*it).second +1, binLabel.str().c_str());
    //  }
  }
}
void TkAlCaRecoMonitor::endJob ( void  ) [virtual]

Reimplemented from edm::EDAnalyzer.

Definition at line 329 of file TkAlCaRecoMonitor.cc.

References conf_, dqmStore_, edm::ParameterSet::getParameter(), ExpressReco_HICollisions_FallBack::outputFileName, and DQMStore::save().

                                   {
  bool outputMEsInRootFile = conf_.getParameter<bool>("OutputMEsInRootFile");
  std::string outputFileName = conf_.getParameter<std::string>("OutputFileName");
  if(outputMEsInRootFile){
    //dqmStore_->showDirStructure();
    dqmStore_->save(outputFileName);
  }
}
void TkAlCaRecoMonitor::fillHitmaps ( const reco::Track track,
const TrackerGeometry geometry 
) [private]

Definition at line 287 of file TkAlCaRecoMonitor.cc.

References binByRawId_, MonitorElement::Fill(), fillRawIdMap_, TrackingRecHit::geographicalId(), Hits_perDetId_, Hits_XvsY_, Hits_ZvsR_, TrackerGeometry::idToDet(), csvReporter::r, reco::Track::recHitsBegin(), reco::Track::recHitsEnd(), mathSSE::sqrt(), and useSignedR_.

Referenced by analyze().

{
  for (trackingRecHit_iterator iHit = track.recHitsBegin(); iHit != track.recHitsEnd(); ++iHit) {    
    if( (*iHit)->isValid() ){
      const TrackingRecHit *hit = (*iHit).get();
      const DetId geoId(hit->geographicalId());
      const GeomDet* gd = geometry.idToDet(geoId);
      // since 2_1_X local hit positions are transient. taking center of the hit module for now.
      // The alternative would be the coarse estimation or a refit.
      //const GlobalPoint globP( gd->toGlobal( hit->localPosition() ) );
      const GlobalPoint globP( gd->toGlobal( Local3DPoint(0.,0.,0.) ) );
      double r = sqrt( globP.x()*globP.x() + globP.y()*globP.y() );
      if( useSignedR_ )
        r*= globP.y() / fabs( globP.y() );

      Hits_ZvsR_->Fill( globP.z(), r );
      Hits_XvsY_->Fill( globP.x(), globP.y() );

      if( fillRawIdMap_)
         Hits_perDetId_->Fill( binByRawId_[ geoId.rawId() ]);  
    }
  }
}
void TkAlCaRecoMonitor::fillRawIdMap ( const TrackerGeometry geometry) [private]

Definition at line 311 of file TkAlCaRecoMonitor.cc.

References binByRawId_, TrackerGeometry::detUnitIds(), i, and python::multivaluedict::sort().

Referenced by analyze().

{
  std::vector<int> sortedRawIds;
  for (std::vector<DetId>::const_iterator iDetId = geometry.detUnitIds().begin();
       iDetId != geometry.detUnitIds().end(); ++iDetId) {
    sortedRawIds.push_back((*iDetId).rawId());
  }
  std::sort(sortedRawIds.begin(), sortedRawIds.end());
  
  int i = 0;
  for (std::vector<int>::iterator iRawId = sortedRawIds.begin();
       iRawId != sortedRawIds.end(); ++iRawId){
    binByRawId_[*iRawId] = i;
    ++i;
  }
}

Member Data Documentation

Definition at line 54 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

std::map<int,int> TkAlCaRecoMonitor::binByRawId_ [private]

Definition at line 71 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), fillHitmaps(), and fillRawIdMap().

Definition at line 43 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), beginJob(), endJob(), and TkAlCaRecoMonitor().

Definition at line 70 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 42 of file TkAlCaRecoMonitor.h.

Referenced by beginJob(), endJob(), and TkAlCaRecoMonitor().

Definition at line 63 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 64 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), beginJob(), and fillHitmaps().

Definition at line 55 of file TkAlCaRecoMonitor.h.

Referenced by beginJob(), and fillHitmaps().

Definition at line 61 of file TkAlCaRecoMonitor.h.

Referenced by beginJob(), and fillHitmaps().

Definition at line 60 of file TkAlCaRecoMonitor.h.

Referenced by beginJob(), and fillHitmaps().

Definition at line 48 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 51 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

double TkAlCaRecoMonitor::maxJetPt_ [private]

Definition at line 45 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 52 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 53 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 69 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 65 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 49 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 58 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 68 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 57 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 56 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 50 of file TkAlCaRecoMonitor.h.

Referenced by analyze(), and beginJob().

Definition at line 66 of file TkAlCaRecoMonitor.h.

Referenced by beginJob(), and fillHitmaps().