Page Menu
Home
HEPForge
Search
Configure Global Search
Log In
Files
F11221417
No One
Temporary
Actions
View File
Edit File
Delete File
View Transforms
Subscribe
Mute Notifications
Award Token
Flag For Later
Size
36 KB
Subscribers
None
View Options
diff --git a/analyses/pluginATLAS/ATLAS_2017_I1614149.cc.waiting-for-nsubjettiness b/analyses/pluginATLAS/ATLAS_2017_I1614149.cc.waiting-for-nsubjettiness
new file mode 100644
--- /dev/null
+++ b/analyses/pluginATLAS/ATLAS_2017_I1614149.cc.waiting-for-nsubjettiness
@@ -0,0 +1,353 @@
+// -*- C++ -*
+#include "Rivet/Analysis.hh"
+#include "Rivet/Projections/FinalState.hh"
+#include "Rivet/Projections/VetoedFinalState.hh"
+#include "Rivet/Projections/IdentifiedFinalState.hh"
+#include "Rivet/Projections/PromptFinalState.hh"
+#include "Rivet/Projections/DressedLeptons.hh"
+#include "Rivet/Projections/FastJets.hh"
+#include "Rivet/Projections/MissingMomentum.hh"
+#include "fastjet/tools/Filter.hh"
+
+// substructure includes included in fjcontrib-1.021 (http://fastjet.hepforge.org/contrib/)
+#include "fastjet/contrib/Njettiness.hh"
+#include "fastjet/contrib/Nsubjettiness.hh"
+#include "fastjet/contrib/NjettinessPlugin.hh"
+
+namespace Rivet {
+ class ATLAS_2017_I1614149 : public Analysis {
+ public:
+
+ /// Constructor
+ ///@brief: Resolved and boosted ttbar l+jets cross sections at 13 TeV
+ DEFAULT_RIVET_ANALYSIS_CTOR(ATLAS_2017_I1614149);
+
+ void init() {
+ // Eta ranges
+ Cut eta_full = (Cuts::abseta < 5.0);
+ Cut lep_cuts = (Cuts::abseta < 2.5) && (Cuts::pT > 25*GeV);
+
+ // All final state particles
+ FinalState fs(eta_full);
+
+ IdentifiedFinalState all_photons(fs);
+ all_photons.acceptIdPair(PID::PHOTON);
+
+ // Get photons to dress leptons
+ IdentifiedFinalState ph_id(fs);
+ ph_id.acceptIdPair(PID::PHOTON);
+
+ // Projection to find the electrons
+ IdentifiedFinalState el_id(fs);
+ el_id.acceptIdPair(PID::ELECTRON);
+
+ PromptFinalState photons(ph_id);
+ photons.acceptTauDecays(true);
+ addProjection(photons, "photons");
+
+ PromptFinalState electrons(el_id);
+ electrons.acceptTauDecays(true);
+ DressedLeptons dressedelectrons(photons, electrons, 0.1, lep_cuts);
+ addProjection(dressedelectrons, "elecs");
+ DressedLeptons ewdressedelectrons(all_photons, electrons, 0.1, eta_full);
+
+ // Projection to find the muons
+ IdentifiedFinalState mu_id(fs);
+ mu_id.acceptIdPair(PID::MUON);
+
+ PromptFinalState muons(mu_id);
+ muons.acceptTauDecays(true);
+ DressedLeptons dressedmuons(photons, muons, 0.1, lep_cuts);
+ addProjection(dressedmuons, "muons");
+ DressedLeptons ewdressedmuons(all_photons, muons, 0.1, eta_full);
+
+ // Projection to find MET
+ declare(MissingMomentum(fs), "MET");
+
+ // remove prompt neutrinos from jet clustering
+ IdentifiedFinalState nu_id(fs);
+ nu_id.acceptNeutrinos();
+ PromptFinalState neutrinos(nu_id);
+ neutrinos.acceptTauDecays(true);
+
+ // Jet clustering.
+ VetoedFinalState vfs(fs);
+ vfs.addVetoOnThisFinalState(ewdressedelectrons);
+ vfs.addVetoOnThisFinalState(ewdressedmuons);
+ vfs.addVetoOnThisFinalState(neutrinos);
+ FastJets jets(vfs, FastJets::ANTIKT, 0.4);
+ jets.useInvisibles(true);
+ addProjection(jets, "jets");
+
+ // Addition of the large-R jets
+ VetoedFinalState vfs1(fs);
+ vfs1.addVetoOnThisFinalState(neutrinos);
+ FastJets fjets(vfs1, FastJets::ANTIKT, 1.);
+ fjets.useInvisibles(JetAlg::NO_INVISIBLES);
+ fjets.useMuons(JetAlg::NO_MUONS);
+ addProjection(fjets, "fjets");
+
+ bookHists("top_pt_res", 15);
+ bookHists("top_absrap_res", 17);
+ bookHists("ttbar_pt_res", 19);
+ bookHists("ttbar_absrap_res", 21);
+ bookHists("ttbar_m_res", 23);
+ bookHists("top_pt_boost", 25);
+ bookHists("top_absrap_boost", 27);
+
+ }
+
+ void analyze(const Event& event) {
+
+ const double weight = event.weight();
+
+ // Get the selected objects, using the projections.
+ vector<DressedLepton> electrons = apply<DressedLeptons>(event, "elecs").dressedLeptons();
+ vector<DressedLepton> muons = apply<DressedLeptons>(event, "muons").dressedLeptons();
+ const Jets& jets = apply<FastJets>(event, "jets").jetsByPt(Cuts::pT > 25*GeV && Cuts::abseta < 2.5);
+ const PseudoJets& all_fjets = apply<FastJets>(event, "fjets").pseudoJetsByPt();
+
+
+ // get MET
+ const Vector3 met = apply<MissingMomentum>(event, "MET").vectorMPT();
+
+ Jets bjets, lightjets;
+ for (const Jet& jet : jets) {
+ bool b_tagged = jet.bTags(Cuts::pT > 5*GeV).size();
+ if ( b_tagged && bjets.size() < 2) bjets +=jet;
+ else lightjets += jet;
+ }
+
+ // Implementing large-R jets definition
+ // trim the jets
+ PseudoJets trimmed_fatJets;
+ float Rfilt = 0.2;
+ float pt_fraction_min = 0.05;
+ fastjet::Filter trimmer(fastjet::JetDefinition(fastjet::kt_algorithm, Rfilt), fastjet::SelectorPtFractionMin(pt_fraction_min));
+ for (PseudoJet pjet : all_fjets) trimmed_fatJets += trimmer(pjet);
+ trimmed_fatJets = fastjet::sorted_by_pt(trimmed_fatJets);
+ PseudoJets trimmed_jets;
+ for (unsigned int i = 0; i < trimmed_fatJets.size(); ++i) {
+ FourMomentum tj_mom = momentum(trimmed_fatJets[i]);
+ if (tj_mom.pt() <= 300*GeV) continue;
+ if (tj_mom.abseta() >= 2.0) continue;
+ trimmed_jets.push_back(trimmed_fatJets[i]);
+ }
+
+ bool single_electron = (electrons.size() == 1) && (muons.empty());
+ bool single_muon = (muons.size() == 1) && (electrons.empty());
+
+ DressedLepton *lepton = NULL;
+ if (single_electron) lepton = &electrons[0];
+ else if (single_muon) lepton = &muons[0];
+
+ if (!single_electron && !single_muon) vetoEvent;
+
+ bool pass_resolved = true;
+ bool num_b_tagged_jets = (bjets.size() == 2);
+ if (!num_b_tagged_jets) pass_resolved = false;
+
+ if (jets.size() < 4) pass_resolved = false;
+
+ bool pass_boosted = true;
+ int fatJetIndex = -1;
+ bool passTopTag = false;
+ bool passDphi = false;
+ bool passAddJet = false;
+ bool goodLepJet = false;
+ bool lepbtag = false;
+ bool hadbtag=false;
+ vector<int> lepJetIndex;
+ vector<int> jet_farFromHadTopJetCandidate;
+ if (met.mod() < 20*GeV) pass_boosted = false;
+ if (pass_boosted) {
+ double transmass = _mT(lepton->momentum(), met);
+ if (transmass + met.mod() < 60*GeV) pass_boosted = false;
+ }
+ if (pass_boosted) {
+ if (trimmed_jets.size() >= 1) {
+ for (unsigned int j = 0; j<trimmed_jets.size(); ++j) {
+ if (tau32( trimmed_jets.at(j), 1. ) < 0.75 &&
+ momentum(trimmed_jets.at(j)).mass() > 100*GeV &&
+ momentum(trimmed_jets.at(j)).pt() > 300*GeV &&
+ momentum(trimmed_jets.at(j)).pt() < 1500*GeV &&
+ fabs(momentum(trimmed_jets.at(j)).eta()) < 2.) {
+ passTopTag = true;
+ fatJetIndex = j;
+ break;
+ }
+ }
+ }
+ }
+ if(!passTopTag && fatJetIndex == -1) pass_boosted = false;
+ if (pass_boosted) {
+ double dPhi_fatjet = deltaPhi(lepton->phi(), momentum(trimmed_jets.at(fatJetIndex)).phi());
+ double dPhi_fatjet_lep_cut = 1.0; //2.3
+ if (dPhi_fatjet > dPhi_fatjet_lep_cut ) {
+ passDphi = true;
+ }
+ }
+ if (!passDphi) pass_boosted = false;
+ if (bjets.empty()) pass_boosted = false;
+ if (pass_boosted) {
+ for (unsigned int sj = 0; sj < jets.size(); ++sj) {
+ double dR = deltaR(jets.at(sj).momentum(), momentum(trimmed_jets.at(fatJetIndex)));
+ if(dR > 1.5) {
+ passAddJet = true;
+ jet_farFromHadTopJetCandidate.push_back(sj);
+ }
+ }
+ }
+ if (!passAddJet) pass_boosted = false;
+ if (pass_boosted) {
+ for (int ltj : jet_farFromHadTopJetCandidate) {
+ double dR_jet_lep = deltaR(jets.at(ltj).momentum(), lepton->momentum());
+ double dR_jet_lep_cut = 2.0;//1.5
+ if (dR_jet_lep < dR_jet_lep_cut) {
+ lepJetIndex.push_back(ltj);
+ goodLepJet = true;
+ }
+ }
+ }
+ if(!goodLepJet) pass_boosted = false;
+ if (pass_boosted) {
+ for (int lepj : lepJetIndex) {
+ lepbtag = jets.at(lepj).bTags(Cuts::pT > 5*GeV).size();
+ if (lepbtag) break;
+ }
+ }
+ double dR_fatBjet_cut = 1.0;
+ if (pass_boosted) {
+ for (const Jet& bjet : bjets) {
+ hadbtag |= deltaR(momentum(trimmed_jets.at(fatJetIndex)), bjet) < dR_fatBjet_cut;
+ }
+ }
+
+ if (!(lepbtag || hadbtag)) pass_boosted = false;
+
+ FourMomentum pbjet1; //Momentum of bjet1
+ FourMomentum pbjet2; //Momentum of bjet
+ int Wj1index = -1, Wj2index = -1;
+
+ if (pass_resolved) {
+
+ if ( deltaR(bjets[0], *lepton) <= deltaR(bjets[1], *lepton) ) {
+ pbjet1 = bjets[0].momentum();
+ pbjet2 = bjets[1].momentum();
+ } else {
+ pbjet1 = bjets[1].momentum();
+ pbjet2 = bjets[0].momentum();
+ }
+
+ double bestWmass = 1000.0*TeV;
+ double mWPDG = 80.399*GeV;
+ for (unsigned int i = 0; i < (lightjets.size() - 1); ++i) {
+ for (unsigned int j = i + 1; j < lightjets.size(); ++j) {
+ double wmass = (lightjets[i].momentum() + lightjets[j].momentum()).mass();
+ if (fabs(wmass - mWPDG) < fabs(bestWmass - mWPDG)) {
+ bestWmass = wmass;
+ Wj1index = i;
+ Wj2index = j;
+ }
+ }
+ }
+
+ FourMomentum pjet1 = lightjets[Wj1index].momentum();
+ FourMomentum pjet2 = lightjets[Wj2index].momentum();
+
+ // compute hadronic W boson
+ FourMomentum pWhadron = pjet1 + pjet2;
+ double pz = computeneutrinoz(lepton->momentum(), met);
+ FourMomentum ppseudoneutrino( sqrt(sqr(met.x()) + sqr(met.y()) + sqr(pz)), met.x(), met.y(), pz);
+
+ //compute leptonic, hadronic, combined pseudo-top
+ FourMomentum ppseudotoplepton = lepton->momentum() + ppseudoneutrino + pbjet1;
+ FourMomentum ppseudotophadron = pbjet2 + pWhadron;
+ FourMomentum pttbar = ppseudotoplepton + ppseudotophadron;
+
+ fillHists("top_pt_res", ppseudotophadron.pt()/GeV, weight);
+ fillHists("top_absrap_res", ppseudotophadron.absrap(), weight);
+ fillHists("ttbar_pt_res", pttbar.pt()/GeV, weight);
+ fillHists("ttbar_absrap_res", pttbar.absrap(), weight);
+ fillHists("ttbar_m_res", pttbar.mass()/GeV, weight);
+ }
+
+ if (pass_boosted) {// Boosted selection
+ double hadtop_pt= momentum(trimmed_jets.at(fatJetIndex)).pt() / GeV;
+ double hadtop_absrap= momentum(trimmed_jets.at(fatJetIndex)).absrap();
+ fillHists("top_pt_boost", hadtop_pt, weight);
+ fillHists("top_absrap_boost", hadtop_absrap, weight);
+ }
+ }
+
+ void finalize() {
+ // Normalize to cross-section
+ const double sf = (crossSection() / sumOfWeights());
+ for (HistoMap::value_type& hist : _h) {
+ scale(hist.second, sf);
+ if (hist.first.find("_norm") != string::npos) normalize(hist.second);
+ }
+ }
+
+ void bookHists(std::string name, unsigned int index) {
+ _h[name] = bookHisto1D(index, 1 ,1);
+ _h[name + "_norm"] = bookHisto1D(index + 1, 1 ,1);
+ }
+
+ void fillHists(std::string name, double value, double weight) {
+ _h[name]->fill(value, weight);
+ _h[name + "_norm"]->fill(value, weight);
+ }
+
+ double _mT(const FourMomentum &l, const Vector3 &met) const {
+ return sqrt(2.0 * l.pT() * met.mod() * (1 - cos(deltaPhi(l, met))) );
+ }
+
+ double tau32(const fastjet::PseudoJet &jet, double jet_rad) const {
+ double alpha = 1.0;
+ fastjet::contrib::NormalizedCutoffMeasure normalized_measure(alpha, jet_rad, 1000000);
+ // WTA definition
+ // fastjet::contrib::OnePass_WTA_KT_Axes wta_kt_axes;
+ // as in JetSubStructure recommendations
+ fastjet::contrib::KT_Axes kt_axes;
+
+ /// NsubjettinessRatio uses the results from Nsubjettiness to calculate the ratio
+ /// tau_N/tau_M, where N and M are specified by the user. The ratio of different tau values
+ /// is often used in analyses, so this class is helpful to streamline code.
+ fastjet::contrib::NsubjettinessRatio tau32_kt(3, 2, kt_axes, normalized_measure);
+
+ double tau32 = tau32_kt.result(jet);
+ return tau32;
+ }
+
+ double computeneutrinoz(const FourMomentum& lepton, const Vector3 &met) const {
+ //computing z component of neutrino momentum given lepton and met
+ double pzneutrino;
+ double m_W = 80.399; // in GeV, given in the paper
+ double k = (( sqr( m_W ) - sqr( lepton.mass() ) ) / 2 ) + (lepton.px() * met.x() + lepton.py() * met.y());
+ double a = sqr ( lepton.E() )- sqr ( lepton.pz() );
+ double b = -2*k*lepton.pz();
+ double c = sqr( lepton.E() ) * sqr( met.mod() ) - sqr( k );
+ double discriminant = sqr(b) - 4 * a * c;
+ double quad[2] = { (- b - sqrt(discriminant)) / (2 * a), (- b + sqrt(discriminant)) / (2 * a) }; //two possible quadratic solns
+ if (discriminant < 0) pzneutrino = - b / (2 * a); //if the discriminant is negative
+ else { //if the discriminant is greater than or equal to zero, take the soln with smallest absolute value
+ double absquad[2];
+ for (int n=0; n<2; ++n) absquad[n] = fabs(quad[n]);
+ if (absquad[0] < absquad[1]) pzneutrino = quad[0];
+ else pzneutrino = quad[1];
+ }
+
+ return pzneutrino;
+ }
+
+ private:
+
+ /// @name Objects that are used by the event selection decisions
+ typedef map<string, Histo1DPtr> HistoMap;
+ HistoMap _h;
+ };
+
+ // The hook for the plugin system
+ DECLARE_RIVET_PLUGIN(ATLAS_2017_I1614149);
+}
diff --git a/analyses/pluginATLAS/ATLAS_2017_I1614149.info b/analyses/pluginATLAS/ATLAS_2017_I1614149.info
new file mode 100644
--- /dev/null
+++ b/analyses/pluginATLAS/ATLAS_2017_I1614149.info
@@ -0,0 +1,53 @@
+Name: ATLAS_2017_I1614149
+Year: 2017
+Summary: Resolved and boosted ttbar l+jets cross sections at 13 TeV
+Experiment: ATLAS
+Collider: LHC
+InspireID: 1614149
+Status: VALIDATED
+Authors:
+ - Francesco La Ruffa <francesco.la.ruffa@cern.ch>
+ - Steffen Henkelmann <steffen.henkelmann@cern.ch>
+ - Federica Fabbri <federica.fabbri@cern.ch>
+ - Christian Gutschow <chris.g@cern.ch>
+References:
+ - JHEP 1711 (2017) 191
+ - doi:10.1007/JHEP11(2017)1
+ - arXiv:1708.00727 [hep-ex]
+Keywords:
+ - TTBAR
+ - NONALLHADRONIC
+ - BOOSTED
+RunInfo:
+ non-all-hadronic ttbar production at 13 TeV
+NeedCrossSection: True
+Beams: [p+, p+]
+Energies: [13000]
+PtCuts: [25.]
+Description:
+ 'Measurements of differential cross-sections of top-quark pair production in fiducial phase-spaces are presented as a function of
+ top-quark and $t\bar{t}$ system kinematic observables in proton-proton collisions at a centre-of-mass energy of $\sqrt{s} = 13$ TeV.
+ The data set corresponds to an integrated luminosity of 3.2 fb${}^{-1}$, recorded in 2015 with the ATLAS detector at the CERN Large
+ Hadron Collider. Events with exactly one electron or muon and at least two jets in the final state are used for the measurement.
+ Two separate selections are applied that each focus on different top-quark momentum regions, referred to as resolved and boosted
+ topologies of the $t\bar{t}$ final state. The measured spectra are corrected for detector effects and are compared to several
+ Monte Carlo simulations by means of calculated $\chi^2$ and $p$-values.'
+BibKey: Aaboud:2017fha,
+BibTex: '@article{Aaboud:2017fha,
+ author = "Aaboud, M. and others",
+ title = "{Measurements of top-quark pair differential
+ cross-sections in the lepton+jets channel in $pp$
+ collisions at $\sqrt{s}=13$ TeV using the ATLAS
+ detector}",
+ collaboration = "ATLAS",
+ journal = "JHEP",
+ volume = "11",
+ year = "2017",
+ pages = "191",
+ doi = "10.1007/JHEP11(2017)191",
+ eprint = "1708.00727",
+ archivePrefix = "arXiv",
+ primaryClass = "hep-ex",
+ reportNumber = "CERN-EP-2017-058",
+ SLACcitation = "%%CITATION = ARXIV:1708.00727;%%"
+}'
diff --git a/analyses/pluginATLAS/ATLAS_2017_I1614149.plot b/analyses/pluginATLAS/ATLAS_2017_I1614149.plot
new file mode 100644
--- /dev/null
+++ b/analyses/pluginATLAS/ATLAS_2017_I1614149.plot
@@ -0,0 +1,103 @@
+# BEGIN PLOT /ATLAS_2017_I1614149/d.
+XTwosidedTicks=1
+YTwosidedTicks=1
+LeftMargin=1.9
+LegendXPos=0.95
+LegendAlign=r
+YLabelSep=8.0
+RatioPlotYMin=0.7
+RatioPlotYMax=1.3
+Title=Combined lepton channels, resolved
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d23
+XLabel=$m_{t\bar{t}}$ [GeV]
+YLabel=$\text{d}\sigma / \text{d}m_{t\bar{t}}$ [pb/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d24
+XLabel=$m_{t\bar{t}}$ [GeV]
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}m_{t\bar{t}}$ [1/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d19
+XLabel=$p_\text{T}^{t\bar{t}}$ [GeV]
+YLabel=$\text{d}\sigma / \text{d}p_\text{T}^{t\bar{t}}$ [pb/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d20
+XLabel=$p_\text{T}^{t\bar{t}}$ [GeV]
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}p_\text{T}^{t\bar{t}}$ [1/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d21
+XLabel=$|y_{t\bar{t}}|$
+YLabel=$\text{d}\sigma / \text{d}|y_{t\bar{t}}|$ [pb]
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d22
+XLabel=$|y_{t\bar{t}}|$
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}|y_{t\bar{t}}|$
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d15
+XLabel=$p_\text{T}^{t,\text{had}}$ [GeV]
+YLabel=$\text{d}\sigma / \text{d}p_\text{T}^{t,\text{had}}$ [pb/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d16
+XLabel=$p_\text{T}^{t,\text{had}}$ [GeV]
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}p_\text{T}^{t,\text{had}}$ [1/GeV]
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d17
+XLabel=$|y_{t,\text{had}}|$
+YLabel=$\text{d}\sigma / \text{d}|y_{t,\text{had}}|$ [pb]
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d18
+XLabel=$|y_{t,\text{had}}|$
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}|y_{t,\text{had}}|$
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d25
+XLabel=$p_\text{T}^{t,\text{had}}$ [GeV]
+YLabel=$\text{d}\sigma / \text{d}p_\text{T}^{t,\text{had}}$ [pb/GeV]
+Title=Combined lepton channels, boosted
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d26
+XLabel=$p_\text{T}^{t,\text{had}}$ [GeV]
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}p_\text{T}^{t,\text{had}}$ [1/GeV]
+Title=Combined lepton channels, boosted
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d27
+XLabel=$|y_{t,\text{had}}|$
+YLabel=$\text{d}\sigma / \text{d}|y_{t,\text{had}}|$ [pb]
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+Title=Combined lepton channels, boosted
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1614149/d28
+XLabel=$|y_{t,\text{had}}|$
+YLabel=$1/\sigma$ $\text{d}\sigma / \text{d}|y_{t,\text{had}}|$
+LegendXPos=0.05
+LegendYPos=0.3
+LegendAlign=l
+Title=Combined lepton channels, boosted
+# END PLOT
diff --git a/analyses/pluginATLAS/ATLAS_2017_I1614149.yoda b/analyses/pluginATLAS/ATLAS_2017_I1614149.yoda
new file mode 100644
--- /dev/null
+++ b/analyses/pluginATLAS/ATLAS_2017_I1614149.yoda
@@ -0,0 +1,284 @@
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d15-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d15-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t15
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.250000e+01 1.250000e+01 1.250000e+01 1.347760e-01 1.906349e-02 1.702081e-02
+3.750000e+01 1.250000e+01 1.250000e+01 3.906600e-01 5.238500e-02 4.883905e-02
+6.250000e+01 1.250000e+01 1.250000e+01 5.804110e-01 7.488764e-02 6.861097e-02
+9.000000e+01 1.500000e+01 1.500000e+01 6.420720e-01 7.680263e-02 7.270427e-02
+1.200000e+02 1.500000e+01 1.500000e+01 5.736510e-01 6.739270e-02 6.167945e-02
+1.500000e+02 1.500000e+01 1.500000e+01 4.114490e-01 4.457987e-02 4.368342e-02
+1.800000e+02 1.500000e+01 1.500000e+01 2.799260e-01 2.960812e-02 2.656063e-02
+2.125000e+02 1.750000e+01 1.750000e+01 1.835310e-01 2.076100e-02 1.734781e-02
+2.475000e+02 1.750000e+01 1.750000e+01 1.129740e-01 1.099519e-02 1.090081e-02
+2.825000e+02 1.750000e+01 1.750000e+01 7.689850e-02 8.507907e-03 7.871883e-03
+3.250000e+02 2.500000e+01 2.500000e+01 4.077590e-02 4.325136e-03 4.099052e-03
+3.750000e+02 2.500000e+01 2.500000e+01 2.228310e-02 2.586023e-03 2.673487e-03
+4.250000e+02 2.500000e+01 2.500000e+01 1.101150e-02 1.500004e-03 1.350515e-03
+4.750000e+02 2.500000e+01 2.500000e+01 5.242400e-03 1.219642e-03 1.165065e-03
+7.500000e+02 2.500000e+02 2.500000e+02 7.297460e-04 1.362707e-04 1.341423e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d16-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d16-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t16
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.250000e+01 1.250000e+01 1.250000e+01 1.317990e-03 6.481695e-05 5.870221e-05
+3.750000e+01 1.250000e+01 1.250000e+01 3.820310e-03 1.619198e-04 1.595662e-04
+6.250000e+01 1.250000e+01 1.250000e+01 5.675900e-03 2.037150e-04 1.973136e-04
+9.000000e+01 1.500000e+01 1.500000e+01 6.278890e-03 1.739129e-04 1.791427e-04
+1.200000e+02 1.500000e+01 1.500000e+01 5.609800e-03 1.439744e-04 1.417565e-04
+1.500000e+02 1.500000e+01 1.500000e+01 4.023600e-03 1.110119e-04 1.228696e-04
+1.800000e+02 1.500000e+01 1.500000e+01 2.737430e-03 9.246606e-05 9.159271e-05
+2.125000e+02 1.750000e+01 1.750000e+01 1.794770e-03 8.604814e-05 7.684170e-05
+2.475000e+02 1.750000e+01 1.750000e+01 1.104790e-03 5.354995e-05 6.160185e-05
+2.825000e+02 1.750000e+01 1.750000e+01 7.519990e-04 5.498739e-05 5.276510e-05
+3.250000e+02 2.500000e+01 2.500000e+01 3.987520e-04 2.649075e-05 2.751978e-05
+3.750000e+02 2.500000e+01 2.500000e+01 2.179090e-04 1.899948e-05 2.080577e-05
+4.250000e+02 2.500000e+01 2.500000e+01 1.076830e-04 1.095501e-05 1.019584e-05
+4.750000e+02 2.500000e+01 2.500000e+01 5.126600e-05 1.047078e-05 1.020328e-05
+7.500000e+02 2.500000e+02 2.500000e+02 7.136270e-06 1.077181e-06 1.108514e-06
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d17-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d17-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t17
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+5.000000e-02 5.000000e-02 5.000000e-02 8.134970e+01 9.832421e+00 8.304737e+00
+1.500000e-01 5.000000e-02 5.000000e-02 7.873880e+01 8.886101e+00 8.455868e+00
+2.500000e-01 5.000000e-02 5.000000e-02 7.879570e+01 8.540534e+00 8.359325e+00
+3.500000e-01 5.000000e-02 5.000000e-02 7.725480e+01 8.522466e+00 7.914571e+00
+4.500000e-01 5.000000e-02 5.000000e-02 7.434100e+01 9.436994e+00 8.455625e+00
+5.500000e-01 5.000000e-02 5.000000e-02 7.223690e+01 8.251308e+00 7.580969e+00
+6.500000e-01 5.000000e-02 5.000000e-02 6.752460e+01 7.984113e+00 7.239027e+00
+7.500000e-01 5.000000e-02 5.000000e-02 6.312290e+01 7.330498e+00 6.635149e+00
+8.500000e-01 5.000000e-02 5.000000e-02 6.291320e+01 7.098896e+00 7.245007e+00
+9.500000e-01 5.000000e-02 5.000000e-02 5.547870e+01 6.628317e+00 5.946935e+00
+1.050000e+00 5.000000e-02 5.000000e-02 5.056940e+01 5.839920e+00 5.471188e+00
+1.150000e+00 5.000000e-02 5.000000e-02 4.755590e+01 5.751045e+00 4.971946e+00
+1.250000e+00 5.000000e-02 5.000000e-02 4.240720e+01 5.065512e+00 4.533267e+00
+1.350000e+00 5.000000e-02 5.000000e-02 3.741120e+01 4.256864e+00 4.277895e+00
+1.450000e+00 5.000000e-02 5.000000e-02 3.210710e+01 3.697561e+00 3.363451e+00
+1.600000e+00 1.000000e-01 1.000000e-01 2.452110e+01 2.879100e+00 2.746465e+00
+1.800000e+00 1.000000e-01 1.000000e-01 1.583020e+01 1.887801e+00 1.808670e+00
+2.200000e+00 3.000000e-01 3.000000e-01 3.586020e+00 4.109772e-01 4.119804e-01
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d18-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d18-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t18
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+5.000000e-02 5.000000e-02 5.000000e-02 7.944110e-01 2.490907e-02 2.082672e-02
+1.500000e-01 5.000000e-02 5.000000e-02 7.689140e-01 2.154794e-02 2.165623e-02
+2.500000e-01 5.000000e-02 5.000000e-02 7.694700e-01 2.052834e-02 2.282662e-02
+3.500000e-01 5.000000e-02 5.000000e-02 7.544230e-01 2.353696e-02 2.386810e-02
+4.500000e-01 5.000000e-02 5.000000e-02 7.259680e-01 3.014801e-02 2.942021e-02
+5.500000e-01 5.000000e-02 5.000000e-02 7.054210e-01 1.928348e-02 1.957646e-02
+6.500000e-01 5.000000e-02 5.000000e-02 6.594030e-01 1.988951e-02 1.938932e-02
+7.500000e-01 5.000000e-02 5.000000e-02 6.164190e-01 1.868366e-02 1.768051e-02
+8.500000e-01 5.000000e-02 5.000000e-02 6.143710e-01 1.767299e-02 2.074339e-02
+9.500000e-01 5.000000e-02 5.000000e-02 5.417700e-01 1.532601e-02 1.459966e-02
+1.050000e+00 5.000000e-02 5.000000e-02 4.938290e-01 1.692170e-02 1.677793e-02
+1.150000e+00 5.000000e-02 5.000000e-02 4.644010e-01 1.472732e-02 1.289785e-02
+1.250000e+00 5.000000e-02 5.000000e-02 4.141230e-01 1.547944e-02 1.524938e-02
+1.350000e+00 5.000000e-02 5.000000e-02 3.653350e-01 1.167564e-02 1.407024e-02
+1.450000e+00 5.000000e-02 5.000000e-02 3.135380e-01 1.096838e-02 1.090869e-02
+1.600000e+00 1.000000e-01 1.000000e-01 2.394580e-01 7.567728e-03 7.798938e-03
+1.800000e+00 1.000000e-01 1.000000e-01 1.545880e-01 5.940042e-03 6.401759e-03
+2.200000e+00 3.000000e-01 3.000000e-01 3.501880e-02 1.777376e-03 1.911674e-03
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d19-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d19-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t19
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.750000e+01 1.750000e+01 1.750000e+01 1.027230e+00 1.224162e-01 1.176785e-01
+5.500000e+01 2.000000e+01 2.000000e+01 8.075510e-01 1.088398e-01 1.008171e-01
+1.000000e+02 2.500000e+01 2.500000e+01 3.417800e-01 6.073859e-02 6.152203e-02
+1.475000e+02 2.250000e+01 2.250000e+01 1.666110e-01 2.557530e-02 2.582549e-02
+1.975000e+02 2.750000e+01 2.750000e+01 8.326590e-02 1.194048e-02 1.101391e-02
+5.125000e+02 2.875000e+02 2.875000e+02 8.564870e-03 1.063570e-03 9.623901e-04
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d20-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d20-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t20
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.750000e+01 1.750000e+01 1.750000e+01 1.003680e-02 1.068080e-03 1.042216e-03
+5.500000e+01 2.000000e+01 2.000000e+01 7.890390e-03 3.565253e-04 3.502528e-04
+1.000000e+02 2.500000e+01 2.500000e+01 3.339460e-03 3.534988e-04 3.743686e-04
+1.475000e+02 2.250000e+01 2.250000e+01 1.627920e-03 1.170965e-04 1.300365e-04
+1.975000e+02 2.750000e+01 2.750000e+01 8.135720e-04 5.097619e-05 4.888983e-05
+5.125000e+02 2.875000e+02 2.875000e+02 8.368530e-05 3.610674e-06 3.575586e-06
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d21-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d21-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t21
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+5.000000e-02 5.000000e-02 5.000000e-02 1.043760e+02 1.224906e+01 1.091370e+01
+1.500000e-01 5.000000e-02 5.000000e-02 1.049610e+02 1.176422e+01 1.091055e+01
+2.500000e-01 5.000000e-02 5.000000e-02 1.020510e+02 1.234745e+01 1.112140e+01
+3.500000e-01 5.000000e-02 5.000000e-02 9.802990e+01 1.126862e+01 1.050227e+01
+4.500000e-01 5.000000e-02 5.000000e-02 9.557200e+01 1.106138e+01 1.035806e+01
+5.500000e-01 5.000000e-02 5.000000e-02 8.608130e+01 9.555996e+00 9.131418e+00
+6.500000e-01 5.000000e-02 5.000000e-02 7.709480e+01 8.361182e+00 8.114520e+00
+7.500000e-01 5.000000e-02 5.000000e-02 7.067620e+01 8.243542e+00 7.471777e+00
+8.500000e-01 5.000000e-02 5.000000e-02 6.130300e+01 7.359286e+00 6.479804e+00
+9.500000e-01 5.000000e-02 5.000000e-02 5.171300e+01 6.041000e+00 5.516802e+00
+1.050000e+00 5.000000e-02 5.000000e-02 4.270800e+01 4.877820e+00 4.449086e+00
+1.150000e+00 5.000000e-02 5.000000e-02 3.542720e+01 3.849449e+00 3.736617e+00
+1.250000e+00 5.000000e-02 5.000000e-02 2.777330e+01 3.506083e+00 2.991778e+00
+1.350000e+00 5.000000e-02 5.000000e-02 2.245830e+01 2.622155e+00 2.586369e+00
+1.450000e+00 5.000000e-02 5.000000e-02 1.532420e+01 1.908683e+00 1.933761e+00
+1.550000e+00 5.000000e-02 5.000000e-02 1.118120e+01 1.266288e+00 1.334073e+00
+1.700000e+00 1.000000e-01 1.000000e-01 6.196180e+00 8.526877e-01 6.816942e-01
+2.150000e+00 3.500000e-01 3.500000e-01 6.318880e-01 8.943181e-02 9.086993e-02
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d22-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d22-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t22
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+5.000000e-02 5.000000e-02 5.000000e-02 1.019750e+00 2.807318e-02 2.589233e-02
+1.500000e-01 5.000000e-02 5.000000e-02 1.025470e+00 2.678672e-02 2.633978e-02
+2.500000e-01 5.000000e-02 5.000000e-02 9.970310e-01 3.022030e-02 2.669482e-02
+3.500000e-01 5.000000e-02 5.000000e-02 9.577480e-01 2.424284e-02 2.516530e-02
+4.500000e-01 5.000000e-02 5.000000e-02 9.337340e-01 2.326986e-02 2.458912e-02
+5.500000e-01 5.000000e-02 5.000000e-02 8.410110e-01 2.392110e-02 2.445721e-02
+6.500000e-01 5.000000e-02 5.000000e-02 7.532130e-01 1.977010e-02 2.092033e-02
+7.500000e-01 5.000000e-02 5.000000e-02 6.905030e-01 2.240690e-02 2.277892e-02
+8.500000e-01 5.000000e-02 5.000000e-02 5.989280e-01 1.664227e-02 1.608500e-02
+9.500000e-01 5.000000e-02 5.000000e-02 5.052340e-01 1.448199e-02 1.416200e-02
+1.050000e+00 5.000000e-02 5.000000e-02 4.172560e-01 1.194448e-02 1.158737e-02
+1.150000e+00 5.000000e-02 5.000000e-02 3.461220e-01 1.025073e-02 1.117776e-02
+1.250000e+00 5.000000e-02 5.000000e-02 2.713440e-01 1.092227e-02 9.630557e-03
+1.350000e+00 5.000000e-02 5.000000e-02 2.194160e-01 8.891946e-03 9.727964e-03
+1.450000e+00 5.000000e-02 5.000000e-02 1.497170e-01 8.150449e-03 8.553045e-03
+1.550000e+00 5.000000e-02 5.000000e-02 1.092400e-01 4.972156e-03 5.570566e-03
+1.700000e+00 1.000000e-01 1.000000e-01 6.053640e-02 4.042391e-03 3.451262e-03
+2.150000e+00 3.500000e-01 3.500000e-01 6.173520e-03 5.629453e-04 5.803675e-04
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d23-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d23-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t23
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+2.850000e+02 6.000000e+01 6.000000e+01 4.945930e-02 8.298358e-03 8.148934e-03
+3.825000e+02 3.750000e+01 3.750000e+01 2.885040e-01 3.491067e-02 3.249859e-02
+4.600000e+02 4.000000e+01 4.000000e+01 2.896760e-01 3.606181e-02 3.416383e-02
+5.450000e+02 4.500000e+01 4.500000e+01 2.122720e-01 2.577274e-02 2.401067e-02
+6.375000e+02 4.750000e+01 4.750000e+01 1.294970e-01 1.490641e-02 1.386200e-02
+7.375000e+02 5.250000e+01 5.250000e+01 7.802050e-02 8.171980e-03 8.178059e-03
+8.500000e+02 6.000000e+01 6.000000e+01 4.327160e-02 4.837769e-03 4.462040e-03
+9.750000e+02 6.500000e+01 6.500000e+01 2.337880e-02 2.861260e-03 2.584894e-03
+1.107500e+03 6.750000e+01 6.750000e+01 1.193100e-02 1.679041e-03 1.449639e-03
+1.247500e+03 7.250000e+01 7.250000e+01 6.596800e-03 9.203030e-04 8.119391e-04
+2.160000e+03 8.400000e+02 8.400000e+02 7.334950e-04 1.493136e-04 1.466897e-04
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d24-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d24-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t24
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+2.850000e+02 6.000000e+01 6.000000e+01 4.831090e-04 6.837627e-05 6.462444e-05
+3.825000e+02 3.750000e+01 3.750000e+01 2.818050e-03 1.452408e-04 1.379114e-04
+4.600000e+02 4.000000e+01 4.000000e+01 2.829500e-03 9.725849e-05 1.030913e-04
+5.450000e+02 4.500000e+01 4.500000e+01 2.073430e-03 7.491460e-05 7.834927e-05
+6.375000e+02 4.750000e+01 4.750000e+01 1.264900e-03 4.519524e-05 4.586528e-05
+7.375000e+02 5.250000e+01 5.250000e+01 7.620890e-04 3.379409e-05 3.816635e-05
+8.500000e+02 6.000000e+01 6.000000e+01 4.226680e-04 2.495249e-05 2.414309e-05
+9.750000e+02 6.500000e+01 6.500000e+01 2.283600e-04 1.691413e-05 1.636381e-05
+1.107500e+03 6.750000e+01 6.750000e+01 1.165400e-04 1.089044e-05 9.777714e-06
+1.247500e+03 7.250000e+01 7.250000e+01 6.443630e-05 5.926205e-06 5.717563e-06
+2.160000e+03 8.400000e+02 8.400000e+02 7.164630e-06 1.289435e-06 1.219956e-06
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d25-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d25-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t25
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+3.250000e+02 2.500000e+01 2.500000e+01 1.905090e-02 3.839854e-03 3.923696e-03
+3.750000e+02 2.500000e+01 2.500000e+01 1.217390e-02 2.442461e-03 2.521886e-03
+4.250000e+02 2.500000e+01 2.500000e+01 6.923070e-03 1.492424e-03 1.362560e-03
+4.750000e+02 2.500000e+01 2.500000e+01 3.967970e-03 9.407674e-04 9.513218e-04
+5.250000e+02 2.500000e+01 2.500000e+01 2.794600e-03 6.666769e-04 7.778452e-04
+6.000000e+02 5.000000e+01 5.000000e+01 1.748060e-03 4.612777e-04 4.892524e-04
+7.000000e+02 5.000000e+01 5.000000e+01 4.189140e-04 1.588149e-04 1.588734e-04
+1.125000e+03 3.750000e+02 3.750000e+02 5.717180e-05 2.666984e-05 2.919500e-05
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d26-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d26-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t26
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+3.250000e+02 2.500000e+01 2.500000e+01 7.604850e-03 5.811648e-04 5.626966e-04
+3.750000e+02 2.500000e+01 2.500000e+01 4.859660e-03 2.929653e-04 2.989207e-04
+4.250000e+02 2.500000e+01 2.500000e+01 2.763590e-03 1.823267e-04 1.695623e-04
+4.750000e+02 2.500000e+01 2.500000e+01 1.583960e-03 1.401179e-04 1.362044e-04
+5.250000e+02 2.500000e+01 2.500000e+01 1.115560e-03 1.463830e-04 1.711515e-04
+6.000000e+02 5.000000e+01 5.000000e+01 6.978000e-04 1.095716e-04 1.125416e-04
+7.000000e+02 5.000000e+01 5.000000e+01 1.672240e-04 4.575952e-05 4.416986e-05
+1.125000e+03 3.750000e+02 3.750000e+02 2.282220e-05 8.367937e-06 8.487175e-06
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d27-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d27-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t27
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.000000e-01 1.000000e-01 1.000000e-01 1.902050e+00 3.831137e-01 4.264242e-01
+3.000000e-01 1.000000e-01 1.000000e-01 1.939310e+00 3.834500e-01 3.825087e-01
+5.000000e-01 1.000000e-01 1.000000e-01 1.714910e+00 3.760307e-01 3.585337e-01
+7.000000e-01 1.000000e-01 1.000000e-01 1.600600e+00 3.311848e-01 3.366266e-01
+9.000000e-01 1.000000e-01 1.000000e-01 1.410320e+00 2.953508e-01 2.822518e-01
+1.100000e+00 1.000000e-01 1.000000e-01 1.291740e+00 2.721535e-01 2.916603e-01
+1.300000e+00 1.000000e-01 1.000000e-01 1.049670e+00 2.336705e-01 2.429457e-01
+1.500000e+00 1.000000e-01 1.000000e-01 8.632600e-01 1.854160e-01 1.940905e-01
+1.700000e+00 1.000000e-01 1.000000e-01 5.564680e-01 1.405216e-01 1.227757e-01
+1.900000e+00 1.000000e-01 1.000000e-01 3.578620e-01 9.045314e-02 9.169748e-02
+END YODA_SCATTER2D
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1614149/d28-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1614149/d28-x01-y01
+Title=doi:10.17182/hepdata.80041.v2/t28
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.000000e-01 1.000000e-01 1.000000e-01 7.496540e-01 3.712491e-02 4.228392e-02
+3.000000e-01 1.000000e-01 1.000000e-01 7.643410e-01 3.867040e-02 4.315083e-02
+5.000000e-01 1.000000e-01 1.000000e-01 6.758960e-01 4.823643e-02 4.431367e-02
+7.000000e-01 1.000000e-01 1.000000e-01 6.308420e-01 3.677069e-02 3.628000e-02
+9.000000e-01 1.000000e-01 1.000000e-01 5.558500e-01 4.293211e-02 3.994918e-02
+1.100000e+00 1.000000e-01 1.000000e-01 5.091110e-01 3.040537e-02 3.150871e-02
+1.300000e+00 1.000000e-01 1.000000e-01 4.137050e-01 4.180356e-02 4.201676e-02
+1.500000e+00 1.000000e-01 1.000000e-01 3.402360e-01 2.830736e-02 2.971461e-02
+1.700000e+00 1.000000e-01 1.000000e-01 2.193200e-01 2.220318e-02 1.975462e-02
+1.900000e+00 1.000000e-01 1.000000e-01 1.410440e-01 1.646549e-02 1.611018e-02
+END YODA_SCATTER2D
File Metadata
Details
Attached
Mime Type
text/x-diff
Expires
Wed, May 14, 10:25 AM (1 d, 17 h)
Storage Engine
blob
Storage Format
Raw Data
Storage Handle
5111121
Default Alt Text
(36 KB)
Attached To
rRIVETHG rivethg
Event Timeline
Log In to Comment