diff --git a/analyses/pluginATLAS/ATLAS_2017_I1589844.info b/analyses/pluginATLAS/ATLAS_2017_I1589844.info --- a/analyses/pluginATLAS/ATLAS_2017_I1589844.info +++ b/analyses/pluginATLAS/ATLAS_2017_I1589844.info @@ -1,46 +1,46 @@ Name: ATLAS_2017_I1589844 Year: 2017 Summary: $k_T$ splittings in $Z$ events at 8 TeV Experiment: ATLAS Collider: LHC InspireID: 1589844 Status: VALIDATED Authors: - Christian Gutschow - Frank Siegert References: - arXiv:1704.01530 [hep-ex] - submitted to JHEP Keywords: - zboson - jets RunInfo: '$pp \to Z(\to ee/\mu\mu) +$ jets at 8 TeV' Luminosity_fb: 20.2 Beams: [p+, p+] Energies: [8000] PtCuts: [25, 25, 0.4] Options: - LMODE=EL,MU Description: 'A measurement of the splitting scales occuring in the $k_\text{t}$ jet-clustering algorithm is presented for final states containing a $Z$ boson. The measurement is done using 20.2 fb$^{-1}$ of proton-proton collision data collected at a centre-of-mass energy of $\sqrt{s} = 8$ TeV by the ATLAS experiment at the LHC in 2012. The measurement is based on charged-particle track information, which is measured with excellent precision in the $p_\text{T}$ region relevant for the transition between the perturbative and the non-perturbative regimes. The data distributions are corrected for detector effects, and are found to deviate from - state-of-the-art predictions in various regions of the observables. If no mode specified, will try to fill both electron and muon plots. If EL or MU - is specified, only the relevant plots will be filled.' + state-of-the-art predictions in various regions of the observables. If no mode specified, will try to fill both electron and muon plots. + If EL or MU is specified, only the relevant plots will be filled.' BibKey: Aaboud:2017hox BibTeX: '@article{Aaboud:2017hox, author = "Aaboud, Morad and others", title = "{Measurement of the $k_\mathrm{t}$ splitting scales in $Z \to \ell\ell$ events in $pp$ collisions at $\sqrt{s} = 8$ TeV with the ATLAS detector}", collaboration = "ATLAS", year = "2017", eprint = "1704.01530", archivePrefix = "arXiv", primaryClass = "hep-ex", reportNumber = "CERN-EP-2017-033", SLACcitation = "%%CITATION = ARXIV:1704.01530;%%" }' diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448.cc b/analyses/pluginATLAS/ATLAS_2017_I1609448.cc --- a/analyses/pluginATLAS/ATLAS_2017_I1609448.cc +++ b/analyses/pluginATLAS/ATLAS_2017_I1609448.cc @@ -1,275 +1,254 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/FastJets.hh" #include "Rivet/Projections/FinalState.hh" #include "Rivet/Projections/DressedLeptons.hh" #include "Rivet/Projections/VetoedFinalState.hh" #include "Rivet/Projections/PromptFinalState.hh" #include "Rivet/Projections/MissingMomentum.hh" namespace Rivet { /// ATLAS pTmiss+jets cross-section ratios at 13 TeV class ATLAS_2017_I1609448 : public Analysis { public: /// Constructor - ATLAS_2017_I1609448(const string name="ATLAS_2017_I1609448", size_t channel = 0, + ATLAS_2017_I1609448(const string name="ATLAS_2017_I1609448", const string ref_data="ATLAS_2017_I1609448") : Analysis(name) { - _mode = channel; // using Z -> nunu channel by default - setNeedsCrossSection(true); setRefDataName(ref_data); } struct HistoHandler { Histo1DPtr histo; Scatter2DPtr scatter; unsigned int d, x, y; void fill(double value, double weight) { histo->fill(value, weight); } }; /// Initialize void init() { + // Get options from the new option system + _mode = 0; + if ( getOption("LMODE") == "NU" ) _mode = 0; // using Z -> nunu channel by default + if ( getOption("LMODE") == "MU" ) _mode = 1; + if ( getOption("LMODE") == "EL" ) _mode = 2; + // Prompt photons PromptFinalState photon_fs(Cuts::abspid == PID::PHOTON && Cuts::abseta < 4.9); // Prompt electrons PromptFinalState el_fs(Cuts::abseta < 4.9 && Cuts::abspid == PID::ELECTRON); // Prompt muons PromptFinalState mu_fs(Cuts::abseta < 4.9 && Cuts::abspid == PID::MUON); // Dressed leptons Cut lep_cuts = Cuts::pT > 7*GeV && Cuts::abseta < 2.5; DressedLeptons dressed_leps(photon_fs, (_mode == 2 ? el_fs : mu_fs), 0.1, lep_cuts); declare(dressed_leps, "DressedLeptons"); // In-acceptance leptons for lepton veto PromptFinalState veto_lep_fs(Cuts::abseta < 4.9 && (Cuts::abspid == PID::ELECTRON || Cuts::abspid == PID::MUON)); veto_lep_fs.acceptTauDecays(); veto_lep_fs.acceptMuonDecays(); DressedLeptons veto_lep(photon_fs, veto_lep_fs, 0.1, lep_cuts); declare(veto_lep, "VetoLeptons"); // MET VetoedFinalState met_fs(Cuts::abseta > 2.5 && Cuts::abspid == PID::MUON); // veto out-of-acceptance muons if (_mode) met_fs.addVetoOnThisFinalState(dressed_leps); declare(MissingMomentum(met_fs), "MET"); // Jet collection FastJets jets(FinalState(Cuts::abseta < 4.9), FastJets::ANTIKT, 0.4, JetAlg::NO_MUONS, JetAlg::NO_INVISIBLES); declare(jets, "Jets"); _h["met_mono"] = bookHandler(1, 1, 2); _h["met_vbf" ] = bookHandler(2, 1, 2); _h["mjj_vbf" ] = bookHandler(3, 1, 2); _h["dphijj_vbf"] = bookHandler(4, 1, 2); } HistoHandler bookHandler(unsigned int id_d, unsigned int id_x, unsigned int id_y) { HistoHandler dummy; if (_mode < 2) { // numerator mode const string histName = "_" + makeAxisCode(id_d, id_x, id_y); dummy.histo = bookHisto1D(histName, refData(id_d, id_x, id_y)); // hidden auxiliary output dummy.scatter = bookScatter2D(id_d, id_x, id_y - 1, true); // ratio dummy.d = id_d; dummy.x = id_x; dummy.y = id_y; } else { dummy.histo = bookHisto1D(id_d, id_x, 4); // denominator mode } return dummy; } bool isBetweenJets(const Jet& probe, const Jet& boundary1, const Jet& boundary2) { const double y_p = probe.rapidity(); const double y_b1 = boundary1.rapidity(); const double y_b2 = boundary2.rapidity(); const double y_min = std::min(y_b1, y_b2); const double y_max = std::max(y_b1, y_b2); return (y_p > y_min && y_p < y_max); } int centralJetVeto(Jets& jets) { if (jets.size() < 2) return 0; const Jet bj1 = jets.at(0); const Jet bj2 = jets.at(1); // Start loop at the 3rd hardest pT jet int n_between = 0; for (size_t i = 2; i < jets.size(); ++i) { const Jet j = jets.at(i); if (isBetweenJets(j, bj1, bj2) && j.pT() > 25*GeV) ++n_between; } return n_between; } /// Perform the per-event analysis void analyze(const Event& event) { const double weight = event.weight(); // Require 0 (Znunu) or 2 (Zll) dressed leptons bool isZll = bool(_mode); const vector &vetoLeptons = applyProjection(event, "VetoLeptons").dressedLeptons(); const vector &all_leps = applyProjection(event, "DressedLeptons").dressedLeptons(); if (!isZll && vetoLeptons.size()) vetoEvent; if ( isZll && all_leps.size() != 2) vetoEvent; vector leptons; bool pass_Zll = true; if (isZll) { // Sort dressed leptons by pT if (all_leps[0].pt() > all_leps[1].pt()) { leptons.push_back(all_leps[0]); leptons.push_back(all_leps[1]); } else { leptons.push_back(all_leps[1]); leptons.push_back(all_leps[0]); } // Leading lepton pT cut pass_Zll &= leptons[0].pT() > 80*GeV; // Opposite-charge requirement pass_Zll &= threeCharge(leptons[0]) + threeCharge(leptons[1]) == 0; // Z-mass requirement const double Zmass = (leptons[0].mom() + leptons[1].mom()).mass(); pass_Zll &= (Zmass >= 66*GeV && Zmass <= 116*GeV); } if (!pass_Zll) vetoEvent; // Get jets and remove those within dR = 0.5 of a dressed lepton Jets jets = applyProjection(event, "Jets").jetsByPt(Cuts::pT > 25*GeV && Cuts::absrap < 4.4); for (const DressedLepton& lep : leptons) ifilter_discard(jets, deltaRLess(lep, 0.5)); const size_t njets = jets.size(); if (!njets) vetoEvent; const int njets_gap = centralJetVeto(jets); double jpt1 = jets[0].pT(); double jeta1 = jets[0].eta(); double mjj = 0., jpt2 = 0., dphijj = 0.; if (njets >= 2) { mjj = (jets[0].momentum() + jets[1].momentum()).mass(); jpt2 = jets[1].pT(); dphijj = deltaPhi(jets[0], jets[1]); } // MET Vector3 met_vec = apply(event, "MET").vectorMPT(); double met = met_vec.mod(); // Cut on deltaPhi between MET and first 4 jets, but only if jet pT > 30 GeV bool dphi_fail = false; for (size_t i = 0; i < jets.size() && i < 4; ++i) { dphi_fail |= (deltaPhi(jets[i], met_vec) < 0.4 && jets[i].pT() > 30*GeV); } const bool pass_met_dphi = met > 200*GeV && !dphi_fail; const bool pass_vbf = pass_met_dphi && mjj > 200*GeV && jpt1 > 80*GeV && jpt2 > 50*GeV && njets >= 2 && !njets_gap; const bool pass_mono = pass_met_dphi && jpt1 > 120*GeV && fabs(jeta1) < 2.4; if (pass_mono) _h["met_mono"].fill(met, weight); if (pass_vbf) { _h["met_vbf"].fill(met/GeV, weight); _h["mjj_vbf"].fill(mjj/GeV, weight); _h["dphijj_vbf"].fill(dphijj, weight); } } /// Normalise, scale and otherwise manipulate histograms here void finalize() { const double sf(crossSection() / femtobarn / sumOfWeights()); for (map::iterator hit = _h.begin(); hit != _h.end(); ++hit) { scale(hit->second.histo, sf); if (_mode < 2) constructRmiss(hit->second); } } void constructRmiss(HistoHandler& handler) { // Load transfer function from reference data file const YODA::Scatter2D& rmiss = refData(handler.d, handler.x, handler.y); const YODA::Scatter2D& numer = refData(handler.d, handler.x, handler.y + 1); const YODA::Scatter2D& denom = refData(handler.d, handler.x, handler.y + 2); for (size_t i = 0; i < handler.scatter->numPoints(); ++i) { const Point2D& r = rmiss.point(i); // SM Rmiss const Point2D& n = numer.point(i); // SM numerator const Point2D& d = denom.point(i); // SM denominator const HistoBin1D& b = handler.histo->bin(i); // BSM double bsmy; try { bsmy = b.height(); } catch (const Exception&) { // LowStatsError or WeightError bsmy = 0; } double bsmey; try { bsmey = b.heightErr(); } catch (const Exception&) { // LowStatsError or WeightError bsmey = 0; } // Combined numerator double sm_plus_bsm = n.y() + bsmy; // Rmiss central value double rmiss_y = safediv(sm_plus_bsm, d.y()); // Ratio error (Rmiss = SM_num/SM_denom + BSM/SM_denom ~ Rmiss_SM + BSM/SM_denom double rmiss_p = sqrt(r.yErrPlus()*r.yErrPlus() + safediv(bsmey*bsmey, d.y()*d.y())); double rmiss_m = sqrt(r.yErrMinus()*r.yErrMinus() + safediv(bsmey*bsmey, d.y()*d.y())); // Set new values Point2D& p = handler.scatter->point(i); // (SM + BSM) Rmiss p.setY(rmiss_y); p.setYErrMinus(rmiss_m); p.setYErrPlus(rmiss_p); } } protected: // Analysis-mode switch size_t _mode; /// Histograms map _h; }; - - - /// ATLAS pTmiss+jets specialisation for Znunu channel - class ATLAS_2017_I1609448_Znunu : public ATLAS_2017_I1609448 { - public: - ATLAS_2017_I1609448_Znunu() : ATLAS_2017_I1609448("ATLAS_2017_I1609448_Znunu", 0) { } - }; - - /// ATLAS pTmiss+jets specialisation for Zmumu channel - class ATLAS_2017_I1609448_Zmumu : public ATLAS_2017_I1609448 { - public: - ATLAS_2017_I1609448_Zmumu() : ATLAS_2017_I1609448("ATLAS_2017_I1609448_Zmumu", 1) { } - }; - - /// ATLAS pTmiss+jets specialisation for Zee channel - class ATLAS_2017_I1609448_Zee : public ATLAS_2017_I1609448 { - public: - ATLAS_2017_I1609448_Zee() : ATLAS_2017_I1609448("ATLAS_2017_I1609448_Zee", 2) { } - }; - - // Hooks for the plugin system DECLARE_RIVET_PLUGIN(ATLAS_2017_I1609448); - DECLARE_RIVET_PLUGIN(ATLAS_2017_I1609448_Znunu); - DECLARE_RIVET_PLUGIN(ATLAS_2017_I1609448_Zmumu); - DECLARE_RIVET_PLUGIN(ATLAS_2017_I1609448_Zee); - } diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448.info b/analyses/pluginATLAS/ATLAS_2017_I1609448.info --- a/analyses/pluginATLAS/ATLAS_2017_I1609448.info +++ b/analyses/pluginATLAS/ATLAS_2017_I1609448.info @@ -1,52 +1,57 @@ Name: ATLAS_2017_I1609448 Year: 2017 Summary: $p_T^\text{miss}$+jets cross-section ratios at 13 TeV Experiment: ATLAS Collider: LHC InspireID: 1609448 Status: VALIDATED Authors: - Christian Gutschow References: - arXiv:1707.03263 [hep-ex] - - submitted to EPJC + - Eur.Phys.J. C77 (2017) no.11, 765 + - doi:10.1140/epjc/s10052-017-5315-6 Keywords: - met - jets - zboson - vjets RunInfo: - pp -> MET + jets at 13 TeV + pp -> MET + jets or pp -> e+ e- + jets or pp -> mu+ mu- + jets at 13 TeV Luminosity_fb: 3.2 Beams: [p+, p+] Energies: [13000] PtCuts: [200] +Options: +- LMODE=NU,EL,MU Description: | Observables sensitive to the anomalous production of events containing hadronic jets and missing momentum in the plane transverse to the proton beams at the Large Hadron Collider are presented. The observables are defined as a ratio of cross sections, for events containing jets and large missing transverse momentum to events containing jets and a pair of charged leptons from the decay of a $Z/\gamma^\ast$ boson. This definition minimises experimental and theoretical systematic uncertainties in the measurements. This ratio is measured differentially with respect to a number of kinematic properties of the hadronic system in two phase-space regions; one inclusive single-jet region and one region sensitive to vector-boson-fusion topologies. The data are found to be in agreement with the Standard Model predictions and used to constrain a variety of theoretical models for dark-matter production, including simplified models, effective field theory models, and invisible decays of the Higgs boson. The measurements use 3.2 fb${}^{-1}$ of proton-proton collision data recorded by the ATLAS experiment at a centre-of-mass energy of 13 TeV and are fully corrected for detector effects, meaning that the data can be used to constrain new-physics models beyond those shown in this paper. The reference data file comes with the measured $R^\text{miss}$ (y01), the expected $R^\text{miss}$ in the Standard Model (y02), the expected $R^\text{miss}$ numerator in the Standard Model (y03) as well as the expected $R^\text{miss}$ - denominator in the Standard Model (y04). + denominator in the Standard Model (y04). If no mode is specified, will assume routine is being run on BSM model and attempt + to combine with SM prediction from ref data file. If NU is specified will assume SM $Z\to\nu\nu$ is being run on. If EL or MU + is specified, will assume routine is run on SM $Z\to ee$ or $Z\to\mu\mu$ respectively.' BibKey: Aaboud:2017buf BibTeX: '@article{Aaboud:2017buf, author = "Aaboud, Morad and others", title = "{Measurement of detector-corrected observables sensitive to the anomalous production of events with jets and large missing transverse momentum in $pp$ collisions at $\sqrt{s} = 13$ TeV using the ATLAS detector}", collaboration = "ATLAS", year = "2017", eprint = "1707.03263", archivePrefix = "arXiv", primaryClass = "hep-ex", reportNumber = "CERN-EP-2017-116", SLACcitation = "%%CITATION = ARXIV:1707.03263;%%" }' diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.info b/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.info +++ /dev/null @@ -1,52 +0,0 @@ -Name: ATLAS_2017_I1609448_Zee -Year: 2017 -Summary: $p_T^\text{miss}$ + jets cross section ratios at 13 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1609448 -Status: VALIDATED -Authors: - - Christian Gutschow -References: - - arXiv:1707.03263 [hep-ex] - - submitted to EPJC -Keywords: - - met - - jets - - zboson - - vjets -RunInfo: - pp -> e+ e- + jets at 13 TeV -Luminosity_fb: 3.2 -Beams: [p+, p+] -Energies: [13000] -PtCuts: [200] -Description: | - Observables sensitive to the anomalous production of events containing hadronic jets and missing momentum in the plane transverse - to the proton beams at the Large Hadron Collider are presented. The observables are defined as a ratio of cross sections, for - events containing jets and large missing transverse momentum to events containing jets and a pair of charged leptons from the - decay of a $Z/\gamma^\ast$ boson. This definition minimises experimental and theoretical systematic uncertainties in the measurements. - This ratio is measured differentially with respect to a number of kinematic properties of the hadronic system in two phase-space - regions; one inclusive single-jet region and one region sensitive to vector-boson-fusion topologies. The data are found to be in - agreement with the Standard Model predictions and used to constrain a variety of theoretical models for dark-matter production, - including simplified models, effective field theory models, and invisible decays of the Higgs boson. The measurements use - 3.2 fb${}^{-1}$ of proton-proton collision data recorded by the ATLAS experiment at a centre-of-mass energy of 13 TeV and are - fully corrected for detector effects, meaning that the data can be used to constrain new-physics models beyond those shown in - this paper. The reference data file comes with the measured $R^\text{miss}$ (y01), the expected $R^\text{miss}$ in the Standard - Model (y02), the expected $R^\text{miss}$ numerator in the Standard Model (y03) as well as the expected $R^\text{miss}$ - denominator in the Standard Model (y04). -BibKey: Aaboud:2017buf -BibTeX: '@article{Aaboud:2017buf, - author = "Aaboud, Morad and others", - title = "{Measurement of detector-corrected observables sensitive - to the anomalous production of events with jets and large - missing transverse momentum in $pp$ collisions at - $\sqrt{s} = 13$ TeV using the ATLAS detector}", - collaboration = "ATLAS", - year = "2017", - eprint = "1707.03263", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2017-116", - SLACcitation = "%%CITATION = ARXIV:1707.03263;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.plot b/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zee.plot +++ /dev/null @@ -1,27 +0,0 @@ -# BEGIN PLOT /ATLAS_2017_I1609448_Zee/d.. -XTwosidedTicks=1 -YTwosidedTicks=1 -LeftMargin=1.5 -LogY=0 -Title=VBF phase space, $Z\to ee$ -XLabel=$p_\text{T}^\text{miss}$ [GeV] -LegendAlign=l -LegendXPos=0.05 -LegendYPos=0.3 -YLabel=$\text{d}\sigma / \text{d} p_\text{T}^\text{miss}$ [fb GeV$^{-1}$] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zee/d01 -Title=$\geq 1$ jet phase space, $Z\to ee$ -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zee/d03 -XLabel=$m_\text{jj}$ [GeV] -YLabel=$\text{d}\sigma / \text{d} m_\text{jj}$ [fb GeV$^{-1}$] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zee/d04 -XLabel=$\Delta\phi_\text{jj}$ [rad] -YLabel=$\text{d}\sigma / \text{d} \Delta\phi_\text{jj}$ [fb rad$^{-1}$] -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.info b/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.info +++ /dev/null @@ -1,52 +0,0 @@ -Name: ATLAS_2017_I1609448_Zmumu -Year: 2017 -Summary: $p_T^\text{miss}$ cross-section ratios at 13 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1609448 -Status: VALIDATED -Authors: - - Christian Gutschow -References: - - arXiv:1707.03263 [hep-ex] - - submitted to EPJC -Keywords: - - met - - jets - - zboson - - vjets -RunInfo: - pp -> mu+ mu- + jets at 13 TeV -Luminosity_fb: 3.2 -Beams: [p+, p+] -Energies: [13000] -PtCuts: [200] -Description: | - Observables sensitive to the anomalous production of events containing hadronic jets and missing momentum in the plane transverse - to the proton beams at the Large Hadron Collider are presented. The observables are defined as a ratio of cross sections, for - events containing jets and large missing transverse momentum to events containing jets and a pair of charged leptons from the - decay of a $Z/\gamma^\ast$ boson. This definition minimises experimental and theoretical systematic uncertainties in the measurements. - This ratio is measured differentially with respect to a number of kinematic properties of the hadronic system in two phase-space - regions; one inclusive single-jet region and one region sensitive to vector-boson-fusion topologies. The data are found to be in - agreement with the Standard Model predictions and used to constrain a variety of theoretical models for dark-matter production, - including simplified models, effective field theory models, and invisible decays of the Higgs boson. The measurements use - 3.2 fb${}^{-1}$ of proton-proton collision data recorded by the ATLAS experiment at a centre-of-mass energy of 13 TeV and are - fully corrected for detector effects, meaning that the data can be used to constrain new-physics models beyond those shown in - this paper. The reference data file comes with the measured $R^\text{miss}$ (y01), the expected $R^\text{miss}$ in the Standard - Model (y02), the expected $R^\text{miss}$ numerator in the Standard Model (y03) as well as the expected $R^\text{miss}$ - denominator in the Standard Model (y04). -BibKey: Aaboud:2017buf -BibTeX: '@article{Aaboud:2017buf, - author = "Aaboud, Morad and others", - title = "{Measurement of detector-corrected observables sensitive - to the anomalous production of events with jets and large - missing transverse momentum in $pp$ collisions at - $\sqrt{s} = 13$ TeV using the ATLAS detector}", - collaboration = "ATLAS", - year = "2017", - eprint = "1707.03263", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2017-116", - SLACcitation = "%%CITATION = ARXIV:1707.03263;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.plot b/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Zmumu.plot +++ /dev/null @@ -1,27 +0,0 @@ -# BEGIN PLOT /ATLAS_2017_I1609448_Zmumu/d.. -XTwosidedTicks=1 -YTwosidedTicks=1 -LeftMargin=1.5 -LogY=0 -Title=VBF phase space, $Z\to \mu\mu$ -XLabel=$p_\text{T}^\text{miss}$ [GeV] -LegendAlign=l -LegendXPos=0.05 -LegendYPos=0.3 -YLabel=$\text{d}\sigma / \text{d} p_\text{T}^\text{miss}$ [fb GeV$^{-1}$] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zmumu/d01 -Title=$\geq 1$ jet phase space, $Z\to \mu\mu$ -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zmumu/d03 -XLabel=$m_\text{jj}$ [GeV] -YLabel=$\text{d}\sigma / \text{d} m_\text{jj}$ [fb GeV$^{-1}$] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Zmumu/d04 -XLabel=$\Delta\phi_\text{jj}$ [rad] -YLabel=$\text{d}\sigma / \text{d} \Delta\phi_\text{jj}$ [fb rad$^{-1}$] -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.info b/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.info +++ /dev/null @@ -1,52 +0,0 @@ -Name: ATLAS_2017_I1609448_Znunu -Year: 2017 -Summary: $p_T^\text{miss}$ + jets cross-section ratios at 13 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1609448 -Status: VALIDATED -Authors: - - Christian Gutschow -References: - - arXiv:1707.03263 [hep-ex] - - submitted to EPJC -Keywords: - - met - - jets - - zboson - - vjets -RunInfo: - pp -> MET + jets at 13 TeV -Luminosity_fb: 3.2 -Beams: [p+, p+] -Energies: [13000] -PtCuts: [200] -Description: | - Observables sensitive to the anomalous production of events containing hadronic jets and missing momentum in the plane transverse - to the proton beams at the Large Hadron Collider are presented. The observables are defined as a ratio of cross sections, for - events containing jets and large missing transverse momentum to events containing jets and a pair of charged leptons from the - decay of a $Z/\gamma^\ast$ boson. This definition minimises experimental and theoretical systematic uncertainties in the measurements. - This ratio is measured differentially with respect to a number of kinematic properties of the hadronic system in two phase-space - regions; one inclusive single-jet region and one region sensitive to vector-boson-fusion topologies. The data are found to be in - agreement with the Standard Model predictions and used to constrain a variety of theoretical models for dark-matter production, - including simplified models, effective field theory models, and invisible decays of the Higgs boson. The measurements use - 3.2 fb${}^{-1}$ of proton-proton collision data recorded by the ATLAS experiment at a centre-of-mass energy of 13 TeV and are - fully corrected for detector effects, meaning that the data can be used to constrain new-physics models beyond those shown in - this paper. The reference data file comes with the measured $R^\text{miss}$ (y01), the expected $R^\text{miss}$ in the Standard - Model (y02), the expected $R^\text{miss}$ numerator in the Standard Model (y03) as well as the expected $R^\text{miss}$ - denominator in the Standard Model (y04). -BibKey: Aaboud:2017buf -BibTeX: '@article{Aaboud:2017buf, - author = "Aaboud, Morad and others", - title = "{Measurement of detector-corrected observables sensitive - to the anomalous production of events with jets and large - missing transverse momentum in $pp$ collisions at - $\sqrt{s} = 13$ TeV using the ATLAS detector}", - collaboration = "ATLAS", - year = "2017", - eprint = "1707.03263", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2017-116", - SLACcitation = "%%CITATION = ARXIV:1707.03263;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.plot b/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1609448_Znunu.plot +++ /dev/null @@ -1,33 +0,0 @@ -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d.. -XTwosidedTicks=1 -YTwosidedTicks=1 -LeftMargin=1.5 -LogY=0 -Title=VBF phase space -XLabel=$p_\text{T}^\text{miss}$ [GeV] -LegendAlign=l -LegendXPos=0.05 -LegendYPos=0.3 -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d01 -Title=$\geq 1$ jet phase space -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d03 -XLabel=$m_\text{jj}$ [GeV] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d04 -XLabel=$\Delta\phi_\text{jj}$ [rad] -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d..-x..-y01 -YLabel=$R^\text{miss}$ -# END PLOT - -# BEGIN PLOT /ATLAS_2017_I1609448_Znunu/d..-x..-y02 -Title=Auxiliairy output: BSM cross section (ignore data points) -YLabel= -# END PLOT -