void METAnalyser::analyse(const EventPtr event) { histMan_->setCurrentHistogramFolder(histogramFolder_); weight_ = event->weight() * prescale_ * scale_; for (unsigned index = 0; index < METAlgorithm::NUMBER_OF_METALGORITHMS; ++index) { std::string prefix = METAlgorithm::prefixes.at(index); METAlgorithm::value metType = (METAlgorithm::value) index; if (!MET::isAvailableInNTupleVersion(Globals::NTupleVersion, index)) continue; bool isMCOnlyMET = MET::isMCOnlyMETType(index); if (isMCOnlyMET && event->isRealData()) //these METs are MC only (Jet resolution systematics) continue; const METPointer met(event->MET(metType)); histMan_->setCurrentHistogramFolder(histogramFolder_ + "/" + prefix); histMan_->H1D_BJetBinned("MET")->Fill(met->et(), weight_); if (index != METAlgorithm::GenMET && !event->isRealData()) { histMan_->H2D_BJetBinned("RecoMET_vs_GenMET")->Fill(event->GenMET()->et(), met->et(), weight_); } //do not fill other histograms for met systematics if ((index > METAlgorithm::patType1p2CorrectedPFMet) && (index != METAlgorithm::recoMetPFlow)) continue; histMan_->H1D_BJetBinned("MET_phi")->Fill(met->phi(), weight_); histMan_->H1D_BJetBinned("METsignificance")->Fill(met->significance(), weight_); histMan_->H2D_BJetBinned("METsignificance_vs_MET")->Fill(met->et(), met->significance(), weight_); } }
void METAnalyser::analyseTransverseMass(const EventPtr event, const ParticlePointer particle) { histMan_->setCurrentHistogramFolder(histogramFolder_); weight_ = event->weight() * prescale_ * scale_; for (unsigned index = 0; index < METAlgorithm::NUMBER_OF_METALGORITHMS; ++index) { std::string prefix = METAlgorithm::prefixes.at(index); METAlgorithm::value metType = (METAlgorithm::value) index; if (!MET::isAvailableInNTupleVersion(Globals::NTupleVersion, index)) continue; if (MET::isMCOnlyMETType(index) && event->isRealData()) continue; //skip MC only METs for real data const METPointer met(event->MET(metType)); histMan_->setCurrentHistogramFolder(histogramFolder_ + "/" + prefix); double MT = Event::MT(particle, met); double angle = met->angle(particle); double delPhi = met->deltaPhi(particle); histMan_->H1D("Transverse_Mass")->Fill(MT, weight_); histMan_->H1D("Angle_lepton_MET")->Fill(angle, weight_); histMan_->H1D("DeltaPhi_lepton_MET")->Fill(delPhi, weight_); if (met->et() < 20) histMan_->H1D("Transverse_Mass_MET20")->Fill(MT, weight_); histMan_->H2D("MET_vs_leptonPt")->Fill(particle->pt(), met->et(), weight_); histMan_->H1D("MET_plus_leptonPt")->Fill(particle->pt() + met->et(), weight_); histMan_->H2D("MET_vs_leptonEta")->Fill(particle->eta(), met->et(), weight_); } }
void METAnalyser::analyse_ST(const EventPtr event, const ParticlePointer particle, const JetCollection jets) { histMan_->setCurrentHistogramFolder(histogramFolder_); weight_ = event->weight() * prescale_ * scale_; for (unsigned index = 0; index < METAlgorithm::NUMBER_OF_METALGORITHMS; ++index) { std::string prefix = METAlgorithm::prefixes.at(index); METAlgorithm::value metType = (METAlgorithm::value) index; if (!MET::isAvailableInNTupleVersion(Globals::NTupleVersion, index)) continue; bool isMCOnlyMET = MET::isMCOnlyMETType(index); if (isMCOnlyMET && event->isRealData()) //these METs are MC only (Jet resolution systematics) continue; const METPointer met(event->MET(metType)); float ST = Event::ST(jets, particle, met); float WPT = Event::WPT(particle, met); float MT = Event::MT(particle, met); histMan_->setCurrentHistogramFolder(histogramFolder_ + "/" + prefix); histMan_->H1D("ST")->Fill(ST, weight_); histMan_->H1D("WPT")->Fill(WPT, weight_); histMan_->H1D("MT")->Fill(MT, weight_); treeMan_->setCurrentFolder(histogramFolder_); treeMan_->Fill("ST",ST); treeMan_->Fill("WPT",WPT); treeMan_->Fill("MT",MT); histMan_->H2D("HT_vs_MET_plus_leptonPt")->Fill(particle->pt() + met->et(), Event::HT(jets), weight_); } }
void TTbar_plus_X_analyser::fillCommonTreesNoBSelection(const EventPtr event, const unsigned int selectionCriteria, std::string folder ) { SelectionCriteria::selection selection = SelectionCriteria::selection(selectionCriteria); // Jets const JetCollection jets(event->CleanedJets()); // B Jets const JetCollection bJets(event->CleanedBJets()); // Lepton const LeptonPointer signalLepton = event->getSignalLepton( selection ); // MET const METPointer MET_original(event->MET((METAlgorithm::value) 0)); treeMan_->setCurrentFolder(folder); treeMan_->Fill("EventWeight", event->weight()); treeMan_->Fill("PUWeight", event->PileUpWeight()); treeMan_->Fill("PUWeight_up", event->PileUpWeight(1)); treeMan_->Fill("PUWeight_down", event->PileUpWeight(-1)); treeMan_->Fill("M3",Event::M3(jets)); if ( Event::NJets(bJets) > 0 ) { treeMan_->Fill("M_bl",Event::M_bl(bJets, signalLepton)); treeMan_->Fill("angle_bl",Event::angle_bl(bJets, signalLepton)); } treeMan_->Fill("HT",Event::HT(jets)); treeMan_->Fill("MET",MET_original->et()); treeMan_->Fill("MET_phi",MET_original->phi()); treeMan_->Fill("ST",Event::ST(jets, signalLepton, MET_original)); treeMan_->Fill("WPT",Event::WPT(signalLepton, MET_original)); treeMan_->Fill("MT",Event::MT(signalLepton, MET_original)); treeMan_->Fill("NJets",Event::NJets(jets)); treeMan_->Fill("NBJets",Event::NJets(bJets)); treeMan_->Fill("NVertices", event->Vertices().size()); treeMan_->Fill("BJetWeight",event->BJetWeight()); treeMan_->Fill("BJetEfficiencyCorrectionWeight",event->BJetEfficiencyCorrectionWeight()); treeMan_->Fill("BJetAlternativeWeight",event->BJetAlternativeWeight()); treeMan_->Fill("BJetUpWeight",event->BJetUpWeight()); treeMan_->Fill("BJetDownWeight",event->BJetDownWeight()); treeMan_->Fill("LightJetUpWeight",event->LightJetUpWeight()); treeMan_->Fill("LightJetDownWeight",event->LightJetDownWeight()); if (selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsReference)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIso03DeltaBeta()); } else if (selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsReference)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIso04DeltaBeta()); } for (unsigned int index = 0; index < jets.size(); ++index) { treeMan_->Fill("jet_csv", jets.at(index)->getBTagDiscriminator(BtagAlgorithm::CombinedSecondaryVertexV2) ); } fillLeptonEfficiencyCorrectionBranches( event, selectionCriteria, signalLepton ); }
double Event::MT(const ParticlePointer particle, const METPointer met) { double energySquared = pow(particle->et() + met->et(), 2); double momentumSquared = pow(particle->px() + met->px(), 2) + pow(particle->py() + met->py(), 2); double MTSquared = energySquared - momentumSquared; if (MTSquared > 0) return sqrt(MTSquared); else return -1; }
void TTbar_plus_X_analyser::fillCommonTrees(const EventPtr event, const unsigned int selectionCriteria, std::string folder ) { SelectionCriteria::selection selection = SelectionCriteria::selection(selectionCriteria); // Jets const JetCollection jets(event->CleanedJets()); // B Jets unsigned int numberOfBjets = event->getNBJets( selection ); const JetCollection bJets(event->CleanedBJets()); // Lepton const LeptonPointer signalLepton = event->getSignalLepton( selection ); // MET const METPointer MET_original(event->MET((METAlgorithm::value) 0)); treeMan_->setCurrentFolder(folder); treeMan_->Fill("EventWeight", event->weight()); treeMan_->Fill("PUWeight", event->PileUpWeight()); treeMan_->Fill("PUWeight_up", event->PileUpWeight(1)); treeMan_->Fill("PUWeight_down", event->PileUpWeight(-1)); treeMan_->Fill("lepton_eta",signalLepton->eta()); treeMan_->Fill("lepton_pt",signalLepton->pt()); treeMan_->Fill("lepton_charge",signalLepton->charge()); if (selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsReference) || selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsQCDNonIsolated) || selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsQCDConversion)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIsoWithEA()); treeMan_->Fill("lepton_hltECALisolation", signalLepton->hltECALIso()); treeMan_->Fill("lepton_hltHCALisolation", signalLepton->hltHCALIso()); treeMan_->Fill("lepton_hltTrackerisolation", signalLepton->hltTrackerIso()); if ( signalLepton->pt() > 0 ) { treeMan_->Fill("lepton_hltTrackerisolation_overPt", signalLepton->hltTrackerIso() / signalLepton->pt() ); } } else if (selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsReference) || selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsQCDNonIsolated1p5to3) || selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsQCDNonIsolated3toInf)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIso04DeltaBeta()); } treeMan_->Fill("M3",Event::M3(jets)); if ( numberOfBjets > 0 ) { treeMan_->Fill("M_bl",Event::M_bl(bJets, signalLepton)); treeMan_->Fill("angle_bl",Event::angle_bl(bJets, signalLepton)); // if ( numberOfBjets >= 2 ) { // unsigned int highestCSVJetIndex = 0; // unsigned int secondHighestCSVJetIndex = 0; // Event::getTopTwoCSVJets( bJets, highestCSVJetIndex, secondHighestCSVJetIndex ); // JetPointer highestCSVJet(bJets.at(highestCSVJetIndex)); // JetPointer secondHighestCSVJet(bJets.at(secondHighestCSVJetIndex)); // treeMan_->Fill("deltaPhi_bb", fabs( Event::deltaPhi_bb(highestCSVJet, secondHighestCSVJet) ) ) ; // treeMan_->Fill("deltaEta_bb", fabs( Event::deltaEta_bb(highestCSVJet, secondHighestCSVJet) ) ) ; // treeMan_->Fill("angle_bb", Event::angle_bb(highestCSVJet, secondHighestCSVJet)); // } } for (unsigned int index = 0; index < jets.size(); ++index) { treeMan_->Fill("jet_pt", jets.at(index)->pt() ); treeMan_->Fill("jet_eta", jets.at(index)->eta() ); treeMan_->Fill("jet_csv", jets.at(index)->getBTagDiscriminator(BtagAlgorithm::CombinedSecondaryVertexV2) ); } treeMan_->Fill("HT",Event::HT(jets)); treeMan_->Fill("MET",MET_original->et()); treeMan_->Fill("MET_phi",MET_original->phi()); treeMan_->Fill("ST",Event::ST(jets, signalLepton, MET_original)); treeMan_->Fill("WPT",Event::WPT(signalLepton, MET_original)); treeMan_->Fill("MT",Event::MT(signalLepton, MET_original)); treeMan_->Fill("NJets",Event::NJets(jets)); treeMan_->Fill("NBJets",Event::NJets(bJets)); treeMan_->Fill("NVertices", event->Vertices().size()); treeMan_->Fill("BJetWeight",event->BJetWeight()); treeMan_->Fill("BJetEfficiencyCorrectionWeight",event->BJetEfficiencyCorrectionWeight()); treeMan_->Fill("BJetAlternativeWeight",event->BJetAlternativeWeight()); treeMan_->Fill("BJetUpWeight",event->BJetUpWeight()); treeMan_->Fill("BJetDownWeight",event->BJetDownWeight()); treeMan_->Fill("LightJetUpWeight",event->LightJetUpWeight()); treeMan_->Fill("LightJetDownWeight",event->LightJetDownWeight()); treeMan_->Fill("tau1", event->getTau1()); treeMan_->Fill("tau2", event->getTau2()); treeMan_->Fill("tau3", event->getTau3()); treeMan_->Fill("tau4", event->getTau4()); treeMan_->Fill("tau5", event->getTau5()); treeMan_->Fill("tau6", event->getTau6()); // MET Uncertainties for ( unsigned int unc_i = 0; unc_i < MET_original->getAllMETUncertainties().size(); ++unc_i ) { METPointer METForUnc_i = MET_original->getMETForUncertainty( unc_i ); treeMan_->Fill("MET_METUncertainties",METForUnc_i->et()); treeMan_->Fill("ST_METUncertainties",Event::ST(jets, signalLepton, METForUnc_i)); treeMan_->Fill("WPT_METUncertainties",Event::WPT(signalLepton, METForUnc_i)); } double topPtWeight = 1.; if ( ( event->isSemiLeptonicElectron() || event->isSemiLeptonicMuon() ) ) { const TTGenInfoPointer ttGen( event->TTGenInfo() ); const ParticlePointer leptonicTop = ttGen->getLeptonicTop(); const ParticlePointer hadronicTop = ttGen->getHadronicTop(); if ( leptonicTop != 0 && hadronicTop != 0 ) { // Store info on leptonic top treeMan_->Fill("lepTopPt_parton", leptonicTop->pt() ); treeMan_->Fill("hadTopPt_parton", hadronicTop->pt() ); topPtWeight = exp( 0.0615 - 0.0005 * leptonicTop->pt() ) * exp( 0.0615 - 0.0005 * hadronicTop->pt() ); } } treeMan_->Fill("topPtWeight",topPtWeight); fillLeptonEfficiencyCorrectionBranches( event, selectionCriteria, signalLepton ); wAnalyser_->analyseHadronicW( event, jets, bJets, folder ); }
void TTbar_plus_X_analyser::fillCommonTrees(const EventPtr event, const unsigned int selectionCriteria, std::string folder ) { SelectionCriteria::selection selection = SelectionCriteria::selection(selectionCriteria); // Jets const JetCollection jets(event->CleanedJets()); // B Jets unsigned int numberOfBjets = event->getNBJets( selection ); const JetCollection bJets(event->CleanedBJets()); // Lepton const LeptonPointer signalLepton = event->getSignalLepton( selection ); // MET const METPointer MET_original(event->MET((METAlgorithm::value) 0)); treeMan_->setCurrentFolder(folder); treeMan_->Fill("EventWeight", event->weight()); treeMan_->Fill("PUWeight", event->PileUpWeight()); treeMan_->Fill("PUWeight_up", event->PileUpWeight(1)); treeMan_->Fill("PUWeight_down", event->PileUpWeight(-1)); treeMan_->Fill("lepton_eta",signalLepton->eta()); treeMan_->Fill("lepton_pt",signalLepton->pt()); treeMan_->Fill("lepton_charge",signalLepton->charge()); if (selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsReference) || selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsQCDNonIsolated) || selection == SelectionCriteria::selection(SelectionCriteria::ElectronPlusJetsQCDConversion)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIsoWithEA()); } else if (selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsReference) || selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsQCDNonIsolated1p5to3) || selection == SelectionCriteria::selection(SelectionCriteria::MuonPlusJetsQCDNonIsolated3toInf)){ treeMan_->Fill("lepton_isolation", signalLepton->PFRelIso04DeltaBeta()); } treeMan_->Fill("M3",Event::M3(jets)); if ( numberOfBjets > 0 ) { treeMan_->Fill("M_bl",Event::M_bl(bJets, signalLepton)); treeMan_->Fill("angle_bl",Event::angle_bl(bJets, signalLepton)); } for (unsigned int index = 0; index < jets.size(); ++index) { treeMan_->Fill("jet_pt", jets.at(index)->pt() ); treeMan_->Fill("jet_eta", jets.at(index)->eta() ); } treeMan_->Fill("HT",Event::HT(jets)); treeMan_->Fill("MET",MET_original->et()); treeMan_->Fill("ST",Event::ST(jets, signalLepton, MET_original)); treeMan_->Fill("WPT",Event::WPT(signalLepton, MET_original)); treeMan_->Fill("MT",Event::MT(signalLepton, MET_original)); treeMan_->Fill("NJets",Event::NJets(jets)); treeMan_->Fill("NBJets",Event::NJets(bJets)); treeMan_->Fill("NVertices", event->Vertices().size()); treeMan_->Fill("BJetWeight",event->BJetWeight()); treeMan_->Fill("BJetUpWeight",event->BJetUpWeight()); treeMan_->Fill("BJetDownWeight",event->BJetDownWeight()); treeMan_->Fill("LightJetUpWeight",event->LightJetUpWeight()); treeMan_->Fill("LightJetDownWeight",event->LightJetDownWeight()); // MET Uncertainties for ( unsigned int unc_i = 0; unc_i < MET_original->getAllMETUncertainties().size(); ++unc_i ) { METPointer METForUnc_i = MET_original->getMETForUncertainty( unc_i ); treeMan_->Fill("MET_METUncertainties",METForUnc_i->et()); treeMan_->Fill("ST_METUncertainties",Event::ST(jets, signalLepton, METForUnc_i)); treeMan_->Fill("WPT_METUncertainties",Event::WPT(signalLepton, METForUnc_i)); } fillLeptonEfficiencyCorrectionBranches( event, selectionCriteria, signalLepton ); }
void PseudoTopAnalyser::analyse(const EventPtr event) { weight_ = event->weight(); treeMan_->setCurrentFolder(histogramFolder_); // Store gen selection criteria treeMan_->Fill("isSemiLeptonicElectron", event->isSemiLeptonicElectron()); treeMan_->Fill("isSemiLeptonicMuon", event->isSemiLeptonicMuon()); const PseudoTopParticlesPointer pseudoTopParticles = event->PseudoTopParticles(); const MCParticleCollection pseudoTops = pseudoTopParticles->getPseudoTops(); const MCParticlePointer pseudoLeptonicW = pseudoTopParticles->getPseudoLeptonicW(); const MCParticlePointer pseudoLepton = pseudoTopParticles->getPseudoLepton(); const ParticleCollection allPseudoLeptons = pseudoTopParticles->getAllPseudoLeptons(); const MCParticleCollection pseudoBs = pseudoTopParticles->getPseudoBs(); const ParticlePointer pseudoMET = pseudoTopParticles->getPseudoMET(); const ParticlePointer pseudoNeutrino = pseudoTopParticles->getPseudoNeutrino(); const JetCollection pseudoJets = pseudoTopParticles->getPseudoJets(); ParticleCollection pseudoTopsForTTbar; // // Only consider events with two pseudo tops // if ( pseudoTops.size() != 2 ) return; // // Also only consider events that are semi leptonic at the pseudo top level // if ( !pseudoTopParticles->isSemiLeptonic() ) return; // Check if event passes event selection (at pseudo top level) if ( passesEventSelection( pseudoLepton, pseudoNeutrino, pseudoJets, pseudoBs, allPseudoLeptons, pseudoMET ) ) { treeMan_->Fill("passesGenEventSelection",1); } else { treeMan_->Fill("passesGenEventSelection",0); } // // TOP VARIABLES // Top reco at particle level performed // // Store info on top for ( unsigned int ptIndex = 0; ptIndex < pseudoTops.size(); ++ ptIndex ) { // cout << "Getting pseudo top number : " << ptIndex << endl; const ParticlePointer pseudoTop = pseudoTops[ptIndex]; pseudoTopsForTTbar.push_back( pseudoTop ); treeMan_->Fill("pseudoTop_pT", pseudoTop->pt() ); treeMan_->Fill("pseudoTop_y", pseudoTop->rapidity() ); } if( pseudoTopsForTTbar.size() == 2 ) { // Store info on ttbar ParticlePointer pseudoTTbar( new Particle( *pseudoTopsForTTbar[0] + *pseudoTopsForTTbar[1] ) ); treeMan_->Fill("pseudoTTbar_pT", pseudoTTbar->pt() ); treeMan_->Fill("pseudoTTbar_y", pseudoTTbar->rapidity() ); treeMan_->Fill("pseudoTTbar_m", pseudoTTbar->mass() ); } // Store info on Bs if ( pseudoBs.size() == 2 ) { unsigned int leadingPsuedoBIndex = 0; if ( pseudoBs[1]->pt() > pseudoBs[0]->pt() ) { leadingPsuedoBIndex = 1; } unsigned int subleadingPsuedoBIndex = ( leadingPsuedoBIndex == 0 ) ? 1 : 0; treeMan_->Fill("pseudoB_pT", pseudoBs[leadingPsuedoBIndex]->pt() ); treeMan_->Fill("pseudoB_eta", pseudoBs[leadingPsuedoBIndex]->eta() ); treeMan_->Fill("pseudoB_pT", pseudoBs[subleadingPsuedoBIndex]->pt() ); treeMan_->Fill("pseudoB_eta", pseudoBs[subleadingPsuedoBIndex]->eta() ); // for ( unsigned int pbIndex = 0; pbIndex < pseudoBs.size(); ++pbIndex ) { // treeMan_->Fill("pseudoB_pT", pseudoBs[pbIndex]->pt() ); // treeMan_->Fill("pseudoB_eta", pseudoBs[pbIndex]->eta() ); // } } // // GLOBAL VARIABLES // No top reco at particle level // if ( allPseudoLeptons.size() > 0 ) { // Store info on lepton treeMan_->Fill("pseudoLepton_pT", allPseudoLeptons[0]->pt() ); treeMan_->Fill("pseudoLepton_eta", allPseudoLeptons[0]->eta() ); } // Store pseudo MET if ( pseudoMET != 0 ) { treeMan_->Fill("pseudoMET", pseudoMET->et() ); METAlgorithm::value metType = (METAlgorithm::value) 0; const METPointer met(event->MET(metType)); if ( pseudoMET->et() <= 0 && met->et() > 0 ) { } treeMan_->Fill("pseudoMET_mass", pseudoMET->mass() ); } // Store pseudo HT treeMan_->Fill("pseudoHT", event->HT( pseudoJets ) ); // Store pseudo ST if ( allPseudoLeptons.size() > 0 ) { treeMan_->Fill("pseudoST", event->ST( pseudoJets, allPseudoLeptons[0], METPointer( new MET( pseudoMET->px(), pseudoMET->py() )) ) ); } // Store pseudo MT and WPT // These are from the W reconstructed from the pseudo particles // i.e. use the neutrino assocaited with the W rather than the more "global" MET if ( pseudoLeptonicW != 0 ) { treeMan_->Fill("pseudoWPT_reco", pseudoLeptonicW->pt() ); } if ( pseudoMET != 0 && allPseudoLeptons.size() > 0 ) { double WPT = event->WPT( allPseudoLeptons[0], METPointer( new MET( pseudoMET->px(), pseudoMET->py() )) ); treeMan_->Fill("pseudoWPT", WPT ); double MT = event->MT( allPseudoLeptons[0], METPointer( new MET( pseudoMET->px(), pseudoMET->py() )) ); treeMan_->Fill("pseudoMT", MT ); } }
void UnfoldingRecoAnalyser::analyse(const EventPtr event) { weight_ = event->weight(); treeMan_->setCurrentFolder(histogramFolder_); treeMan_->Fill("EventWeight", event->weight()); double centralLHEWeight = event->centralLHEWeight(); for ( unsigned int unc_i = 0; unc_i < event->generatorSystematicWeights().size(); ++unc_i ) { double weight = event->generatorSystematicWeights().at( unc_i ) / centralLHEWeight; int weightID = event->generatorSystematicWeightsID().at( unc_i ); // cout << to_string(unc_i) << " " << weightID << " " << weight/centralLHEWeight << endl; // string uncString = to_string(unc_i); if ( weightID >= 1001 && weightID <= 1009 ) { treeMan_->Fill( "muFmuRWeight_" + to_string(weightID-1001), weight); } else if ( weightID >= 2001 && weightID <= 2100 ) { treeMan_->Fill( "pdfWeight_" + to_string(weightID-2001), weight); } else if ( weightID == 2101 || weightID == 2102 ) { treeMan_->Fill( "alphaSWeight_" + to_string(weightID-2101), weight); } } treeMan_->setCurrentFolder(histogramFolder_); int selectionCriteria = -1; if ( event->PassesElectronTriggerAndSelection() ) selectionCriteria = SelectionCriteria::ElectronPlusJetsReference; else if ( event->PassesMuonTriggerAndSelection() ) selectionCriteria = SelectionCriteria::MuonPlusJetsReference; if ( event->PassesElectronTriggerAndSelection() && event->PassesMuonTriggerAndSelection() ) { cout << "-------------> This should not happen <-------------" << endl; } // Store selection flags first treeMan_->Fill("passSelection",selectionCriteria); if ( !( event->PassesMuonTriggerAndSelection() || event->PassesElectronTriggerAndSelection() )) return; const JetCollection jets(event->CleanedJets()); const JetCollection bjets(event->CleanedBJets()); const LeptonPointer signalLepton = event->getSignalLepton( selectionCriteria ); METAlgorithm::value metType = (METAlgorithm::value) 0; const METPointer met(event->MET(metType)); treeMan_->Fill("MET",met->et()); treeMan_->Fill("HT",Event::HT(jets)); treeMan_->Fill("ST",Event::ST(jets,signalLepton,met)); treeMan_->Fill("WPT",Event::WPT(signalLepton,met)); treeMan_->Fill("MT",Event::MT(signalLepton,met)); treeMan_->Fill("leptonPt", signalLepton->pt() ); treeMan_->Fill("leptonEta", signalLepton->eta() ); treeMan_->Fill("leptonCharge", signalLepton->charge() ); // Get lepton scale factor if ( event->PassesMuonTriggerAndSelection() ) { const MuonPointer signalMuon(boost::static_pointer_cast<Muon>(signalLepton)); double efficiencyCorrection = signalMuon->getEfficiencyCorrection( 0 ); treeMan_->Fill("LeptonEfficiencyCorrection", efficiencyCorrection); treeMan_->Fill("LeptonEfficiencyCorrectionUp", signalMuon->getEfficiencyCorrection( 1 )); treeMan_->Fill("LeptonEfficiencyCorrectionDown", signalMuon->getEfficiencyCorrection( -1 )); } else if ( event->PassesElectronTriggerAndSelection() ) { const ElectronPointer signalElectron(boost::static_pointer_cast<Electron>(signalLepton)); double efficiencyCorrection = signalElectron->getEfficiencyCorrection( 0 ); treeMan_->Fill("LeptonEfficiencyCorrection", efficiencyCorrection); treeMan_->Fill("LeptonEfficiencyCorrectionUp", signalElectron->getEfficiencyCorrection( 1 )); treeMan_->Fill("LeptonEfficiencyCorrectionDown", signalElectron->getEfficiencyCorrection( -1 )); } treeMan_->Fill("PUWeight", event->PileUpWeight() ); treeMan_->Fill("PUWeight_up", event->PileUpWeight(1) ); treeMan_->Fill("PUWeight_down", event->PileUpWeight(-1) ); treeMan_->Fill("BJetWeight",event->BJetWeight()); treeMan_->Fill("LightJetUpWeight",event->LightJetUpWeight()); treeMan_->Fill("LightJetDownWeight",event->LightJetDownWeight()); treeMan_->Fill("BJetUpWeight",event->BJetUpWeight()); treeMan_->Fill("BJetDownWeight",event->BJetDownWeight()); // MET Uncertainties for ( unsigned int unc_i = 0; unc_i < met->getAllMETUncertainties().size(); ++unc_i ) { METPointer METForUnc_i = met->getMETForUncertainty( unc_i ); treeMan_->Fill("MET_METUncertainties",METForUnc_i->et()); treeMan_->Fill("ST_METUncertainties",Event::ST(jets, signalLepton, METForUnc_i)); treeMan_->Fill("WPT_METUncertainties",Event::WPT(signalLepton, METForUnc_i)); } for (unsigned int index = 0; index < bjets.size(); ++index) { treeMan_->Fill("bPt", bjets.at(index)->pt() ); treeMan_->Fill("bEta", bjets.at(index)->eta() ); } for (unsigned int index = 0; index < jets.size(); ++index) { treeMan_->Fill("jetPt", jets.at(index)->pt() ); treeMan_->Fill("jetEta", jets.at(index)->eta() ); treeMan_->Fill("jetParton", jets.at(index)->ttbar_decay_parton() ); } BAT::TtbarHypothesis topHypothesis = event->ttbarHypothesis(); if ( topHypothesis.isValid() && topHypothesis.isPhysical() ) { treeMan_->Fill("lepTopPt",topHypothesis.leptonicTop->pt()); treeMan_->Fill("hadTopPt",topHypothesis.hadronicTop->pt()); treeMan_->Fill("lepTopRap",topHypothesis.leptonicTop->rapidity()); treeMan_->Fill("hadTopRap",topHypothesis.hadronicTop->rapidity()); treeMan_->Fill("ttbarPt",topHypothesis.resonance->pt()); treeMan_->Fill("ttbarM",topHypothesis.resonance->mass()); treeMan_->Fill("ttbarRap",topHypothesis.resonance->rapidity()); } unsigned int numberOfJets(event->NJets(jets)); unsigned int numberOfBJets(event->NJets(bjets)); treeMan_->Fill("NJets", numberOfJets ); treeMan_->Fill("NBJets", numberOfBJets ); }
double Event::ST(const JetCollection jets, const ParticlePointer lepton, const METPointer met) { // ST = HT + MET + lepton pt double ht = Event::HT(jets); return ht + met->et() + lepton->pt(); }