diff --git a/PhysicsTools/BPHNano/plugins/BToTrkLLBuilder.cc b/PhysicsTools/BPHNano/plugins/BToTrkLLBuilder.cc index 93fdba0e4e99..e52b51fe0c41 100644 --- a/PhysicsTools/BPHNano/plugins/BToTrkLLBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/BToTrkLLBuilder.cc @@ -30,35 +30,32 @@ #include "KinVtxFitter.h" class BToTrkLLBuilder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) public: typedef std::vector TransientTrackCollection; - explicit BToTrkLLBuilder(const edm::ParameterSet &cfg): - bFieldToken_{esConsumes()}, - pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - dileptons_{consumes( cfg.getParameter("dileptons") )}, - leptons_ttracks_{consumes( cfg.getParameter("leptonTransientTracks") )}, - kaons_{consumes( cfg.getParameter("kaons") )}, - kaons_ttracks_{consumes( cfg.getParameter("kaonsTransientTracks") )}, - track_mass_{cfg.getParameter("trackMass") }, - pu_tracks_(consumes(cfg.getParameter("PUtracks"))), - beamspot_{consumes( cfg.getParameter("beamSpot") )}, - dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} - { + explicit BToTrkLLBuilder(const edm::ParameterSet &cfg) + : bFieldToken_{esConsumes()}, + pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + dileptons_{consumes(cfg.getParameter("dileptons"))}, + leptons_ttracks_{consumes(cfg.getParameter("leptonTransientTracks"))}, + kaons_{consumes(cfg.getParameter("kaons"))}, + kaons_ttracks_{consumes(cfg.getParameter("kaonsTransientTracks"))}, + track_mass_{cfg.getParameter("trackMass")}, + pu_tracks_(consumes(cfg.getParameter("PUtracks"))), + beamspot_{consumes(cfg.getParameter("beamSpot"))}, + dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} { produces(); } ~BToTrkLLBuilder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: - const edm::ESGetToken bFieldToken_; //selections @@ -77,7 +74,6 @@ private: }; void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &iSetup) const { - //input edm::Handle dileptons; evt.getByToken(dileptons_, dileptons); @@ -96,7 +92,7 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co evt.getByToken(beamspot_, beamspot); edm::ESHandle fieldHandle; - const auto& bField = iSetup.getData(bFieldToken_); + const auto &bField = iSetup.getData(bFieldToken_); AnalyticalImpactPointExtrapolator extrapolator(&bField); // output @@ -105,12 +101,7 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co for (size_t k_idx = 0; k_idx < kaons->size(); ++k_idx) { edm::Ptr k_ptr(kaons, k_idx); - math::PtEtaPhiMLorentzVector k_p4( - k_ptr->pt(), - k_ptr->eta(), - k_ptr->phi(), - K_MASS - ); + math::PtEtaPhiMLorentzVector k_p4(k_ptr->pt(), k_ptr->eta(), k_ptr->phi(), K_MASS); for (size_t ll_idx = 0; ll_idx < dileptons->size(); ++ll_idx) { edm::Ptr ll_prt(dileptons, ll_idx); @@ -137,61 +128,50 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co cand.addUserFloat("min_dr", dr_info.first); cand.addUserFloat("max_dr", dr_info.second); + if (!pre_vtx_selection_(cand)) + continue; - if ( !pre_vtx_selection_(cand) ) continue; - - KinVtxFitter fitter( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), - kaons_ttracks->at(k_idx) - }, - {l1_ptr->mass(), l2_ptr->mass(), K_MASS}, - {LEP_SIGMA, LEP_SIGMA, K_SIGMA} //some small sigma for the lepton mass - ); - - if (!fitter.success()) continue; // hardcoded, but do we need otherwise? - cand.setVertex( - reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() - ) + KinVtxFitter fitter({leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), kaons_ttracks->at(k_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA} //some small sigma for the lepton mass ); - cand.addUserInt("sv_OK" , fitter.success()); + + if (!fitter.success()) + continue; // hardcoded, but do we need otherwise? + cand.setVertex(reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); + cand.addUserInt("sv_OK", fitter.success()); cand.addUserFloat("sv_chi2", fitter.chi2()); - cand.addUserFloat("sv_ndof", fitter.dof()); // float?? + cand.addUserFloat("sv_ndof", fitter.dof()); // float?? cand.addUserFloat("sv_prob", fitter.prob()); - cand.addUserFloat("fitted_mll" , - (fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); + cand.addUserFloat("fitted_mll", (fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); auto fit_p4 = fitter.fitted_p4(); - cand.addUserFloat("fitted_pt" , fit_p4.pt()); - cand.addUserFloat("fitted_eta" , fit_p4.eta()); - cand.addUserFloat("fitted_phi" , fit_p4.phi()); + cand.addUserFloat("fitted_pt", fit_p4.pt()); + cand.addUserFloat("fitted_eta", fit_p4.eta()); + cand.addUserFloat("fitted_phi", fit_p4.phi()); cand.addUserFloat("fitted_mass", fitter.fitted_candidate().mass()); - cand.addUserFloat("fitted_massErr", - sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - - cand.addUserFloat("cos_theta_2D", - cos_theta_2D(fitter, *beamspot, cand.p4())); - cand.addUserFloat("fitted_cos_theta_2D", - cos_theta_2D(fitter, *beamspot, fit_p4)); + cand.addUserFloat("fitted_massErr", sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + + cand.addUserFloat("cos_theta_2D", cos_theta_2D(fitter, *beamspot, cand.p4())); + cand.addUserFloat("fitted_cos_theta_2D", cos_theta_2D(fitter, *beamspot, fit_p4)); auto lxy = l_xy(fitter, *beamspot); cand.addUserFloat("l_xy", lxy.value()); cand.addUserFloat("l_xy_unc", lxy.error()); // track impact parameter from SV - TrajectoryStateOnSurface tsos = extrapolator.extrapolate(kaons_ttracks->at(k_idx).impactPointState(), fitter.fitted_vtx()); + TrajectoryStateOnSurface tsos = + extrapolator.extrapolate(kaons_ttracks->at(k_idx).impactPointState(), fitter.fitted_vtx()); std::pair cur2DIP = signedTransverseImpactParameter(tsos, fitter.fitted_refvtx(), *beamspot); - cand.addUserFloat("k_svip2d" , cur2DIP.second.value()); - cand.addUserFloat("k_svip2d_err" , cur2DIP.second.error()); - + cand.addUserFloat("k_svip2d", cur2DIP.second.value()); + cand.addUserFloat("k_svip2d_err", cur2DIP.second.error()); - if ( !post_vtx_selection_(cand) ) continue; + if (!post_vtx_selection_(cand)) + continue; cand.addUserFloat("vtx_x", cand.vx()); cand.addUserFloat("vtx_y", cand.vy()); cand.addUserFloat("vtx_z", cand.vz()); - const auto& covMatrix = fitter.fitted_vtx_uncertainty(); + const auto &covMatrix = fitter.fitted_vtx_uncertainty(); cand.addUserFloat("vtx_cxx", covMatrix.cxx()); cand.addUserFloat("vtx_cyy", covMatrix.cyy()); cand.addUserFloat("vtx_czz", covMatrix.czz()); @@ -199,24 +179,19 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co cand.addUserFloat("vtx_czx", covMatrix.czx()); cand.addUserFloat("vtx_czy", covMatrix.czy()); - // refitted daughters (leptons/tracks) - std::vector dnames{ "l1", "l2", "trk" }; + std::vector dnames{"l1", "l2", "trk"}; for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { - cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt" , - fitter.daughter_p4(idaughter).pt() ); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt", fitter.daughter_p4(idaughter).pt()); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", - fitter.daughter_p4(idaughter).eta() ); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", fitter.daughter_p4(idaughter).eta()); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", - fitter.daughter_p4(idaughter).phi() ); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", fitter.daughter_p4(idaughter).phi()); } - //compute isolation - std::vector isos = TrackerIsolation(pu_tracks, cand, dnames ); + std::vector isos = TrackerIsolation(pu_tracks, cand, dnames); for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { cand.addUserFloat(dnames[idaughter] + "_iso04", isos[idaughter]); } @@ -227,15 +202,14 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co cand.addUserFloat("constraint_phi", -99); cand.addUserFloat("constraint_mass", -99); cand.addUserFloat("constraint_massErr", -99); - cand.addUserFloat("constraint_mll" , -99); - + cand.addUserFloat("constraint_mll", -99); + const double dilepton_mass = ll_prt->userFloat("fitted_mass"); const double jpsi_bin[2] = {2.8, 3.35}; const double psi2s_bin[2] = {3.45, 3.85}; if (dilepton_constraint_ && ((dilepton_mass > jpsi_bin[0] && dilepton_mass < jpsi_bin[1]) || - (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { - + (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { ParticleMass JPsi_mass = 3.0969; // Jpsi mass 3.096900±0.000006 ParticleMass Psi2S_mass = 3.6861; // Psi2S mass 3.6861093±0.0000034 ParticleMass mass_constraint = (dilepton_mass < jpsi_bin[1]) ? JPsi_mass : Psi2S_mass; @@ -243,12 +217,10 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co // Mass constraint is applied to the first two particles in the "particles" vector // Make sure that the first two particles are the ones you want to constrain KinVtxFitter constraint_fitter( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), - kaons_ttracks->at(k_idx) - }, - {l1_ptr->mass(), l2_ptr->mass(), K_MASS}, - {LEP_SIGMA, LEP_SIGMA, K_SIGMA}, - mass_constraint); + {leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), kaons_ttracks->at(k_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA}, + mass_constraint); if (constraint_fitter.success()) { auto constraint_p4 = constraint_fitter.fitted_p4(); cand.addUserFloat("constraint_sv_prob", constraint_fitter.prob()); @@ -256,15 +228,16 @@ void BToTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup co cand.addUserFloat("constraint_eta", constraint_p4.eta()); cand.addUserFloat("constraint_phi", constraint_p4.phi()); cand.addUserFloat("constraint_mass", constraint_fitter.fitted_candidate().mass()); - cand.addUserFloat("constraint_massErr", sqrt(constraint_fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("constraint_mll", (constraint_fitter.daughter_p4(0) + constraint_fitter.daughter_p4(1)).mass()); - } + cand.addUserFloat("constraint_massErr", + sqrt(constraint_fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("constraint_mll", + (constraint_fitter.daughter_p4(0) + constraint_fitter.daughter_p4(1)).mass()); + } } ret_val->push_back(cand); - } // for(size_t ll_idx = 0; ll_idx < dileptons->size(); ++ll_idx) { - } // for(size_t k_idx = 0; k_idx < kaons->size(); ++k_idx) - + } // for(size_t ll_idx = 0; ll_idx < dileptons->size(); ++ll_idx) { + } // for(size_t k_idx = 0; k_idx < kaons->size(); ++k_idx) evt.put(std::move(ret_val)); } diff --git a/PhysicsTools/BPHNano/plugins/BToTrkTrkLLBuilder.cc b/PhysicsTools/BPHNano/plugins/BToTrkTrkLLBuilder.cc index a4acb5d91d14..c9ec3cbff17f 100644 --- a/PhysicsTools/BPHNano/plugins/BToTrkTrkLLBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/BToTrkTrkLLBuilder.cc @@ -30,38 +30,35 @@ #include "KinVtxFitter.h" class BToTrkTrkLLBuilder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) public: typedef std::vector TransientTrackCollection; - explicit BToTrkTrkLLBuilder(const edm::ParameterSet &cfg): - bFieldToken_{esConsumes()}, - // selections - pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - //inputs - dileptons_{consumes( cfg.getParameter("dileptons") )}, - // dileptons_kinVtxs_{consumes >( cfg.getParameter("dileptonKinVtxs") )}, - ditracks_{consumes( cfg.getParameter("ditracks") )}, - leptons_ttracks_{consumes( cfg.getParameter("leptonTransientTracks") )}, - ditracks_ttracks_{consumes( cfg.getParameter("transientTracks") )}, - pu_tracks_(consumes(cfg.getParameter("PUtracks"))), - beamspot_{consumes( cfg.getParameter("beamSpot") )}, - dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} - { + explicit BToTrkTrkLLBuilder(const edm::ParameterSet &cfg) + : bFieldToken_{esConsumes()}, + // selections + pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + //inputs + dileptons_{consumes(cfg.getParameter("dileptons"))}, + // dileptons_kinVtxs_{consumes >( cfg.getParameter("dileptonKinVtxs") )}, + ditracks_{consumes(cfg.getParameter("ditracks"))}, + leptons_ttracks_{consumes(cfg.getParameter("leptonTransientTracks"))}, + ditracks_ttracks_{consumes(cfg.getParameter("transientTracks"))}, + pu_tracks_(consumes(cfg.getParameter("PUtracks"))), + beamspot_{consumes(cfg.getParameter("beamSpot"))}, + dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} { //output produces(); } ~BToTrkTrkLLBuilder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: - const edm::ESGetToken bFieldToken_; // selections @@ -77,16 +74,14 @@ private: const edm::EDGetTokenT pu_tracks_; const edm::EDGetTokenT beamspot_; const bool dilepton_constraint_; - }; void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &iSetup) const { - //input edm::Handle dileptons; evt.getByToken(dileptons_, dileptons); -// edm::Handle > dileptons_kinVtxs; -// evt.getByToken(dileptons_kinVtxs_, dileptons_kinVtxs); + // edm::Handle > dileptons_kinVtxs; + // evt.getByToken(dileptons_kinVtxs_, dileptons_kinVtxs); edm::Handle leptons_ttracks; evt.getByToken(leptons_ttracks_, leptons_ttracks); @@ -102,14 +97,12 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup evt.getByToken(beamspot_, beamspot); edm::ESHandle fieldHandle; - const auto& bField = iSetup.getData(bFieldToken_); + const auto &bField = iSetup.getData(bFieldToken_); AnalyticalImpactPointExtrapolator extrapolator(&bField); - // output std::unique_ptr ret_val(new pat::CompositeCandidateCollection()); - for (size_t ditracks_idx = 0; ditracks_idx < ditracks->size(); ++ditracks_idx) { // both k*,phi and lep pair already passed cuts; no need for more preselection edm::Ptr ditracks_ptr(ditracks, ditracks_idx); @@ -128,7 +121,7 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup // B0 candidate pat::CompositeCandidate cand; cand.setP4(ll_ptr->p4() + ditracks_ptr->p4()); - cand.setCharge( l1_ptr->charge() + l2_ptr->charge() + trk1_ptr->charge() + trk2_ptr->charge() ); + cand.setCharge(l1_ptr->charge() + l2_ptr->charge() + trk1_ptr->charge() + trk2_ptr->charge()); // save daughters - unfitted cand.addUserCand("l1", l1_ptr); @@ -143,62 +136,61 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup cand.addUserInt("l2_idx", l2_idx); cand.addUserInt("trk1_idx", trk1_idx); cand.addUserInt("trk2_idx", trk2_idx); - cand.addUserInt("ditrack_idx" , ditracks_idx); + cand.addUserInt("ditrack_idx", ditracks_idx); auto lep1_p4 = l1_ptr->polarP4(); auto lep2_p4 = l2_ptr->polarP4(); lep1_p4.SetM(l1_ptr->mass()); lep2_p4.SetM(l2_ptr->mass()); - auto trk1_p4=trk1_ptr->polarP4(); - auto trk2_p4=trk2_ptr->polarP4(); + auto trk1_p4 = trk1_ptr->polarP4(); + auto trk2_p4 = trk2_ptr->polarP4(); trk1_p4.SetM(K_MASS); - trk2_p4.SetM(K_MASS); - cand.addUserFloat("unfitted_B_mass_KK",(trk1_p4+trk2_p4+lep1_p4+lep2_p4).M()); + trk2_p4.SetM(K_MASS); + cand.addUserFloat("unfitted_B_mass_KK", (trk1_p4 + trk2_p4 + lep1_p4 + lep2_p4).M()); trk1_p4.SetM(K_MASS); trk2_p4.SetM(PI_MASS); - cand.addUserFloat("unfitted_B_mass_Kpi",(trk1_p4+trk2_p4+lep1_p4+lep2_p4).M()); + cand.addUserFloat("unfitted_B_mass_Kpi", (trk1_p4 + trk2_p4 + lep1_p4 + lep2_p4).M()); trk2_p4.SetM(K_MASS); trk1_p4.SetM(PI_MASS); - cand.addUserFloat("unfitted_B_mass_piK",(trk1_p4+trk2_p4+lep1_p4+lep2_p4).M()); + cand.addUserFloat("unfitted_B_mass_piK", (trk1_p4 + trk2_p4 + lep1_p4 + lep2_p4).M()); auto dr_info = min_max_dr({l1_ptr, l2_ptr, trk1_ptr, trk2_ptr}); cand.addUserFloat("min_dr", dr_info.first); cand.addUserFloat("max_dr", dr_info.second); - // check if pass pre vertex cut - if ( !pre_vtx_selection_(cand) ) continue; - - KinVtxFitter fitter( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), K_MASS, K_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA } - ); - if (!fitter.success()) continue; - KinVtxFitter fitter_Kpi( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), K_MASS, PI_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA } - ); - if (!fitter_Kpi.success()) continue; - KinVtxFitter fitter_piK( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), PI_MASS, K_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA } - ); - if (!fitter_piK.success()) continue; - + if (!pre_vtx_selection_(cand)) + continue; + + KinVtxFitter fitter({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS, K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}); + if (!fitter.success()) + continue; + KinVtxFitter fitter_Kpi({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS, PI_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}); + if (!fitter_Kpi.success()) + continue; + KinVtxFitter fitter_piK({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), PI_MASS, K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}); + if (!fitter_piK.success()) + continue; // B0 position - cand.setVertex( - reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() - ) - ); + cand.setVertex(reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); // vertex vars cand.addUserFloat("sv_chi2", fitter.chi2()); @@ -206,55 +198,59 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup cand.addUserFloat("sv_prob", fitter.prob()); // refitted kinematic vars - cand.addUserFloat("fitted_ditrack_mass_KK",(fitter.daughter_p4(2) + fitter.daughter_p4(3)).mass() ); - cand.addUserFloat("fitted_ditrack_mass_Kpi",(fitter_Kpi.daughter_p4(2) + fitter_Kpi.daughter_p4(3)).mass() ); - cand.addUserFloat("fitted_ditrack_mass_piK",(fitter_piK.daughter_p4(2) + fitter_piK.daughter_p4(3)).mass() ); - cand.addUserFloat("fitted_massErr_KK",sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("fitted_massErr_Kpi",sqrt(fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("fitted_massErr_piK",sqrt(fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - + cand.addUserFloat("fitted_ditrack_mass_KK", (fitter.daughter_p4(2) + fitter.daughter_p4(3)).mass()); + cand.addUserFloat("fitted_ditrack_mass_Kpi", (fitter_Kpi.daughter_p4(2) + fitter_Kpi.daughter_p4(3)).mass()); + cand.addUserFloat("fitted_ditrack_mass_piK", (fitter_piK.daughter_p4(2) + fitter_piK.daughter_p4(3)).mass()); + cand.addUserFloat("fitted_massErr_KK", sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("fitted_massErr_Kpi", + sqrt(fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("fitted_massErr_piK", + sqrt(fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("fitted_mll",(fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); + cand.addUserFloat("fitted_mll", (fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); auto fit_p4 = fitter.fitted_p4(); - cand.addUserFloat("fitted_pt" , fit_p4.pt()); - cand.addUserFloat("fitted_eta" , fit_p4.eta()); - cand.addUserFloat("fitted_phi" , fit_p4.phi()); + cand.addUserFloat("fitted_pt", fit_p4.pt()); + cand.addUserFloat("fitted_eta", fit_p4.eta()); + cand.addUserFloat("fitted_phi", fit_p4.phi()); cand.addUserFloat("fitted_mass_KK", fit_p4.phi()); - cand.addUserFloat("fitted_mass_Kpi", fitter_Kpi.fitted_p4().mass()); + cand.addUserFloat("fitted_mass_Kpi", fitter_Kpi.fitted_p4().mass()); cand.addUserFloat("fitted_mass_piK", fitter_piK.fitted_p4().mass()); // other vars - cand.addUserFloat("cos_theta_2D", - cos_theta_2D(fitter, *beamspot, cand.p4())); + cand.addUserFloat("cos_theta_2D", cos_theta_2D(fitter, *beamspot, cand.p4())); - cand.addUserFloat("fitted_cos_theta_2D", - cos_theta_2D(fitter, *beamspot, fit_p4)); + cand.addUserFloat("fitted_cos_theta_2D", cos_theta_2D(fitter, *beamspot, fit_p4)); auto lxy = l_xy(fitter, *beamspot); cand.addUserFloat("l_xy", lxy.value()); cand.addUserFloat("l_xy_unc", lxy.error()); // track impact parameter from dilepton SV - TrajectoryStateOnSurface tsos1 = extrapolator.extrapolate(ditracks_ttracks->at(trk1_idx).impactPointState(), fitter.fitted_vtx()); - std::pair cur2DIP1 = signedTransverseImpactParameter(tsos1, fitter.fitted_refvtx(), *beamspot); - cand.addUserFloat("trk1_svip2d" , cur2DIP1.second.value()); - cand.addUserFloat("trk1_svip2d_err" , cur2DIP1.second.error()); + TrajectoryStateOnSurface tsos1 = + extrapolator.extrapolate(ditracks_ttracks->at(trk1_idx).impactPointState(), fitter.fitted_vtx()); + std::pair cur2DIP1 = + signedTransverseImpactParameter(tsos1, fitter.fitted_refvtx(), *beamspot); + cand.addUserFloat("trk1_svip2d", cur2DIP1.second.value()); + cand.addUserFloat("trk1_svip2d_err", cur2DIP1.second.error()); - TrajectoryStateOnSurface tsos2 = extrapolator.extrapolate(ditracks_ttracks->at(trk2_idx).impactPointState(), fitter.fitted_vtx()); - std::pair cur2DIP2 = signedTransverseImpactParameter(tsos2, fitter.fitted_refvtx(), *beamspot); - cand.addUserFloat("trk2_svip2d" , cur2DIP2.second.value()); - cand.addUserFloat("trk2_svip2d_err" , cur2DIP2.second.error()); + TrajectoryStateOnSurface tsos2 = + extrapolator.extrapolate(ditracks_ttracks->at(trk2_idx).impactPointState(), fitter.fitted_vtx()); + std::pair cur2DIP2 = + signedTransverseImpactParameter(tsos2, fitter.fitted_refvtx(), *beamspot); + cand.addUserFloat("trk2_svip2d", cur2DIP2.second.value()); + cand.addUserFloat("trk2_svip2d_err", cur2DIP2.second.error()); // post fit selection - if ( !post_vtx_selection_(cand) ) continue; + if (!post_vtx_selection_(cand)) + continue; cand.addUserFloat("vtx_x", cand.vx()); cand.addUserFloat("vtx_y", cand.vy()); cand.addUserFloat("vtx_z", cand.vz()); - const auto& covMatrix = fitter.fitted_vtx_uncertainty(); + const auto &covMatrix = fitter.fitted_vtx_uncertainty(); cand.addUserFloat("vtx_cxx", covMatrix.cxx()); cand.addUserFloat("vtx_cyy", covMatrix.cyy()); cand.addUserFloat("vtx_czz", covMatrix.czz()); @@ -263,16 +259,16 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup cand.addUserFloat("vtx_czy", covMatrix.czy()); // refitted daughters (leptons/tracks) - std::vector dnames{ "l1", "l2", "trk1", "trk2" }; + std::vector dnames{"l1", "l2", "trk1", "trk2"}; for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { - cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt" , fitter.daughter_p4(idaughter).pt() ); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", fitter.daughter_p4(idaughter).eta() ); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", fitter.daughter_p4(idaughter).phi() ); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt", fitter.daughter_p4(idaughter).pt()); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", fitter.daughter_p4(idaughter).eta()); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", fitter.daughter_p4(idaughter).phi()); } //compute isolation - std::vector isos = TrackerIsolation(pu_tracks, cand, dnames ); + std::vector isos = TrackerIsolation(pu_tracks, cand, dnames); for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { cand.addUserFloat(dnames[idaughter] + "_iso04", isos[idaughter]); } @@ -283,19 +279,18 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup cand.addUserFloat("constraint_phi", -99); cand.addUserFloat("constraint_mass_KK", -99); cand.addUserFloat("constraint_mass_Kpi", -99); - cand.addUserFloat("constraint_mass_piK", -99); + cand.addUserFloat("constraint_mass_piK", -99); cand.addUserFloat("constraint_massErr_KK", -99); cand.addUserFloat("constraint_massErr_Kpi", -99); - cand.addUserFloat("constraint_massErr_piK", -99); - cand.addUserFloat("constraint_mll" , -99); + cand.addUserFloat("constraint_massErr_piK", -99); + cand.addUserFloat("constraint_mll", -99); const double dilepton_mass = ll_ptr->userFloat("fitted_mass"); const double jpsi_bin[2] = {2.8, 3.35}; const double psi2s_bin[2] = {3.45, 3.85}; if (dilepton_constraint_ && ((dilepton_mass > jpsi_bin[0] && dilepton_mass < jpsi_bin[1]) || - (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { - + (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { ParticleMass JPsi_mass = 3.0969; // Jpsi mass 3.096900±0.000006 ParticleMass Psi2S_mass = 3.6861; // Psi2S mass 3.6861093±0.0000034 ParticleMass mass_constraint = (dilepton_mass < jpsi_bin[1]) ? JPsi_mass : Psi2S_mass; @@ -303,24 +298,33 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup // Mass constraint is applied to the first two particles in the "particles" vector // Make sure that the first two particles are the ones you want to constrain - KinVtxFitter constraint_fitter_KK( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), K_MASS, K_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, - mass_constraint); - if (!constraint_fitter_KK.success()) continue; - KinVtxFitter constraint_fitter_Kpi( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), K_MASS, PI_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, - mass_constraint); - if (!constraint_fitter_Kpi.success()) continue; - KinVtxFitter constraint_fitter_piK( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), ditracks_ttracks->at(trk1_idx), ditracks_ttracks->at(trk2_idx)}, - { l1_ptr->mass(), l2_ptr->mass(), PI_MASS, K_MASS}, - { LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, - mass_constraint); - if (!constraint_fitter_piK.success()) continue; + KinVtxFitter constraint_fitter_KK({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS, K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, + mass_constraint); + if (!constraint_fitter_KK.success()) + continue; + KinVtxFitter constraint_fitter_Kpi({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), K_MASS, PI_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, + mass_constraint); + if (!constraint_fitter_Kpi.success()) + continue; + KinVtxFitter constraint_fitter_piK({leptons_ttracks->at(l1_idx), + leptons_ttracks->at(l2_idx), + ditracks_ttracks->at(trk1_idx), + ditracks_ttracks->at(trk2_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), PI_MASS, K_MASS}, + {LEP_SIGMA, LEP_SIGMA, K_SIGMA, K_SIGMA}, + mass_constraint); + if (!constraint_fitter_piK.success()) + continue; if (constraint_fitter_KK.success()) { auto constraint_p4 = constraint_fitter_KK.fitted_p4(); @@ -329,20 +333,24 @@ void BToTrkTrkLLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup cand.addUserFloat("constraint_eta", constraint_p4.eta()); cand.addUserFloat("constraint_phi", constraint_p4.phi()); cand.addUserFloat("constraint_mass_KK", constraint_fitter_KK.fitted_candidate().mass()); - cand.addUserFloat("constraint_massErr_KK",sqrt(constraint_fitter_KK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("constraint_massErr_KK", + sqrt(constraint_fitter_KK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); cand.addUserFloat("constraint_mass_Kpi", constraint_fitter_Kpi.fitted_candidate().mass()); - cand.addUserFloat("constraint_massErr_Kpi",sqrt(constraint_fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("constraint_massErr_Kpi", + sqrt(constraint_fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6, 6))); cand.addUserFloat("constraint_mass_piK", constraint_fitter_piK.fitted_candidate().mass()); - cand.addUserFloat("constraint_massErr_piK",sqrt(constraint_fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("constraint_mll",(constraint_fitter_KK.daughter_p4(0) + constraint_fitter_KK.daughter_p4(1)).mass()); + cand.addUserFloat("constraint_massErr_piK", + sqrt(constraint_fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("constraint_mll", + (constraint_fitter_KK.daughter_p4(0) + constraint_fitter_KK.daughter_p4(1)).mass()); } } ret_val->push_back(cand); - } // for(size_t ll_idx = 0; ll_idx < dileptons->size(); ++ll_idx) { + } // for(size_t ll_idx = 0; ll_idx < dileptons->size(); ++ll_idx) { - } // for(size_t k_idx = 0; k_idx < ditracks->size(); ++k_idx) + } // for(size_t k_idx = 0; k_idx < ditracks->size(); ++k_idx) evt.put(std::move(ret_val)); } diff --git a/PhysicsTools/BPHNano/plugins/BToV0LLBuilder.cc b/PhysicsTools/BPHNano/plugins/BToV0LLBuilder.cc index 1a5f5a06232a..7c36415af7f6 100644 --- a/PhysicsTools/BPHNano/plugins/BToV0LLBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/BToV0LLBuilder.cc @@ -43,38 +43,32 @@ #include "helper.h" class BToV0LLBuilder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) public: typedef std::vector TransientTrackCollection; - explicit BToV0LLBuilder(const edm::ParameterSet &cfg): - bFieldToken_{esConsumes()}, - pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - dileptons_{consumes( cfg.getParameter("dileptons") )}, -// dileptons_kinVtxs_{consumes >( cfg.getParameter("dileptonKinVtxs") )}, - leptons_ttracks_{consumes( cfg.getParameter("leptonTransientTracks") )}, - v0s_{consumes( cfg.getParameter("v0s") )}, - v0_ttracks_{consumes( cfg.getParameter("v0TransientTracks") )}, - pu_tracks_(consumes(cfg.getParameter("PUtracks"))), - beamspot_{consumes( cfg.getParameter("beamSpot") )}, - dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} - { + explicit BToV0LLBuilder(const edm::ParameterSet &cfg) + : bFieldToken_{esConsumes()}, + pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + dileptons_{consumes(cfg.getParameter("dileptons"))}, + // dileptons_kinVtxs_{consumes >( cfg.getParameter("dileptonKinVtxs") )}, + leptons_ttracks_{consumes(cfg.getParameter("leptonTransientTracks"))}, + v0s_{consumes(cfg.getParameter("v0s"))}, + v0_ttracks_{consumes(cfg.getParameter("v0TransientTracks"))}, + pu_tracks_(consumes(cfg.getParameter("PUtracks"))), + beamspot_{consumes(cfg.getParameter("beamSpot"))}, + dilepton_constraint_{cfg.getParameter("dileptonMassContraint")} { produces(); } - ~BToV0LLBuilder() override {} - - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} - private: - const edm::ESGetToken bFieldToken_; // selection @@ -92,9 +86,7 @@ private: const bool dilepton_constraint_; }; - void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &iSetup) const { - //input edm::Handle dileptons; evt.getByToken(dileptons_, dileptons); @@ -115,7 +107,7 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con evt.getByToken(beamspot_, beamspot); edm::ESHandle fieldHandle; - const auto& bField = iSetup.getData(bFieldToken_); + const auto &bField = iSetup.getData(bFieldToken_); AnalyticalImpactPointExtrapolator extrapolator(&bField); // output @@ -123,7 +115,6 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con //access V0 for (size_t v0_idx = 0; v0_idx < v0s->size(); ++v0_idx) { - edm::Ptr v0_ptr(v0s, v0_idx); // access ll @@ -143,7 +134,7 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con cand.addUserInt("ll_idx", ll_idx); cand.addUserInt("v0_idx", v0_idx); - auto dr_info = min_max_dr({l1_ptr, l2_ptr, v0_ptr }); + auto dr_info = min_max_dr({l1_ptr, l2_ptr, v0_ptr}); cand.addUserFloat("min_dr", dr_info.first); cand.addUserFloat("max_dr", dr_info.second); @@ -151,27 +142,19 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con if (!pre_vtx_selection_(cand)) continue; - KinVtxFitter fitter( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), - v0_ttracks->at(v0_idx) - }, - {l1_ptr->mass(), l2_ptr->mass(), v0_ptr->mass()}, - {LEP_SIGMA, LEP_SIGMA, v0_ptr->userFloat("massErr")} ); + KinVtxFitter fitter({leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), v0_ttracks->at(v0_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), v0_ptr->mass()}, + {LEP_SIGMA, LEP_SIGMA, v0_ptr->userFloat("massErr")}); if (!fitter.success()) continue; - cand.setVertex( reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() ) - ); + cand.setVertex(reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); cand.addUserFloat("sv_chi2", fitter.chi2()); cand.addUserFloat("sv_ndof", fitter.dof()); cand.addUserFloat("sv_prob", fitter.prob()); - cand.addUserFloat("fitted_mll", - (fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); + cand.addUserFloat("fitted_mll", (fitter.daughter_p4(0) + fitter.daughter_p4(1)).mass()); cand.addUserFloat("fitted_v0_mass", fitter.daughter_p4(2).mass()); auto fit_p4 = fitter.fitted_p4(); @@ -179,29 +162,28 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con cand.addUserFloat("fitted_eta", fit_p4.eta()); cand.addUserFloat("fitted_phi", fit_p4.phi()); cand.addUserFloat("fitted_mass", fitter.fitted_candidate().mass()); - cand.addUserFloat("fitted_massErr", - sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("cos_theta_2D", - cos_theta_2D(fitter, *beamspot, cand.p4())); - cand.addUserFloat("fitted_cos_theta_2D", - cos_theta_2D(fitter, *beamspot, fit_p4)); + cand.addUserFloat("fitted_massErr", sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("cos_theta_2D", cos_theta_2D(fitter, *beamspot, cand.p4())); + cand.addUserFloat("fitted_cos_theta_2D", cos_theta_2D(fitter, *beamspot, fit_p4)); auto lxy = l_xy(fitter, *beamspot); cand.addUserFloat("l_xy", lxy.value()); cand.addUserFloat("l_xy_unc", lxy.error()); - TrajectoryStateOnSurface tsos = extrapolator.extrapolate(v0_ttracks->at(v0_idx).impactPointState(), fitter.fitted_vtx()); + TrajectoryStateOnSurface tsos = + extrapolator.extrapolate(v0_ttracks->at(v0_idx).impactPointState(), fitter.fitted_vtx()); std::pair cur2DIP = signedTransverseImpactParameter(tsos, fitter.fitted_refvtx(), *beamspot); - cand.addUserFloat("v0_svip2d" , cur2DIP.second.value()); - cand.addUserFloat("v0_svip2d_err" , cur2DIP.second.error()); + cand.addUserFloat("v0_svip2d", cur2DIP.second.value()); + cand.addUserFloat("v0_svip2d_err", cur2DIP.second.error()); - if (!post_vtx_selection_(cand)) continue; + if (!post_vtx_selection_(cand)) + continue; cand.addUserFloat("vtx_x", cand.vx()); cand.addUserFloat("vtx_y", cand.vy()); cand.addUserFloat("vtx_z", cand.vz()); - const auto& covMatrix = fitter.fitted_vtx_uncertainty(); + const auto &covMatrix = fitter.fitted_vtx_uncertainty(); cand.addUserFloat("vtx_cxx", covMatrix.cxx()); cand.addUserFloat("vtx_cyy", covMatrix.cyy()); cand.addUserFloat("vtx_czz", covMatrix.czz()); @@ -210,16 +192,15 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con cand.addUserFloat("vtx_czy", covMatrix.czy()); // refitted daughters (leptons/tracks) - std::vector dnames{ "l1", "l2", "v0" }; + std::vector dnames{"l1", "l2", "v0"}; for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { - cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt" , fitter.daughter_p4(idaughter).pt() ); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", fitter.daughter_p4(idaughter).eta() ); - cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", fitter.daughter_p4(idaughter).phi() ); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_pt", fitter.daughter_p4(idaughter).pt()); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_eta", fitter.daughter_p4(idaughter).eta()); + cand.addUserFloat("fitted_" + dnames[idaughter] + "_phi", fitter.daughter_p4(idaughter).phi()); } - //compute isolation - std::vector isos = TrackerIsolation(pu_tracks, cand, dnames ); + std::vector isos = TrackerIsolation(pu_tracks, cand, dnames); for (size_t idaughter = 0; idaughter < dnames.size(); idaughter++) { cand.addUserFloat(dnames[idaughter] + "_iso04", isos[idaughter]); } @@ -230,15 +211,14 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con cand.addUserFloat("constraint_phi", -99); cand.addUserFloat("constraint_mass", -99); cand.addUserFloat("constraint_massErr", -99); - cand.addUserFloat("constraint_mll" , -99); + cand.addUserFloat("constraint_mll", -99); const double dilepton_mass = ll_ptr->userFloat("fitted_mass"); const double jpsi_bin[2] = {2.8, 3.35}; const double psi2s_bin[2] = {3.45, 3.85}; if (dilepton_constraint_ && ((dilepton_mass > jpsi_bin[0] && dilepton_mass < jpsi_bin[1]) || - (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { - + (dilepton_mass > psi2s_bin[0] && dilepton_mass < psi2s_bin[1]))) { ParticleMass JPsi_mass = 3.0969; // Jpsi mass 3.096900±0.000006 ParticleMass Psi2S_mass = 3.6861; // Psi2S mass 3.6861093±0.0000034 ParticleMass mass_constraint = (dilepton_mass < jpsi_bin[1]) ? JPsi_mass : Psi2S_mass; @@ -246,10 +226,10 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con // Mass constraint is applied to the first two particles in the "particles" vector // Make sure that the first two particles are the ones you want to constrain KinVtxFitter constraint_fitter( - { leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx),v0_ttracks->at(v0_idx)}, - {l1_ptr->mass(), l2_ptr->mass(),v0_ptr->mass()}, - {LEP_SIGMA, LEP_SIGMA, v0_ptr->userFloat("massErr")}, - mass_constraint); + {leptons_ttracks->at(l1_idx), leptons_ttracks->at(l2_idx), v0_ttracks->at(v0_idx)}, + {l1_ptr->mass(), l2_ptr->mass(), v0_ptr->mass()}, + {LEP_SIGMA, LEP_SIGMA, v0_ptr->userFloat("massErr")}, + mass_constraint); if (constraint_fitter.success()) { auto constraint_p4 = constraint_fitter.fitted_p4(); cand.addUserFloat("constraint_sv_prob", constraint_fitter.prob()); @@ -257,8 +237,10 @@ void BToV0LLBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con cand.addUserFloat("constraint_eta", constraint_p4.eta()); cand.addUserFloat("constraint_phi", constraint_p4.phi()); cand.addUserFloat("constraint_mass", constraint_fitter.fitted_candidate().mass()); - cand.addUserFloat("constraint_massErr", sqrt(constraint_fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("constraint_mll", (constraint_fitter.daughter_p4(0) + constraint_fitter.daughter_p4(1)).mass()); + cand.addUserFloat("constraint_massErr", + sqrt(constraint_fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("constraint_mll", + (constraint_fitter.daughter_p4(0) + constraint_fitter.daughter_p4(1)).mass()); } } diff --git a/PhysicsTools/BPHNano/plugins/CandMCMatchTableProducerBPH.cc b/PhysicsTools/BPHNano/plugins/CandMCMatchTableProducerBPH.cc index 23a08ca8037b..9915ead2d2ca 100644 --- a/PhysicsTools/BPHNano/plugins/CandMCMatchTableProducerBPH.cc +++ b/PhysicsTools/BPHNano/plugins/CandMCMatchTableProducerBPH.cc @@ -13,56 +13,76 @@ #include "DataFormats/HepMCCandidate/interface/GenParticle.h" #include "DataFormats/HepMCCandidate/interface/GenParticleFwd.h" - #include #include - class CandMCMatchTableProducerBPH : public edm::global::EDProducer<> { public: - CandMCMatchTableProducerBPH( edm::ParameterSet const & params ) : - objName_(params.getParameter("objName")), - objBranchName_(params.getParameter("objBranchName")), - genBranchName_(params.getParameter("genBranchName")), - doc_(params.getParameter("docString")), - recoObjects_(consumes(params.getParameter("recoObjects"))), - genParts_(consumes(params.getParameter("genParts"))), - candMap_(consumes>(params.getParameter("mcMap"))) - { + CandMCMatchTableProducerBPH(edm::ParameterSet const& params) + : objName_(params.getParameter("objName")), + objBranchName_(params.getParameter("objBranchName")), + genBranchName_(params.getParameter("genBranchName")), + doc_(params.getParameter("docString")), + recoObjects_(consumes(params.getParameter("recoObjects"))), + genParts_(consumes(params.getParameter("genParts"))), + candMap_(consumes>(params.getParameter("mcMap"))) { produces(); - const std::string & type = params.getParameter("objType"); - if (type == "Muon") type_ = MMuon; - else if (type == "Electron") type_ = MElectron; - else if (type == "Tau") type_ = MTau; - else if (type == "Photon") type_ = MPhoton; - else if (type == "Track") type_ = MTrack; - else if (type == "Other") type_ = MOther; - else throw cms::Exception("Configuration", "Unsupported objType '" + type + "'\n"); + const std::string& type = params.getParameter("objType"); + if (type == "Muon") + type_ = MMuon; + else if (type == "Electron") + type_ = MElectron; + else if (type == "Tau") + type_ = MTau; + else if (type == "Photon") + type_ = MPhoton; + else if (type == "Track") + type_ = MTrack; + else if (type == "Other") + type_ = MOther; + else + throw cms::Exception("Configuration", "Unsupported objType '" + type + "'\n"); std::cout << "type = " << type << std::endl; switch (type_) { - case MMuon: flavDoc_ = "1 = prompt muon (including gamma*->mu mu), 15 = muon from prompt tau, " // continues below - "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; + case MMuon: + flavDoc_ = + "1 = prompt muon (including gamma*->mu mu), 15 = muon from prompt tau, " // continues below + "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; - case MElectron: flavDoc_ = "1 = prompt electron (including gamma*->mu mu), 15 = electron from prompt tau, " // continues below - "22 = prompt photon (likely conversion), " // continues below - "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; - case MPhoton: flavDoc_ = "1 = prompt photon, 13 = prompt electron, 0 = unknown or unmatched"; break; - case MTau: flavDoc_ = "1 = prompt electron, 2 = prompt muon, 3 = tau->e decay, 4 = tau->mu decay, 5 = hadronic tau decay, 0 = unknown or unmatched"; break; - case MTrack: flavDoc_ = "1 = prompt, 511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; + case MElectron: + flavDoc_ = + "1 = prompt electron (including gamma*->mu mu), 15 = electron from prompt tau, " // continues below + "22 = prompt photon (likely conversion), " // continues below + "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; + case MPhoton: + flavDoc_ = "1 = prompt photon, 13 = prompt electron, 0 = unknown or unmatched"; + break; + case MTau: + flavDoc_ = + "1 = prompt electron, 2 = prompt muon, 3 = tau->e decay, 4 = tau->mu decay, 5 = hadronic tau decay, 0 = " + "unknown or unmatched"; + break; + case MTrack: + flavDoc_ = "1 = prompt, 511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; - case MOther: flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; break; + case MOther: + flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; + break; } - if ( type_ == MTau ) { - candMapVisTau_ = consumes>(params.getParameter("mcMapVisTau")); + if (type_ == MTau) { + candMapVisTau_ = + consumes>(params.getParameter("mcMapVisTau")); } } ~CandMCMatchTableProducerBPH() override {} void produce(edm::StreamID id, edm::Event& iEvent, const edm::EventSetup& iSetup) const override { - edm::Handle cands; iEvent.getByToken(recoObjects_, cands); unsigned int ncand = cands->size(); @@ -71,14 +91,14 @@ public: iEvent.getByToken(genParts_, gen_parts); unsigned int ngen = gen_parts->size(); - auto tab = std::make_unique(ncand, objName_, false, true); - auto tab_reverse = std::make_unique(ngen, "GenPart", false, true); + auto tab = std::make_unique(ncand, objName_, false, true); + auto tab_reverse = std::make_unique(ngen, "GenPart", false, true); edm::Handle> map; iEvent.getByToken(candMap_, map); edm::Handle> mapVisTau; - if ( type_ == MTau ) { + if (type_ == MTau) { iEvent.getByToken(candMapVisTau_, mapVisTau); } @@ -89,48 +109,60 @@ public: //std::cout << "cand #" << i << ": pT = " << cands->ptrAt(i)->pt() << ", eta = " << cands->ptrAt(i)->eta() << ", phi = " << cands->ptrAt(i)->phi() << std::endl; reco::GenParticleRef match = (*map)[cands->ptrAt(i)]; reco::GenParticleRef matchVisTau; - if ( type_ == MTau ) { + if (type_ == MTau) { matchVisTau = (*mapVisTau)[cands->ptrAt(i)]; } - if ( match.isNonnull() ) { + if (match.isNonnull()) { key[i] = match.key(); genkey[match.key()] = i; - } - else if ( matchVisTau.isNonnull() ) key[i] = matchVisTau.key(); - else continue; + } else if (matchVisTau.isNonnull()) + key[i] = matchVisTau.key(); + else + continue; switch (type_) { - case MMuon: - if (match->isPromptFinalState()) flav[i] = 1; // prompt - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - case MElectron: - if (match->isPromptFinalState()) flav[i] = (match->pdgId() == 22 ? 22 : 1); // prompt electron or photon - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - case MPhoton: - if (match->isPromptFinalState()) flav[i] = (match->pdgId() == 22 ? 1 : 13); // prompt electron or photon - break; - case MTau: - // CV: assignment of status codes according to https://twiki.cern.ch/twiki/bin/viewauth/CMS/HiggsToTauTauWorking2016#MC_Matching - if ( match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 11 ) flav[i] = 1; - else if ( match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 13 ) flav[i] = 2; - else if ( match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 11 ) flav[i] = 3; - else if ( match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 13 ) flav[i] = 4; - else if ( matchVisTau.isNonnull() ) flav[i] = 5; - break; - case MTrack: - if (match->isPromptFinalState()) flav[i] = 1; //prompt - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - default: - flav[i] = match->statusFlags().fromHardProcess(); + case MMuon: + if (match->isPromptFinalState()) + flav[i] = 1; // prompt + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + case MElectron: + if (match->isPromptFinalState()) + flav[i] = (match->pdgId() == 22 ? 22 : 1); // prompt electron or photon + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + case MPhoton: + if (match->isPromptFinalState()) + flav[i] = (match->pdgId() == 22 ? 1 : 13); // prompt electron or photon + break; + case MTau: + // CV: assignment of status codes according to https://twiki.cern.ch/twiki/bin/viewauth/CMS/HiggsToTauTauWorking2016#MC_Matching + if (match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 11) + flav[i] = 1; + else if (match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 13) + flav[i] = 2; + else if (match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 11) + flav[i] = 3; + else if (match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 13) + flav[i] = 4; + else if (matchVisTau.isNonnull()) + flav[i] = 5; + break; + case MTrack: + if (match->isPromptFinalState()) + flav[i] = 1; //prompt + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + default: + flav[i] = match->statusFlags().fromHardProcess(); }; } - - tab->addColumn(objBranchName_ + "Idx", key, "Index into genParticle list for " + doc_); + tab->addColumn(objBranchName_ + "Idx", key, "Index into genParticle list for " + doc_); tab->addColumn(objBranchName_ + "Flav", flav, "Flavour of genParticle for " + doc_ + ": " + flavDoc_); - tab_reverse->addColumn(genBranchName_ + "Idx", genkey, "Index into genParticle list for " + doc_); + tab_reverse->addColumn(genBranchName_ + "Idx", genkey, "Index into genParticle list for " + doc_); iEvent.put(std::move(tab)); iEvent.put(std::move(tab_reverse)); @@ -139,25 +171,37 @@ public: static int getParentHadronFlag(const reco::GenParticleRef match) { for (unsigned int im = 0, nm = match->numberOfMothers(); im < nm; ++im) { reco::GenParticleRef mom = match->motherRef(im); - assert(mom.isNonnull() && mom.isAvailable()); // sanity - if (mom.key() >= match.key()) continue; // prevent circular refs + assert(mom.isNonnull() && mom.isAvailable()); // sanity + if (mom.key() >= match.key()) + continue; // prevent circular refs int id = std::abs(mom->pdgId()); return id; } return 0; } - static void fillDescriptions(edm::ConfigurationDescriptions & descriptions) { + static void fillDescriptions(edm::ConfigurationDescriptions& descriptions) { edm::ParameterSetDescription desc; desc.add("objName")->setComment("name of the nanoaod::FlatTable to extend with this table"); - desc.add("objBranchName")->setComment("name of the column to write (the final branch in the nanoaod will be _Idx and _Flav"); - desc.add("genBranchName")->setComment("name of the column to write (the final branch in the nanoaod will be _Idx and _Flav"); + desc.add("objBranchName") + ->setComment( + "name of the column to write (the final branch in the nanoaod will be _Idx and " + "_Flav"); + desc.add("genBranchName") + ->setComment( + "name of the column to write (the final branch in the nanoaod will be _Idx and " + "_Flav"); desc.add("docString")->setComment("documentation to forward to the output"); - desc.add("recoObjects")->setComment("physics object collection for the reconstructed objects (e.g. leptons)"); - desc.add("genParts")->setComment("physics object collection for the reconstructed objects (e.g. leptons)"); - desc.add("mcMap")->setComment("tag to an edm::Association mapping src to gen, such as the one produced by MCMatcher"); - desc.add("objType")->setComment("type of object to match (Muon, Electron, Tau, Photon, Track, Other), taylors what's in t Flav branch"); - desc.addOptional("mcMapVisTau")->setComment("as mcMap, but pointing to the visible gen taus (only if objType == Tau)"); + desc.add("recoObjects") + ->setComment("physics object collection for the reconstructed objects (e.g. leptons)"); + desc.add("genParts") + ->setComment("physics object collection for the reconstructed objects (e.g. leptons)"); + desc.add("mcMap")->setComment( + "tag to an edm::Association mapping src to gen, such as the one produced by MCMatcher"); + desc.add("objType")->setComment( + "type of object to match (Muon, Electron, Tau, Photon, Track, Other), taylors what's in t Flav branch"); + desc.addOptional("mcMapVisTau") + ->setComment("as mcMap, but pointing to the visible gen taus (only if objType == Tau)"); descriptions.add("candMcMatchTable", desc); } @@ -173,4 +217,3 @@ protected: #include "FWCore/Framework/interface/MakerMacros.h" DEFINE_FWK_MODULE(CandMCMatchTableProducerBPH); - diff --git a/PhysicsTools/BPHNano/plugins/DiLeptonBuilder.cc b/PhysicsTools/BPHNano/plugins/DiLeptonBuilder.cc index c832a2fab029..0cae5d751044 100644 --- a/PhysicsTools/BPHNano/plugins/DiLeptonBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/DiLeptonBuilder.cc @@ -20,42 +20,40 @@ #include #include "KinVtxFitter.h" -template +template class DiLeptonBuilder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) public: typedef std::vector LeptonCollection; typedef std::vector TransientTrackCollection; - explicit DiLeptonBuilder(const edm::ParameterSet &cfg): - l1_selection_{cfg.getParameter("lep1Selection")}, - l2_selection_{cfg.getParameter("lep2Selection")}, - pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - src_{consumes( cfg.getParameter("src") )}, - ttracks_src_{consumes( cfg.getParameter("transientTracksSrc") )} { + explicit DiLeptonBuilder(const edm::ParameterSet &cfg) + : l1_selection_{cfg.getParameter("lep1Selection")}, + l2_selection_{cfg.getParameter("lep2Selection")}, + pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + src_{consumes(cfg.getParameter("src"))}, + ttracks_src_{consumes(cfg.getParameter("transientTracksSrc"))} { produces("SelectedDiLeptons"); } ~DiLeptonBuilder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: - const StringCutObjectSelector l1_selection_; // cut on leading lepton - const StringCutObjectSelector l2_selection_; // cut on sub-leading lepton - const StringCutObjectSelector pre_vtx_selection_; // cut on the di-lepton before the SV fit - const StringCutObjectSelector post_vtx_selection_; // cut on the di-lepton after the SV fit + const StringCutObjectSelector l1_selection_; // cut on leading lepton + const StringCutObjectSelector l2_selection_; // cut on sub-leading lepton + const StringCutObjectSelector pre_vtx_selection_; // cut on the di-lepton before the SV fit + const StringCutObjectSelector post_vtx_selection_; // cut on the di-lepton after the SV fit const edm::EDGetTokenT src_; const edm::EDGetTokenT ttracks_src_; }; -template +template void DiLeptonBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &) const { - //input edm::Handle leptons; evt.getByToken(src_, leptons); @@ -65,15 +63,17 @@ void DiLeptonBuilder::produce(edm::StreamID, edm::Event &evt, edm::Event // output std::unique_ptr ret_value(new pat::CompositeCandidateCollection()); - std::unique_ptr > kinVtx_out( new std::vector ); + std::unique_ptr > kinVtx_out(new std::vector); for (size_t l1_idx = 0; l1_idx < leptons->size(); ++l1_idx) { edm::Ptr l1_ptr(leptons, l1_idx); - if (!l1_selection_(*l1_ptr)) continue; + if (!l1_selection_(*l1_ptr)) + continue; for (size_t l2_idx = l1_idx + 1; l2_idx < leptons->size(); ++l2_idx) { edm::Ptr l2_ptr(leptons, l2_idx); - if (!l2_selection_(*l2_ptr)) continue; + if (!l2_selection_(*l2_ptr)) + continue; pat::CompositeCandidate lepton_pair; lepton_pair.setP4(l1_ptr->p4() + l2_ptr->p4()); @@ -81,33 +81,31 @@ void DiLeptonBuilder::produce(edm::StreamID, edm::Event &evt, edm::Event lepton_pair.addUserFloat("lep_deltaR", reco::deltaR(*l1_ptr, *l2_ptr)); // Put the lepton passing the corresponding selection - lepton_pair.addUserInt("l1_idx", l1_idx ); - lepton_pair.addUserInt("l2_idx", l2_idx ); + lepton_pair.addUserInt("l1_idx", l1_idx); + lepton_pair.addUserInt("l2_idx", l2_idx); // Use UserCands as they should not use memory but keep the Ptr itself - lepton_pair.addUserCand("l1", l1_ptr ); - lepton_pair.addUserCand("l2", l2_ptr ); - if ( !pre_vtx_selection_(lepton_pair) ) continue; // before making the SV, cut on the info we have + lepton_pair.addUserCand("l1", l1_ptr); + lepton_pair.addUserCand("l2", l2_ptr); + if (!pre_vtx_selection_(lepton_pair)) + continue; // before making the SV, cut on the info we have KinVtxFitter fitter( - {ttracks->at(l1_idx), ttracks->at(l2_idx)}, - {l1_ptr->mass(), l2_ptr->mass()}, - {LEP_SIGMA, LEP_SIGMA} //some small sigma for the particle mass - ); - if ( !fitter.success() ) continue; - lepton_pair.setVertex( - reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() - ) + {ttracks->at(l1_idx), ttracks->at(l2_idx)}, {l1_ptr->mass(), l2_ptr->mass()}, {LEP_SIGMA, LEP_SIGMA} + //some small sigma for the particle mass ); + if (!fitter.success()) + continue; + lepton_pair.setVertex( + reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); lepton_pair.addUserInt("sv_ok", fitter.success() ? 1 : 0); lepton_pair.addUserFloat("sv_chi2", fitter.chi2()); - lepton_pair.addUserFloat("sv_ndof", fitter.dof()); // float?? + lepton_pair.addUserFloat("sv_ndof", fitter.dof()); // float?? lepton_pair.addUserFloat("sv_prob", fitter.prob()); lepton_pair.addUserFloat("fitted_mass", fitter.success() ? fitter.fitted_candidate().mass() : -1); - lepton_pair.addUserFloat("fitted_massErr", fitter.success() ? sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6)) : -1); + lepton_pair.addUserFloat( + "fitted_massErr", + fitter.success() ? sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6)) : -1); lepton_pair.addUserFloat("vtx_x", lepton_pair.vx()); lepton_pair.addUserFloat("vtx_y", lepton_pair.vy()); lepton_pair.addUserFloat("vtx_z", lepton_pair.vz()); @@ -115,7 +113,8 @@ void DiLeptonBuilder::produce(edm::StreamID, edm::Event &evt, edm::Event // if needed, add here more stuff // cut on the SV info - if ( !post_vtx_selection_(lepton_pair) ) continue; + if (!post_vtx_selection_(lepton_pair)) + continue; ret_value->push_back(lepton_pair); } } diff --git a/PhysicsTools/BPHNano/plugins/DiTrackBuilder.cc b/PhysicsTools/BPHNano/plugins/DiTrackBuilder.cc index 3347e53459a7..5294abd4aece 100644 --- a/PhysicsTools/BPHNano/plugins/DiTrackBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/DiTrackBuilder.cc @@ -3,8 +3,6 @@ // takes selected track collection and a mass hypothesis and produces ditrack ca // -ndidates - - #include "FWCore/Framework/interface/global/EDProducer.h" #include "FWCore/Framework/interface/Event.h" #include "FWCore/ParameterSet/interface/ParameterSet.h" @@ -27,54 +25,44 @@ #include #include "KinVtxFitter.h" - - - class DiTrackBuilder : public edm::global::EDProducer<> { - - public: - typedef std::vector TransientTrackCollection; - explicit DiTrackBuilder(const edm::ParameterSet &cfg): - trk1_selection_{cfg.getParameter("trk1Selection")}, - trk2_selection_{cfg.getParameter("trk2Selection")}, - pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - pfcands_{consumes( cfg.getParameter("tracks") )}, - ttracks_{consumes( cfg.getParameter("transientTracks") )}, - beamspot_{consumes( cfg.getParameter("beamSpot") )}, - trk1_mass_{ cfg.getParameter("trk1Mass")}, - trk2_mass_{ cfg.getParameter("trk2Mass")} - { - + explicit DiTrackBuilder(const edm::ParameterSet &cfg) + : trk1_selection_{cfg.getParameter("trk1Selection")}, + trk2_selection_{cfg.getParameter("trk2Selection")}, + pre_vtx_selection_{cfg.getParameter("preVtxSelection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + pfcands_{consumes(cfg.getParameter("tracks"))}, + ttracks_{consumes(cfg.getParameter("transientTracks"))}, + beamspot_{consumes(cfg.getParameter("beamSpot"))}, + trk1_mass_{cfg.getParameter("trk1Mass")}, + trk2_mass_{cfg.getParameter("trk2Mass")} { //output produces(); - } ~DiTrackBuilder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: - const StringCutObjectSelector trk1_selection_; // cuts on leading cand - const StringCutObjectSelector trk2_selection_; // sub-leading cand - const StringCutObjectSelector pre_vtx_selection_; // cut on the di-track before the SV fit - const StringCutObjectSelector post_vtx_selection_; // cut on the di-track after the SV fit - const edm::EDGetTokenT pfcands_; //input PF cands this is sorted in pT in previous step - const edm::EDGetTokenT ttracks_; //input TTracks of PF cands + const StringCutObjectSelector trk1_selection_; // cuts on leading cand + const StringCutObjectSelector trk2_selection_; // sub-leading cand + const StringCutObjectSelector pre_vtx_selection_; // cut on the di-track before the SV fit + const StringCutObjectSelector post_vtx_selection_; // cut on the di-track after the SV fit + const edm::EDGetTokenT + pfcands_; //input PF cands this is sorted in pT in previous step + const edm::EDGetTokenT ttracks_; //input TTracks of PF cands const edm::EDGetTokenT beamspot_; double trk1_mass_; double trk2_mass_; }; - void DiTrackBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &) const { - //inputs edm::Handle pfcands; evt.getByToken(pfcands_, pfcands); @@ -83,23 +71,20 @@ void DiTrackBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con edm::Handle beamspot; evt.getByToken(beamspot_, beamspot); - // output std::unique_ptr ditrack_out(new pat::CompositeCandidateCollection()); - - // main loop - for (size_t trk1_idx = 0; trk1_idx < pfcands->size(); ++trk1_idx ) { - - edm::Ptr trk1_ptr( pfcands, trk1_idx ); - if (!trk1_selection_(*trk1_ptr)) continue; + for (size_t trk1_idx = 0; trk1_idx < pfcands->size(); ++trk1_idx) { + edm::Ptr trk1_ptr(pfcands, trk1_idx); + if (!trk1_selection_(*trk1_ptr)) + continue; for (size_t trk2_idx = trk1_idx + 1; trk2_idx < pfcands->size(); ++trk2_idx) { - - edm::Ptr trk2_ptr( pfcands, trk2_idx ); + edm::Ptr trk2_ptr(pfcands, trk2_idx); //if (trk1_ptr->charge() == trk2_ptr->charge()) continue; - if (!trk2_selection_(*trk2_ptr)) continue; + if (!trk2_selection_(*trk2_ptr)) + continue; pat::CompositeCandidate ditrack_cand; auto trk1_p4 = trk1_ptr->polarP4(); @@ -110,58 +95,54 @@ void DiTrackBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con ditrack_cand.setCharge(trk1_ptr->charge() + trk2_ptr->charge()); ditrack_cand.addUserFloat("trk_deltaR", reco::deltaR(*trk1_ptr, *trk2_ptr)); // save indices - ditrack_cand.addUserInt("trk1_idx", trk1_idx ); - ditrack_cand.addUserInt("trk2_idx", trk2_idx ); + ditrack_cand.addUserInt("trk1_idx", trk1_idx); + ditrack_cand.addUserInt("trk2_idx", trk2_idx); // save cands - ditrack_cand.addUserCand("trk1", trk1_ptr ); - ditrack_cand.addUserCand("trk2", trk2_ptr ); + ditrack_cand.addUserCand("trk1", trk1_ptr); + ditrack_cand.addUserCand("trk2", trk2_ptr); - ditrack_cand.addUserFloat("trk_dz", trk1_ptr->vz()-trk2_ptr->vz()); - ditrack_cand.addUserFloat("unfitted_mass_KK",(trk1_p4+trk2_p4).M()); + ditrack_cand.addUserFloat("trk_dz", trk1_ptr->vz() - trk2_ptr->vz()); + ditrack_cand.addUserFloat("unfitted_mass_KK", (trk1_p4 + trk2_p4).M()); trk1_p4.SetM(K_MASS); trk2_p4.SetM(PI_MASS); - ditrack_cand.addUserFloat("unfitted_mass_Kpi",(trk1_p4+trk2_p4).M()); + ditrack_cand.addUserFloat("unfitted_mass_Kpi", (trk1_p4 + trk2_p4).M()); trk2_p4.SetM(K_MASS); trk1_p4.SetM(PI_MASS); - ditrack_cand.addUserFloat("unfitted_mass_piK",(trk1_p4+trk2_p4).M()); + ditrack_cand.addUserFloat("unfitted_mass_piK", (trk1_p4 + trk2_p4).M()); trk2_p4.SetM(K_MASS); trk1_p4.SetM(K_MASS); - if ( !pre_vtx_selection_(ditrack_cand) ) continue; + if (!pre_vtx_selection_(ditrack_cand)) + continue; - KinVtxFitter fitter( - {ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, - {K_MASS, K_MASS}, - {K_SIGMA, K_SIGMA} //K and PI sigma equal... + KinVtxFitter fitter({ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, {K_MASS, K_MASS}, {K_SIGMA, K_SIGMA} + //K and PI sigma equal... ); - if ( !fitter.success() ) continue; - ditrack_cand.addUserFloat("fitted_mass_KK", fitter.fitted_candidate().mass() ); - ditrack_cand.addUserFloat("fitted_mass_KK_Err", sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6,6))); - //fits required in order to calculate the error of the mass for each mass hypothesis. - KinVtxFitter fitter_Kpi( - {ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, - {K_MASS, PI_MASS}, - {K_SIGMA, K_SIGMA} //K and PI sigma equal... + if (!fitter.success()) + continue; + ditrack_cand.addUserFloat("fitted_mass_KK", fitter.fitted_candidate().mass()); + ditrack_cand.addUserFloat("fitted_mass_KK_Err", + sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + //fits required in order to calculate the error of the mass for each mass hypothesis. + KinVtxFitter fitter_Kpi({ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, {K_MASS, PI_MASS}, {K_SIGMA, K_SIGMA} + //K and PI sigma equal... ); - if ( !fitter_Kpi.success() ) continue; - ditrack_cand.addUserFloat("fitted_mass_Kpi", fitter_Kpi.fitted_candidate().mass() ); - ditrack_cand.addUserFloat("fitted_mass_Kpi_Err", sqrt(fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6,6))); - KinVtxFitter fitter_piK( - {ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, - {PI_MASS, K_MASS}, - {K_SIGMA, K_SIGMA} //K and PI sigma equal... + if (!fitter_Kpi.success()) + continue; + ditrack_cand.addUserFloat("fitted_mass_Kpi", fitter_Kpi.fitted_candidate().mass()); + ditrack_cand.addUserFloat("fitted_mass_Kpi_Err", + sqrt(fitter_Kpi.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + KinVtxFitter fitter_piK({ttracks->at(trk1_idx), ttracks->at(trk2_idx)}, {PI_MASS, K_MASS}, {K_SIGMA, K_SIGMA} + //K and PI sigma equal... ); - if ( !fitter_piK.success() ) continue; - ditrack_cand.addUserFloat("fitted_mass_piK", fitter_piK.fitted_candidate().mass() ); - ditrack_cand.addUserFloat("fitted_mass_piK_Err", sqrt(fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6,6))); + if (!fitter_piK.success()) + continue; + ditrack_cand.addUserFloat("fitted_mass_piK", fitter_piK.fitted_candidate().mass()); + ditrack_cand.addUserFloat("fitted_mass_piK_Err", + sqrt(fitter_piK.fitted_candidate().kinematicParametersError().matrix()(6, 6))); ditrack_cand.setVertex( - reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() - ) - ); + reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); // save quantities after fit auto lxy = l_xy(fitter, *beamspot); ditrack_cand.addUserFloat("l_xy", lxy.value()); @@ -173,13 +154,13 @@ void DiTrackBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con ditrack_cand.addUserFloat("sv_chi2", fitter.chi2()); ditrack_cand.addUserFloat("sv_ndof", fitter.dof()); ditrack_cand.addUserFloat("sv_prob", fitter.prob()); - ditrack_cand.addUserFloat("fitted_pt",fitter.fitted_candidate().globalMomentum().perp() ); - ditrack_cand.addUserFloat("fitted_eta",fitter.fitted_candidate().globalMomentum().eta() ); - ditrack_cand.addUserFloat("fitted_phi",fitter.fitted_candidate().globalMomentum().phi() ); + ditrack_cand.addUserFloat("fitted_pt", fitter.fitted_candidate().globalMomentum().perp()); + ditrack_cand.addUserFloat("fitted_eta", fitter.fitted_candidate().globalMomentum().eta()); + ditrack_cand.addUserFloat("fitted_phi", fitter.fitted_candidate().globalMomentum().phi()); ditrack_cand.addUserFloat("vtx_x", ditrack_cand.vx()); ditrack_cand.addUserFloat("vtx_y", ditrack_cand.vy()); ditrack_cand.addUserFloat("vtx_z", ditrack_cand.vz()); - const auto& covMatrix = fitter.fitted_vtx_uncertainty(); + const auto &covMatrix = fitter.fitted_vtx_uncertainty(); ditrack_cand.addUserFloat("vtx_cxx", covMatrix.cxx()); ditrack_cand.addUserFloat("vtx_cyy", covMatrix.cyy()); ditrack_cand.addUserFloat("vtx_czz", covMatrix.czz()); @@ -188,10 +169,11 @@ void DiTrackBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup con ditrack_cand.addUserFloat("vtx_czy", covMatrix.czy()); // after fit selection - if ( !post_vtx_selection_(ditrack_cand) ) continue; + if (!post_vtx_selection_(ditrack_cand)) + continue; ditrack_out->emplace_back(ditrack_cand); - } // end for(size_t trk2_idx = trk1_idx + 1 - } //for(size_t trk1_idx = 0 + } // end for(size_t trk2_idx = trk1_idx + 1 + } //for(size_t trk1_idx = 0 evt.put(std::move(ditrack_out)); } diff --git a/PhysicsTools/BPHNano/plugins/KinVtxFitter.cc b/PhysicsTools/BPHNano/plugins/KinVtxFitter.cc index 393feeda68a2..c32b48c30aa7 100644 --- a/PhysicsTools/BPHNano/plugins/KinVtxFitter.cc +++ b/PhysicsTools/BPHNano/plugins/KinVtxFitter.cc @@ -4,91 +4,76 @@ #include "RecoVertex/KinematicFit/interface/KinematicParticleVertexFitter.h" #include "RecoVertex/KinematicFit/interface/KinematicConstrainedVertexFitter.h" #include "RecoVertex/KinematicFit/interface/KinematicParticleVertexFitter.h" -#include "RecoVertex/KinematicFit/interface/TwoTrackMassKinematicConstraint.h" // MIGHT be useful for Phi->KK? +#include "RecoVertex/KinematicFit/interface/TwoTrackMassKinematicConstraint.h" // MIGHT be useful for Phi->KK? - -KinVtxFitter::KinVtxFitter(const std::vector tracks, - const std::vector masses, - std::vector sigmas): - n_particles_{masses.size()} { - +KinVtxFitter::KinVtxFitter(const std::vector tracks, + const std::vector masses, + std::vector sigmas) + : n_particles_{masses.size()} { KinematicParticleFactoryFromTransientTrack factory; std::vector particles; - for(size_t i = 0; i < tracks.size(); ++i) { - particles.emplace_back( - factory.particle( - tracks.at(i), masses.at(i), kin_chi2_, - kin_ndof_, sigmas[i] - ) - ); + for (size_t i = 0; i < tracks.size(); ++i) { + particles.emplace_back(factory.particle(tracks.at(i), masses.at(i), kin_chi2_, kin_ndof_, sigmas[i])); } - KinematicParticleVertexFitter kcv_fitter; + KinematicParticleVertexFitter kcv_fitter; RefCountedKinematicTree vtx_tree = kcv_fitter.fit(particles); if (vtx_tree->isEmpty() || !vtx_tree->isValid() || !vtx_tree->isConsistent()) { - success_ = false; + success_ = false; return; } - vtx_tree->movePointerToTheTop(); + vtx_tree->movePointerToTheTop(); fitted_particle_ = vtx_tree->currentParticle(); fitted_vtx_ = vtx_tree->currentDecayVertex(); - if (!fitted_particle_->currentState().isValid() || !fitted_vtx_->vertexIsValid()){ - success_ = false; + if (!fitted_particle_->currentState().isValid() || !fitted_vtx_->vertexIsValid()) { + success_ = false; return; } fitted_state_ = fitted_particle_->currentState(); fitted_children_ = vtx_tree->finalStateParticles(); - if(fitted_children_.size() != n_particles_) { - success_=false; + if (fitted_children_.size() != n_particles_) { + success_ = false; return; } fitted_track_ = fitted_particle_->refittedTransientTrack(); success_ = true; } - - -KinVtxFitter::KinVtxFitter(const std::vector tracks, - const std::vector masses, - std::vector sigmas, ParticleMass dilep_mass): - n_particles_{masses.size()} { - +KinVtxFitter::KinVtxFitter(const std::vector tracks, + const std::vector masses, + std::vector sigmas, + ParticleMass dilep_mass) + : n_particles_{masses.size()} { KinematicParticleFactoryFromTransientTrack factory; std::vector particles; - for(size_t i = 0; i < tracks.size(); ++i) { - particles.emplace_back( - factory.particle( - tracks.at(i), masses.at(i), kin_chi2_, - kin_ndof_, sigmas[i] - ) - ); + for (size_t i = 0; i < tracks.size(); ++i) { + particles.emplace_back(factory.particle(tracks.at(i), masses.at(i), kin_chi2_, kin_ndof_, sigmas[i])); } - MultiTrackKinematicConstraint * dilep_c = new TwoTrackMassKinematicConstraint(dilep_mass); - KinematicConstrainedVertexFitter kcv_fitter; - RefCountedKinematicTree vtx_tree = kcv_fitter.fit(particles,dilep_c); + MultiTrackKinematicConstraint* dilep_c = new TwoTrackMassKinematicConstraint(dilep_mass); + KinematicConstrainedVertexFitter kcv_fitter; + RefCountedKinematicTree vtx_tree = kcv_fitter.fit(particles, dilep_c); if (vtx_tree->isEmpty() || !vtx_tree->isValid() || !vtx_tree->isConsistent()) { - success_ = false; + success_ = false; return; } - vtx_tree->movePointerToTheTop(); + vtx_tree->movePointerToTheTop(); fitted_particle_ = vtx_tree->currentParticle(); fitted_vtx_ = vtx_tree->currentDecayVertex(); - if (!fitted_particle_->currentState().isValid() || !fitted_vtx_->vertexIsValid()){ - success_ = false; + if (!fitted_particle_->currentState().isValid() || !fitted_vtx_->vertexIsValid()) { + success_ = false; return; } fitted_state_ = fitted_particle_->currentState(); fitted_children_ = vtx_tree->finalStateParticles(); - if(fitted_children_.size() != n_particles_) { - success_=false; + if (fitted_children_.size() != n_particles_) { + success_ = false; return; } fitted_track_ = fitted_particle_->refittedTransientTrack(); success_ = true; } - diff --git a/PhysicsTools/BPHNano/plugins/KinVtxFitter.h b/PhysicsTools/BPHNano/plugins/KinVtxFitter.h index 16a41a9ee3e6..4fe2f92e66ea 100644 --- a/PhysicsTools/BPHNano/plugins/KinVtxFitter.h +++ b/PhysicsTools/BPHNano/plugins/KinVtxFitter.h @@ -9,76 +9,51 @@ #include class KinVtxFitter { -public: - KinVtxFitter(): - fitted_vtx_{}, - fitted_state_{}, - fitted_particle_{}, - fitted_children_{}, - fitted_track_{} {}; - - KinVtxFitter(const std::vector tracks, - const std::vector masses, - std::vector sigmas); +public: + KinVtxFitter() : fitted_vtx_{}, fitted_state_{}, fitted_particle_{}, fitted_children_{}, fitted_track_{} {}; KinVtxFitter(const std::vector tracks, const std::vector masses, - std::vector sigmas, ParticleMass dilep_mass); + std::vector sigmas); + KinVtxFitter(const std::vector tracks, + const std::vector masses, + std::vector sigmas, + ParticleMass dilep_mass); ~KinVtxFitter() {}; - bool success() const {return success_;} - float chi2() const {return success_ ? fitted_vtx_->chiSquared() : 999;} - float dof() const {return success_ ? fitted_vtx_->degreesOfFreedom() : -1;} - float prob() const { - return success_ ? ChiSquaredProbability(chi2(), dof()) : 0.; - } - float kin_chi2() const {return kin_chi2_;} // should they be merged in a single value? - float kin_ndof() const {return kin_ndof_;} - - const KinematicState fitted_daughter(size_t i) const { - return fitted_children_.at(i)->currentState(); - } + bool success() const { return success_; } + float chi2() const { return success_ ? fitted_vtx_->chiSquared() : 999; } + float dof() const { return success_ ? fitted_vtx_->degreesOfFreedom() : -1; } + float prob() const { return success_ ? ChiSquaredProbability(chi2(), dof()) : 0.; } + float kin_chi2() const { return kin_chi2_; } // should they be merged in a single value? + float kin_ndof() const { return kin_ndof_; } + + const KinematicState fitted_daughter(size_t i) const { return fitted_children_.at(i)->currentState(); } - const math::PtEtaPhiMLorentzVector daughter_p4(size_t i) const { + const math::PtEtaPhiMLorentzVector daughter_p4(size_t i) const { const auto& state = fitted_children_.at(i)->currentState(); return math::PtEtaPhiMLorentzVector( - state.globalMomentum().perp(), - state.globalMomentum().eta() , - state.globalMomentum().phi() , - state.mass() - ); + state.globalMomentum().perp(), state.globalMomentum().eta(), state.globalMomentum().phi(), state.mass()); } - const KinematicState fitted_candidate() const { - return fitted_state_; - } + const KinematicState fitted_candidate() const { return fitted_state_; } - const RefCountedKinematicVertex fitted_refvtx() const { - return fitted_vtx_; - } + const RefCountedKinematicVertex fitted_refvtx() const { return fitted_vtx_; } - const math::PtEtaPhiMLorentzVector fitted_p4() const { - return math::PtEtaPhiMLorentzVector( - fitted_state_.globalMomentum().perp(), - fitted_state_.globalMomentum().eta() , - fitted_state_.globalMomentum().phi() , - fitted_state_.mass() - ); + const math::PtEtaPhiMLorentzVector fitted_p4() const { + return math::PtEtaPhiMLorentzVector(fitted_state_.globalMomentum().perp(), + fitted_state_.globalMomentum().eta(), + fitted_state_.globalMomentum().phi(), + fitted_state_.mass()); } - const reco::TransientTrack& fitted_candidate_ttrk() const { - return fitted_track_; - } + const reco::TransientTrack& fitted_candidate_ttrk() const { return fitted_track_; } - GlobalPoint fitted_vtx() const { - return fitted_vtx_->position(); - } + GlobalPoint fitted_vtx() const { return fitted_vtx_->position(); } - GlobalError fitted_vtx_uncertainty() const { - return fitted_vtx_->error(); - } + GlobalError fitted_vtx_uncertainty() const { return fitted_vtx_->error(); } private: float kin_chi2_ = 0.; @@ -86,10 +61,10 @@ private: size_t n_particles_ = 0; bool success_ = false; - RefCountedKinematicVertex fitted_vtx_; + RefCountedKinematicVertex fitted_vtx_; KinematicState fitted_state_; RefCountedKinematicParticle fitted_particle_; - std::vector< RefCountedKinematicParticle > fitted_children_; + std::vector fitted_children_; reco::TransientTrack fitted_track_; }; #endif diff --git a/PhysicsTools/BPHNano/plugins/MCFinalStateSelector.cc b/PhysicsTools/BPHNano/plugins/MCFinalStateSelector.cc index 651721a3876f..56489ed9d6c3 100644 --- a/PhysicsTools/BPHNano/plugins/MCFinalStateSelector.cc +++ b/PhysicsTools/BPHNano/plugins/MCFinalStateSelector.cc @@ -13,63 +13,87 @@ #include #include - class MCFinalStateSelector : public edm::global::EDProducer<> { public: - MCFinalStateSelector( edm::ParameterSet const & params ) : - objName_(params.getParameter("objName")), - branchName_(params.getParameter("branchName")), - doc_(params.getParameter("docString")), - src_(consumes(params.getParameter("src"))), - candMap_(consumes>(params.getParameter("mcMap"))) - { + MCFinalStateSelector(edm::ParameterSet const& params) + : objName_(params.getParameter("objName")), + branchName_(params.getParameter("branchName")), + doc_(params.getParameter("docString")), + src_(consumes(params.getParameter("src"))), + candMap_(consumes>(params.getParameter("mcMap"))) { produces(); - const std::string & type = params.getParameter("objType"); - if (type == "Muon") type_ = MMuon; - else if (type == "Electron") type_ = MElectron; - else if (type == "Tau") type_ = MTau; - else if (type == "Photon") type_ = MPhoton; - else if (type == "ProbeTracks") type_ = MTrack; - else if (type == "Kshort") type_ = MKshort; - else if (type == "Other") type_ = MOther; - else throw cms::Exception("Configuration", "Unsupported objType '" + type + "'\n"); + const std::string& type = params.getParameter("objType"); + if (type == "Muon") + type_ = MMuon; + else if (type == "Electron") + type_ = MElectron; + else if (type == "Tau") + type_ = MTau; + else if (type == "Photon") + type_ = MPhoton; + else if (type == "ProbeTracks") + type_ = MTrack; + else if (type == "Kshort") + type_ = MKshort; + else if (type == "Other") + type_ = MOther; + else + throw cms::Exception("Configuration", "Unsupported objType '" + type + "'\n"); std::cout << "type = " << type << std::endl; switch (type_) { - case MMuon: flavDoc_ = "1 = prompt muon (including gamma*->mu mu), 15 = muon from prompt tau, " // continues below - "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; - - case MElectron: flavDoc_ = "1 = prompt electron (including gamma*->mu mu), 15 = electron from prompt tau, " // continues below - "22 = prompt photon (likely conversion), " // continues below - "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; - case MPhoton: flavDoc_ = "1 = prompt photon, 13 = prompt electron, 0 = unknown or unmatched"; break; - case MTau: flavDoc_ = "1 = prompt electron, 2 = prompt muon, 3 = tau->e decay, 4 = tau->mu decay, 5 = hadronic tau decay, 0 = unknown or unmatched"; break; - case MTrack: flavDoc_ = "1 = prompt, 511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; break; - - case MOther: flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; break; - case MKshort: flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; break; + case MMuon: + flavDoc_ = + "1 = prompt muon (including gamma*->mu mu), 15 = muon from prompt tau, " // continues below + "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; + + case MElectron: + flavDoc_ = + "1 = prompt electron (including gamma*->mu mu), 15 = electron from prompt tau, " // continues below + "22 = prompt photon (likely conversion), " // continues below + "511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; + case MPhoton: + flavDoc_ = "1 = prompt photon, 13 = prompt electron, 0 = unknown or unmatched"; + break; + case MTau: + flavDoc_ = + "1 = prompt electron, 2 = prompt muon, 3 = tau->e decay, 4 = tau->mu decay, 5 = hadronic tau decay, 0 = " + "unknown or unmatched"; + break; + case MTrack: + flavDoc_ = "1 = prompt, 511 = from B0, 521 = from B+/-, 0 = unknown or unmatched"; + break; + + case MOther: + flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; + break; + case MKshort: + flavDoc_ = "1 = from hard scatter, 0 = unknown or unmatched"; + break; } - if ( type_ == MTau ) { - candMapVisTau_ = consumes>(params.getParameter("mcMapVisTau")); + if (type_ == MTau) { + candMapVisTau_ = + consumes>(params.getParameter("mcMapVisTau")); } } ~MCFinalStateSelector() override {} void produce(edm::StreamID id, edm::Event& iEvent, const edm::EventSetup& iSetup) const override { - edm::Handle cands; iEvent.getByToken(src_, cands); unsigned int ncand = cands->size(); - auto tab = std::make_unique(ncand, objName_, false, true); + auto tab = std::make_unique(ncand, objName_, false, true); edm::Handle> map; iEvent.getByToken(candMap_, map); edm::Handle> mapVisTau; - if ( type_ == MTau ) { + if (type_ == MTau) { iEvent.getByToken(candMapVisTau_, mapVisTau); } @@ -78,46 +102,63 @@ public: //std::cout << "cand #" << i << ": pT = " << cands->ptrAt(i)->pt() << ", eta = " << cands->ptrAt(i)->eta() << ", phi = " << cands->ptrAt(i)->phi() << std::endl; reco::GenParticleRef match = (*map)[cands->ptrAt(i)]; reco::GenParticleRef matchVisTau; - if ( type_ == MTau ) { + if (type_ == MTau) { matchVisTau = (*mapVisTau)[cands->ptrAt(i)]; } - if ( match.isNonnull() ) key[i] = match.key(); - else if ( matchVisTau.isNonnull() ) key[i] = matchVisTau.key(); - else continue; + if (match.isNonnull()) + key[i] = match.key(); + else if (matchVisTau.isNonnull()) + key[i] = matchVisTau.key(); + else + continue; switch (type_) { - case MMuon: - if (match->isPromptFinalState()) flav[i] = 1; // prompt - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - case MElectron: - if (match->isPromptFinalState()) flav[i] = (match->pdgId() == 22 ? 22 : 1); // prompt electron or photon - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - case MPhoton: - if (match->isPromptFinalState()) flav[i] = (match->pdgId() == 22 ? 1 : 13); // prompt electron or photon - break; - case MTau: - // CV: assignment of status codes according to https://twiki.cern.ch/twiki/bin/viewauth/CMS/HiggsToTauTauWorking2016#MC_Matching - if ( match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 11 ) flav[i] = 1; - else if ( match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 13 ) flav[i] = 2; - else if ( match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 11 ) flav[i] = 3; - else if ( match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 13 ) flav[i] = 4; - else if ( matchVisTau.isNonnull() ) flav[i] = 5; - break; - case MTrack: - if (match->isPromptFinalState()) flav[i] = 1; //prompt - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - case MKshort: - if (match->isPromptFinalState()) flav[i] = 1; //prompt - else flav[i] = getParentHadronFlag(match); // pdgId of mother - break; - default: - flav[i] = match->statusFlags().fromHardProcess(); + case MMuon: + if (match->isPromptFinalState()) + flav[i] = 1; // prompt + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + case MElectron: + if (match->isPromptFinalState()) + flav[i] = (match->pdgId() == 22 ? 22 : 1); // prompt electron or photon + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + case MPhoton: + if (match->isPromptFinalState()) + flav[i] = (match->pdgId() == 22 ? 1 : 13); // prompt electron or photon + break; + case MTau: + // CV: assignment of status codes according to https://twiki.cern.ch/twiki/bin/viewauth/CMS/HiggsToTauTauWorking2016#MC_Matching + if (match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 11) + flav[i] = 1; + else if (match.isNonnull() && match->statusFlags().isPrompt() && abs(match->pdgId()) == 13) + flav[i] = 2; + else if (match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 11) + flav[i] = 3; + else if (match.isNonnull() && match->isDirectPromptTauDecayProductFinalState() && abs(match->pdgId()) == 13) + flav[i] = 4; + else if (matchVisTau.isNonnull()) + flav[i] = 5; + break; + case MTrack: + if (match->isPromptFinalState()) + flav[i] = 1; //prompt + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + case MKshort: + if (match->isPromptFinalState()) + flav[i] = 1; //prompt + else + flav[i] = getParentHadronFlag(match); // pdgId of mother + break; + default: + flav[i] = match->statusFlags().fromHardProcess(); }; } - tab->addColumn(branchName_ + "Idx", key, "Index into genParticle list for " + doc_); + tab->addColumn(branchName_ + "Idx", key, "Index into genParticle list for " + doc_); //for(auto ij : flav) std::cout << " flav = " << ij << " " << (uint8_t)ij << std::endl; //tab->addColumn(branchName_+"Flav", flav, "Flavour of genParticle for "+doc_+": "+flavDoc_, nanoaod::FlatTable::UInt8Column); tab->addColumn(branchName_ + "Flav", flav, "Flavour of genParticle for " + doc_ + ": " + flavDoc_); @@ -128,23 +169,31 @@ public: static int getParentHadronFlag(const reco::GenParticleRef match) { for (unsigned int im = 0, nm = match->numberOfMothers(); im < nm; ++im) { reco::GenParticleRef mom = match->motherRef(im); - assert(mom.isNonnull() && mom.isAvailable()); // sanity - if (mom.key() >= match.key()) continue; // prevent circular refs + assert(mom.isNonnull() && mom.isAvailable()); // sanity + if (mom.key() >= match.key()) + continue; // prevent circular refs int id = std::abs(mom->pdgId()); return id; } return 0; } - static void fillDescriptions(edm::ConfigurationDescriptions & descriptions) { + static void fillDescriptions(edm::ConfigurationDescriptions& descriptions) { edm::ParameterSetDescription desc; desc.add("objName")->setComment("name of the nanoaod::FlatTable to extend with this table"); - desc.add("branchName")->setComment("name of the column to write (the final branch in the nanoaod will be _Idx and _Flav"); + desc.add("branchName") + ->setComment( + "name of the column to write (the final branch in the nanoaod will be _Idx and " + "_Flav"); desc.add("docString")->setComment("documentation to forward to the output"); - desc.add("src")->setComment("physics object collection for the reconstructed objects (e.g. leptons)"); - desc.add("mcMap")->setComment("tag to an edm::Association mapping src to gen, such as the one produced by MCMatcher"); - desc.add("objType")->setComment("type of object to match (Muon, Electron, Tau, Photon, Track, Other), taylors what's in t Flav branch"); - desc.addOptional("mcMapVisTau")->setComment("as mcMap, but pointing to the visible gen taus (only if objType == Tau)"); + desc.add("src")->setComment( + "physics object collection for the reconstructed objects (e.g. leptons)"); + desc.add("mcMap")->setComment( + "tag to an edm::Association mapping src to gen, such as the one produced by MCMatcher"); + desc.add("objType")->setComment( + "type of object to match (Muon, Electron, Tau, Photon, Track, Other), taylors what's in t Flav branch"); + desc.addOptional("mcMapVisTau") + ->setComment("as mcMap, but pointing to the visible gen taus (only if objType == Tau)"); descriptions.add("mcFinalStatesTable", desc); } @@ -159,4 +208,3 @@ protected: #include "FWCore/Framework/interface/MakerMacros.h" DEFINE_FWK_MODULE(MCFinalStateSelector); - diff --git a/PhysicsTools/BPHNano/plugins/MatchEmbedder.cc b/PhysicsTools/BPHNano/plugins/MatchEmbedder.cc index 9ac2e3198895..7dfaba214037 100644 --- a/PhysicsTools/BPHNano/plugins/MatchEmbedder.cc +++ b/PhysicsTools/BPHNano/plugins/MatchEmbedder.cc @@ -19,55 +19,49 @@ #include #include "helper.h" -template< typename PATOBJ > +template class MatchEmbedder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) - public: - - explicit MatchEmbedder(const edm::ParameterSet &cfg): - src_{consumes(cfg.getParameter("src"))}, - matching_{consumes< edm::Association >( cfg.getParameter("matching") )} { + explicit MatchEmbedder(const edm::ParameterSet &cfg) + : src_{consumes(cfg.getParameter("src"))}, + matching_{ + consumes >(cfg.getParameter("matching"))} { produces(); } ~MatchEmbedder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: typedef std::vector PATOBJCollection; const edm::EDGetTokenT src_; - const edm::EDGetTokenT< edm::Association > matching_; + const edm::EDGetTokenT > matching_; }; -template< typename PATOBJ > -void MatchEmbedder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const & iSetup) const { - +template +void MatchEmbedder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &iSetup) const { //input edm::Handle src; evt.getByToken(src_, src); - edm::Handle< edm::Association > matching; + edm::Handle > matching; evt.getByToken(matching_, matching); size_t nsrc = src->size(); // output - std::unique_ptr out(new PATOBJCollection() ); + std::unique_ptr out(new PATOBJCollection()); out->reserve(nsrc); for (unsigned int i = 0; i < nsrc; ++i) { edm::Ptr ptr(src, i); reco::GenParticleRef match = (*matching)[ptr]; out->emplace_back(src->at(i)); - out->back().addUserInt( - "mcMatch", - match.isNonnull() ? match->pdgId() : 0 - ); + out->back().addUserInt("mcMatch", match.isNonnull() ? match->pdgId() : 0); } //adding label to be consistent with the muon and track naming diff --git a/PhysicsTools/BPHNano/plugins/MuonTriggerSelector.cc b/PhysicsTools/BPHNano/plugins/MuonTriggerSelector.cc index 9f38bd799616..85bdcb7f92d0 100644 --- a/PhysicsTools/BPHNano/plugins/MuonTriggerSelector.cc +++ b/PhysicsTools/BPHNano/plugins/MuonTriggerSelector.cc @@ -33,16 +33,13 @@ using namespace std; constexpr bool debug = false; -class MuonTriggerSelector : public edm::stream::EDProducer <> { - +class MuonTriggerSelector : public edm::stream::EDProducer<> { public: - explicit MuonTriggerSelector(const edm::ParameterSet &iConfig); ~MuonTriggerSelector() override {}; private: - - void produce(edm::Event&, const edm::EventSetup&) override; + void produce(edm::Event &, const edm::EventSetup &) override; const edm::ESGetToken bFieldToken_; edm::EDGetTokenT> muonSrc_; edm::EDGetTokenT triggerBits_; @@ -53,18 +50,18 @@ private: const double maxdR_; // triggers std::vector HLTPaths_; - }; -MuonTriggerSelector::MuonTriggerSelector(const edm::ParameterSet &iConfig): - bFieldToken_(esConsumes()), - muonSrc_( consumes> ( iConfig.getParameter( "muonCollection" ) ) ), - triggerBits_(consumes(iConfig.getParameter("bits"))), - triggerObjects_(consumes>(iConfig.getParameter("objects"))), - triggerPrescales_(consumes(iConfig.getParameter("prescales"))), - muon_selection_{iConfig.getParameter("muonSelection")}, - maxdR_(iConfig.getParameter("maxdR_matching")), - HLTPaths_(iConfig.getParameter>("HLTPaths"))// multiple paths with comma +MuonTriggerSelector::MuonTriggerSelector(const edm::ParameterSet &iConfig) + : bFieldToken_(esConsumes()), + muonSrc_(consumes>(iConfig.getParameter("muonCollection"))), + triggerBits_(consumes(iConfig.getParameter("bits"))), + triggerObjects_( + consumes>(iConfig.getParameter("objects"))), + triggerPrescales_(consumes(iConfig.getParameter("prescales"))), + muon_selection_{iConfig.getParameter("muonSelection")}, + maxdR_(iConfig.getParameter("maxdR_matching")), + HLTPaths_(iConfig.getParameter>("HLTPaths")) // multiple paths with comma { // outputs produces("AllMuons"); @@ -72,9 +69,8 @@ MuonTriggerSelector::MuonTriggerSelector(const edm::ParameterSet &iConfig): produces("SelectedTransientMuons"); } -void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSetup) { - - const auto& bField = iSetup.getData(bFieldToken_); +void MuonTriggerSelector::produce(edm::Event &iEvent, const edm::EventSetup &iSetup) { + const auto &bField = iSetup.getData(bFieldToken_); edm::Handle triggerBits; iEvent.getByToken(triggerBits_, triggerBits); @@ -85,9 +81,9 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe edm::Handle> triggerObjects; iEvent.getByToken(triggerObjects_, triggerObjects); - std::unique_ptr allmuons_out ( new pat::MuonCollection ); - std::unique_ptr muons_out ( new pat::MuonCollection ); - std::unique_ptr trans_muons_out( new TransientTrackCollection ); + std::unique_ptr allmuons_out(new pat::MuonCollection); + std::unique_ptr muons_out(new pat::MuonCollection); + std::unique_ptr trans_muons_out(new TransientTrackCollection); edm::Handle> muons; iEvent.getByToken(muonSrc_, muons); @@ -107,12 +103,11 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe std::vector> DR; std::vector> DPT; - for (const pat::Muon &muon : *muons) { - if (debug)std::cout << "Muon Pt=" << muon.pt() << " Eta=" << muon.eta() << " Phi=" << muon.phi() << endl; - + if (debug) + std::cout << "Muon Pt=" << muon.pt() << " Eta=" << muon.eta() << " Phi=" << muon.phi() << endl; - std::vector frs(HLTPaths_.size(), 0); //path fires for each reco muon + std::vector frs(HLTPaths_.size(), 0); //path fires for each reco muon std::vector temp_matched_to(HLTPaths_.size(), 1000.); std::vector temp_DR(HLTPaths_.size(), 1000.); std::vector temp_DPT(HLTPaths_.size(), 1000.); @@ -124,22 +119,29 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe std::vector temp_dr(muon.triggerObjectMatches().size(), 1000.); std::vector temp_dpt(muon.triggerObjectMatches().size(), 1000.); std::vector temp_pt(muon.triggerObjectMatches().size(), 1000.); - char cstr[ (path + "*").size() + 1]; - strcpy( cstr, (path + "*").c_str() ); + char cstr[(path + "*").size() + 1]; + strcpy(cstr, (path + "*").c_str()); //Here we find all the HLT objects from each HLT path each time that are matched with the reco muon. if (!muon.triggerObjectMatches().empty()) { for (size_t i = 0; i < muon.triggerObjectMatches().size(); i++) { if (muon.triggerObjectMatch(i) != nullptr && muon.triggerObjectMatch(i)->hasPathName(cstr, true, true)) { frs[ipath] = 1; - float dr=deltaR(muon.eta(),muon.phi(),muon.triggerObjectMatch(i)->eta(),muon.triggerObjectMatch(i)->phi()); - float dpt = (muon.triggerObjectMatch(i)->pt() - muon.pt()) / muon.triggerObjectMatch(i)->pt(); + float dr = + deltaR(muon.eta(), muon.phi(), muon.triggerObjectMatch(i)->eta(), muon.triggerObjectMatch(i)->phi()); + float dpt = (muon.triggerObjectMatch(i)->pt() - muon.pt()) / muon.triggerObjectMatch(i)->pt(); temp_dr[i] = dr; temp_dpt[i] = dpt; temp_pt[i] = muon.triggerObjectMatch(i)->pt(); - if (debug)std::cout << "Path=" << cstr << endl; - if (debug)std::cout << "HLT Pt=" << muon.triggerObjectMatch(i)->pt() << " Eta=" << muon.triggerObjectMatch(i)->eta() << " Phi=" << muon.triggerObjectMatch(i)->phi() << endl; - if (debug)std::cout << "Muon Pt=" << muon.pt() << " Eta=" << muon.eta() << " Phi=" << muon.phi() << endl; - if (debug)std::cout << "DR = " << temp_dr[i] << endl; + if (debug) + std::cout << "Path=" << cstr << endl; + if (debug) + std::cout << "HLT Pt=" << muon.triggerObjectMatch(i)->pt() + << " Eta=" << muon.triggerObjectMatch(i)->eta() << " Phi=" << muon.triggerObjectMatch(i)->phi() + << endl; + if (debug) + std::cout << "Muon Pt=" << muon.pt() << " Eta=" << muon.eta() << " Phi=" << muon.phi() << endl; + if (debug) + std::cout << "DR = " << temp_dr[i] << endl; } } // and now we find the real minimum between the reco muon and all its matched HLT objects. @@ -150,24 +152,23 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe } } //and now since we have found the minimum DR we save a few variables for plots - fires.push_back(frs);//This is used in order to see if a reco muon fired a Trigger (1) or not (0). - matcher.push_back(temp_matched_to); //This is used in order to see if a reco muon is matched with a HLT object. PT of the reco muon is saved in this vector. + fires.push_back(frs); //This is used in order to see if a reco muon fired a Trigger (1) or not (0). + matcher.push_back( + temp_matched_to); //This is used in order to see if a reco muon is matched with a HLT object. PT of the reco muon is saved in this vector. DR.push_back(temp_DR); DPT.push_back(temp_DPT); - } //now, check for different reco muons that are matched to the same HLTObject. for (unsigned int path = 0; path < HLTPaths_.size(); path++) { for (unsigned int iMuo = 0; iMuo < muons->size(); iMuo++) { for (unsigned int im = (iMuo + 1); im < muons->size(); im++) { if (matcher[iMuo][path] != 1000. && matcher[iMuo][path] == matcher[im][path]) { - if (DR[iMuo][path] < DR[im][path]) { //Keep the one that has the minimum DR with the HLT object + if (DR[iMuo][path] < DR[im][path]) { //Keep the one that has the minimum DR with the HLT object fires[im][path] = 0; matcher[im][path] = 1000.; DR[im][path] = 1000.; DPT[im][path] = 1000.; - } - else { + } else { fires[iMuo][path] = 0; matcher[iMuo][path] = 1000.; DR[iMuo][path] = 1000.; @@ -183,18 +184,18 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe } } - - //save the reco muon in both collections - for (const pat::Muon & muon : *muons) { - unsigned int iMuo(&muon - & (muons->at(0)) ); - if ( !muon_selection_(muon) ) continue; // selection cuts + for (const pat::Muon &muon : *muons) { + unsigned int iMuo(&muon - &(muons->at(0))); + if (!muon_selection_(muon)) + continue; // selection cuts const reco::TransientTrack muonTT((*(muon.bestTrack())), &bField); - if (!muonTT.isValid()) continue; + if (!muonTT.isValid()) + continue; allmuons_out->emplace_back(muon); - if (muonIsTrigger[iMuo] != 1) continue; - + if (muonIsTrigger[iMuo] != 1) + continue; muons_out->emplace_back(muon); muons_out->back().addUserInt("isTriggering", muonIsTrigger[iMuo]); @@ -208,8 +209,8 @@ void MuonTriggerSelector::produce(edm::Event& iEvent, const edm::EventSetup& iSe trans_muons_out->emplace_back(muonTT); } - iEvent.put(std::move(allmuons_out), "AllMuons"); - iEvent.put(std::move(muons_out), "SelectedMuons"); + iEvent.put(std::move(allmuons_out), "AllMuons"); + iEvent.put(std::move(muons_out), "SelectedMuons"); iEvent.put(std::move(trans_muons_out), "SelectedTransientMuons"); } diff --git a/PhysicsTools/BPHNano/plugins/PVertexBPHTable.cc b/PhysicsTools/BPHNano/plugins/PVertexBPHTable.cc index 071099401e95..f8f5c50d9b50 100644 --- a/PhysicsTools/BPHNano/plugins/PVertexBPHTable.cc +++ b/PhysicsTools/BPHNano/plugins/PVertexBPHTable.cc @@ -57,7 +57,6 @@ private: void produce(edm::Event&, const edm::EventSetup&) override; void endStream() override; - // ----------member data --------------------------- const edm::EDGetTokenT> pvs_; @@ -97,38 +96,36 @@ void PVertexBPHTable::produce(edm::Event& iEvent, const edm::EventSetup& iSetup) auto pvsCol = iEvent.getHandle(pvs_); auto selCandPv = std::make_unique>(); - std::vector pvscore, chi2, covXX, covYY, covZZ, covXY, covXZ, covYZ, - vx, vy, vz, pt, eta, phi, mass, ndof; + std::vector pvscore, chi2, covXX, covYY, covZZ, covXY, covXZ, covYZ, vx, vy, vz, pt, eta, phi, mass, ndof; std::vector charge, ntracks; - size_t i=0; - for (const auto& pv : *pvsCol){ - if (!goodPvCut_(pv)){ - i++; - continue; + size_t i = 0; + for (const auto& pv : *pvsCol) { + if (!goodPvCut_(pv)) { + i++; + continue; } int sum_charge = 0; pvscore.push_back(pvsScoreProd.get(pvsCol.id(), i)); - ntracks.push_back(pv.tracksSize() ); - chi2.push_back(pv.chi2() ); - covXX.push_back(pv.covariance(0,0)); - covYY.push_back(pv.covariance(1,1)); - covZZ.push_back(pv.covariance(2,2)); - covXY.push_back(pv.covariance(0,1)); - covXZ.push_back(pv.covariance(0,2)); - covYZ.push_back(pv.covariance(1,2)); + ntracks.push_back(pv.tracksSize()); + chi2.push_back(pv.chi2()); + covXX.push_back(pv.covariance(0, 0)); + covYY.push_back(pv.covariance(1, 1)); + covZZ.push_back(pv.covariance(2, 2)); + covXY.push_back(pv.covariance(0, 1)); + covXZ.push_back(pv.covariance(0, 2)); + covYZ.push_back(pv.covariance(1, 2)); vx.push_back(pv.x()); - vy.push_back(pv.y()); - vz.push_back(pv.z()); + vy.push_back(pv.y()); + vz.push_back(pv.z()); pt.push_back(pv.p4().pt()); - eta.push_back(pv.p4().eta()); - phi.push_back(pv.p4().phi()); + eta.push_back(pv.p4().eta()); + phi.push_back(pv.p4().phi()); mass.push_back(pv.p4().M()); ndof.push_back(pv.ndof()); i++; - } - auto table = std::make_unique(pvscore.size(), pvName_, false,false); + auto table = std::make_unique(pvscore.size(), pvName_, false, false); table->addColumn("score", pvscore, "", 10); table->addColumn("vx", vx, "", 10); table->addColumn("vy", vy, "", 10); @@ -147,7 +144,6 @@ void PVertexBPHTable::produce(edm::Event& iEvent, const edm::EventSetup& iSetup) table->addColumn("covYZ", covYZ, "", 10); table->addColumn("ntracks", ntracks, ""); - iEvent.put(std::move(table), "pv"); } diff --git a/PhysicsTools/BPHNano/plugins/TrackMerger.cc b/PhysicsTools/BPHNano/plugins/TrackMerger.cc index 281e2aeb2710..a733538de3ab 100644 --- a/PhysicsTools/BPHNano/plugins/TrackMerger.cc +++ b/PhysicsTools/BPHNano/plugins/TrackMerger.cc @@ -28,22 +28,19 @@ #include "helper.h" class TrackMerger : public edm::global::EDProducer<> { - public: - //would it be useful to give this a bit more standard structure? - explicit TrackMerger(const edm::ParameterSet &cfg): - bFieldToken_(esConsumes()), - beamSpotSrc_(consumes(cfg.getParameter("beamSpot"))), - tracksToken_(consumes(cfg.getParameter("tracks"))), - lostTracksToken_(consumes(cfg.getParameter("lostTracks"))), - dileptonToken_(consumes(cfg.getParameter("dileptons"))), - muonToken_(consumes(cfg.getParameter("muons"))), - eleToken_(consumes(cfg.getParameter("electrons"))), - maxDzDilep_(cfg.getParameter("maxDzDilep")), - dcaSig_(cfg.getParameter("dcaSig")), - track_selection_(cfg.getParameter("trackSelection")) - { + explicit TrackMerger(const edm::ParameterSet &cfg) + : bFieldToken_(esConsumes()), + beamSpotSrc_(consumes(cfg.getParameter("beamSpot"))), + tracksToken_(consumes(cfg.getParameter("tracks"))), + lostTracksToken_(consumes(cfg.getParameter("lostTracks"))), + dileptonToken_(consumes(cfg.getParameter("dileptons"))), + muonToken_(consumes(cfg.getParameter("muons"))), + eleToken_(consumes(cfg.getParameter("electrons"))), + maxDzDilep_(cfg.getParameter("maxDzDilep")), + dcaSig_(cfg.getParameter("dcaSig")), + track_selection_(cfg.getParameter("trackSelection")) { produces("SelectedTracks"); produces("SelectedTransientTracks"); produces>("SelectedTracks"); @@ -51,10 +48,9 @@ public: ~TrackMerger() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; - - static void fillDescriptions(edm::ConfigurationDescriptions & descriptions) {} + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; + static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} private: const edm::ESGetToken bFieldToken_; @@ -71,18 +67,16 @@ private: const StringCutObjectSelector track_selection_; }; - void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &stp) const { - //input edm::Handle beamSpotHandle; evt.getByToken(beamSpotSrc_, beamSpotHandle); - if ( ! beamSpotHandle.isValid() ) { - edm::LogError("BToKstllProducer") << "No beam spot available from Event" ; + if (!beamSpotHandle.isValid()) { + edm::LogError("BToKstllProducer") << "No beam spot available from Event"; } - const reco::BeamSpot& beamSpot = *beamSpotHandle; + const reco::BeamSpot &beamSpot = *beamSpotHandle; - const auto& bField = stp.getData(bFieldToken_); + const auto &bField = stp.getData(bFieldToken_); edm::Handle tracks; evt.getByToken(tracksToken_, tracks); edm::Handle lostTracks; @@ -95,16 +89,15 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const edm::Handle pfele; evt.getByToken(eleToken_, pfele); - //for lost tracks / pf discrimination unsigned int nTracks = tracks->size(); unsigned int totalTracks = nTracks + lostTracks->size(); //ok this was CompositeCandidateCollection - std::unique_ptr tracks_out (new pat::CompositeCandidateCollection); - std::unique_ptr trans_tracks_out(new TransientTrackCollection); + std::unique_ptr tracks_out(new pat::CompositeCandidateCollection); + std::unique_ptr trans_tracks_out(new TransientTrackCollection); - std::vector< std::pair > vectrk_ttrk; + std::vector> vectrk_ttrk; //try topreserve same logic avoiding the copy of the full collection /* //correct logic but a bit convoluted -> changing to smthn simpler @@ -114,48 +107,52 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const std::vector match_indices(totalTracks, -1); // for loop is better to be range based - especially for large ensembles - for ( unsigned int iTrk = 0; iTrk < totalTracks; ++iTrk ) { - const pat::PackedCandidate & trk = (iTrk < nTracks) ? (*tracks)[iTrk] : (*lostTracks)[iTrk - nTracks]; + for (unsigned int iTrk = 0; iTrk < totalTracks; ++iTrk) { + const pat::PackedCandidate &trk = (iTrk < nTracks) ? (*tracks)[iTrk] : (*lostTracks)[iTrk - nTracks]; //arranging cuts for speed - if (!trk.hasTrackDetails()) continue; - if (fabs(trk.pdgId()) != 211) continue; //do we want also to keep muons? - if ( !track_selection_(trk) ) continue; + if (!trk.hasTrackDetails()) + continue; + if (fabs(trk.pdgId()) != 211) + continue; //do we want also to keep muons? + if (!track_selection_(trk)) + continue; bool skipTrack = true; float dzTrg = 0.0; - for (const pat::CompositeCandidate & dilep : *dileptons) { + for (const pat::CompositeCandidate &dilep : *dileptons) { //if dz is negative it is deactivated - if ( fabs(trk.vz() - dilep.vz()) > maxDzDilep_ && maxDzDilep_ > 0) + if (fabs(trk.vz() - dilep.vz()) > maxDzDilep_ && maxDzDilep_ > 0) continue; skipTrack = false; dzTrg = trk.vz() - dilep.vz(); - break; // at least for one dilepton candidate to pass this cuts + break; // at least for one dilepton candidate to pass this cuts } // if track is far from all dilepton candidate - if (skipTrack) continue; + if (skipTrack) + continue; // high purity requirment applied only in packedCands - if ( iTrk < nTracks && !trk.trackHighPurity()) continue; - const reco::TransientTrack trackTT( (*trk.bestTrack()) , &bField); + if (iTrk < nTracks && !trk.trackHighPurity()) + continue; + const reco::TransientTrack trackTT((*trk.bestTrack()), &bField); //distance closest approach in x,y wrt beam spot std::pair DCA = computeDCA(trackTT, beamSpot); float DCABS = DCA.first; float DCABSErr = DCA.second; float DCASig = (DCABSErr != 0 && float(DCABSErr) == DCABSErr) ? fabs(DCABS / DCABSErr) : -1; - if (DCASig > dcaSig_ && dcaSig_ > 0) continue; - + if (DCASig > dcaSig_ && dcaSig_ > 0) + continue; // clean tracks wrt to all muons - int matchedToMuon = 0; + int matchedToMuon = 0; for (const pat::Muon &imutmp : *muons) { for (unsigned int i = 0; i < imutmp.numberOfSourceCandidatePtrs(); ++i) { - if (! ((imutmp.sourceCandidatePtr(i)).isNonnull() && - (imutmp.sourceCandidatePtr(i)).isAvailable()) - ) continue; + if (!((imutmp.sourceCandidatePtr(i)).isNonnull() && (imutmp.sourceCandidatePtr(i)).isAvailable())) + continue; - const edm::Ptr & source = imutmp.sourceCandidatePtr(i); + const edm::Ptr &source = imutmp.sourceCandidatePtr(i); if (source.id() == tracks.id() && source.key() == iTrk) { matchedToMuon = 1; break; @@ -164,20 +161,17 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const } // clean tracks wrt to all pf electrons - int matchedToEle = 0; + int matchedToEle = 0; for (const pat::Electron &ietmp : *pfele) { for (unsigned int i = 0; i < ietmp.numberOfSourceCandidatePtrs(); ++i) { - - if (! ((ietmp.sourceCandidatePtr(i)).isNonnull() && - (ietmp.sourceCandidatePtr(i)).isAvailable()) - ) continue; - const edm::Ptr & source = ietmp.sourceCandidatePtr(i); + if (!((ietmp.sourceCandidatePtr(i)).isNonnull() && (ietmp.sourceCandidatePtr(i)).isAvailable())) + continue; + const edm::Ptr &source = ietmp.sourceCandidatePtr(i); if (source.id() == tracks.id() && source.key() == iTrk) { matchedToEle = 1; break; } } - } // output @@ -213,14 +207,14 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const pcand.addUserInt("nValidPixelHits", trk.numberOfPixelHits()); //adding the candidate in the composite stuff for fit (need to test) - if ( iTrk < nTracks ) - pcand.addUserCand( "cand", edm::Ptr ( tracks, iTrk )); + if (iTrk < nTracks) + pcand.addUserCand("cand", edm::Ptr(tracks, iTrk)); else - pcand.addUserCand( "cand", edm::Ptr ( lostTracks, iTrk - nTracks )); + pcand.addUserCand("cand", edm::Ptr(lostTracks, iTrk - nTracks)); //in order to avoid revoking the sxpensive ttrack builder many times and still have everything sorted, we add them to vector of pairs match_indices[iTrk] = vectrk_ttrk.size(); - vectrk_ttrk.emplace_back( std::make_pair(pcand, trackTT ) ); + vectrk_ttrk.emplace_back(std::make_pair(pcand, trackTT)); } std::vector sort_indices(vectrk_ttrk.size()); @@ -228,10 +222,9 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const // sort to be uniform with leptons // sort by index since we want to update the match too - std::sort( sort_indices.begin(), sort_indices.end(), - [&vectrk_ttrk] ( auto & iTrk1, auto & iTrk2) -> - bool {return (vectrk_ttrk[iTrk1].first).pt() > (vectrk_ttrk[iTrk2].first).pt();} - ); + std::sort(sort_indices.begin(), sort_indices.end(), [&vectrk_ttrk](auto &iTrk1, auto &iTrk2) -> bool { + return (vectrk_ttrk[iTrk1].first).pt() > (vectrk_ttrk[iTrk2].first).pt(); + }); // std::sort( vectrk_ttrk.begin(), vectrk_ttrk.end(), // [] ( auto & trk1, auto & trk2) -> // bool {return (trk1.first).pt() > (trk2.first).pt();} @@ -240,29 +233,30 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const // finally save ttrks and trks to the correct _out vectors // also fill the reverse matching std::vector reverse_sort_indices(vectrk_ttrk.size()); - for ( size_t iSort = 0; iSort < sort_indices.size(); iSort++) { + for (size_t iSort = 0; iSort < sort_indices.size(); iSort++) { auto iUnsortedTrack = sort_indices[iSort]; - auto&& trk = vectrk_ttrk[iUnsortedTrack]; - tracks_out -> emplace_back( trk.first); - trans_tracks_out -> emplace_back(trk.second); + auto &&trk = vectrk_ttrk[iUnsortedTrack]; + tracks_out->emplace_back(trk.first); + trans_tracks_out->emplace_back(trk.second); reverse_sort_indices[iUnsortedTrack] = iSort; } // Now point the match indices to the sorted output collection - std::transform(match_indices.begin(), match_indices.end(), match_indices.begin(), [&reverse_sort_indices](int iUnsortedTrack) { - if (iUnsortedTrack < 0) return -1; - return reverse_sort_indices[iUnsortedTrack]; - }); + std::transform( + match_indices.begin(), match_indices.end(), match_indices.begin(), [&reverse_sort_indices](int iUnsortedTrack) { + if (iUnsortedTrack < 0) + return -1; + return reverse_sort_indices[iUnsortedTrack]; + }); int unassoc = 0; - for (auto iTrkAssoc: match_indices) { + for (auto iTrkAssoc : match_indices) { unassoc += iTrkAssoc < 0; } // std::clog << "There are " << unassoc << " unassociated tracks" << std::endl; // std::clog << "Total tracks: " << totalTracks << " output tracks: " << tracks_out->size() << std::endl; - auto tracks_orphan_handle = - evt.put(std::move(tracks_out), "SelectedTracks"); + auto tracks_orphan_handle = evt.put(std::move(tracks_out), "SelectedTracks"); evt.put(std::move(trans_tracks_out), "SelectedTransientTracks"); // Associate PackedCandidates to the merged Track collection @@ -276,6 +270,5 @@ void TrackMerger::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const evt.put(std::move(tracks_out_match), "SelectedTracks"); } - //define this as a plug-in DEFINE_FWK_MODULE(TrackMerger); diff --git a/PhysicsTools/BPHNano/plugins/TriggerObjectTable.cc b/PhysicsTools/BPHNano/plugins/TriggerObjectTable.cc index 107e5f73ed1d..6843314dac26 100644 --- a/PhysicsTools/BPHNano/plugins/TriggerObjectTable.cc +++ b/PhysicsTools/BPHNano/plugins/TriggerObjectTable.cc @@ -26,19 +26,19 @@ class TriggerObjectTableBParkProducer : public edm::stream::EDProducer<> { public: - explicit TriggerObjectTableBParkProducer(const edm::ParameterSet &iConfig) : - name_(iConfig.getParameter("name")), - src_(consumes>(iConfig.getParameter("src"))), - l1Muon_(consumes(iConfig.getParameter("l1Muon"))) - { + explicit TriggerObjectTableBParkProducer(const edm::ParameterSet &iConfig) + : name_(iConfig.getParameter("name")), + src_(consumes>(iConfig.getParameter("src"))), + l1Muon_(consumes(iConfig.getParameter("l1Muon"))) { std::vector selPSets = iConfig.getParameter>("selections"); sels_.reserve(selPSets.size()); std::stringstream idstr, qualitystr; idstr << "ID of the object: "; - for (auto & pset : selPSets) { + for (auto &pset : selPSets) { sels_.emplace_back(pset); idstr << sels_.back().id << " = " << sels_.back().name; - if (sels_.size() < selPSets.size()) idstr << ", "; + if (sels_.size() < selPSets.size()) + idstr << ", "; if (!sels_.back().qualityBitsDoc.empty()) { qualitystr << sels_.back().qualityBitsDoc << " for " << sels_.back().name << "; "; } @@ -52,7 +52,7 @@ public: ~TriggerObjectTableBParkProducer() override {} private: - void produce(edm::Event&, edm::EventSetup const&) override ; + void produce(edm::Event &, edm::EventSetup const &) override; std::string name_; edm::EDGetTokenT> src_; @@ -65,19 +65,22 @@ private: int id; StringCutObjectSelector cut; StringCutObjectSelector l1cut, l1cut_2, l2cut; - float l1DR2, l1DR2_2, l2DR2; + float l1DR2, l1DR2_2, l2DR2; StringObjectFunction qualityBits; std::string qualityBitsDoc; - SelectedObject(const edm::ParameterSet & pset) : - name(pset.getParameter("name")), - id(pset.getParameter("id")), - cut(pset.getParameter("sel")), - l1cut(""), l1cut_2(""), l2cut(""), - l1DR2(-1), l1DR2_2(-1), l2DR2(-1), - qualityBits(pset.getParameter("qualityBits")), - qualityBitsDoc(pset.getParameter("qualityBitsDoc")) - { + SelectedObject(const edm::ParameterSet &pset) + : name(pset.getParameter("name")), + id(pset.getParameter("id")), + cut(pset.getParameter("sel")), + l1cut(""), + l1cut_2(""), + l2cut(""), + l1DR2(-1), + l1DR2_2(-1), + l2DR2(-1), + qualityBits(pset.getParameter("qualityBits")), + qualityBitsDoc(pset.getParameter("qualityBitsDoc")) { if (pset.existsAs("l1seed")) { l1cut = StringCutObjectSelector(pset.getParameter("l1seed")); l1DR2 = std::pow(pset.getParameter("l1deltaR"), 2); @@ -92,25 +95,20 @@ private: } } - bool match(const pat::TriggerObjectStandAlone & obj) const { - return cut(obj); - } + bool match(const pat::TriggerObjectStandAlone &obj) const { return cut(obj); } }; std::vector sels_; }; // ------------ method called to produce the data ------------ -void -TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSetup& iSetup) -{ - +void TriggerObjectTableBParkProducer::produce(edm::Event &iEvent, const edm::EventSetup &iSetup) { edm::Handle> src; iEvent.getByToken(src_, src); std::vector> selected; - for (const auto & obj : *src) { - for (const auto & sel : sels_) { + for (const auto &obj : *src) { + for (const auto &sel : sels_) { if (sel.match(obj)) { selected.emplace_back(&obj, &sel); break; @@ -121,15 +119,15 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet // Self-cleaning std::map selected_bits; for (unsigned int i = 0; i < selected.size(); ++i) { - const auto & obj = *selected[i].first; - const auto & sel = *selected[i].second; + const auto &obj = *selected[i].first; + const auto &sel = *selected[i].second; selected_bits[&obj] = int(sel.qualityBits(obj)); for (unsigned int j = 0; j < i; ++j) { - const auto & obj2 = *selected[j].first; - const auto & sel2 = *selected[j].second; + const auto &obj2 = *selected[j].first; + const auto &sel2 = *selected[j].second; if (sel.id == sel2.id && abs(obj.pt() - obj2.pt()) < 1e-6 && deltaR2(obj, obj2) < 1e-6) { - selected_bits[&obj2] |= selected_bits[&obj]; //Keep filters from all the objects + selected_bits[&obj2] |= selected_bits[&obj]; //Keep filters from all the objects selected.erase(selected.begin() + i); i--; } @@ -141,7 +139,6 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet std::vector> l1Objects; - for (l1t::MuonBxCollection::const_iterator it = l1Muon->begin(0); it != l1Muon->end(0); it++) { pat::TriggerObjectStandAlone l1obj(it->p4()); l1obj.setCollection("L1Mu"); @@ -150,14 +147,12 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet l1Objects.emplace_back(l1obj, it->hwIso()); } - - unsigned int nobj = selected.size(); std::vector pt(nobj, 0), eta(nobj, 0), phi(nobj, 0), l1pt(nobj, 0), l1pt_2(nobj, 0), l2pt(nobj, 0); - std::vector id(nobj, 0), bits(nobj, 0), l1iso(nobj, 0), l1charge(nobj, 0); + std::vector id(nobj, 0), bits(nobj, 0), l1iso(nobj, 0), l1charge(nobj, 0); for (unsigned int i = 0; i < nobj; ++i) { - const auto & obj = *selected[i].first; - const auto & sel = *selected[i].second; + const auto &obj = *selected[i].first; + const auto &sel = *selected[i].second; pt[i] = obj.pt(); eta[i] = obj.eta(); phi[i] = obj.phi(); @@ -165,8 +160,8 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet bits[i] = selected_bits[&obj]; if (sel.l1DR2 > 0) { float best = sel.l1DR2; - for (const auto & l1obj : l1Objects) { - const auto & seed = l1obj.first; + for (const auto &l1obj : l1Objects) { + const auto &seed = l1obj.first; float dr2 = deltaR2(seed, obj); if (dr2 < best && sel.l1cut(seed)) { l1pt[i] = seed.pt(); @@ -177,8 +172,8 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet } if (sel.l1DR2_2 > 0) { float best = sel.l1DR2_2; - for (const auto & l1obj : l1Objects) { - const auto & seed = l1obj.first; + for (const auto &l1obj : l1Objects) { + const auto &seed = l1obj.first; float dr2 = deltaR2(seed, obj); if (dr2 < best && sel.l1cut_2(seed)) { l1pt_2[i] = seed.pt(); @@ -187,7 +182,7 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet } if (sel.l2DR2 > 0) { float best = sel.l2DR2; - for (const auto & seed : *src) { + for (const auto &seed : *src) { float dr2 = deltaR2(seed, obj); if (dr2 < best && sel.l2cut(seed)) { l2pt[i] = seed.pt(); @@ -196,13 +191,13 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet } } - auto tab = std::make_unique(nobj, name_, false, false); - tab->addColumn("id", id, idDoc_ ); + auto tab = std::make_unique(nobj, name_, false, false); + tab->addColumn("id", id, idDoc_); tab->addColumn("pt", pt, "pt", 12); - tab->addColumn("eta", eta, "eta", 12); + tab->addColumn("eta", eta, "eta", 12); tab->addColumn("phi", phi, "phi", 12); tab->addColumn("l1pt", l1pt, "pt of associated L1 seed", 8); - tab->addColumn("l1iso", l1iso, "iso of associated L1 seed" ); + tab->addColumn("l1iso", l1iso, "iso of associated L1 seed"); tab->addColumn("l1charge", l1charge, "charge of associated L1 seed"); tab->addColumn("l1pt_2", l1pt_2, "pt of associated secondary L1 seed", 8); tab->addColumn("l2pt", l2pt, "pt of associated 'L2' seed (i.e. HLT before tracking/PF)", 10); @@ -210,6 +205,5 @@ TriggerObjectTableBParkProducer::produce(edm::Event& iEvent, const edm::EventSet iEvent.put(std::move(tab)); } - //define this as a plug-in DEFINE_FWK_MODULE(TriggerObjectTableBParkProducer); diff --git a/PhysicsTools/BPHNano/plugins/V0ReBuilder.cc b/PhysicsTools/BPHNano/plugins/V0ReBuilder.cc index 15f8a638063d..128a7e579654 100644 --- a/PhysicsTools/BPHNano/plugins/V0ReBuilder.cc +++ b/PhysicsTools/BPHNano/plugins/V0ReBuilder.cc @@ -43,29 +43,28 @@ #include "helper.h" class V0ReBuilder : public edm::global::EDProducer<> { - // perhaps we need better structure here (begin run etc) public: typedef std::vector TransientTrackCollection; typedef std::vector V0Collection; - explicit V0ReBuilder(const edm::ParameterSet &cfg): - theB_(esConsumes(edm::ESInputTag{"", "TransientTrackBuilder"})), - trk_selection_{cfg.getParameter("trkSelection")}, - pre_vtx_selection_{cfg.getParameter("V0Selection")}, - post_vtx_selection_{cfg.getParameter("postVtxSelection")}, - v0s_{consumes( cfg.getParameter("V0s") )}, - beamspot_{consumes( cfg.getParameter("beamSpot") )}, - track_match_{consumes>( cfg.getParameter("track_match") )}, - isLambda_{cfg.getParameter("isLambda")} - { + explicit V0ReBuilder(const edm::ParameterSet &cfg) + : theB_(esConsumes(edm::ESInputTag{"", "TransientTrackBuilder"})), + trk_selection_{cfg.getParameter("trkSelection")}, + pre_vtx_selection_{cfg.getParameter("V0Selection")}, + post_vtx_selection_{cfg.getParameter("postVtxSelection")}, + v0s_{consumes(cfg.getParameter("V0s"))}, + beamspot_{consumes(cfg.getParameter("beamSpot"))}, + track_match_{consumes>( + cfg.getParameter("track_match"))}, + isLambda_{cfg.getParameter("isLambda")} { produces("SelectedV0Collection"); produces("SelectedV0TransientCollection"); } ~V0ReBuilder() override {} - void produce(edm::StreamID, edm::Event&, const edm::EventSetup&) const override; + void produce(edm::StreamID, edm::Event &, const edm::EventSetup &) const override; static void fillDescriptions(edm::ConfigurationDescriptions &descriptions) {} @@ -81,7 +80,6 @@ private: }; void V0ReBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const &iSetup) const { - //input auto const theB = &iSetup.getData(theB_); edm::Handle V0s; @@ -89,65 +87,65 @@ void V0ReBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const edm::Handle beamspot; evt.getByToken(beamspot_, beamspot); - auto& track_match = evt.get(track_match_); + auto &track_match = evt.get(track_match_); // output std::unique_ptr ret_val(new pat::CompositeCandidateCollection()); - std::unique_ptr trans_out( new TransientTrackCollection ); + std::unique_ptr trans_out(new TransientTrackCollection); size_t v0_idx = 0; for (reco::VertexCompositePtrCandidateCollection::const_iterator v0 = V0s->begin(); v0 != V0s->end(); v0++) { - reco::VertexCompositePtrCandidate V0 = V0s->at(v0_idx); v0_idx++; // selection on V0s - if (v0->numberOfDaughters() != 2) continue; - if (!pre_vtx_selection_(V0)) continue; + if (v0->numberOfDaughters() != 2) + continue; + if (!pre_vtx_selection_(V0)) + continue; pat::PackedCandidate v0daughter1 = *(dynamic_cast(v0->daughter(0))); pat::PackedCandidate v0daughter2 = *(dynamic_cast(v0->daughter(1))); - if (!v0daughter1.hasTrackDetails()) continue; - if (!v0daughter2.hasTrackDetails()) continue; - - if (fabs(v0daughter1.pdgId()) != 211) continue;// This cut do not affect the Lambda->proton pion candidates - if (fabs(v0daughter2.pdgId()) != 211) continue;// This cut do not affect the Lambda->proton pion candidates - - if (!trk_selection_(v0daughter1) || !trk_selection_(v0daughter2)) continue; - - reco::TransientTrack v0daughter1_ttrack; // 1st daughter, leading daughter to be assigned. Proton mass will be assigned for the Lambda->Proton Pion mode, Pion mass will be assigned for the Kshort->PionPion mode. - reco::TransientTrack v0daughter2_ttrack; // 2nd daughter, subleading daughter to be assigned. It hass always the pion mass - - if (v0daughter1.p()>v0daughter2.p()) - { - v0daughter1_ttrack = theB->build(v0daughter1.bestTrack()); - v0daughter2_ttrack = theB->build(v0daughter2.bestTrack()); - } - else - { - v0daughter1_ttrack = theB->build(v0daughter2.bestTrack()); - v0daughter2_ttrack = theB->build(v0daughter1.bestTrack()); + if (!v0daughter1.hasTrackDetails()) + continue; + if (!v0daughter2.hasTrackDetails()) + continue; + + if (fabs(v0daughter1.pdgId()) != 211) + continue; // This cut do not affect the Lambda->proton pion candidates + if (fabs(v0daughter2.pdgId()) != 211) + continue; // This cut do not affect the Lambda->proton pion candidates + + if (!trk_selection_(v0daughter1) || !trk_selection_(v0daughter2)) + continue; + + reco::TransientTrack + v0daughter1_ttrack; // 1st daughter, leading daughter to be assigned. Proton mass will be assigned for the Lambda->Proton Pion mode, Pion mass will be assigned for the Kshort->PionPion mode. + reco::TransientTrack + v0daughter2_ttrack; // 2nd daughter, subleading daughter to be assigned. It hass always the pion mass + + if (v0daughter1.p() > v0daughter2.p()) { + v0daughter1_ttrack = theB->build(v0daughter1.bestTrack()); + v0daughter2_ttrack = theB->build(v0daughter2.bestTrack()); + } else { + v0daughter1_ttrack = theB->build(v0daughter2.bestTrack()); + v0daughter2_ttrack = theB->build(v0daughter1.bestTrack()); } float Track1_mass = (isLambda_) ? PROT_MASS : PI_MASS; float Track1_sigma = PI_SIGMA; float Track2_mass = PI_MASS; - float Track2_sigma = PI_SIGMA; + float Track2_sigma = PI_SIGMA; // create V0 vertex KinVtxFitter fitter( - {v0daughter1_ttrack, v0daughter2_ttrack}, - {Track1_mass, Track2_mass}, - {Track1_sigma,Track2_sigma} ); + {v0daughter1_ttrack, v0daughter2_ttrack}, {Track1_mass, Track2_mass}, {Track1_sigma, Track2_sigma}); - if (!fitter.success()) continue; + if (!fitter.success()) + continue; pat::CompositeCandidate cand; - cand.setVertex( reco::Candidate::Point( - fitter.fitted_vtx().x(), - fitter.fitted_vtx().y(), - fitter.fitted_vtx().z() ) - ); + cand.setVertex(reco::Candidate::Point(fitter.fitted_vtx().x(), fitter.fitted_vtx().y(), fitter.fitted_vtx().z())); auto fit_p4 = fitter.fitted_p4(); cand.setP4(fit_p4); @@ -155,23 +153,21 @@ void V0ReBuilder::produce(edm::StreamID, edm::Event &evt, edm::EventSetup const cand.addUserFloat("sv_chi2", fitter.chi2()); cand.addUserFloat("sv_prob", fitter.prob()); cand.addUserFloat("fitted_mass", fitter.fitted_candidate().mass()); - cand.addUserFloat("massErr", - sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); - cand.addUserFloat("cos_theta_2D", - cos_theta_2D(fitter, *beamspot, cand.p4())); - cand.addUserFloat("fitted_cos_theta_2D", - cos_theta_2D(fitter, *beamspot, fit_p4)); + cand.addUserFloat("massErr", sqrt(fitter.fitted_candidate().kinematicParametersError().matrix()(6, 6))); + cand.addUserFloat("cos_theta_2D", cos_theta_2D(fitter, *beamspot, cand.p4())); + cand.addUserFloat("fitted_cos_theta_2D", cos_theta_2D(fitter, *beamspot, fit_p4)); auto lxy = l_xy(fitter, *beamspot); cand.addUserFloat("l_xy", lxy.value()); cand.addUserFloat("l_xy_unc", lxy.error()); - if (!post_vtx_selection_(cand)) continue; + if (!post_vtx_selection_(cand)) + continue; cand.addUserFloat("vtx_x", cand.vx()); cand.addUserFloat("vtx_y", cand.vy()); cand.addUserFloat("vtx_z", cand.vz()); - const auto& covMatrix = fitter.fitted_vtx_uncertainty(); + const auto &covMatrix = fitter.fitted_vtx_uncertainty(); cand.addUserFloat("vtx_cxx", covMatrix.cxx()); cand.addUserFloat("vtx_cyy", covMatrix.cyy()); cand.addUserFloat("vtx_czz", covMatrix.czz()); diff --git a/PhysicsTools/BPHNano/plugins/helper.h b/PhysicsTools/BPHNano/plugins/helper.h index d02fc5ec2c4a..692c09f6c355 100644 --- a/PhysicsTools/BPHNano/plugins/helper.h +++ b/PhysicsTools/BPHNano/plugins/helper.h @@ -38,7 +38,7 @@ constexpr float PROT_SIGMA = 0.000016; constexpr float MUON_MASS = 0.10565837; constexpr float ELECTRON_MASS = 0.000511; -inline std::pair min_max_dr(const std::vector< edm::Ptr > & cands) { +inline std::pair min_max_dr(const std::vector>& cands) { float min_dr = std::numeric_limits::max(); float max_dr = 0.; for (size_t i = 0; i < cands.size(); ++i) { @@ -51,9 +51,10 @@ inline std::pair min_max_dr(const std::vector< edm::Ptr -inline double cos_theta_2D(const FITTER& fitter, const reco::BeamSpot &bs, const LORENTZ_VEC& p4) { - if (!fitter.success()) return -2; +template +inline double cos_theta_2D(const FITTER& fitter, const reco::BeamSpot& bs, const LORENTZ_VEC& p4) { + if (!fitter.success()) + return -2; GlobalPoint point = fitter.fitted_vtx(); auto bs_pos = bs.position(point.z()); math::XYZVector delta(point.x() - bs_pos.x(), point.y() - bs_pos.y(), 0.); @@ -62,9 +63,10 @@ inline double cos_theta_2D(const FITTER& fitter, const reco::BeamSpot &bs, const return (den != 0.) ? delta.Dot(pt) / den : -2; } -template -inline Measurement1D l_xy(const FITTER& fitter, const reco::BeamSpot &bs) { - if (!fitter.success()) return { -2, -2}; +template +inline Measurement1D l_xy(const FITTER& fitter, const reco::BeamSpot& bs) { + if (!fitter.success()) + return {-2, -2}; GlobalPoint point = fitter.fitted_vtx(); GlobalError err = fitter.fitted_vtx_uncertainty(); auto bs_pos = bs.position(point.z()); @@ -82,38 +84,31 @@ inline GlobalPoint FlightDistVector (const reco::BeamSpot & bm, GlobalPoint Bvtx } */ -inline float CosA(GlobalPoint & dist, ROOT::Math::LorentzVector> & Bp4) -{ +inline float CosA(GlobalPoint& dist, ROOT::Math::LorentzVector>& Bp4) { math::XYZVector vperp(dist.x(), dist.y(), 0); math::XYZVector pperp(Bp4.Px(), Bp4.Py(), 0); return vperp.Dot(pperp) / (vperp.R() * pperp.R()); } - -inline std::pair computeDCA(const reco::TransientTrack& trackTT, - const reco::BeamSpot& beamSpot) -{ - double DCABS = -1.; +inline std::pair computeDCA(const reco::TransientTrack& trackTT, const reco::BeamSpot& beamSpot) { + double DCABS = -1.; double DCABSErr = -1.; - TrajectoryStateClosestToPoint theDCAXBS = - trackTT.trajectoryStateClosestToPoint(GlobalPoint(beamSpot.position().x(), beamSpot.position().y(), beamSpot.position().z())); + TrajectoryStateClosestToPoint theDCAXBS = trackTT.trajectoryStateClosestToPoint( + GlobalPoint(beamSpot.position().x(), beamSpot.position().y(), beamSpot.position().z())); if (theDCAXBS.isValid()) { - DCABS = theDCAXBS.perigeeParameters().transverseImpactParameter(); + DCABS = theDCAXBS.perigeeParameters().transverseImpactParameter(); DCABSErr = theDCAXBS.perigeeError().transverseImpactParameterError(); } return std::make_pair(DCABS, DCABSErr); } - -inline bool track_to_lepton_match(edm::Ptr l_ptr, auto iso_tracks_id, unsigned int iTrk) -{ +inline bool track_to_lepton_match(edm::Ptr l_ptr, auto iso_tracks_id, unsigned int iTrk) { for (unsigned int i = 0; i < l_ptr->numberOfSourceCandidatePtrs(); ++i) { - if (! ((l_ptr->sourceCandidatePtr(i)).isNonnull() && - (l_ptr->sourceCandidatePtr(i)).isAvailable()) - ) continue; - const edm::Ptr & source = l_ptr->sourceCandidatePtr(i); + if (!((l_ptr->sourceCandidatePtr(i)).isNonnull() && (l_ptr->sourceCandidatePtr(i)).isAvailable())) + continue; + const edm::Ptr& source = l_ptr->sourceCandidatePtr(i); if (source.id() == iso_tracks_id && source.key() == iTrk) { return true; } @@ -121,10 +116,9 @@ inline bool track_to_lepton_match(edm::Ptr l_ptr, auto iso_trac return false; } - inline std::pair absoluteImpactParameter(const TrajectoryStateOnSurface& tsos, - RefCountedKinematicVertex vertex, - VertexDistance& distanceComputer) { + RefCountedKinematicVertex vertex, + VertexDistance& distanceComputer) { if (!tsos.isValid()) { return std::pair(false, Measurement1D(0., 0.)); } @@ -132,28 +126,27 @@ inline std::pair absoluteImpactParameter(const TrajectorySt GlobalError refPointErr = tsos.cartesianError().position(); GlobalPoint vertexPosition = vertex->vertexState().position(); GlobalError vertexPositionErr = RecoVertex::convertError(vertex->vertexState().error()); - return std::pair(true, - distanceComputer.distance(VertexState(vertexPosition, vertexPositionErr), VertexState(refPoint, refPointErr))); + return std::pair( + true, + distanceComputer.distance(VertexState(vertexPosition, vertexPositionErr), VertexState(refPoint, refPointErr))); } - inline std::pair absoluteImpactParameter3D(const TrajectoryStateOnSurface& tsos, - RefCountedKinematicVertex vertex) { + RefCountedKinematicVertex vertex) { VertexDistance3D dist; return absoluteImpactParameter(tsos, vertex, dist); } - inline std::pair absoluteTransverseImpactParameter(const TrajectoryStateOnSurface& tsos, - RefCountedKinematicVertex vertex) { + RefCountedKinematicVertex vertex) { VertexDistanceXY dist; return absoluteImpactParameter(tsos, vertex, dist); } - inline std::pair signedImpactParameter3D(const TrajectoryStateOnSurface& tsos, - RefCountedKinematicVertex vertex, - const reco::BeamSpot &bs, double pv_z) { + RefCountedKinematicVertex vertex, + const reco::BeamSpot& bs, + double pv_z) { VertexDistance3D dist; std::pair result = absoluteImpactParameter(tsos, vertex, dist); @@ -175,14 +168,13 @@ inline std::pair signedImpactParameter3D(const TrajectorySt double sign = (prod >= 0) ? 1. : -1.; //Apply sign to the result - return std::pair(result.first, Measurement1D(sign * result.second.value(), result.second.error())); - + return std::pair(result.first, + Measurement1D(sign * result.second.value(), result.second.error())); } - inline std::pair signedTransverseImpactParameter(const TrajectoryStateOnSurface& tsos, - RefCountedKinematicVertex vertex, - const reco::BeamSpot &bs) { + RefCountedKinematicVertex vertex, + const reco::BeamSpot& bs) { VertexDistanceXY dist; std::pair result = absoluteImpactParameter(tsos, vertex, dist); @@ -192,25 +184,31 @@ inline std::pair signedTransverseImpactParameter(const Traj //Compute Sign auto bs_pos = bs.position(vertex->vertexState().position().z()); GlobalPoint impactPoint = tsos.globalPosition(); - GlobalVector IPVec(impactPoint.x() - vertex->vertexState().position().x(), impactPoint.y() - vertex->vertexState().position().y(), 0.); - GlobalVector direction(vertex->vertexState().position().x() - bs_pos.x(), - vertex->vertexState().position().y() - bs_pos.y(), 0); + GlobalVector IPVec(impactPoint.x() - vertex->vertexState().position().x(), + impactPoint.y() - vertex->vertexState().position().y(), + 0.); + GlobalVector direction( + vertex->vertexState().position().x() - bs_pos.x(), vertex->vertexState().position().y() - bs_pos.y(), 0); double prod = IPVec.dot(direction); double sign = (prod >= 0) ? 1. : -1.; //Apply sign to the result - return std::pair(result.first, Measurement1D(sign * result.second.value(), result.second.error())); - + return std::pair(result.first, + Measurement1D(sign * result.second.value(), result.second.error())); } -inline std::vector -TrackerIsolation(edm::Handle & tracks, pat::CompositeCandidate &B, std::vector &dnames ) { +inline std::vector TrackerIsolation(edm::Handle& tracks, + pat::CompositeCandidate& B, + std::vector& dnames) { std::vector iso(dnames.size(), 0); for (size_t k_idx = 0; k_idx < tracks->size(); ++k_idx) { edm::Ptr trk_ptr(tracks, k_idx); - for ( size_t iname = 0; iname < dnames.size(); ++iname) { - float dr = deltaR(B.userFloat("fitted_" + dnames[iname] + "_eta"), B.userFloat("fitted_" + dnames[iname] + "_phi"), trk_ptr->eta(), trk_ptr->phi()); + for (size_t iname = 0; iname < dnames.size(); ++iname) { + float dr = deltaR(B.userFloat("fitted_" + dnames[iname] + "_eta"), + B.userFloat("fitted_" + dnames[iname] + "_phi"), + trk_ptr->eta(), + trk_ptr->phi()); if (dr > 0 && dr < 0.4) iso[iname] += trk_ptr->pt(); } @@ -218,5 +216,4 @@ TrackerIsolation(edm::Handle & tracks, pat::C return iso; } - #endif diff --git a/PhysicsTools/BPHNano/src/classes.h b/PhysicsTools/BPHNano/src/classes.h index f3997b35d2b8..7241955e0f66 100644 --- a/PhysicsTools/BPHNano/src/classes.h +++ b/PhysicsTools/BPHNano/src/classes.h @@ -8,13 +8,12 @@ #include "PhysicsTools/BPHNano/plugins/KinVtxFitter.h" #include - namespace { struct dictionary { - std::vector ttv; - edm::Wrapper > wttv; - edm::Wrapper > wkv; + std::vector ttv; + edm::Wrapper > wttv; + edm::Wrapper > wkv; }; -} +} // namespace -#endif +#endif