114 #include <CLHEP/Vector/LorentzVector.h>
148 #include "HepPDT/defs.h"
149 #include "HepPDT/TableBuilder.hh"
150 #include "HepPDT/ParticleDataTable.hh"
152 #include "HepMC/GenParticle.h"
153 #include "HepMC/GenEvent.h"
172 #include "valgrind/callgrind.h"
214 template <
typename T>
232 template <
typename T>
315 template <
typename T>
317 std::vector<MuScleFitMuon>
muons;
318 typename std::vector<T>::const_iterator
track;
319 for (track = tracks.begin(); track != tracks.end(); ++
track) {
333 std::cout <<
"track charge: " << track->charge() << std::endl;
335 Double_t hitsTk = track->innerTrack()->hitPattern().numberOfValidTrackerHits();
336 Double_t hitsMuon = track->innerTrack()->hitPattern().numberOfValidMuonHits();
337 Double_t ptError = track->innerTrack()->ptError();
340 std::cout <<
"[MuScleFit::fillMuonCollection]" << std::endl;
346 muons.push_back(
muon);
351 template <
typename T>
357 tracks.push_back(*(muon->globalTrack()));
359 tracks.push_back(*(muon->outerTrack()));
361 tracks.push_back(*(muon->innerTrack()));
363 else if (
theMuonType_ == 10 && !(muon->isStandAloneMuon()))
364 tracks.push_back(*(muon->innerTrack()));
366 tracks.push_back(*(muon->innerTrack()));
368 tracks.push_back(*(muon->innerTrack()));
376 std::cout <<
"[MuScleFit]: Constructor" << std::endl;
378 if ((theMuonType_ < -4 || theMuonType_ > 5) &&
theMuonType_ < 10) {
379 std::cout <<
"[MuScleFit]: Unknown muon type! Aborting." << std::endl;
423 int resolFitType = pset.
getParameter<
int>(
"ResolFitType");
510 if (MuScleFitUtils::SmearType > 0) {
511 std::cout <<
"[MuScleFit-Constructor]: Generating random values for smearing" << std::endl;
512 TF1
G(
"G",
"[0]*exp(-0.5*pow(x,2))", -5., 5.);
514 G.SetParameter(0, norm);
515 for (
int i = 0;
i < 10000;
i++) {
516 for (
int j = 0;
j < 7;
j++) {
537 MuScleFitUtils::rapidityBinsForZ_ =
false;
574 pset.
getParameter<std::vector<double> >(
"LeftWindowBorder"),
575 pset.
getParameter<std::vector<double> >(
"RightWindowBorder"),
588 std::cout <<
"End of MuScleFit constructor" << std::endl;
605 std::cout <<
"[MuScleFit]: Destructor" << std::endl;
611 std::cout <<
"Saving muon pairs to root tree" << std::endl;
616 std::vector<MuonPair>::const_iterator it =
muonPairs_.begin();
617 std::cout <<
"[MuScleFit::~MuScleFit] (Destructor)" << std::endl;
619 std::cout <<
" Debugging pairs that are going to be written to file" << std::endl;
620 std::cout <<
" muon1 = " << it->mu1 << std::endl;
621 std::cout <<
" muon2 = " << it->mu2 << std::endl;
644 std::cout <<
"[MuScleFit]: beginOfJob" << std::endl;
651 std::cout <<
"[MuScleFit]: beginOfJob" << std::endl;
656 std::stringstream
ss;
662 theFiles_.push_back(
new TFile(rootFileName.c_str(),
"RECREATE"));
666 std::cout <<
"[MuScleFit]: Root file created" << std::endl;
668 std::cout <<
"creating plotter" << std::endl;
677 std::cout <<
"[MuScleFit]: endOfJob" << std::endl;
684 std::cout <<
"[MuScleFit]: Starting loop # " << iLoop << std::endl;
710 unsigned int iFastLoop = 1;
725 std::cout <<
"Starting fast loop number " << iFastLoop << std::endl;
735 if (
iev % 50000 == 0) {
736 std::cout <<
"Fast looping on event number " <<
iev << std::endl;
741 std::cout <<
"End of fast loop number " << iFastLoop <<
". Ran on " <<
iev <<
" events" << std::endl;
762 std::cout <<
"Ending loop # " << iLoop << std::endl;
772 TDirectory* likelihoodDir =
theFiles_[iLoop]->mkdir(
"likelihood");
792 bool isFired =
false;
797 isFired = triggerResults->accept();
799 std::cout <<
"Trigger " << isFired << std::endl;
807 for (
unsigned i = 0;
i < triggerNames.
size();
i++) {
811 for (
unsigned int ipath = 0; ipath <
triggerPath_.size(); ipath++) {
812 if (hltName.find(
triggerPath_[ipath]) != std::string::npos) {
813 unsigned int triggerIndex(hltConfig.
triggerIndex(hltName));
816 if (triggerIndex < triggerResults->
size()) {
817 isFired = triggerResults->accept(triggerIndex);
832 CALLGRIND_START_INSTRUMENTATION;
836 std::cout <<
"[MuScleFit-duringLoop]: loopCounter = " <<
loopCounter <<
" Run: " <<
event.id().run()
837 <<
" Event: " <<
event.id().event() << std::endl;
848 std::cout <<
"Reading from edm event" << std::endl;
858 CALLGRIND_STOP_INSTRUMENTATION;
859 CALLGRIND_DUMP_STATS;
867 std::vector<MuScleFitMuon>
muons;
872 std::cout <<
"[MuScleFit::selectMuons] Debugging muons collections after call to muonSelector_->selectMuons"
875 for (std::vector<MuScleFitMuon>::const_iterator it = muons.begin(); it < muons.end(); ++it) {
876 std::cout <<
" - muon n. " << iMu <<
" = " << (*it) << std::endl;
887 std::cout << std::setprecision(9) <<
"Pt after findbestrecores: " << (recMuFromBestRes.first).Pt() <<
" "
888 << (recMuFromBestRes.second).Pt() << std::endl;
892 recMu1 = recMuFromBestRes.first.p4();
893 recMu2 = recMuFromBestRes.second.p4();
915 Int_t the_numPUvtx(0);
916 Float_t the_TrueNumInteractions(0);
923 std::vector<PileupSummaryInfo>::const_iterator PVI;
924 for (PVI = puInfo->begin(); PVI != puInfo->end(); ++PVI) {
925 int BX = PVI->getBunchCrossing();
927 the_TrueNumInteractions = PVI->getTrueNumInteractions();
928 the_numPUvtx = PVI->getPU_NumInteractions();
936 std::vector<reco::Vertex>::const_iterator itv;
938 for (itv = vertices->begin(); itv != vertices->end(); ++itv) {
942 if (fabs(itv->z()) > 50.0)
944 if (fabs(itv->position().rho()) > 2.0)
952 event.getByLabel(
"generator", genEvtInfo);
953 double the_genEvtweight = 1.;
955 the_genEvtweight = genEvtInfo->weight();
962 event.
run(),
event.id().event(), the_genEvtweight, the_numPUvtx, the_TrueNumInteractions, the_NVtx)));
970 std::cout <<
"Reading muon pairs from Root Tree in " << treeFileName << std::endl;
972 std::vector<std::pair<unsigned int, unsigned long long> > evtRun;
985 std::vector<std::pair<unsigned int, unsigned long long> >::iterator evtRunIt = evtRun.begin();
987 std::vector<std::pair<MuScleFitMuon, MuScleFitMuon> >::iterator genIt;
994 double pt1 = it->first.pt();
996 double pt2 = it->second.pt();
998 double eta1 = it->first.eta();
1000 double eta2 = it->second.eta();
1003 bool dontPass =
false;
1004 bool eta1InFirstRange;
1005 bool eta2InFirstRange;
1006 bool eta1InSecondRange;
1007 bool eta2InSecondRange;
1009 int ch1 = it->first.charge();
1010 int ch2 = it->second.charge();
1023 ((eta1InFirstRange && eta2InSecondRange && ch1 >= ch2) ||
1024 (eta1InSecondRange && eta2InFirstRange && ch1 < ch2))))
1035 (((eta1InFirstRange && !eta2InFirstRange) && (eta2InSecondRange && !eta1InSecondRange) && ch1 >= ch2) ||
1036 ((eta2InFirstRange && !eta1InFirstRange) && (eta1InSecondRange && !eta2InSecondRange) && ch1 < ch2))))
1070 (*evtRunIt).first, (*evtRunIt).second, 0, 0, 0, 0))
1115 <<
" Pt2 = " <<
recMu2.Pt() << std::endl;
1127 <<
" Pt2 = " <<
recMu2.Pt() << std::endl;
1141 mapHisto_[
"hRecBestRes"]->Fill(bestRecRes, +1, weight);
1142 mapHisto_[
"hRecBestResAllEvents"]->Fill(bestRecRes, +1, 1.);
1164 mapHisto_[
"hRecBestResVSRes"]->Fill(bestRecRes, bestRecRes, +1, weight);
1166 std::vector<double>* parval;
1167 std::vector<double> initpar;
1207 mapHisto_[
"hFunctionResolCotgTheta"]->Fill(
1213 mapHisto_[
"hFunctionResolCotgTheta"]->Fill(
1221 std::cout <<
"mass = " << bestRecRes.mass() << std::endl;
1227 std::vector<double> initpar;
1247 bestRecRes.Rapidity(),
1259 bestRecRes.Rapidity(),
1267 std::cout <<
"inside weight: mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1270 std::cout <<
"inside prob: mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1279 if (recoMass != 0) {
1283 mapHisto_[
"hFunctionResolMassVSMu"]->Fill(
recMu1, massResol / recoMass, -1);
1284 mapHisto_[
"hFunctionResolMassVSMu"]->Fill(
recMu2, massResol / recoMass, +1);
1306 double diffMass = (recoMass - genMass) / genMass;
1309 double pt1 =
recMu1.pt();
1311 double pt2 =
recMu2.pt();
1314 if (diffMass == diffMass) {
1316 mapHisto_[
"hDeltaMassOverGenMassVsPt"]->Fill(pt1, diffMass);
1317 mapHisto_[
"hDeltaMassOverGenMassVsPt"]->Fill(pt2, diffMass);
1318 mapHisto_[
"hDeltaMassOverGenMassVsEta"]->Fill(eta1, diffMass);
1319 mapHisto_[
"hDeltaMassOverGenMassVsEta"]->Fill(eta2, diffMass);
1321 mapHisto_[
"hMassResolutionVsPtEta"]->Fill(pt1, eta1, diffMass, diffMass);
1322 mapHisto_[
"hMassResolutionVsPtEta"]->Fill(pt2, eta2, diffMass, diffMass);
1324 std::cout <<
"Error, there is a nan: recoMass = " << recoMass <<
", genMass = " << genMass << std::endl;
1333 mapHisto_[
"hMass_P"]->Fill(bestRecRes.mass(), prob);
1335 std::cout <<
"mass = " << bestRecRes.mass() <<
", prob = " << prob << std::endl;
1336 mapHisto_[
"hMass_fine_P"]->Fill(bestRecRes.mass(), prob);
1338 mapHisto_[
"hMassProbVsRes"]->Fill(bestRecRes, bestRecRes, +1, prob);
1341 mapHisto_[
"hMassProbVsRes_fine"]->Fill(bestRecRes, bestRecRes, +1, prob);
1352 std::cout <<
"[MuScleFit]: filling the pair" << std::endl;
1366 ((recMu.Eta() - genMu.Eta()) * (recMu.Eta() - genMu.Eta())));
1370 std::cout <<
"Reco muon " << recMu <<
" with eta " << recMu.Eta() <<
" and phi " << recMu.Phi() << std::endl
1371 <<
" DOES NOT MATCH with generated muon from resonance: " << std::endl
1372 << genMu <<
" with eta " << genMu.Eta() <<
" and phi " << genMu.Phi() << std::endl;
1382 mapHisto_[
"hResolPt" +
name]->Fill(recMu, (-genMu.Pt() + recMu.Pt()) / genMu.Pt(),
charge);
1383 mapHisto_[
"hResolTheta" +
name]->Fill(recMu, (-genMu.Theta() + recMu.Theta()), charge);
1385 recMu, (-
cos(genMu.Theta()) /
sin(genMu.Theta()) +
cos(recMu.Theta()) /
sin(recMu.Theta())),
charge);
1386 mapHisto_[
"hResolEta" +
name]->Fill(recMu, (-genMu.Eta() + recMu.Eta()), charge);
1390 if ((genMu.Pt() != 0) && (recMu.Pt() != 0)) {
1391 mapHisto_[
"hPtRecoVsPt" + inputName]->Fill(genMu.Pt(), recMu.Pt());
1416 std::cout <<
"[MuScleFit-Constructor]: wrong size of resolution fits selector = "
1418 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1424 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1428 std::cout <<
"[MuScleFit-Constructor]: wrong size of cross section fits selector = "
1430 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1434 std::cout <<
"[MuScleFit-Constructor]: wrong size of background fits selector = "
1436 std::cout <<
"it must have as many values as the number of loops, which is = " <<
maxLoopNumber << std::endl;
1462 std::cout <<
"[MuScleFit-Constructor]: Wrong bias type or number of parameters: aborting!" << std::endl;
1475 std::cout <<
"[MuScleFit-Constructor]: Wrong smear type or number of parameters: aborting!" << std::endl;
1482 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Resol: aborting!" << std::endl;
1487 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Scale: aborting!" << std::endl;
1492 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Bgr: aborting!" << std::endl;
1497 std::cout <<
"[MuScleFit-Constructor]: Mismatch in number of parameters for Bgr: aborting!" << std::endl;
1504 std::cout <<
"[MuScleFit-Constructor]: resfind must have 6 elements (1 Z, 3 Y, 2 Psi): aborting!" << std::endl;
1518 iTrack->chi2() / iTrack->ndof() < 4.0 && aMuon->
muonID(
"TrackerMuonArbitrated") &&
1520 fabs(iTrack->dxy()) < 3.0 &&
1521 fabs(iTrack->dz()) < 15.0);
1529 iTrack->found() > 11 && iTrack->chi2() / iTrack->ndof() < 4.0 && aMuon->
muonID(
"TrackerMuonArbitrated") &&
1531 fabs(iTrack->dxy()) < 3.0 &&
1532 fabs(iTrack->dz()) < 15.0);
static double deltaPhiNoFabs(const double &phi1, const double &phi2)
Without fabs at the end, used to have a symmetric distribution for the resolution fits and variance c...
static std::vector< std::pair< lorentzVector, lorentzVector > > simPair
static std::vector< int > doScaleFit
static std::vector< int > doResolFit
T getUntrackedParameter(std::string const &, T const &) const
static std::vector< double > parBias
void selectMuons(const edm::Event &event)
static std::vector< int > parCrossSectionOrder
std::vector< GenMuonPair > genMuonPairs_
Stores the genMuon pairs and the motherId prior to the creation of the internal tree.
static smearFunctionBase * smearFunction
static std::vector< int > parScaleOrder
edm::InputTag theMuonLabel_
static std::vector< std::string > checklist log
static std::vector< int > doCrossSectionFit
static void minimizeLikelihood()
static double maxMuonEtaSecondRange_
std::vector< MuScleFitMuon > fillMuonCollection(const std::vector< T > &tracks)
static std::vector< int > parBgrOrder
bool selGlobalMuon(const pat::Muon *aMuon)
Function for onia selections.
static unsigned int loopCounter
static double deltaPhiMaxCut_
static std::vector< double > parResolMax
static std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > SavedPairMuScleFitMuons
static std::vector< std::pair< MuScleFitMuon, MuScleFitMuon > > genMuscleFitPair
static bool startWithSimplex_
std::string triggerResultsProcess_
static std::vector< int > doBackgroundFit
static std::vector< double > parResol
static bool debugMassResol_
virtual void duringFastLoop()
Sin< T >::type sin(const T &t)
static BackgroundHandler * backgroundHandler
static double x[7][10000]
static double massWindowHalfWidth[3][6]
#define DEFINE_FWK_LOOPER(type)
bool muonID(const std::string &name) const
Run const & getRun() const
std::map< std::string, Histograms * > mapHisto_
The map of histograms.
auto const & tracks
cannot be loose
void readTree(const int maxEvents, const TString &fileName, MuonPairVector *savedPair, const int muonType, std::vector< std::pair< unsigned int, unsigned long long > > *evtRun, MuonPairVector *genPair=nullptr)
void fillTreeRec(const std::vector< std::pair< reco::Particle::LorentzVector, reco::Particle::LorentzVector > > &savedPairs)
Used when running on the root tree containing preselected muon pairs.
static scaleFunctionBase< std::vector< double > > * biasFunction
bool selTrackerMuon(const pat::Muon *aMuon)
void startingNewLoop(unsigned int iLoop) override
static std::vector< int > parBgrFix
static std::vector< double > parResolMin
static bool minimumShapePlots_
int pixelLayersWithMeasurement() const
edm::InputTag simTracksCollection_
static int MuonTypeForCheckMassWindow
static double minMuonEtaFirstRange_
static double massProb(const double &mass, const double &rapidity, const int ires, const double &massResol)
void fillComparisonHistograms(const reco::Particle::LorentzVector &genMu, const reco::Particle::LorentzVector &recoMu, const std::string &inputName, const int charge)
Fill the reco vs gen and reco vs sim comparison histograms.
static struct MuScleFitUtils::massResolComponentsStruct massResolComponents
std::vector< std::string > triggerPath_
static std::vector< int > parScaleFix
static bool computeMinosErrors_
MuScleFitMuon recMuScleMu1
reco::Particle::LorentzVector lorentzVector
static scaleFunctionBase< std::vector< double > > * scaleFunctionForVec
static std::vector< std::vector< double > > parvalue
unsigned int triggerIndex(const std::string &triggerName) const
slot position of trigger path in trigger table (0 to size-1)
resolutionFunctionBase< double * > * resolutionFunctionService(const int identifier)
Service to build the resolution functor corresponding to the passed identifier.
U second(std::pair< T, U > const &p)
void writeTree(const TString &fileName, const std::vector< MuonPair > *savedPair, const int muonType=0, const std::vector< GenMuonPair > *genPair=nullptr, const bool saveAll=false)
int theCompressionSettings_
static std::pair< MuScleFitMuon, MuScleFitMuon > findBestRecoRes(const std::vector< MuScleFitMuon > &muons)
static std::vector< std::pair< lorentzVector, lorentzVector > > genPair
std::string outputRootTreeFileName_
std::string theGenInfoRootFileName_
resolutionFunctionBase< std::vector< double > > * resolutionFunctionVecService(const int identifier)
Service to build the resolution functor corresponding to the passed identifier when receiving a std::...
static double massResolution(const lorentzVector &mu1, const lorentzVector &mu2)
reco::Particle::LorentzVector recMu2
static std::vector< double > parScaleMin
std::vector< double > vec1
reco::Particle::LorentzVector recMu1
static lorentzVector applyBias(const lorentzVector &muon, const int charge)
static std::vector< double > parBgr
unsigned int maxLoopNumber
MuonServiceProxy * theService
std::string genParticlesName_
Cos< T >::type cos(const T &t)
scaleFunctionBase< double * > * scaleFunctionService(const int identifier)
Service to build the scale functor corresponding to the passed identifier.
void clearHistoMap()
Clean the histograms map.
MuScleFitMuon recMuScleMu2
static double computeWeight(const double &mass, const int iev, const bool doUseBkgrWindow=false)
static std::vector< double > parScaleStep
static std::vector< std::pair< lorentzVector, lorentzVector > > SavedPair
MuScleFit(const edm::ParameterSet &pset)
static std::string const triggerResults
static lorentzVector applyScale(const lorentzVector &muon, const std::vector< double > &parval, const int charge)
static std::vector< int > parResolFix
static std::vector< double > parSmear
void beginOfJobInConstructor()
smearFunctionBase * smearFunctionService(const int identifier)
Service to build the smearing functor corresponding to the passed identifier.
static std::vector< int > parResolOrder
edm::EDLooper::Status duringLoop(const edm::Event &event, const edm::EventSetup &eventSetup) override
static std::vector< double > parScaleMax
scaleFunctionBase< std::vector< double > > * scaleFunctionVecService(const int identifier)
Service to build the scale functor corresponding to the passed identifier when receiving a std::vecto...
void writeHistoMap(const unsigned int iLoop)
Save the histograms map to file.
static std::vector< double > parScale
static double oldNormalization_
void applySmearing(reco::Particle::LorentzVector &mu)
Apply the smearing if needed using the function in MuScleFitUtils.
std::string const & triggerName(unsigned int index) const
std::string theRootFileName_
void fillTreeGen(const std::vector< std::pair< reco::Particle::LorentzVector, reco::Particle::LorentzVector > > &genPairs)
bool init(const edm::Run &iRun, const edm::EventSetup &iSetup, const std::string &processName, bool &changed)
d'tor
static double deltaPhiMinCut_
T getParameter(std::string const &) const
std::string triggerResultsLabel_
static bool rapidityBinsForZ_
MuScleFitPlotter * plotter
void fillHistoMap(TFile *outputFile, unsigned int iLoop)
Create the histograms map.
std::vector< TFile * > theFiles_
The files were the histograms are saved.
double minResMass_hwindow[6]
reco::TrackRef globalTrack() const override
reference to Track reconstructed in both tracked and muon detector (reimplemented from reco::Muon) ...
static bool separateRanges_
static double minMuonEtaSecondRange_
reco::TrackRef innerTrack() const override
reference to Track reconstructed in the tracker only (reimplemented from reco::Muon) ...
static std::vector< double > parCrossSection
static lorentzVector applySmearing(const lorentzVector &muon)
static bool normalizeLikelihoodByEventNumber_
std::string inputRootTreeFileName_
bool checkDeltaR(reco::Particle::LorentzVector &genMu, reco::Particle::LorentzVector &recMu)
Check if two lorentzVector are near in deltaR.
int maxEventsFromRootTree_
double maxResMass_hwindow[6]
std::vector< MuonPair > muonPairs_
Used to store the muon pairs plus run and event number prior to the creation of the internal tree...
static double deltaPhi(const double &phi1, const double &phi2)
static scaleFunctionBase< double * > * scaleFunction
int numberOfValidMuonHits() const
static bool useProbsFile_
static std::vector< int > resfind
void readProbabilityDistributionsFromFile()
Read probability distributions from a local root file.
void takeSelectedMuonType(const T &muon, std::vector< reco::Track > &tracks)
Template method used to fill the track collection starting from reco::muons or pat::muons.
static int counter_resprob
static resolutionFunctionBase< std::vector< double > > * resolutionFunctionForVec
math::XYZTLorentzVector LorentzVector
Lorentz vector.
Analysis-level muon class.
static double maxMuonEtaFirstRange_
std::unique_ptr< MuScleFitMuonSelector > muonSelector_
tuple size
Write out results.
Power< A, B >::type pow(const A &a, const B &b)
void applyBias(reco::Particle::LorentzVector &mu, const int charge)
Apply the bias if needed using the function in MuScleFitUtils.
static CrossSectionHandler * crossSectionHandler
edm::EDLooper::Status endOfLoop(const edm::EventSetup &eventSetup, unsigned int iLoop) override
static std::vector< double > parResolStep
static std::vector< int > parCrossSectionFix
static resolutionFunctionBase< double * > * resolutionFunction
void addParameters(std::vector< double > &initpar)
Inputs the vars in a vector.
virtual void endOfFastLoop(const unsigned int iLoop)