diff --git a/analyses/pluginATLAS/ATLAS_2013_I1230812.cc b/analyses/pluginATLAS/ATLAS_2013_I1230812.cc --- a/analyses/pluginATLAS/ATLAS_2013_I1230812.cc +++ b/analyses/pluginATLAS/ATLAS_2013_I1230812.cc @@ -1,317 +1,307 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/ZFinder.hh" #include "Rivet/Projections/FastJets.hh" #include "Rivet/Projections/VetoedFinalState.hh" #include "Rivet/Projections/PromptFinalState.hh" namespace Rivet { /// Z + jets in pp at 7 TeV (combined channel / base class) /// @note This base class contains a "mode" variable for combined, e, and mu channel derived classes class ATLAS_2013_I1230812 : public Analysis { public: /// @name Constructors etc. //@{ /// Constructor - ATLAS_2013_I1230812(string name="ATLAS_2013_I1230812") - : Analysis(name) - { - // This class uses the combined e+mu mode - _mode = 1; + ATLAS_2013_I1230812(const string name="ATLAS_2013_I1230812", size_t mode = 0, + const string ref_data="ATLAS_2013_I1230812") : Analysis(name) { + _mode = mode; //default is combined e+mu mode + setRefDataName(ref_data); } //@} /// Book histograms and initialise projections before the run void init() { // Get options from the new option system - if ( getOption("ZMODE") == "EL" ) _mode = 2; - if ( getOption("ZMODE") == "MU" ) _mode = 3; + if ( getOption("ZMODE") == "EL" ) _mode = 1; + if ( getOption("ZMODE") == "MU" ) _mode = 2; // Determine the e/mu decay channels used (NB Prompt leptons only). /// @todo Note that Zs are accepted with any rapidity: the cuts are on the e/mu: is this correct? - Cut pt20 = Cuts::pT >= 20.0*GeV; - if (_mode == 1) { - // Combined - ZFinder zfinder(FinalState(Cuts::abseta < 2.5), pt20, PID::ELECTRON, 66*GeV, 116*GeV); - declare(zfinder, "zfinder"); - } else if (_mode == 2) { - // Electron - const Cut eta_e = Cuts::abseta < 1.37 || Cuts::absetaIn(1.52, 2.47); - ZFinder zfinder(FinalState(eta_e), pt20, PID::ELECTRON, 66*GeV, 116*GeV); - declare(zfinder, "zfinder"); - } else if (_mode == 3) { - // Muon - ZFinder zfinder(FinalState(Cuts::abseta < 2.4), pt20, PID::MUON, 66*GeV, 116*GeV); - declare(zfinder, "zfinder"); - } else { - MSG_ERROR("Unknown decay channel mode!!!"); - } + Cut pt20 = Cuts::pT >= 20*GeV; + Cut eta_e = _mode? Cuts::abseta < 1.37 || Cuts::absetaIn(1.52, 2.47) : Cuts::abseta < 2.5; + Cut eta_m = _mode? Cuts::abseta < 2.4 : Cuts::abseta < 2.5; + ZFinder zfinder_el(FinalState(eta_e), pt20, PID::ELECTRON, 66*GeV, 116*GeV); + ZFinder zfinder_mu(FinalState(eta_m), pt20, PID::MUON, 66*GeV, 116*GeV); + declare(zfinder_el, "zfinder_el"); + declare(zfinder_mu, "zfinder_mu"); // Define veto FS in order to prevent Z-decay products entering the jet algorithm VetoedFinalState had_fs; - had_fs.addVetoOnThisFinalState(getProjection("zfinder")); + had_fs.addVetoOnThisFinalState(getProjection("zfinder_el")); + had_fs.addVetoOnThisFinalState(getProjection("zfinder_mu")); FastJets jets(had_fs, FastJets::ANTIKT, 0.4); jets.useInvisibles(true); declare(jets, "jets"); - _h_njet_incl = bookHisto1D( 1, 1, _mode); - _h_njet_incl_ratio = bookScatter2D(2, 1, _mode, true); - _h_njet_excl = bookHisto1D( 3, 1, _mode); - _h_njet_excl_ratio = bookScatter2D(4, 1, _mode, true); - _h_njet_excl_pt150 = bookHisto1D( 5, 1, _mode); - _h_njet_excl_pt150_ratio = bookScatter2D(6, 1, _mode, true); - _h_njet_excl_vbf = bookHisto1D ( 7, 1, _mode); - _h_njet_excl_vbf_ratio = bookScatter2D(8, 1, _mode, true); - _h_ptlead = bookHisto1D( 9, 1, _mode); - _h_ptseclead = bookHisto1D( 10, 1, _mode); - _h_ptthirdlead = bookHisto1D( 11, 1, _mode); - _h_ptfourthlead = bookHisto1D( 12, 1, _mode); - _h_ptlead_excl = bookHisto1D( 13, 1, _mode); - _h_pt_ratio = bookHisto1D( 14, 1, _mode); - _h_pt_z = bookHisto1D( 15, 1, _mode); - _h_pt_z_excl = bookHisto1D( 16, 1, _mode); - _h_ylead = bookHisto1D( 17, 1, _mode); - _h_yseclead = bookHisto1D( 18, 1, _mode); - _h_ythirdlead = bookHisto1D( 19, 1, _mode); - _h_yfourthlead = bookHisto1D( 20, 1, _mode); - _h_deltay = bookHisto1D( 21, 1, _mode); - _h_mass = bookHisto1D( 22, 1, _mode); - _h_deltaphi = bookHisto1D( 23, 1, _mode); - _h_deltaR = bookHisto1D( 24, 1, _mode); - _h_ptthirdlead_vbf = bookHisto1D( 25, 1, _mode); - _h_ythirdlead_vbf = bookHisto1D( 26, 1, _mode); - _h_ht = bookHisto1D( 27, 1, _mode); - _h_st = bookHisto1D( 28, 1, _mode); + _h_njet_incl = bookHisto1D( 1, 1, _mode + 1); + _h_njet_incl_ratio = bookScatter2D(2, 1, _mode + 1, true); + _h_njet_excl = bookHisto1D( 3, 1, _mode + 1); + _h_njet_excl_ratio = bookScatter2D(4, 1, _mode + 1, true); + _h_njet_excl_pt150 = bookHisto1D( 5, 1, _mode + 1); + _h_njet_excl_pt150_ratio = bookScatter2D(6, 1, _mode + 1, true); + _h_njet_excl_vbf = bookHisto1D ( 7, 1, _mode + 1); + _h_njet_excl_vbf_ratio = bookScatter2D(8, 1, _mode + 1, true); + _h_ptlead = bookHisto1D( 9, 1, _mode + 1); + _h_ptseclead = bookHisto1D( 10, 1, _mode + 1); + _h_ptthirdlead = bookHisto1D( 11, 1, _mode + 1); + _h_ptfourthlead = bookHisto1D( 12, 1, _mode + 1); + _h_ptlead_excl = bookHisto1D( 13, 1, _mode + 1); + _h_pt_ratio = bookHisto1D( 14, 1, _mode + 1); + _h_pt_z = bookHisto1D( 15, 1, _mode + 1); + _h_pt_z_excl = bookHisto1D( 16, 1, _mode + 1); + _h_ylead = bookHisto1D( 17, 1, _mode + 1); + _h_yseclead = bookHisto1D( 18, 1, _mode + 1); + _h_ythirdlead = bookHisto1D( 19, 1, _mode + 1); + _h_yfourthlead = bookHisto1D( 20, 1, _mode + 1); + _h_deltay = bookHisto1D( 21, 1, _mode + 1); + _h_mass = bookHisto1D( 22, 1, _mode + 1); + _h_deltaphi = bookHisto1D( 23, 1, _mode + 1); + _h_deltaR = bookHisto1D( 24, 1, _mode + 1); + _h_ptthirdlead_vbf = bookHisto1D( 25, 1, _mode + 1); + _h_ythirdlead_vbf = bookHisto1D( 26, 1, _mode + 1); + _h_ht = bookHisto1D( 27, 1, _mode + 1); + _h_st = bookHisto1D( 28, 1, _mode + 1); } /// Perform the per-event analysis void analyze(const Event& event) { - const ZFinder& zfinder = apply(event, "zfinder"); - MSG_DEBUG("# Z constituents = " << zfinder.constituents().size()); - if (zfinder.constituents().size() != 2) vetoEvent; + FourMomentum z, lp, lm; + const ZFinder& zfinder_el = apply(event, "zfinder_el"); + const ZFinder& zfinder_mu = apply(event, "zfinder_mu"); - FourMomentum z = zfinder.boson().momentum(); - FourMomentum lp = zfinder.constituents()[0].momentum(); - FourMomentum lm = zfinder.constituents()[1].momentum(); + if (_mode == 0 && (zfinder_el.constituents().size() + zfinder_mu.constituents().size()) != 2) vetoEvent; + if (_mode == 1 && !(zfinder_el.constituents().size() == 2 && zfinder_mu.constituents().empty())) vetoEvent; + if (_mode == 2 && !(zfinder_el.constituents().empty() && zfinder_mu.constituents().size() == 2)) vetoEvent; + + if (zfinder_el.constituents().size() == 2) { + z = zfinder_el.boson().momentum(); + lp = zfinder_el.constituents()[0].momentum(); + lm = zfinder_el.constituents()[1].momentum(); + } + else if (zfinder_mu.constituents().size() == 2) { + z = zfinder_mu.boson().momentum(); + lp = zfinder_mu.constituents()[0].momentum(); + lm = zfinder_mu.constituents()[1].momentum(); + } + else vetoEvent; + if (deltaR(lp, lm) < 0.2) vetoEvent; Jets jets = apply(event, "jets").jetsByPt(Cuts::pT > 30*GeV && Cuts::absrap < 4.4); ifilter_discard(jets, deltaRLess(lp, 0.5)); ifilter_discard(jets, deltaRLess(lm, 0.5)); const double weight = event.weight(); // Fill jet multiplicities for (size_t ijet = 0; ijet <= jets.size(); ++ijet) { _h_njet_incl->fill(ijet, weight); } _h_njet_excl->fill(jets.size(), weight); // Require at least one jet if (jets.size() >= 1) { // Leading jet histos const double ptlead = jets[0].pT()/GeV; const double yabslead = fabs(jets[0].rapidity()); const double ptz = z.pT()/GeV; _h_ptlead->fill(ptlead, weight); _h_ylead ->fill(yabslead, weight); _h_pt_z ->fill(ptz, weight); // Fill jet multiplicities if (ptlead > 150) _h_njet_excl_pt150->fill(jets.size(), weight); // Loop over selected jets, fill inclusive distributions double st = 0; double ht = lp.pT()/GeV + lm.pT()/GeV; for (size_t ijet = 0; ijet < jets.size(); ++ijet) { ht += jets[ijet].pT()/GeV; st += jets[ijet].pT()/GeV; } _h_ht->fill(ht, weight); _h_st->fill(st, weight); // Require exactly one jet if (jets.size() == 1) { _h_ptlead_excl->fill(ptlead, weight); _h_pt_z_excl ->fill(ptz, weight); } } // Require at least two jets if (jets.size() >= 2) { // Second jet histos const double ptlead = jets[0].pT()/GeV; const double pt2ndlead = jets[1].pT()/GeV; const double ptratio = pt2ndlead/ptlead; const double yabs2ndlead = fabs(jets[1].rapidity()); _h_ptseclead->fill(pt2ndlead, weight); _h_yseclead->fill( yabs2ndlead, weight); _h_pt_ratio->fill( ptratio, weight); // Dijet histos const double deltaphi = fabs(deltaPhi(jets[1], jets[0])); const double deltarap = fabs(jets[0].rapidity() - jets[1].rapidity()) ; const double deltar = fabs(deltaR(jets[0], jets[1], RAPIDITY)); const double mass = (jets[0].momentum() + jets[1].momentum()).mass()/GeV; _h_mass->fill( mass, weight); _h_deltay->fill( deltarap, weight); _h_deltaphi->fill(deltaphi, weight); _h_deltaR->fill( deltar, weight); if (mass > 350 && deltarap > 3) _h_njet_excl_vbf->fill(jets.size(), weight); } // Require at least three jets if (jets.size() >= 3) { // Third jet histos const double pt3rdlead = jets[2].pT()/GeV; const double yabs3rdlead = fabs(jets[2].rapidity()); _h_ptthirdlead->fill(pt3rdlead, weight); _h_ythirdlead->fill( yabs3rdlead, weight); //Histos after VBF preselection const double deltarap = fabs(jets[0].rapidity() - jets[1].rapidity()) ; const double mass = (jets[0].momentum() + jets[1].momentum()).mass(); if (mass > 350 && deltarap > 3) { _h_ptthirdlead_vbf->fill(pt3rdlead, weight); _h_ythirdlead_vbf->fill( yabs3rdlead, weight); } } // Require at least four jets if (jets.size() >= 4) { // Fourth jet histos const double pt4thlead = jets[3].pT()/GeV; const double yabs4thlead = fabs(jets[3].rapidity()); _h_ptfourthlead->fill(pt4thlead, weight); _h_yfourthlead->fill( yabs4thlead, weight); } } /// @name Ratio calculator util functions //@{ /// Calculate the efficiency error, being careful about div-by-zero double err_incl(const HistoBin1D &M, const HistoBin1D &N, bool hasWeights) { double r = safediv(M.sumW(), N.sumW()); if (hasWeights) { // use F. James's approximation for weighted events return sqrt( safediv((1 - 2 * r) * M.sumW2() + r * r * N.sumW2(), N.sumW() * N.sumW()) ); } return sqrt( safediv(r * (1 - r), N.sumW()) ); } /// Calculate the ratio error, being careful about div-by-zero double err_excl(const HistoBin1D &A, const HistoBin1D &B) { double r = safediv(A.sumW(), B.sumW()); double dAsquared = safediv(A.sumW2(), A.sumW() * A.sumW()); // squared relative error of A double dBsquared = safediv(B.sumW2(), B.sumW() * B.sumW()); // squared relative error of B return r * sqrt(dAsquared + dBsquared); } //@} void finalize() { bool hasWeights = _h_njet_incl->effNumEntries() != _h_njet_incl->numEntries(); for (size_t i = 0; i < 6; ++i) { _h_njet_incl_ratio->point(i).setY(safediv(_h_njet_incl->bin(i + 1).sumW(), _h_njet_incl->bin(i).sumW()), err_incl(_h_njet_incl->bin(i + 1), _h_njet_incl->bin(i), hasWeights)); _h_njet_excl_ratio->point(i).setY(safediv(_h_njet_excl->bin(i + 1).sumW(), _h_njet_excl->bin(i).sumW()), err_excl(_h_njet_excl->bin(i + 1), _h_njet_excl->bin(i))); if (i >= 1) { _h_njet_excl_pt150_ratio->point(i - 1).setY(safediv(_h_njet_excl_pt150->bin(i).sumW(), _h_njet_excl_pt150->bin(i - 1).sumW()), err_excl(_h_njet_excl_pt150->bin(i), _h_njet_excl_pt150->bin(i - 1))); if (i >= 2) { _h_njet_excl_vbf_ratio->point(i - 2).setY(safediv(_h_njet_excl_vbf->bin(i).sumW(), _h_njet_excl_vbf->bin(i - 1).sumW()), err_excl(_h_njet_excl_vbf->bin(i), _h_njet_excl_vbf->bin(i - 1))); } } } - const double xs = crossSectionPerEvent()/picobarn; + double sf = _mode? 1.0 : 0.5; + const double xs = sf * crossSectionPerEvent()/picobarn; + scale({_h_njet_incl, _h_njet_excl, _h_njet_excl_pt150, _h_njet_excl_vbf}, xs); scale({_h_ptlead, _h_ptseclead, _h_ptthirdlead, _h_ptfourthlead, _h_ptlead_excl}, xs); scale({_h_pt_ratio, _h_pt_z, _h_pt_z_excl}, xs); scale({_h_ylead, _h_yseclead, _h_ythirdlead, _h_yfourthlead}, xs); scale({_h_deltay, _h_mass, _h_deltaphi, _h_deltaR}, xs); scale({_h_ptthirdlead_vbf, _h_ythirdlead_vbf}, xs); scale({_h_ht, _h_st}, xs); } //@} protected: size_t _mode; private: Scatter2DPtr _h_njet_incl_ratio; Scatter2DPtr _h_njet_excl_ratio; Scatter2DPtr _h_njet_excl_pt150_ratio; Scatter2DPtr _h_njet_excl_vbf_ratio; Histo1DPtr _h_njet_incl; Histo1DPtr _h_njet_excl; Histo1DPtr _h_njet_excl_pt150; Histo1DPtr _h_njet_excl_vbf; Histo1DPtr _h_ptlead; Histo1DPtr _h_ptseclead; Histo1DPtr _h_ptthirdlead; Histo1DPtr _h_ptfourthlead; Histo1DPtr _h_ptlead_excl; Histo1DPtr _h_pt_ratio; Histo1DPtr _h_pt_z; Histo1DPtr _h_pt_z_excl; Histo1DPtr _h_ylead; Histo1DPtr _h_yseclead; Histo1DPtr _h_ythirdlead; Histo1DPtr _h_yfourthlead; Histo1DPtr _h_deltay; Histo1DPtr _h_mass; Histo1DPtr _h_deltaphi; Histo1DPtr _h_deltaR; Histo1DPtr _h_ptthirdlead_vbf; Histo1DPtr _h_ythirdlead_vbf; Histo1DPtr _h_ht; Histo1DPtr _h_st; }; - - class ATLAS_2013_I1230812_EL : public ATLAS_2013_I1230812 { - public: - ATLAS_2013_I1230812_EL() - : ATLAS_2013_I1230812("ATLAS_2013_I1230812_EL") - { - _mode = 2; - } + /*struct ATLAS_2013_I1230812_EL : public ATLAS_2013_I1230812 { + ATLAS_2013_I1230812_EL() : ATLAS_2013_I1230812("ATLAS_2013_I1230812_EL", 1) { } }; - - - class ATLAS_2013_I1230812_MU : public ATLAS_2013_I1230812 { - public: - ATLAS_2013_I1230812_MU() - : ATLAS_2013_I1230812("ATLAS_2013_I1230812_MU") - { - _mode = 3; - } - }; - - + struct ATLAS_2013_I1230812_MU : public ATLAS_2013_I1230812 { + ATLAS_2013_I1230812_MU() : ATLAS_2013_I1230812("ATLAS_2013_I1230812_MU", 2) { } + };*/ DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812); - DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812_EL); - DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812_MU); + //DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812_EL); + //DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812_MU); } diff --git a/analyses/pluginATLAS/ATLAS_2013_I1230812.plot b/analyses/pluginATLAS/ATLAS_2013_I1230812.plot --- a/analyses/pluginATLAS/ATLAS_2013_I1230812.plot +++ b/analyses/pluginATLAS/ATLAS_2013_I1230812.plot @@ -1,276 +1,281 @@ # BEGIN PLOT /ATLAS_2013_I1230812.*/d01-x01-y.* Title=Inclusive jet multiplicity XLabel=$N_\text{jet}$ YLabel=$\sigma(Z/\gamma^*(\to \ell^+\ell^-)+\geq N_\text{jet})$ [pb] LegendYPos=0.5 LegendXPos=0.05 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d02-x01-y.* Title=Inclusive jet multiplicity ratio XLabel=$N_\text{jet}$ YLabel=$\sigma(\geq N_\text{jet})/\sigma(\geq N_\text{jet}-1)$ LogY=0 LegendYPos=0.4 Scale=1.0 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d03-x01-y.* Title=Exclusive jet multiplicity XLabel=$N_\text{jet}$ YLabel=$\sigma(Z/\gamma^*(\to \ell^+\ell^-)+ N_\text{jet})$ [pb] LegendYPos=0.5 LegendXPos=0.05 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d04-x01-y.* Title=Exclusive jet multiplicity ratio XLabel=$N_\text{jet}$ YLabel=$\sigma(N_\text{jet})/\sigma(N_\text{jet}-1)$ LogY=0 LegendYPos=0.4 Scale=1.0 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d05-x01-y.* Title=Exclusive jet multiplicity ($p_\perp^\text{jet1}>150$ GeV) XLabel=$N_\text{jet}$ YLabel=$\sigma(Z/\gamma^*(\to \ell^+\ell^-)+ N_\text{jet})$ [pb] LegendYPos=0.5 LegendXPos=0.05 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d06-x01-y.* Title=Exclusive jet multiplicity ratio ($p_\perp^\text{jet1}>150$ GeV) XLabel=$N_\text{jet}$ YLabel=$\sigma(N_\text{jet})/\sigma(N_\text{jet}-1)$ LogY=0 LegendYPos=0.4 Scale=1.0 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d07-x01-y.* Title=Exclusive jet multiplicity (VBF selection) XLabel=$N_\text{jet}$ YLabel=$\sigma(Z/\gamma^*(\to \ell^+\ell^-)+ N_\text{jet})$ [pb] LegendYPos=0.5 LegendXPos=0.05 XMinorTickMarks=0 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d08-x01-y.* Title=Exclusive jet multiplicity ratio (VBF selection) XLabel=$N_\text{jet}$ YLabel=$\sigma(N_\text{jet})/\sigma(N_\text{jet}-1)$ LogY=0 LegendYPos=0.4 Scale=1.0 XMinorTickMarks=0 XMajorTickMarks=10 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d09-x01-y.* Title=Transverse momentum of 1st jet XLabel=$p_\perp$(1st jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d10-x01-y.* Title=Transverse momentum of 2nd jet XLabel=$p_\perp$(2nd jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d11-x01-y.* Title=Transverse momentum of 3rd jet XLabel=$p_\perp$(3rd jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d12-x01-y.* Title=Transverse momentum of 4th jet XLabel=$p_\perp$(4th jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d13-x01-y.* Title=Transverse jet momentum in $Z+1$jet events XLabel=$p_\perp$(jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d14-x01-y.* Title=Ratio of jet transverse momenta XLabel=$p_\perp$(2nd jet)/$p_\perp$(1st jet) YLabel=d$\sigma$/d($p_\perp$ ratio) [pb] LegendAlign=r LegendYPos=0.5 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d15-x01-y.* Title=Transverse momentum of $Z$-boson XLabel=$p_\perp(Z)$ [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d16-x01-y.* Title=Transverse momentum of $Z$-boson ($Z+1$jet events) XLabel=$p_\perp(Z)$ [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d17-x01-y.* Title=Rapidity of 1st jet XLabel=$|y|$(1st jet) YLabel=d$\sigma$/d$|y|$ [pb] LegendAlign=l LegendYPos=0.5 LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d18-x01-y.* Title=Rapidity of 2nd jet XLabel=$|y|$(2nd jet) YLabel=d$\sigma$/d$|y|$ [pb] LegendAlign=l LegendYPos=0.5 LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d19-x01-y.* Title=Rapidity of 3rd jet XLabel=$|y|$(3rd jet) YLabel=d$\sigma$/d$|y|$ [pb] LegendAlign=l LegendYPos=0.5 LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d20-x01-y.* Title=Rapidity of 4th jet XLabel=$|y|$(4th jet) YLabel=d$\sigma$/d$|y|$ [pb] LegendAlign=l LegendYPos=0.5 LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d21-x01-y.* Title=Rapidity distance of leading jets XLabel=$|\Delta y|$(1st jet, 2nd jet) YLabel=d$\sigma$/d$|\Delta y|$ [pb] LegendAlign=l LegendYPos=0.5 LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d22-x01-y.* Title=Invariant mass of leading jets XLabel=$m$(1st jet, 2nd jet) [GeV] YLabel=d$\sigma$/d$m$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d23-x01-y.* Title=Azimuthal distance of leading jets XLabel=$|\Delta\phi|$(1st jet, 2nd jet) YLabel=d$\sigma$/d$|\Delta\phi|$ [pb] LegendAlign=l LegendXPos=0.05 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d24-x01-y.* Title=$\Delta R$ distance of leading jets XLabel=$\Delta R$(1st jet, 2nd jet) YLabel=d$\sigma$/d$\Delta R$ [pb] LegendAlign=l LegendXPos=0.05 LegendYPos=0.5 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d25-x01-y.* Title=Transverse momentum of 3rd jet (VBF selection) XLabel=$p_\perp$(3rd jet) [GeV] YLabel=d$\sigma$/d$p_\perp$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d26-x01-y.* Title=Rapidity of 3rd jet (VBF selection) XLabel=$|y|$(3rd jet) YLabel=d$\sigma$/d$|y|$ [pb] LegendAlign=l LegendXPos=0.05 LegendYPos=0.5 # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d27-x01-y.* Title=Scalar $p_\perp$ sum of leptons and jets XLabel=$H_T$ [GeV] YLabel=d$\sigma$/d$H_T$ [pb/GeV] LegendAlign=r # END PLOT # BEGIN PLOT /ATLAS_2013_I1230812.*/d28-x01-y.* Title=Scalar $p_\perp$ sum of jets XLabel=$S_T$ [GeV] YLabel=d$\sigma$/d$S_T$ [pb/GeV] LegendAlign=r # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_EL/.* -CustomLegend=$Z/\gamma^*\to \text{e}^+\text{e}^-$ +# BEGIN PLOT /ATLAS_2013_I1230812/*-y01 +CustomLegend=$Z/\gamma^*\to \ell^+\ell^-$ # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/.* +# BEGIN PLOT /ATLAS_2013_I1230812/*-y02 +CustomLegend=$Z/\gamma^*\to e^+e^-$ +# END PLOT + +# BEGIN PLOT /ATLAS_2013_I1230812/*-y03 CustomLegend=$Z/\gamma^*\to \mu^+\mu^-$ # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_EL/d01-x01-y.* -YLabel=$\sigma(Z/\gamma^*(\to \text{e}^+\text{e}^-)+\geq N_\text{jet})$ [pb] +# BEGIN PLOT /ATLAS_2013_I1230812/d01-x01-y02 +YLabel=$\sigma(Z/\gamma^*(\to e^+e^-)+\geq N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_EL/d03-x01-y.* -YLabel=$\sigma(Z/\gamma^*(\to \text{e}^+\text{e}^-)+ N_\text{jet})$ [pb] +# BEGIN PLOT /ATLAS_2013_I1230812/d03-x01-y02 +YLabel=$\sigma(Z/\gamma^*(\to e^+e^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_EL/d05-x01-y.* -YLabel=$\sigma(Z/\gamma^*(\to \text{e}^+\text{e}^-)+ N_\text{jet})$ [pb] +# BEGIN PLOT /ATLAS_2013_I1230812/d05-x01-y02 +YLabel=$\sigma(Z/\gamma^*(\to e^+e^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_EL/d07-x01-y.* -YLabel=$\sigma(Z/\gamma^*(\to \text{e}^+\text{e}^-)+ N_\text{jet})$ [pb] +# BEGIN PLOT /ATLAS_2013_I1230812/d07-x01-y02 +YLabel=$\sigma(Z/\gamma^*(\to e^+e^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/d01-x01-y.* +# BEGIN PLOT /ATLAS_2013_I1230812/d01-x01-y03 YLabel=$\sigma(Z/\gamma^*(\to \mu^+\mu^-)+\geq N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/d03-x01-y.* +# BEGIN PLOT /ATLAS_2013_I1230812/d03-x01-y03 YLabel=$\sigma(Z/\gamma^*(\to \mu^+\mu^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/d05-x01-y.* +# BEGIN PLOT /ATLAS_2013_I1230812/d05-x01-y03 YLabel=$\sigma(Z/\gamma^*(\to \mu^+\mu^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/d07-x01-y.* +# BEGIN PLOT /ATLAS_2013_I1230812/d07-x01-y03 YLabel=$\sigma(Z/\gamma^*(\to \mu^+\mu^-)+ N_\text{jet})$ [pb] # END PLOT -# BEGIN PLOT /ATLAS_2013_I1230812_MU/d01-x01-y01 +# BEGIN PLOT /ATLAS_2013_I1230812/d01-x01-y03 CustomLegend=$Z/\gamma^*\to \mu^+\mu^-$ First data bin read from plot # END PLOT + diff --git a/analyses/pluginATLAS/ATLAS_2013_I1230812.yoda b/analyses/pluginATLAS/ATLAS_2013_I1230812.yoda --- a/analyses/pluginATLAS/ATLAS_2013_I1230812.yoda +++ b/analyses/pluginATLAS/ATLAS_2013_I1230812.yoda @@ -1,630 +1,1890 @@ BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d01-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d01-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 0.000000e+00 5.000000e-01 5.000000e-01 4.650000e+02 3.000000e+01 6.500000e+01 1.000000e+00 5.000000e-01 5.000000e-01 6.884000e+01 5.151990e+00 5.151990e+00 2.000000e+00 5.000000e-01 5.000000e-01 1.505000e+01 1.511320e+00 1.511320e+00 3.000000e+00 5.000000e-01 5.000000e-01 3.085000e+00 4.012030e-01 4.012030e-01 4.000000e+00 5.000000e-01 5.000000e-01 6.549000e-01 1.071520e-01 1.071520e-01 5.000000e+00 5.000000e-01 5.000000e-01 1.350000e-01 2.730590e-02 2.730590e-02 6.000000e+00 5.000000e-01 5.000000e-01 2.526000e-02 6.517090e-03 6.517090e-03 7.000000e+00 5.000000e-01 5.000000e-01 6.226000e-03 2.584600e-03 2.584600e-03 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d02-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d02-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+00 5.000000e-01 5.000000e-01 1.415000e-01 1.060240e-02 1.060240e-02 2.000000e+00 5.000000e-01 5.000000e-01 2.187000e-01 7.151220e-03 7.151220e-03 3.000000e+00 5.000000e-01 5.000000e-01 2.049000e-01 7.027090e-03 7.027090e-03 4.000000e+00 5.000000e-01 5.000000e-01 2.123000e-01 8.924680e-03 8.924680e-03 5.000000e+00 5.000000e-01 5.000000e-01 2.061000e-01 1.249040e-02 1.249040e-02 6.000000e+00 5.000000e-01 5.000000e-01 1.872000e-01 2.173500e-02 2.173500e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d03-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d03-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 0.000000e+00 5.000000e-01 5.000000e-01 4.176000e+02 7.107039e+00 7.107039e+00 1.000000e+00 5.000000e-01 5.000000e-01 5.378000e+01 3.692438e+00 3.692438e+00 2.000000e+00 5.000000e-01 5.000000e-01 1.197000e+01 1.111306e+00 1.111306e+00 3.000000e+00 5.000000e-01 5.000000e-01 2.430000e+00 2.953456e-01 2.953456e-01 4.000000e+00 5.000000e-01 5.000000e-01 5.200000e-01 8.088566e-02 8.088566e-02 5.000000e+00 5.000000e-01 5.000000e-01 1.097000e-01 2.162082e-02 2.162082e-02 6.000000e+00 5.000000e-01 5.000000e-01 1.904000e-02 4.620703e-03 4.620703e-03 7.000000e+00 5.000000e-01 5.000000e-01 4.940000e-03 2.065167e-03 2.065167e-03 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d04-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d04-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+00 5.000000e-01 5.000000e-01 1.288000e-01 1.030490e-02 1.030490e-02 2.000000e+00 5.000000e-01 5.000000e-01 2.226000e-01 7.689600e-03 7.689600e-03 3.000000e+00 5.000000e-01 5.000000e-01 2.030000e-01 7.057620e-03 7.057620e-03 4.000000e+00 5.000000e-01 5.000000e-01 2.140000e-01 9.712880e-03 9.712880e-03 5.000000e+00 5.000000e-01 5.000000e-01 2.110000e-01 1.517960e-02 1.517960e-02 6.000000e+00 5.000000e-01 5.000000e-01 1.735000e-01 2.398600e-02 2.398600e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d05-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d05-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+00 5.000000e-01 5.000000e-01 7.347000e-01 3.136335e-02 3.136335e-02 2.000000e+00 5.000000e-01 5.000000e-01 7.672000e-01 3.995322e-02 3.995322e-02 3.000000e+00 5.000000e-01 5.000000e-01 3.702000e-01 2.764435e-02 2.764435e-02 4.000000e+00 5.000000e-01 5.000000e-01 1.371000e-01 1.593581e-02 1.593581e-02 5.000000e+00 5.000000e-01 5.000000e-01 3.903000e-02 5.953058e-03 5.953058e-03 6.000000e+00 5.000000e-01 5.000000e-01 1.043000e-02 2.367383e-03 2.367383e-03 7.000000e+00 5.000000e-01 5.000000e-01 2.678000e-03 1.125968e-03 1.125968e-03 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d06-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d06-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e+00 5.000000e-01 5.000000e-01 1.044000e+00 3.986230e-02 3.986230e-02 3.000000e+00 5.000000e-01 5.000000e-01 4.825000e-01 2.088370e-02 2.088370e-02 4.000000e+00 5.000000e-01 5.000000e-01 3.705000e-01 2.330750e-02 2.330750e-02 5.000000e+00 5.000000e-01 5.000000e-01 2.846000e-01 2.427800e-02 2.427800e-02 6.000000e+00 5.000000e-01 5.000000e-01 2.671000e-01 4.227080e-02 4.227080e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d07-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d07-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e+00 5.000000e-01 5.000000e-01 6.426000e-01 1.021378e-01 1.021378e-01 3.000000e+00 5.000000e-01 5.000000e-01 1.828000e-01 2.959780e-02 2.959780e-02 4.000000e+00 5.000000e-01 5.000000e-01 4.047000e-02 8.742980e-03 8.742980e-03 5.000000e+00 5.000000e-01 5.000000e-01 1.298000e-02 3.814145e-03 3.814145e-03 6.000000e+00 5.000000e-01 5.000000e-01 1.453000e-03 7.247103e-04 7.247103e-04 7.000000e+00 5.000000e-01 5.000000e-01 2.870000e-04 4.041484e-04 4.041484e-04 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d08-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d08-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.000000e+00 5.000000e-01 5.000000e-01 2.845000e-01 1.668770e-02 1.668770e-02 4.000000e+00 5.000000e-01 5.000000e-01 2.214000e-01 2.235960e-02 2.235960e-02 5.000000e+00 5.000000e-01 5.000000e-01 3.209000e-01 6.661240e-02 6.661240e-02 6.000000e+00 5.000000e-01 5.000000e-01 1.119000e-01 5.584990e-02 5.584990e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d09-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d09-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 2.735000e+00 2.381785e-01 2.381785e-01 3.750000e+01 2.500000e+00 2.500000e+00 2.054000e+00 1.262418e-01 1.262418e-01 4.500000e+01 5.000000e+00 5.000000e+00 1.424000e+00 7.716217e-02 7.716217e-02 5.500000e+01 5.000000e+00 5.000000e+00 8.982000e-01 4.620097e-02 4.620097e-02 6.500000e+01 5.000000e+00 5.000000e+00 5.961000e-01 3.077158e-02 3.077158e-02 7.500000e+01 5.000000e+00 5.000000e+00 4.087000e-01 2.052706e-02 2.052706e-02 9.000000e+01 1.000000e+01 1.000000e+01 2.452000e-01 1.171751e-02 1.171751e-02 1.100000e+02 1.000000e+01 1.000000e+01 1.292000e-01 6.022458e-03 6.022458e-03 1.300000e+02 1.000000e+01 1.000000e+01 7.394000e-02 3.507264e-03 3.507264e-03 1.500000e+02 1.000000e+01 1.000000e+01 4.457000e-02 2.270617e-03 2.270617e-03 1.700000e+02 1.000000e+01 1.000000e+01 2.707000e-02 1.462190e-03 1.462190e-03 1.900000e+02 1.000000e+01 1.000000e+01 1.729000e-02 8.982761e-04 8.982761e-04 2.100000e+02 1.000000e+01 1.000000e+01 1.154000e-02 6.700746e-04 6.700746e-04 2.350000e+02 1.500000e+01 1.500000e+01 6.841000e-03 4.814312e-04 4.814312e-04 2.650000e+02 1.500000e+01 1.500000e+01 3.971000e-03 2.658891e-04 2.658891e-04 2.950000e+02 1.500000e+01 1.500000e+01 2.538000e-03 1.612762e-04 1.612762e-04 3.250000e+02 1.500000e+01 1.500000e+01 1.612000e-03 1.370876e-04 1.370876e-04 3.550000e+02 1.500000e+01 1.500000e+01 1.101000e-03 1.046996e-04 1.046996e-04 3.850000e+02 1.500000e+01 1.500000e+01 6.471000e-04 7.243901e-05 7.243901e-05 4.250000e+02 2.500000e+01 2.500000e+01 3.244000e-04 3.575150e-05 3.575150e-05 4.750000e+02 2.500000e+01 2.500000e+01 2.399000e-04 3.774348e-05 3.774348e-05 5.250000e+02 2.500000e+01 2.500000e+01 1.194000e-04 2.466516e-05 2.466516e-05 6.250000e+02 7.500000e+01 7.500000e+01 3.150000e-05 1.010177e-05 1.010177e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d10-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d10-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 8.223000e-01 9.750067e-02 9.750067e-02 3.750000e+01 2.500000e+00 2.500000e+00 5.431000e-01 5.023405e-02 5.023405e-02 4.500000e+01 5.000000e+00 5.000000e+00 3.251000e-01 2.662968e-02 2.662968e-02 5.500000e+01 5.000000e+00 5.000000e+00 1.745000e-01 1.262933e-02 1.262933e-02 6.500000e+01 5.000000e+00 5.000000e+00 1.050000e-01 6.836666e-03 6.836666e-03 7.500000e+01 5.000000e+00 5.000000e+00 6.716000e-02 4.134356e-03 4.134356e-03 9.000000e+01 1.000000e+01 1.000000e+01 3.688000e-02 2.265590e-03 2.265590e-03 1.100000e+02 1.000000e+01 1.000000e+01 1.783000e-02 1.121160e-03 1.121160e-03 1.300000e+02 1.000000e+01 1.000000e+01 9.456000e-03 5.645016e-04 5.645016e-04 1.500000e+02 1.000000e+01 1.000000e+01 5.631000e-03 3.557274e-04 3.557274e-04 1.700000e+02 1.000000e+01 1.000000e+01 3.434000e-03 2.402852e-04 2.402852e-04 1.900000e+02 1.000000e+01 1.000000e+01 2.088000e-03 1.616261e-04 1.616261e-04 2.100000e+02 1.000000e+01 1.000000e+01 1.588000e-03 1.218031e-04 1.218031e-04 2.350000e+02 1.500000e+01 1.500000e+01 9.908000e-04 1.144285e-04 1.144285e-04 2.650000e+02 1.500000e+01 1.500000e+01 5.090000e-04 6.397406e-05 6.397406e-05 2.950000e+02 1.500000e+01 1.500000e+01 3.404000e-04 4.969517e-05 4.969517e-05 3.250000e+02 1.500000e+01 1.500000e+01 2.213000e-04 3.544094e-05 3.544094e-05 3.700000e+02 3.000000e+01 3.000000e+01 1.304000e-04 2.517499e-05 2.517499e-05 4.750000e+02 7.500000e+01 7.500000e+01 2.502000e-05 6.205199e-06 6.205199e-06 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d11-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d11-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 2.151000e-01 3.056632e-02 3.056632e-02 3.750000e+01 2.500000e+00 2.500000e+00 1.291000e-01 1.567418e-02 1.567418e-02 4.500000e+01 5.000000e+00 5.000000e+00 6.903000e-02 7.444004e-03 7.444004e-03 5.500000e+01 5.000000e+00 5.000000e+00 3.237000e-02 3.288419e-03 3.288419e-03 6.500000e+01 5.000000e+00 5.000000e+00 1.666000e-02 1.579050e-03 1.579050e-03 7.500000e+01 5.000000e+00 5.000000e+00 9.228000e-03 8.236468e-04 8.236468e-04 9.000000e+01 1.000000e+01 1.000000e+01 4.372000e-03 4.420362e-04 4.420362e-04 1.100000e+02 1.000000e+01 1.000000e+01 1.546000e-03 1.973449e-04 1.973449e-04 1.300000e+02 1.000000e+01 1.000000e+01 7.238000e-04 9.744029e-05 9.744029e-05 1.500000e+02 1.000000e+01 1.000000e+01 3.755000e-04 6.637658e-05 6.637658e-05 1.800000e+02 2.000000e+01 2.000000e+01 1.253000e-04 3.059068e-05 3.059068e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d12-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d12-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 5.297000e-02 9.149137e-03 9.149137e-03 3.750000e+01 2.500000e+00 2.500000e+00 2.908000e-02 4.676847e-03 4.676847e-03 4.500000e+01 5.000000e+00 5.000000e+00 1.346000e-02 1.991833e-03 1.991833e-03 5.500000e+01 5.000000e+00 5.000000e+00 5.514000e-03 7.443830e-04 7.443830e-04 6.500000e+01 5.000000e+00 5.000000e+00 2.538000e-03 3.335776e-04 3.335776e-04 7.500000e+01 5.000000e+00 5.000000e+00 1.310000e-03 1.754366e-04 1.754366e-04 9.000000e+01 1.000000e+01 1.000000e+01 5.608000e-04 9.590501e-05 9.590501e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d13-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d13-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 2.632000e+00 2.112676e-01 2.112676e-01 3.750000e+01 2.500000e+00 2.500000e+00 1.845000e+00 9.338629e-02 9.338629e-02 4.500000e+01 5.000000e+00 5.000000e+00 1.181000e+00 4.825971e-02 4.825971e-02 5.500000e+01 5.000000e+00 5.000000e+00 6.769000e-01 2.501899e-02 2.501899e-02 6.500000e+01 5.000000e+00 5.000000e+00 4.128000e-01 1.530915e-02 1.530915e-02 7.500000e+01 5.000000e+00 5.000000e+00 2.635000e-01 9.416475e-03 9.416475e-03 9.000000e+01 1.000000e+01 1.000000e+01 1.448000e-01 4.941660e-03 4.941660e-03 1.100000e+02 1.000000e+01 1.000000e+01 6.774000e-02 2.350957e-03 2.350957e-03 1.300000e+02 1.000000e+01 1.000000e+01 3.376000e-02 1.464445e-03 1.464445e-03 1.500000e+02 1.000000e+01 1.000000e+01 1.880000e-02 8.949302e-04 8.949302e-04 1.700000e+02 1.000000e+01 1.000000e+01 1.076000e-02 5.262129e-04 5.262129e-04 1.900000e+02 1.000000e+01 1.000000e+01 6.422000e-03 3.346924e-04 3.346924e-04 2.100000e+02 1.000000e+01 1.000000e+01 3.816000e-03 2.551255e-04 2.551255e-04 2.350000e+02 1.500000e+01 1.500000e+01 1.978000e-03 1.672453e-04 1.672453e-04 2.650000e+02 1.500000e+01 1.500000e+01 1.131000e-03 1.209049e-04 1.209049e-04 2.950000e+02 1.500000e+01 1.500000e+01 7.085000e-04 7.947647e-05 7.947647e-05 3.250000e+02 1.500000e+01 1.500000e+01 3.383000e-04 6.250072e-05 6.250072e-05 3.700000e+02 3.000000e+01 3.000000e+01 2.239000e-04 4.741477e-05 4.741477e-05 4.750000e+02 7.500000e+01 7.500000e+01 4.150000e-05 1.330009e-05 1.330009e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d14-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d14-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.500000e-02 2.500000e-02 2.500000e-02 5.939000e-03 3.485795e-03 3.485795e-03 7.500000e-02 2.500000e-02 2.500000e-02 1.352000e-01 2.200932e-02 2.200932e-02 1.250000e-01 2.500000e-02 2.500000e-02 7.181000e-01 6.629427e-02 6.629427e-02 1.750000e-01 2.500000e-02 2.500000e-02 1.941000e+00 1.557498e-01 1.557498e-01 2.250000e-01 2.500000e-02 2.500000e-02 3.795000e+00 2.861014e-01 2.861014e-01 2.750000e-01 2.500000e-02 2.500000e-02 6.045000e+00 4.766561e-01 4.766561e-01 3.250000e-01 2.500000e-02 2.500000e-02 8.552000e+00 6.696372e-01 6.696372e-01 3.750000e-01 2.500000e-02 2.500000e-02 1.105000e+01 8.568547e-01 8.568547e-01 4.250000e-01 2.500000e-02 2.500000e-02 1.357000e+01 1.075453e+00 1.075453e+00 4.750000e-01 2.500000e-02 2.500000e-02 1.593000e+01 1.304990e+00 1.304990e+00 5.250000e-01 2.500000e-02 2.500000e-02 1.813000e+01 1.524893e+00 1.524893e+00 5.750000e-01 2.500000e-02 2.500000e-02 2.009000e+01 1.744706e+00 1.744706e+00 6.250000e-01 2.500000e-02 2.500000e-02 2.165000e+01 1.934244e+00 1.934244e+00 6.750000e-01 2.500000e-02 2.500000e-02 2.319000e+01 2.114379e+00 2.114379e+00 7.250000e-01 2.500000e-02 2.500000e-02 2.436000e+01 2.284426e+00 2.284426e+00 7.750000e-01 2.500000e-02 2.500000e-02 2.548000e+01 2.444136e+00 2.444136e+00 8.250000e-01 2.500000e-02 2.500000e-02 2.628000e+01 2.564761e+00 2.564761e+00 8.750000e-01 2.500000e-02 2.500000e-02 2.721000e+01 2.704977e+00 2.704977e+00 9.250000e-01 2.500000e-02 2.500000e-02 2.772000e+01 2.785696e+00 2.785696e+00 9.750000e-01 2.500000e-02 2.500000e-02 2.785000e+01 2.825615e+00 2.825615e+00 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d15-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d15-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e+01 2.000000e+01 2.000000e+01 6.170000e-01 8.341732e-02 8.341732e-02 6.000000e+01 2.000000e+01 2.000000e+01 8.101000e-01 2.269383e-02 2.269383e-02 1.000000e+02 2.000000e+01 2.000000e+01 1.980000e-01 3.082207e-03 3.082207e-03 1.400000e+02 2.000000e+01 2.000000e+01 5.676000e-02 9.080749e-04 9.080749e-04 1.800000e+02 2.000000e+01 2.000000e+01 2.013000e-02 4.123106e-04 4.123106e-04 2.200000e+02 2.000000e+01 2.000000e+01 8.096000e-03 2.201886e-04 2.201886e-04 2.600000e+02 2.000000e+01 2.000000e+01 3.582000e-03 1.474924e-04 1.474924e-04 3.000000e+02 2.000000e+01 2.000000e+01 1.660000e-03 9.136192e-05 9.136192e-05 3.400000e+02 2.000000e+01 2.000000e+01 7.228000e-04 5.509419e-05 5.509419e-05 3.800000e+02 2.000000e+01 2.000000e+01 4.620000e-04 4.200202e-05 4.200202e-05 4.200000e+02 2.000000e+01 2.000000e+01 1.874000e-04 2.990719e-05 2.990719e-05 4.600000e+02 2.000000e+01 2.000000e+01 1.223000e-04 2.181513e-05 2.181513e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d16-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d16-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e+01 2.000000e+01 2.000000e+01 4.911000e-01 6.772045e-02 6.772045e-02 6.000000e+01 2.000000e+01 2.000000e+01 6.746000e-01 1.444091e-02 1.444091e-02 1.000000e+02 2.000000e+01 2.000000e+01 1.294000e-01 4.508880e-03 4.508880e-03 1.400000e+02 2.000000e+01 2.000000e+01 2.933000e-02 1.179407e-03 1.179407e-03 1.800000e+02 2.000000e+01 2.000000e+01 9.162000e-03 4.225352e-04 4.225352e-04 2.200000e+02 2.000000e+01 2.000000e+01 3.091000e-03 1.756645e-04 1.756645e-04 2.600000e+02 2.000000e+01 2.000000e+01 1.239000e-03 9.426558e-05 9.426558e-05 3.000000e+02 2.000000e+01 2.000000e+01 5.828000e-04 6.403046e-05 6.403046e-05 3.400000e+02 2.000000e+01 2.000000e+01 2.312000e-04 3.732801e-05 3.732801e-05 3.800000e+02 2.000000e+01 2.000000e+01 1.391000e-04 2.803498e-05 2.803498e-05 4.200000e+02 2.000000e+01 2.000000e+01 7.579000e-05 2.181150e-05 2.181150e-05 4.600000e+02 2.000000e+01 2.000000e+01 2.896000e-05 1.122416e-05 1.122416e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d17-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d17-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e-01 1.000000e-01 1.000000e-01 3.551000e+01 1.661716e+00 1.661716e+00 3.000000e-01 1.000000e-01 1.000000e-01 3.467000e+01 1.633065e+00 1.633065e+00 5.000000e-01 1.000000e-01 1.000000e-01 3.494000e+01 1.670599e+00 1.670599e+00 7.000000e-01 1.000000e-01 1.000000e-01 3.297000e+01 1.592231e+00 1.592231e+00 9.000000e-01 1.000000e-01 1.000000e-01 3.077000e+01 1.540422e+00 1.540422e+00 1.100000e+00 1.000000e-01 1.000000e-01 2.720000e+01 1.492548e+00 1.492548e+00 1.300000e+00 1.000000e-01 1.000000e-01 2.634000e+01 1.532221e+00 1.532221e+00 1.500000e+00 1.000000e-01 1.000000e-01 2.303000e+01 1.350185e+00 1.350185e+00 1.700000e+00 1.000000e-01 1.000000e-01 1.920000e+01 1.191008e+00 1.191008e+00 1.900000e+00 1.000000e-01 1.000000e-01 1.737000e+01 1.228373e+00 1.228373e+00 2.100000e+00 1.000000e-01 1.000000e-01 1.480000e+01 1.087796e+00 1.087796e+00 2.300000e+00 1.000000e-01 1.000000e-01 1.187000e+01 9.874209e-01 9.874209e-01 2.500000e+00 1.000000e-01 1.000000e-01 9.016000e+00 1.077595e+00 1.077595e+00 2.700000e+00 1.000000e-01 1.000000e-01 7.302000e+00 1.049267e+00 1.049267e+00 2.900000e+00 1.000000e-01 1.000000e-01 6.293000e+00 1.212887e+00 1.212887e+00 3.200000e+00 2.000000e-01 2.000000e-01 3.643000e+00 7.244108e-01 7.244108e-01 3.600000e+00 2.000000e-01 2.000000e-01 1.577000e+00 3.810105e-01 3.810105e-01 4.100000e+00 3.000000e-01 3.000000e-01 4.989000e-01 1.928764e-01 1.928764e-01 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d18-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d18-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e-01 1.000000e-01 1.000000e-01 7.099000e+00 5.217950e-01 5.217950e-01 3.000000e-01 1.000000e-01 1.000000e-01 6.987000e+00 5.129474e-01 5.129474e-01 5.000000e-01 1.000000e-01 1.000000e-01 6.768000e+00 4.884977e-01 4.884977e-01 7.000000e-01 1.000000e-01 1.000000e-01 6.581000e+00 5.039057e-01 5.039057e-01 9.000000e-01 1.000000e-01 1.000000e-01 6.239000e+00 4.837127e-01 4.837127e-01 1.100000e+00 1.000000e-01 1.000000e-01 5.747000e+00 4.737774e-01 4.737774e-01 1.300000e+00 1.000000e-01 1.000000e-01 5.647000e+00 4.881731e-01 4.881731e-01 1.500000e+00 1.000000e-01 1.000000e-01 5.112000e+00 4.170719e-01 4.170719e-01 1.700000e+00 1.000000e-01 1.000000e-01 4.294000e+00 3.798236e-01 3.798236e-01 1.900000e+00 1.000000e-01 1.000000e-01 4.009000e+00 3.657130e-01 3.657130e-01 2.100000e+00 1.000000e-01 1.000000e-01 3.430000e+00 3.253721e-01 3.253721e-01 2.300000e+00 1.000000e-01 1.000000e-01 3.039000e+00 3.074638e-01 3.074638e-01 2.500000e+00 1.000000e-01 1.000000e-01 2.457000e+00 3.177955e-01 3.177955e-01 2.700000e+00 1.000000e-01 1.000000e-01 2.110000e+00 3.037647e-01 3.037647e-01 2.900000e+00 1.000000e-01 1.000000e-01 1.899000e+00 3.338892e-01 3.338892e-01 3.200000e+00 2.000000e-01 2.000000e-01 1.194000e+00 2.050975e-01 2.050975e-01 3.600000e+00 2.000000e-01 2.000000e-01 6.398000e-01 1.284426e-01 1.284426e-01 4.100000e+00 3.000000e-01 3.000000e-01 2.198000e-01 5.902787e-02 5.902787e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d19-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d19-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 1.436000e+00 1.471394e-01 1.471394e-01 6.000000e-01 2.000000e-01 2.000000e-01 1.371000e+00 1.459932e-01 1.459932e-01 1.000000e+00 2.000000e-01 2.000000e-01 1.229000e+00 1.331390e-01 1.331390e-01 1.400000e+00 2.000000e-01 2.000000e-01 1.072000e+00 1.241129e-01 1.241129e-01 1.800000e+00 2.000000e-01 2.000000e-01 8.374000e-01 1.047606e-01 1.047606e-01 2.200000e+00 2.000000e-01 2.000000e-01 7.194000e-01 9.699469e-02 9.699469e-02 2.600000e+00 2.000000e-01 2.000000e-01 5.032000e-01 8.235618e-02 8.235618e-02 3.000000e+00 2.000000e-01 2.000000e-01 3.793000e-01 7.984754e-02 7.984754e-02 3.400000e+00 2.000000e-01 2.000000e-01 1.728000e-01 3.615453e-02 3.615453e-02 3.800000e+00 2.000000e-01 2.000000e-01 8.788000e-02 2.281524e-02 2.281524e-02 4.200000e+00 2.000000e-01 2.000000e-01 2.968000e-02 1.143211e-02 1.143211e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d20-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d20-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 3.054000e-01 4.574079e-02 4.574079e-02 8.000000e-01 4.000000e-01 4.000000e-01 2.625000e-01 3.842929e-02 3.842929e-02 1.600000e+00 4.000000e-01 4.000000e-01 2.101000e-01 3.344548e-02 3.344548e-02 2.400000e+00 4.000000e-01 4.000000e-01 1.223000e-01 2.243881e-02 2.243881e-02 3.200000e+00 4.000000e-01 4.000000e-01 6.038000e-02 1.649617e-02 1.649617e-02 4.000000e+00 4.000000e-01 4.000000e-01 1.052000e-02 3.397955e-03 3.397955e-03 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d21-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d21-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 6.180000e+00 5.487039e-01 5.487039e-01 6.000000e-01 2.000000e-01 2.000000e-01 6.151000e+00 5.392597e-01 5.392597e-01 1.000000e+00 2.000000e-01 2.000000e-01 5.427000e+00 4.451528e-01 4.451528e-01 1.400000e+00 2.000000e-01 2.000000e-01 4.650000e+00 3.736322e-01 3.736322e-01 1.800000e+00 2.000000e-01 2.000000e-01 4.047000e+00 3.362410e-01 3.362410e-01 2.200000e+00 2.000000e-01 2.000000e-01 3.290000e+00 2.843343e-01 2.843343e-01 2.600000e+00 2.000000e-01 2.000000e-01 2.608000e+00 2.450163e-01 2.450163e-01 3.000000e+00 2.000000e-01 2.000000e-01 1.939000e+00 2.045629e-01 2.045629e-01 3.400000e+00 2.000000e-01 2.000000e-01 1.334000e+00 1.641128e-01 1.641128e-01 3.800000e+00 2.000000e-01 2.000000e-01 8.823000e-01 1.220534e-01 1.220534e-01 4.200000e+00 2.000000e-01 2.000000e-01 5.990000e-01 9.389148e-02 9.389148e-02 4.600000e+00 2.000000e-01 2.000000e-01 3.427000e-01 6.701119e-02 6.701119e-02 5.000000e+00 2.000000e-01 2.000000e-01 1.940000e-01 4.526257e-02 4.526257e-02 5.400000e+00 2.000000e-01 2.000000e-01 1.007000e-01 3.347282e-02 3.347282e-02 5.800000e+00 2.000000e-01 2.000000e-01 6.251000e-02 2.667495e-02 2.667495e-02 6.200000e+00 2.000000e-01 2.000000e-01 2.359000e-02 1.292211e-02 1.292211e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d22-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d22-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.250000e+01 1.250000e+01 1.250000e+01 2.306000e-03 6.738820e-04 6.738820e-04 3.750000e+01 1.250000e+01 1.250000e+01 3.305000e-02 4.957691e-03 4.957691e-03 6.250000e+01 1.250000e+01 1.250000e+01 5.577000e-02 6.616381e-03 6.616381e-03 8.750000e+01 1.250000e+01 1.250000e+01 8.734000e-02 8.321370e-03 8.321370e-03 1.125000e+02 1.250000e+01 1.250000e+01 8.405000e-02 7.087863e-03 7.087863e-03 1.375000e+02 1.250000e+01 1.250000e+01 6.883000e-02 4.976686e-03 4.976686e-03 1.625000e+02 1.250000e+01 1.250000e+01 5.429000e-02 4.178576e-03 4.178576e-03 1.875000e+02 1.250000e+01 1.250000e+01 4.135000e-02 3.353342e-03 3.353342e-03 2.125000e+02 1.250000e+01 1.250000e+01 3.200000e-02 2.533160e-03 2.533160e-03 2.375000e+02 1.250000e+01 1.250000e+01 2.535000e-02 2.039461e-03 2.039461e-03 2.625000e+02 1.250000e+01 1.250000e+01 2.056000e-02 1.669760e-03 1.669760e-03 2.875000e+02 1.250000e+01 1.250000e+01 1.692000e-02 1.426394e-03 1.426394e-03 3.125000e+02 1.250000e+01 1.250000e+01 1.322000e-02 1.223315e-03 1.223315e-03 3.375000e+02 1.250000e+01 1.250000e+01 1.059000e-02 1.011237e-03 1.011237e-03 3.625000e+02 1.250000e+01 1.250000e+01 8.574000e-03 7.899215e-04 7.899215e-04 3.875000e+02 1.250000e+01 1.250000e+01 7.193000e-03 6.470023e-04 6.470023e-04 4.250000e+02 2.500000e+01 2.500000e+01 5.731000e-03 5.411931e-04 5.411931e-04 4.750000e+02 2.500000e+01 2.500000e+01 4.290000e-03 4.104485e-04 4.104485e-04 5.375000e+02 3.750000e+01 3.750000e+01 3.042000e-03 3.401088e-04 3.401088e-04 6.250000e+02 5.000000e+01 5.000000e+01 1.737000e-03 2.378003e-04 2.378003e-04 7.375000e+02 6.250000e+01 6.250000e+01 8.985000e-04 1.219290e-04 1.219290e-04 9.000000e+02 1.000000e+02 1.000000e+02 4.517000e-04 8.257542e-05 8.257542e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d23-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d23-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 9.820000e-02 9.820000e-02 9.810000e-02 2.185000e+00 2.903946e-01 2.903946e-01 2.945000e-01 9.820000e-02 9.820000e-02 2.449000e+00 3.117387e-01 3.117387e-01 4.909000e-01 9.820000e-02 9.810000e-02 2.924000e+00 3.901397e-01 3.901397e-01 6.872000e-01 9.820000e-02 9.820000e-02 2.668000e+00 3.429125e-01 3.429125e-01 8.836000e-01 9.820000e-02 9.810000e-02 2.496000e+00 2.951085e-01 2.951085e-01 1.079900e+00 9.820000e-02 9.820000e-02 2.587000e+00 2.988411e-01 2.988411e-01 1.276300e+00 9.820000e-02 9.810000e-02 2.722000e+00 3.005229e-01 3.005229e-01 1.472600e+00 9.820000e-02 9.820000e-02 3.073000e+00 3.295269e-01 3.295269e-01 1.669000e+00 9.820000e-02 9.810000e-02 3.518000e+00 3.634955e-01 3.634955e-01 1.865300e+00 9.820000e-02 9.820000e-02 4.109000e+00 4.013241e-01 4.013241e-01 2.061700e+00 9.820000e-02 9.810000e-02 4.986000e+00 4.588420e-01 4.588420e-01 2.258000e+00 9.820000e-02 9.820000e-02 6.021000e+00 5.099373e-01 5.099373e-01 2.454400e+00 9.820000e-02 9.810000e-02 7.357000e+00 5.765666e-01 5.765666e-01 2.650700e+00 9.820000e-02 9.820000e-02 8.903000e+00 6.780819e-01 6.780819e-01 2.847100e+00 9.820000e-02 9.810000e-02 1.054000e+01 7.956758e-01 7.956758e-01 3.043400e+00 9.820000e-02 9.820000e-02 1.169000e+01 8.762420e-01 8.762420e-01 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d24-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d24-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e-01 1.000000e-01 1.000000e-01 1.706000e+00 2.596209e-01 2.596209e-01 7.000000e-01 1.000000e-01 1.000000e-01 1.940000e+00 3.048557e-01 3.048557e-01 9.000000e-01 1.000000e-01 1.000000e-01 1.769000e+00 2.053509e-01 2.053509e-01 1.100000e+00 1.000000e-01 1.000000e-01 1.794000e+00 2.049219e-01 2.049219e-01 1.300000e+00 1.000000e-01 1.000000e-01 1.864000e+00 1.976714e-01 1.976714e-01 1.500000e+00 1.000000e-01 1.000000e-01 2.046000e+00 2.095257e-01 2.095257e-01 1.700000e+00 1.000000e-01 1.000000e-01 2.425000e+00 2.437601e-01 2.437601e-01 1.900000e+00 1.000000e-01 1.000000e-01 2.667000e+00 2.488956e-01 2.488956e-01 2.100000e+00 1.000000e-01 1.000000e-01 3.346000e+00 3.081785e-01 3.081785e-01 2.300000e+00 1.000000e-01 1.000000e-01 4.249000e+00 3.660642e-01 3.660642e-01 2.500000e+00 1.000000e-01 1.000000e-01 5.153000e+00 4.210238e-01 4.210238e-01 2.700000e+00 1.000000e-01 1.000000e-01 6.423000e+00 5.187417e-01 5.187417e-01 2.900000e+00 1.000000e-01 1.000000e-01 7.925000e+00 6.185321e-01 6.185321e-01 3.100000e+00 1.000000e-01 1.000000e-01 8.697000e+00 6.658851e-01 6.658851e-01 3.300000e+00 1.000000e-01 1.000000e-01 5.961000e+00 4.800167e-01 4.800167e-01 3.500000e+00 1.000000e-01 1.000000e-01 4.278000e+00 3.515636e-01 3.515636e-01 3.700000e+00 1.000000e-01 1.000000e-01 3.369000e+00 3.054914e-01 3.054914e-01 3.900000e+00 1.000000e-01 1.000000e-01 2.530000e+00 2.474288e-01 2.474288e-01 4.200000e+00 2.000000e-01 2.000000e-01 1.745000e+00 1.866467e-01 1.866467e-01 4.600000e+00 2.000000e-01 2.000000e-01 1.038000e+00 1.371240e-01 1.371240e-01 5.200000e+00 4.000000e-01 4.000000e-01 4.102000e-01 6.780332e-02 6.780332e-02 6.100000e+00 5.000000e-01 5.000000e-01 9.707000e-02 2.978309e-02 2.978309e-02 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d25-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d25-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.250000e+01 2.500000e+00 2.500000e+00 1.498000e-02 3.083958e-03 3.083958e-03 3.750000e+01 2.500000e+00 2.500000e+00 1.017000e-02 1.730722e-03 1.730722e-03 4.500000e+01 5.000000e+00 5.000000e+00 5.817000e-03 8.861715e-04 8.861715e-04 5.500000e+01 5.000000e+00 5.000000e+00 2.901000e-03 4.685659e-04 4.685659e-04 6.500000e+01 5.000000e+00 5.000000e+00 1.449000e-03 2.459309e-04 2.459309e-04 7.500000e+01 5.000000e+00 5.000000e+00 6.748000e-04 1.409451e-04 1.409451e-04 9.000000e+01 1.000000e+01 1.000000e+01 2.564000e-04 6.802154e-05 6.802154e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d26-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d26-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 9.981000e-02 1.510411e-02 1.510411e-02 8.000000e-01 4.000000e-01 4.000000e-01 1.009000e-01 1.410071e-02 1.410071e-02 1.600000e+00 4.000000e-01 4.000000e-01 7.262000e-02 1.205257e-02 1.205257e-02 2.400000e+00 4.000000e-01 4.000000e-01 4.641000e-02 9.755645e-03 9.755645e-03 3.200000e+00 4.000000e-01 4.000000e-01 2.210000e-02 6.161201e-03 6.161201e-03 4.000000e+00 4.000000e-01 4.000000e-01 5.134000e-03 2.277186e-03 2.277186e-03 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d27-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d27-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 7.500000e+01 5.000000e+00 5.000000e+00 8.142000e-03 1.173534e-03 1.173534e-03 8.500000e+01 5.000000e+00 5.000000e+00 5.202000e-02 7.007375e-03 7.007375e-03 9.500000e+01 5.000000e+00 5.000000e+00 1.426000e-01 1.725254e-02 1.725254e-02 1.050000e+02 5.000000e+00 5.000000e+00 2.995000e-01 3.276019e-02 3.276019e-02 1.150000e+02 5.000000e+00 5.000000e+00 5.502000e-01 5.196239e-02 5.196239e-02 1.250000e+02 5.000000e+00 5.000000e+00 9.538000e-01 7.077160e-02 7.077160e-02 1.350000e+02 5.000000e+00 5.000000e+00 9.418000e-01 5.290085e-02 5.290085e-02 1.450000e+02 5.000000e+00 5.000000e+00 6.880000e-01 3.291018e-02 3.291018e-02 1.550000e+02 5.000000e+00 5.000000e+00 5.177000e-01 2.429918e-02 2.429918e-02 1.650000e+02 5.000000e+00 5.000000e+00 4.134000e-01 2.017771e-02 2.017771e-02 1.750000e+02 5.000000e+00 5.000000e+00 3.379000e-01 1.667963e-02 1.667963e-02 1.850000e+02 5.000000e+00 5.000000e+00 2.789000e-01 1.367333e-02 1.367333e-02 1.950000e+02 5.000000e+00 5.000000e+00 2.292000e-01 1.137146e-02 1.137146e-02 2.100000e+02 1.000000e+01 1.000000e+01 1.752000e-01 8.949860e-03 8.949860e-03 2.300000e+02 1.000000e+01 1.000000e+01 1.243000e-01 6.351378e-03 6.351378e-03 2.500000e+02 1.000000e+01 1.000000e+01 9.071000e-02 4.650957e-03 4.650957e-03 2.700000e+02 1.000000e+01 1.000000e+01 6.783000e-02 3.474478e-03 3.474478e-03 2.900000e+02 1.000000e+01 1.000000e+01 5.089000e-02 2.571653e-03 2.571653e-03 3.100000e+02 1.000000e+01 1.000000e+01 3.920000e-02 1.878297e-03 1.878297e-03 3.300000e+02 1.000000e+01 1.000000e+01 3.110000e-02 1.498199e-03 1.498199e-03 3.500000e+02 1.000000e+01 1.000000e+01 2.502000e-02 1.279805e-03 1.279805e-03 3.700000e+02 1.000000e+01 1.000000e+01 2.000000e-02 1.017743e-03 1.017743e-03 3.900000e+02 1.000000e+01 1.000000e+01 1.616000e-02 8.363014e-04 8.363014e-04 4.100000e+02 1.000000e+01 1.000000e+01 1.314000e-02 7.071775e-04 7.071775e-04 4.300000e+02 1.000000e+01 1.000000e+01 1.060000e-02 5.938013e-04 5.938013e-04 4.500000e+02 1.000000e+01 1.000000e+01 8.727000e-03 5.087367e-04 5.087367e-04 4.700000e+02 1.000000e+01 1.000000e+01 7.107000e-03 4.049000e-04 4.049000e-04 4.900000e+02 1.000000e+01 1.000000e+01 5.737000e-03 3.052048e-04 3.052048e-04 5.150000e+02 1.500000e+01 1.500000e+01 4.728000e-03 2.383820e-04 2.383820e-04 5.600000e+02 3.000000e+01 3.000000e+01 3.289000e-03 1.788771e-04 1.788771e-04 6.350000e+02 4.500000e+01 4.500000e+01 1.806000e-03 1.093709e-04 1.093709e-04 7.400000e+02 6.000000e+01 6.000000e+01 8.919000e-04 5.339906e-05 5.339906e-05 9.000000e+02 1.000000e+02 1.000000e+02 3.023000e-04 2.417954e-05 2.417954e-05 END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d28-x01-y01 IsRef: 1 Path: /REF/ATLAS_2013_I1230812/d28-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 3.500000e+01 5.000000e+00 5.000000e+00 2.223000e+00 1.571082e-01 1.571082e-01 4.500000e+01 5.000000e+00 5.000000e+00 1.179000e+00 6.709694e-02 6.709694e-02 5.500000e+01 5.000000e+00 5.000000e+00 6.797000e-01 3.519744e-02 3.519744e-02 6.500000e+01 5.000000e+00 5.000000e+00 5.058000e-01 2.987055e-02 2.987055e-02 7.500000e+01 5.000000e+00 5.000000e+00 4.217000e-01 2.645921e-02 2.645921e-02 8.500000e+01 5.000000e+00 5.000000e+00 3.305000e-01 2.065357e-02 2.065357e-02 9.500000e+01 5.000000e+00 5.000000e+00 2.553000e-01 1.585718e-02 1.585718e-02 1.050000e+02 5.000000e+00 5.000000e+00 2.044000e-01 1.295029e-02 1.295029e-02 1.150000e+02 5.000000e+00 5.000000e+00 1.657000e-01 1.093892e-02 1.093892e-02 1.250000e+02 5.000000e+00 5.000000e+00 1.348000e-01 9.047099e-03 9.047099e-03 1.350000e+02 5.000000e+00 5.000000e+00 1.105000e-01 7.341662e-03 7.341662e-03 1.450000e+02 5.000000e+00 5.000000e+00 9.197000e-02 6.089089e-03 6.089089e-03 1.550000e+02 5.000000e+00 5.000000e+00 7.633000e-02 5.068659e-03 5.068659e-03 1.650000e+02 5.000000e+00 5.000000e+00 6.471000e-02 4.335597e-03 4.335597e-03 1.750000e+02 5.000000e+00 5.000000e+00 5.375000e-02 3.643158e-03 3.643158e-03 1.850000e+02 5.000000e+00 5.000000e+00 4.581000e-02 3.171640e-03 3.171640e-03 1.950000e+02 5.000000e+00 5.000000e+00 3.950000e-02 2.749927e-03 2.749927e-03 2.100000e+02 1.000000e+01 1.000000e+01 3.133000e-02 2.200114e-03 2.200114e-03 2.300000e+02 1.000000e+01 1.000000e+01 2.303000e-02 1.620278e-03 1.620278e-03 2.500000e+02 1.000000e+01 1.000000e+01 1.770000e-02 1.200250e-03 1.200250e-03 2.700000e+02 1.000000e+01 1.000000e+01 1.356000e-02 8.982761e-04 8.982761e-04 2.900000e+02 1.000000e+01 1.000000e+01 1.065000e-02 7.164496e-04 7.164496e-04 3.100000e+02 1.000000e+01 1.000000e+01 8.679000e-03 6.076915e-04 6.076915e-04 3.300000e+02 1.000000e+01 1.000000e+01 6.820000e-03 4.792505e-04 4.792505e-04 3.500000e+02 1.000000e+01 1.000000e+01 5.391000e-03 3.882023e-04 3.882023e-04 3.700000e+02 1.000000e+01 1.000000e+01 4.249000e-03 3.158259e-04 3.158259e-04 3.900000e+02 1.000000e+01 1.000000e+01 3.494000e-03 2.768863e-04 2.768863e-04 4.200000e+02 2.000000e+01 2.000000e+01 2.605000e-03 1.694786e-04 1.694786e-04 4.700000e+02 3.000000e+01 3.000000e+01 1.718000e-03 1.287362e-04 1.287362e-04 5.750000e+02 7.500000e+01 7.500000e+01 7.086000e-04 5.552198e-05 5.552198e-05 8.250000e+02 1.750000e+02 1.750000e+02 1.431000e-04 1.350444e-05 1.350444e-05 END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d01-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d01-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +0.000000e+00 5.000000e-01 5.000000e-01 4.240000e+02 4.000000e+01 3.500000e+01 +1.000000e+00 5.000000e-01 5.000000e-01 6.142000e+01 4.854170e+00 4.854170e+00 +2.000000e+00 5.000000e-01 5.000000e-01 1.329000e+01 1.392620e+00 1.392620e+00 +3.000000e+00 5.000000e-01 5.000000e-01 2.688000e+00 3.602860e-01 3.602860e-01 +4.000000e+00 5.000000e-01 5.000000e-01 5.738000e-01 9.853990e-02 9.853990e-02 +5.000000e+00 5.000000e-01 5.000000e-01 1.129000e-01 2.496820e-02 2.496820e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.760000e-02 5.423980e-03 5.423980e-03 +7.000000e+00 5.000000e-01 5.000000e-01 4.133000e-03 2.329770e-03 2.329770e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d02-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d02-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 1.424000e-01 1.060940e-02 1.060940e-02 +2.000000e+00 5.000000e-01 5.000000e-01 2.164000e-01 7.218030e-03 7.218030e-03 +3.000000e+00 5.000000e-01 5.000000e-01 2.022000e-01 6.862220e-03 6.862220e-03 +4.000000e+00 5.000000e-01 5.000000e-01 2.135000e-01 1.022790e-02 1.022790e-02 +5.000000e+00 5.000000e-01 5.000000e-01 1.967000e-01 1.594400e-02 1.594400e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.559000e-01 2.954490e-02 2.954490e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d03-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d03-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +0.000000e+00 5.000000e-01 5.000000e-01 3.699000e+02 1.130885e+01 1.130885e+01 +1.000000e+00 5.000000e-01 5.000000e-01 4.813000e+01 3.514555e+00 3.514555e+00 +2.000000e+00 5.000000e-01 5.000000e-01 1.060000e+01 1.042785e+00 1.042785e+00 +3.000000e+00 5.000000e-01 5.000000e-01 2.114000e+00 2.645165e-01 2.645165e-01 +4.000000e+00 5.000000e-01 5.000000e-01 4.609000e-01 7.537301e-02 7.537301e-02 +5.000000e+00 5.000000e-01 5.000000e-01 9.529000e-02 2.087925e-02 2.087925e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.347000e-02 4.176159e-03 4.176159e-03 +7.000000e+00 5.000000e-01 5.000000e-01 3.472000e-03 2.065333e-03 2.065333e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d04-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d04-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 1.301000e-01 1.031410e-02 1.031410e-02 +2.000000e+00 5.000000e-01 5.000000e-01 2.203000e-01 7.916440e-03 7.916440e-03 +3.000000e+00 5.000000e-01 5.000000e-01 1.994000e-01 7.083080e-03 7.083080e-03 +4.000000e+00 5.000000e-01 5.000000e-01 2.180000e-01 1.215280e-02 1.215280e-02 +5.000000e+00 5.000000e-01 5.000000e-01 2.067000e-01 2.130680e-02 2.130680e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.413000e-01 3.268330e-02 3.268330e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d05-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d05-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 6.404000e-01 3.450507e-02 3.450507e-02 +2.000000e+00 5.000000e-01 5.000000e-01 6.793000e-01 4.055071e-02 4.055071e-02 +3.000000e+00 5.000000e-01 5.000000e-01 3.134000e-01 2.651094e-02 2.651094e-02 +4.000000e+00 5.000000e-01 5.000000e-01 1.169000e-01 1.543341e-02 1.543341e-02 +5.000000e+00 5.000000e-01 5.000000e-01 3.481000e-02 7.268040e-03 7.268040e-03 +6.000000e+00 5.000000e-01 5.000000e-01 5.193000e-03 1.770531e-03 1.770531e-03 +7.000000e+00 5.000000e-01 5.000000e-01 1.665000e-03 1.032832e-03 1.032832e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d06-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d06-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+00 5.000000e-01 5.000000e-01 1.061000e+00 4.863130e-02 4.863130e-02 +3.000000e+00 5.000000e-01 5.000000e-01 4.614000e-01 2.704830e-02 2.704830e-02 +4.000000e+00 5.000000e-01 5.000000e-01 3.730000e-01 3.224690e-02 3.224690e-02 +5.000000e+00 5.000000e-01 5.000000e-01 2.977000e-01 4.309280e-02 4.309280e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.492000e-01 4.529250e-02 4.529250e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d07-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d07-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+00 5.000000e-01 5.000000e-01 5.554000e-01 9.019673e-02 9.019673e-02 +3.000000e+00 5.000000e-01 5.000000e-01 1.640000e-01 2.828940e-02 2.828940e-02 +4.000000e+00 5.000000e-01 5.000000e-01 3.038000e-02 7.774285e-03 7.774285e-03 +5.000000e+00 5.000000e-01 5.000000e-01 7.301000e-03 1.849994e-02 1.849994e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.781000e-03 3.821775e-02 3.821775e-02 +7.000000e+00 5.000000e-01 5.000000e-01 4.050000e-04 1.306976e-01 1.306976e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d08-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d08-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.000000e+00 5.000000e-01 5.000000e-01 2.953000e-01 2.176810e-02 2.176810e-02 +4.000000e+00 5.000000e-01 5.000000e-01 1.852000e-01 2.779800e-02 2.779800e-02 +5.000000e+00 5.000000e-01 5.000000e-01 2.403000e-01 6.076620e-01 6.076620e-01 +6.000000e+00 5.000000e-01 5.000000e-01 2.439000e-01 5.270080e+00 5.270080e+00 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d09-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d09-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 2.451000e+00 2.273609e-01 2.273609e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.842000e+00 1.274441e-01 1.274441e-01 +4.500000e+01 5.000000e+00 5.000000e+00 1.269000e+00 8.032434e-02 8.032434e-02 +5.500000e+01 5.000000e+00 5.000000e+00 7.991000e-01 4.764767e-02 4.764767e-02 +6.500000e+01 5.000000e+00 5.000000e+00 5.310000e-01 3.253613e-02 3.253613e-02 +7.500000e+01 5.000000e+00 5.000000e+00 3.627000e-01 2.111540e-02 2.111540e-02 +9.000000e+01 1.000000e+01 1.000000e+01 2.192000e-01 1.213384e-02 1.213384e-02 +1.100000e+02 1.000000e+01 1.000000e+01 1.170000e-01 6.707459e-03 6.707459e-03 +1.300000e+02 1.000000e+01 1.000000e+01 6.519000e-02 3.807795e-03 3.807795e-03 +1.500000e+02 1.000000e+01 1.000000e+01 3.994000e-02 2.429115e-03 2.429115e-03 +1.700000e+02 1.000000e+01 1.000000e+01 2.381000e-02 1.537530e-03 1.537530e-03 +1.900000e+02 1.000000e+01 1.000000e+01 1.485000e-02 9.737043e-04 9.737043e-04 +2.100000e+02 1.000000e+01 1.000000e+01 9.756000e-03 6.619396e-04 6.619396e-04 +2.350000e+02 1.500000e+01 1.500000e+01 6.074000e-03 4.374666e-04 4.374666e-04 +2.650000e+02 1.500000e+01 1.500000e+01 3.700000e-03 3.201140e-04 3.201140e-04 +2.950000e+02 1.500000e+01 1.500000e+01 2.220000e-03 2.002049e-04 2.002049e-04 +3.250000e+02 1.500000e+01 1.500000e+01 1.324000e-03 1.440278e-04 1.440278e-04 +3.550000e+02 1.500000e+01 1.500000e+01 8.740000e-04 1.094534e-04 1.094534e-04 +3.850000e+02 1.500000e+01 1.500000e+01 5.131000e-04 7.620033e-05 7.620033e-05 +4.250000e+02 2.500000e+01 2.500000e+01 2.778000e-04 4.709798e-05 4.709798e-05 +4.750000e+02 2.500000e+01 2.500000e+01 1.542000e-04 3.762366e-05 3.762366e-05 +5.250000e+02 2.500000e+01 2.500000e+01 7.818000e-05 2.545746e-05 2.545746e-05 +6.250000e+02 7.500000e+01 7.500000e+01 3.080000e-05 1.299593e-05 1.299593e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d10-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d10-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 7.286000e-01 8.884036e-02 8.884036e-02 +3.750000e+01 2.500000e+00 2.500000e+00 4.787000e-01 4.757930e-02 4.757930e-02 +4.500000e+01 5.000000e+00 5.000000e+00 2.842000e-01 2.481894e-02 2.481894e-02 +5.500000e+01 5.000000e+00 5.000000e+00 1.541000e-01 1.232437e-02 1.232437e-02 +6.500000e+01 5.000000e+00 5.000000e+00 9.340000e-02 6.564335e-03 6.564335e-03 +7.500000e+01 5.000000e+00 5.000000e+00 6.006000e-02 4.260352e-03 4.260352e-03 +9.000000e+01 1.000000e+01 1.000000e+01 3.187000e-02 2.342499e-03 2.342499e-03 +1.100000e+02 1.000000e+01 1.000000e+01 1.543000e-02 1.156460e-03 1.156460e-03 +1.300000e+02 1.000000e+01 1.000000e+01 8.504000e-03 6.201081e-04 6.201081e-04 +1.500000e+02 1.000000e+01 1.000000e+01 4.784000e-03 4.171403e-04 4.171403e-04 +1.700000e+02 1.000000e+01 1.000000e+01 3.007000e-03 2.871846e-04 2.871846e-04 +1.900000e+02 1.000000e+01 1.000000e+01 1.810000e-03 1.917316e-04 1.917316e-04 +2.100000e+02 1.000000e+01 1.000000e+01 1.466000e-03 1.603933e-04 1.603933e-04 +2.350000e+02 1.500000e+01 1.500000e+01 9.015000e-04 1.553557e-04 1.553557e-04 +2.650000e+02 1.500000e+01 1.500000e+01 3.994000e-04 8.052944e-05 8.052944e-05 +2.950000e+02 1.500000e+01 1.500000e+01 2.782000e-04 5.936472e-05 5.936472e-05 +3.250000e+02 1.500000e+01 1.500000e+01 1.819000e-04 4.652107e-05 4.652107e-05 +3.700000e+02 3.000000e+01 3.000000e+01 1.249000e-04 3.523876e-05 3.523876e-05 +4.750000e+02 7.500000e+01 7.500000e+01 2.757000e-05 1.077621e-05 1.077621e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d11-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d11-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 1.867000e-01 2.702924e-02 2.702924e-02 +3.750000e+01 2.500000e+00 2.500000e+00 1.127000e-01 1.435479e-02 1.435479e-02 +4.500000e+01 5.000000e+00 5.000000e+00 5.987000e-02 7.116839e-03 7.116839e-03 +5.500000e+01 5.000000e+00 5.000000e+00 2.755000e-02 3.113342e-03 3.113342e-03 +6.500000e+01 5.000000e+00 5.000000e+00 1.382000e-02 1.476415e-03 1.476415e-03 +7.500000e+01 5.000000e+00 5.000000e+00 7.589000e-03 8.408032e-04 8.408032e-04 +9.000000e+01 1.000000e+01 1.000000e+01 3.790000e-03 4.523339e-04 4.523339e-04 +1.100000e+02 1.000000e+01 1.000000e+01 1.479000e-03 2.174327e-04 2.174327e-04 +1.300000e+02 1.000000e+01 1.000000e+01 6.346000e-04 1.234653e-04 1.234653e-04 +1.500000e+02 1.000000e+01 1.000000e+01 3.144000e-04 8.144649e-05 8.144649e-05 +1.800000e+02 2.000000e+01 2.000000e+01 1.019000e-04 3.583336e-05 3.583336e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d12-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d12-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 4.699000e-02 8.350120e-03 8.350120e-03 +3.750000e+01 2.500000e+00 2.500000e+00 2.511000e-02 4.243654e-03 4.243654e-03 +4.500000e+01 5.000000e+00 5.000000e+00 1.177000e-02 1.838178e-03 1.838178e-03 +5.500000e+01 5.000000e+00 5.000000e+00 4.654000e-03 6.933931e-04 6.933931e-04 +6.500000e+01 5.000000e+00 5.000000e+00 2.160000e-03 3.482241e-04 3.482241e-04 +7.500000e+01 5.000000e+00 5.000000e+00 9.850000e-04 1.799987e-04 1.799987e-04 +9.000000e+01 1.000000e+01 1.000000e+01 4.084000e-04 9.066080e-05 9.066080e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d13-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d13-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 2.358000e+00 2.063977e-01 2.063977e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.653000e+00 9.857484e-02 9.857484e-02 +4.500000e+01 5.000000e+00 5.000000e+00 1.056000e+00 5.447935e-02 5.447935e-02 +5.500000e+01 5.000000e+00 5.000000e+00 6.054000e-01 2.869390e-02 2.869390e-02 +6.500000e+01 5.000000e+00 5.000000e+00 3.694000e-01 1.807235e-02 1.807235e-02 +7.500000e+01 5.000000e+00 5.000000e+00 2.337000e-01 1.103857e-02 1.103857e-02 +9.000000e+01 1.000000e+01 1.000000e+01 1.298000e-01 5.814637e-03 5.814637e-03 +1.100000e+02 1.000000e+01 1.000000e+01 6.264000e-02 3.052474e-03 3.052474e-03 +1.300000e+02 1.000000e+01 1.000000e+01 2.987000e-02 1.823732e-03 1.823732e-03 +1.500000e+02 1.000000e+01 1.000000e+01 1.699000e-02 1.035133e-03 1.035133e-03 +1.700000e+02 1.000000e+01 1.000000e+01 9.525000e-03 6.700567e-04 6.700567e-04 +1.900000e+02 1.000000e+01 1.000000e+01 5.368000e-03 4.021020e-04 4.021020e-04 +2.100000e+02 1.000000e+01 1.000000e+01 3.179000e-03 2.715898e-04 2.715898e-04 +2.350000e+02 1.500000e+01 1.500000e+01 1.833000e-03 1.749228e-04 1.749228e-04 +2.650000e+02 1.500000e+01 1.500000e+01 1.084000e-03 1.565248e-04 1.565248e-04 +2.950000e+02 1.500000e+01 1.500000e+01 6.928000e-04 1.071257e-04 1.071257e-04 +3.250000e+02 1.500000e+01 1.500000e+01 3.047000e-04 8.074615e-05 8.074615e-05 +3.700000e+02 3.000000e+01 3.000000e+01 1.974000e-04 8.047136e-05 8.047136e-05 +4.750000e+02 7.500000e+01 7.500000e+01 3.147000e-05 2.313167e-05 2.313167e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d14-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d14-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-02 2.500000e-02 2.500000e-02 6.433000e-03 5.153919e-03 5.153919e-03 +7.500000e-02 2.500000e-02 2.500000e-02 1.113000e-01 2.391757e-02 2.391757e-02 +1.250000e-01 2.500000e-02 2.500000e-02 6.032000e-01 6.658896e-02 6.658896e-02 +1.750000e-01 2.500000e-02 2.500000e-02 1.627000e+00 1.410035e-01 1.410035e-01 +2.250000e-01 2.500000e-02 2.500000e-02 3.305000e+00 2.645600e-01 2.645600e-01 +2.750000e-01 2.500000e-02 2.500000e-02 5.256000e+00 4.343282e-01 4.343282e-01 +3.250000e-01 2.500000e-02 2.500000e-02 7.495000e+00 6.169449e-01 6.169449e-01 +3.750000e-01 2.500000e-02 2.500000e-02 9.805000e+00 8.006716e-01 8.006716e-01 +4.250000e-01 2.500000e-02 2.500000e-02 1.208000e+01 1.000450e+00 1.000450e+00 +4.750000e-01 2.500000e-02 2.500000e-02 1.418000e+01 1.230203e+00 1.230203e+00 +5.250000e-01 2.500000e-02 2.500000e-02 1.594000e+01 1.429720e+00 1.429720e+00 +5.750000e-01 2.500000e-02 2.500000e-02 1.775000e+01 1.639055e+00 1.639055e+00 +6.250000e-01 2.500000e-02 2.500000e-02 1.910000e+01 1.808204e+00 1.808204e+00 +6.750000e-01 2.500000e-02 2.500000e-02 2.047000e+01 1.978029e+00 1.978029e+00 +7.250000e-01 2.500000e-02 2.500000e-02 2.150000e+01 2.127463e+00 2.127463e+00 +7.750000e-01 2.500000e-02 2.500000e-02 2.249000e+01 2.278113e+00 2.278113e+00 +8.250000e-01 2.500000e-02 2.500000e-02 2.329000e+01 2.398875e+00 2.398875e+00 +8.750000e-01 2.500000e-02 2.500000e-02 2.410000e+01 2.519107e+00 2.519107e+00 +9.250000e-01 2.500000e-02 2.500000e-02 2.445000e+01 2.590058e+00 2.590058e+00 +9.750000e-01 2.500000e-02 2.500000e-02 2.461000e+01 2.621202e+00 2.621202e+00 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d15-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d15-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+01 2.000000e+01 2.000000e+01 5.453000e-01 7.564450e-02 7.564450e-02 +6.000000e+01 2.000000e+01 2.000000e+01 7.269000e-01 2.994612e-02 2.994612e-02 +1.000000e+02 2.000000e+01 2.000000e+01 1.801000e-01 6.256996e-03 6.256996e-03 +1.400000e+02 2.000000e+01 2.000000e+01 5.077000e-02 1.744534e-03 1.744534e-03 +1.800000e+02 2.000000e+01 2.000000e+01 1.794000e-02 7.463913e-04 7.463913e-04 +2.200000e+02 2.000000e+01 2.000000e+01 7.123000e-03 3.581745e-04 3.581745e-04 +2.600000e+02 2.000000e+01 2.000000e+01 3.225000e-03 1.998024e-04 1.998024e-04 +3.000000e+02 2.000000e+01 2.000000e+01 1.589000e-03 1.355618e-04 1.355618e-04 +3.400000e+02 2.000000e+01 2.000000e+01 6.199000e-04 7.907402e-05 7.907402e-05 +3.800000e+02 2.000000e+01 2.000000e+01 4.906000e-04 6.858673e-05 6.858673e-05 +4.200000e+02 2.000000e+01 2.000000e+01 1.300000e-04 3.366987e-05 3.366987e-05 +4.600000e+02 2.000000e+01 2.000000e+01 1.111000e-04 3.162499e-05 3.162499e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d16-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d16-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+01 2.000000e+01 2.000000e+01 4.345000e-01 6.134974e-02 6.134974e-02 +6.000000e+01 2.000000e+01 2.000000e+01 6.068000e-01 2.257166e-02 2.257166e-02 +1.000000e+02 2.000000e+01 2.000000e+01 1.174000e-01 5.533534e-03 5.533534e-03 +1.400000e+02 2.000000e+01 2.000000e+01 2.661000e-02 1.365796e-03 1.365796e-03 +1.800000e+02 2.000000e+01 2.000000e+01 8.215000e-03 5.310565e-04 5.310565e-04 +2.200000e+02 2.000000e+01 2.000000e+01 2.772000e-03 2.195040e-04 2.195040e-04 +2.600000e+02 2.000000e+01 2.000000e+01 1.147000e-03 1.271259e-04 1.271259e-04 +3.000000e+02 2.000000e+01 2.000000e+01 6.114000e-04 8.909287e-05 8.909287e-05 +3.400000e+02 2.000000e+01 2.000000e+01 2.069000e-04 4.872874e-05 4.872874e-05 +3.800000e+02 2.000000e+01 2.000000e+01 1.794000e-04 4.549527e-05 4.549527e-05 +4.200000e+02 2.000000e+01 2.000000e+01 7.958000e-05 3.136218e-05 3.136218e-05 +4.600000e+02 2.000000e+01 2.000000e+01 3.095000e-05 1.673328e-05 1.673328e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d17-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d17-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 3.139000e+01 1.752084e+00 1.752084e+00 +3.000000e-01 1.000000e-01 1.000000e-01 3.105000e+01 1.723949e+00 1.723949e+00 +5.000000e-01 1.000000e-01 1.000000e-01 3.077000e+01 1.722469e+00 1.722469e+00 +7.000000e-01 1.000000e-01 1.000000e-01 2.938000e+01 1.673141e+00 1.673141e+00 +9.000000e-01 1.000000e-01 1.000000e-01 2.733000e+01 1.573054e+00 1.573054e+00 +1.100000e+00 1.000000e-01 1.000000e-01 2.430000e+01 1.551096e+00 1.551096e+00 +1.300000e+00 1.000000e-01 1.000000e-01 2.365000e+01 1.548967e+00 1.548967e+00 +1.500000e+00 1.000000e-01 1.000000e-01 2.057000e+01 1.340336e+00 1.340336e+00 +1.700000e+00 1.000000e-01 1.000000e-01 1.698000e+01 1.198582e+00 1.198582e+00 +1.900000e+00 1.000000e-01 1.000000e-01 1.561000e+01 1.197038e+00 1.197038e+00 +2.100000e+00 1.000000e-01 1.000000e-01 1.326000e+01 1.106074e+00 1.106074e+00 +2.300000e+00 1.000000e-01 1.000000e-01 1.070000e+01 9.650907e-01 9.650907e-01 +2.500000e+00 1.000000e-01 1.000000e-01 7.952000e+00 9.807844e-01 9.807844e-01 +2.700000e+00 1.000000e-01 1.000000e-01 6.689000e+00 9.352422e-01 9.352422e-01 +2.900000e+00 1.000000e-01 1.000000e-01 5.706000e+00 1.079482e+00 1.079482e+00 +3.200000e+00 2.000000e-01 2.000000e-01 3.299000e+00 6.419790e-01 6.419790e-01 +3.600000e+00 2.000000e-01 2.000000e-01 1.466000e+00 3.514698e-01 3.514698e-01 +4.100000e+00 3.000000e-01 3.000000e-01 4.696000e-01 1.805051e-01 1.805051e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d18-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d18-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 6.178000e+00 4.929686e-01 4.929686e-01 +3.000000e-01 1.000000e-01 1.000000e-01 6.220000e+00 5.061492e-01 5.061492e-01 +5.000000e-01 1.000000e-01 1.000000e-01 6.068000e+00 4.816191e-01 4.816191e-01 +7.000000e-01 1.000000e-01 1.000000e-01 5.761000e+00 4.809834e-01 4.809834e-01 +9.000000e-01 1.000000e-01 1.000000e-01 5.459000e+00 4.680481e-01 4.680481e-01 +1.100000e+00 1.000000e-01 1.000000e-01 5.076000e+00 4.492060e-01 4.492060e-01 +1.300000e+00 1.000000e-01 1.000000e-01 4.986000e+00 4.621277e-01 4.621277e-01 +1.500000e+00 1.000000e-01 1.000000e-01 4.526000e+00 3.947696e-01 3.947696e-01 +1.700000e+00 1.000000e-01 1.000000e-01 3.809000e+00 3.564674e-01 3.564674e-01 +1.900000e+00 1.000000e-01 1.000000e-01 3.455000e+00 3.282773e-01 3.282773e-01 +2.100000e+00 1.000000e-01 1.000000e-01 2.927000e+00 2.847929e-01 2.847929e-01 +2.300000e+00 1.000000e-01 1.000000e-01 2.670000e+00 2.879878e-01 2.879878e-01 +2.500000e+00 1.000000e-01 1.000000e-01 2.190000e+00 2.949881e-01 2.949881e-01 +2.700000e+00 1.000000e-01 1.000000e-01 1.946000e+00 2.918784e-01 2.918784e-01 +2.900000e+00 1.000000e-01 1.000000e-01 1.653000e+00 2.943348e-01 2.943348e-01 +3.200000e+00 2.000000e-01 2.000000e-01 1.045000e+00 1.753796e-01 1.753796e-01 +3.600000e+00 2.000000e-01 2.000000e-01 5.510000e-01 1.120202e-01 1.120202e-01 +4.100000e+00 3.000000e-01 3.000000e-01 2.108000e-01 5.819149e-02 5.819149e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d19-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d19-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 1.234000e+00 1.353920e-01 1.353920e-01 +6.000000e-01 2.000000e-01 2.000000e-01 1.196000e+00 1.366053e-01 1.366053e-01 +1.000000e+00 2.000000e-01 2.000000e-01 1.083000e+00 1.204076e-01 1.204076e-01 +1.400000e+00 2.000000e-01 2.000000e-01 9.554000e-01 1.105561e-01 1.105561e-01 +1.800000e+00 2.000000e-01 2.000000e-01 7.309000e-01 9.411918e-02 9.411918e-02 +2.200000e+00 2.000000e-01 2.000000e-01 5.655000e-01 8.270798e-02 8.270798e-02 +2.600000e+00 2.000000e-01 2.000000e-01 4.318000e-01 6.843216e-02 6.843216e-02 +3.000000e+00 2.000000e-01 2.000000e-01 3.163000e-01 6.741884e-02 6.741884e-02 +3.400000e+00 2.000000e-01 2.000000e-01 1.550000e-01 3.441584e-02 3.441584e-02 +3.800000e+00 2.000000e-01 2.000000e-01 6.966000e-02 1.985502e-02 1.985502e-02 +4.200000e+00 2.000000e-01 2.000000e-01 3.267000e-02 1.436745e-02 1.436745e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d20-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d20-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 2.576000e-01 4.159976e-02 4.159976e-02 +8.000000e-01 4.000000e-01 4.000000e-01 2.309000e-01 3.441104e-02 3.441104e-02 +1.600000e+00 4.000000e-01 4.000000e-01 1.875000e-01 3.073923e-02 3.073923e-02 +2.400000e+00 4.000000e-01 4.000000e-01 1.043000e-01 2.116672e-02 2.116672e-02 +3.200000e+00 4.000000e-01 4.000000e-01 5.288000e-02 1.441113e-02 1.441113e-02 +4.000000e+00 4.000000e-01 4.000000e-01 7.938000e-03 3.951286e-03 3.951286e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d21-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d21-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 5.442000e+00 5.247533e-01 5.247533e-01 +6.000000e-01 2.000000e-01 2.000000e-01 5.365000e+00 4.963920e-01 4.963920e-01 +1.000000e+00 2.000000e-01 2.000000e-01 4.754000e+00 4.219953e-01 4.219953e-01 +1.400000e+00 2.000000e-01 2.000000e-01 4.181000e+00 3.620069e-01 3.620069e-01 +1.800000e+00 2.000000e-01 2.000000e-01 3.622000e+00 3.300000e-01 3.300000e-01 +2.200000e+00 2.000000e-01 2.000000e-01 2.875000e+00 2.702906e-01 2.702906e-01 +2.600000e+00 2.000000e-01 2.000000e-01 2.288000e+00 2.256103e-01 2.256103e-01 +3.000000e+00 2.000000e-01 2.000000e-01 1.763000e+00 1.948769e-01 1.948769e-01 +3.400000e+00 2.000000e-01 2.000000e-01 1.129000e+00 1.454579e-01 1.454579e-01 +3.800000e+00 2.000000e-01 2.000000e-01 7.802000e-01 1.094046e-01 1.094046e-01 +4.200000e+00 2.000000e-01 2.000000e-01 5.522000e-01 8.240158e-02 8.240158e-02 +4.600000e+00 2.000000e-01 2.000000e-01 3.086000e-01 6.174342e-02 6.174342e-02 +5.000000e+00 2.000000e-01 2.000000e-01 1.765000e-01 4.407845e-02 4.407845e-02 +5.400000e+00 2.000000e-01 2.000000e-01 8.162000e-02 2.940625e-02 2.940625e-02 +5.800000e+00 2.000000e-01 2.000000e-01 4.919000e-02 2.214318e-02 2.214318e-02 +6.200000e+00 2.000000e-01 2.000000e-01 2.217000e-02 1.282574e-02 1.282574e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d22-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d22-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.250000e+01 1.250000e+01 1.250000e+01 1.889000e-03 5.497499e-04 5.497499e-04 +3.750000e+01 1.250000e+01 1.250000e+01 3.008000e-02 4.641250e-03 4.641250e-03 +6.250000e+01 1.250000e+01 1.250000e+01 4.834000e-02 5.943290e-03 5.943290e-03 +8.750000e+01 1.250000e+01 1.250000e+01 7.675000e-02 7.625523e-03 7.625523e-03 +1.125000e+02 1.250000e+01 1.250000e+01 7.470000e-02 6.764022e-03 6.764022e-03 +1.375000e+02 1.250000e+01 1.250000e+01 6.054000e-02 4.937155e-03 4.937155e-03 +1.625000e+02 1.250000e+01 1.250000e+01 4.803000e-02 3.910166e-03 3.910166e-03 +1.875000e+02 1.250000e+01 1.250000e+01 3.656000e-02 3.191583e-03 3.191583e-03 +2.125000e+02 1.250000e+01 1.250000e+01 2.813000e-02 2.408859e-03 2.408859e-03 +2.375000e+02 1.250000e+01 1.250000e+01 2.274000e-02 1.992210e-03 1.992210e-03 +2.625000e+02 1.250000e+01 1.250000e+01 1.841000e-02 1.659699e-03 1.659699e-03 +2.875000e+02 1.250000e+01 1.250000e+01 1.513000e-02 1.418485e-03 1.418485e-03 +3.125000e+02 1.250000e+01 1.250000e+01 1.158000e-02 1.085265e-03 1.085265e-03 +3.375000e+02 1.250000e+01 1.250000e+01 9.268000e-03 8.899157e-04 8.899157e-04 +3.625000e+02 1.250000e+01 1.250000e+01 7.379000e-03 7.243901e-04 7.243901e-04 +3.875000e+02 1.250000e+01 1.250000e+01 6.205000e-03 5.781600e-04 5.781600e-04 +4.250000e+02 2.500000e+01 2.500000e+01 5.124000e-03 5.034263e-04 5.034263e-04 +4.750000e+02 2.500000e+01 2.500000e+01 3.725000e-03 3.842057e-04 3.842057e-04 +5.375000e+02 3.750000e+01 3.750000e+01 2.615000e-03 2.817339e-04 2.817339e-04 +6.250000e+02 5.000000e+01 5.000000e+01 1.558000e-03 2.384659e-04 2.384659e-04 +7.375000e+02 6.250000e+01 6.250000e+01 7.589000e-04 1.131928e-04 1.131928e-04 +9.000000e+02 1.000000e+02 1.000000e+02 3.637000e-04 6.659812e-05 6.659812e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d23-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d23-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +9.820000e-02 9.820000e-02 9.810000e-02 1.915000e+00 2.496518e-01 2.496518e-01 +2.945000e-01 9.820000e-02 9.820000e-02 2.195000e+00 2.767418e-01 2.767418e-01 +4.909000e-01 9.820000e-02 9.810000e-02 2.610000e+00 3.575528e-01 3.575528e-01 +6.872000e-01 9.820000e-02 9.820000e-02 2.417000e+00 3.213736e-01 3.213736e-01 +8.836000e-01 9.820000e-02 9.810000e-02 2.196000e+00 2.625624e-01 2.625624e-01 +1.079900e+00 9.820000e-02 9.820000e-02 2.347000e+00 2.727013e-01 2.727013e-01 +1.276300e+00 9.820000e-02 9.810000e-02 2.425000e+00 2.782876e-01 2.782876e-01 +1.472600e+00 9.820000e-02 9.820000e-02 2.729000e+00 3.000900e-01 3.000900e-01 +1.669000e+00 9.820000e-02 9.810000e-02 3.067000e+00 3.242761e-01 3.242761e-01 +1.865300e+00 9.820000e-02 9.820000e-02 3.545000e+00 3.574773e-01 3.574773e-01 +2.061700e+00 9.820000e-02 9.810000e-02 4.461000e+00 4.303022e-01 4.303022e-01 +2.258000e+00 9.820000e-02 9.820000e-02 5.312000e+00 4.882151e-01 4.882151e-01 +2.454400e+00 9.820000e-02 9.810000e-02 6.507000e+00 5.542030e-01 5.542030e-01 +2.650700e+00 9.820000e-02 9.820000e-02 7.819000e+00 6.586395e-01 6.586395e-01 +2.847100e+00 9.820000e-02 9.810000e-02 9.165000e+00 7.396256e-01 7.396256e-01 +3.043400e+00 9.820000e-02 9.820000e-02 1.022000e+01 8.213404e-01 8.213404e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d24-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d24-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +5.000000e-01 1.000000e-01 1.000000e-01 1.493000e+00 2.236202e-01 2.236202e-01 +7.000000e-01 1.000000e-01 1.000000e-01 1.730000e+00 2.770289e-01 2.770289e-01 +9.000000e-01 1.000000e-01 1.000000e-01 1.616000e+00 1.921692e-01 1.921692e-01 +1.100000e+00 1.000000e-01 1.000000e-01 1.580000e+00 1.832539e-01 1.832539e-01 +1.300000e+00 1.000000e-01 1.000000e-01 1.631000e+00 1.866387e-01 1.866387e-01 +1.500000e+00 1.000000e-01 1.000000e-01 1.816000e+00 1.937369e-01 1.937369e-01 +1.700000e+00 1.000000e-01 1.000000e-01 2.170000e+00 2.260442e-01 2.260442e-01 +1.900000e+00 1.000000e-01 1.000000e-01 2.303000e+00 2.335487e-01 2.335487e-01 +2.100000e+00 1.000000e-01 1.000000e-01 2.909000e+00 2.854085e-01 2.854085e-01 +2.300000e+00 1.000000e-01 1.000000e-01 3.832000e+00 3.658470e-01 3.658470e-01 +2.500000e+00 1.000000e-01 1.000000e-01 4.582000e+00 4.142970e-01 4.142970e-01 +2.700000e+00 1.000000e-01 1.000000e-01 5.810000e+00 5.048604e-01 5.048604e-01 +2.900000e+00 1.000000e-01 1.000000e-01 6.837000e+00 5.810112e-01 5.810112e-01 +3.100000e+00 1.000000e-01 1.000000e-01 7.669000e+00 6.409126e-01 6.409126e-01 +3.300000e+00 1.000000e-01 1.000000e-01 5.282000e+00 4.694646e-01 4.694646e-01 +3.500000e+00 1.000000e-01 1.000000e-01 3.725000e+00 3.383105e-01 3.383105e-01 +3.700000e+00 1.000000e-01 1.000000e-01 3.042000e+00 3.000333e-01 3.000333e-01 +3.900000e+00 1.000000e-01 1.000000e-01 2.175000e+00 2.315059e-01 2.315059e-01 +4.200000e+00 2.000000e-01 2.000000e-01 1.482000e+00 1.671347e-01 1.671347e-01 +4.600000e+00 2.000000e-01 2.000000e-01 9.128000e-01 1.240522e-01 1.240522e-01 +5.200000e+00 4.000000e-01 4.000000e-01 3.590000e-01 6.027653e-02 6.027653e-02 +6.100000e+00 5.000000e-01 5.000000e-01 7.776000e-02 2.558003e-02 2.558003e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d25-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d25-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 1.339000e-02 2.795174e-03 2.795174e-03 +3.750000e+01 2.500000e+00 2.500000e+00 8.785000e-03 1.651909e-03 1.651909e-03 +4.500000e+01 5.000000e+00 5.000000e+00 4.975000e-03 8.478225e-04 8.478225e-04 +5.500000e+01 5.000000e+00 5.000000e+00 2.343000e-03 4.346930e-04 4.346930e-04 +6.500000e+01 5.000000e+00 5.000000e+00 9.845000e-04 2.660102e-04 2.660102e-04 +7.500000e+01 5.000000e+00 5.000000e+00 3.335000e-04 1.288464e-04 1.288464e-04 +9.000000e+01 1.000000e+01 1.000000e+01 1.022000e-04 5.650398e-05 5.650398e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d26-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d26-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 8.622000e-02 1.547283e-02 1.547283e-02 +8.000000e-01 4.000000e-01 4.000000e-01 8.611000e-02 1.371243e-02 1.371243e-02 +1.600000e+00 4.000000e-01 4.000000e-01 6.767000e-02 1.202327e-02 1.202327e-02 +2.400000e+00 4.000000e-01 4.000000e-01 4.025000e-02 8.963978e-03 8.963978e-03 +3.200000e+00 4.000000e-01 4.000000e-01 1.789000e-02 5.332073e-03 5.332073e-03 +4.000000e+00 4.000000e-01 4.000000e-01 3.581000e-03 3.247247e-03 3.247247e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d27-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d27-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.500000e+01 5.000000e+00 5.000000e+00 7.583000e-03 1.132688e-03 1.132688e-03 +8.500000e+01 5.000000e+00 5.000000e+00 4.919000e-02 7.651072e-03 7.651072e-03 +9.500000e+01 5.000000e+00 5.000000e+00 1.294000e-01 1.721482e-02 1.721482e-02 +1.050000e+02 5.000000e+00 5.000000e+00 2.678000e-01 3.031963e-02 3.031963e-02 +1.150000e+02 5.000000e+00 5.000000e+00 4.936000e-01 4.923769e-02 4.923769e-02 +1.250000e+02 5.000000e+00 5.000000e+00 8.513000e-01 6.746747e-02 6.746747e-02 +1.350000e+02 5.000000e+00 5.000000e+00 8.415000e-01 5.339382e-02 5.339382e-02 +1.450000e+02 5.000000e+00 5.000000e+00 6.205000e-01 3.577541e-02 3.577541e-02 +1.550000e+02 5.000000e+00 5.000000e+00 4.641000e-01 2.636816e-02 2.636816e-02 +1.650000e+02 5.000000e+00 5.000000e+00 3.699000e-01 2.133635e-02 2.133635e-02 +1.750000e+02 5.000000e+00 5.000000e+00 3.019000e-01 1.772738e-02 1.772738e-02 +1.850000e+02 5.000000e+00 5.000000e+00 2.498000e-01 1.462532e-02 1.462532e-02 +1.950000e+02 5.000000e+00 5.000000e+00 2.052000e-01 1.201083e-02 1.201083e-02 +2.100000e+02 1.000000e+01 1.000000e+01 1.563000e-01 9.075241e-03 9.075241e-03 +2.300000e+02 1.000000e+01 1.000000e+01 1.122000e-01 6.568105e-03 6.568105e-03 +2.500000e+02 1.000000e+01 1.000000e+01 8.163000e-02 4.865100e-03 4.865100e-03 +2.700000e+02 1.000000e+01 1.000000e+01 6.077000e-02 3.759415e-03 3.759415e-03 +2.900000e+02 1.000000e+01 1.000000e+01 4.487000e-02 2.727600e-03 2.727600e-03 +3.100000e+02 1.000000e+01 1.000000e+01 3.453000e-02 1.986102e-03 1.986102e-03 +3.300000e+02 1.000000e+01 1.000000e+01 2.748000e-02 1.594522e-03 1.594522e-03 +3.500000e+02 1.000000e+01 1.000000e+01 2.220000e-02 1.372880e-03 1.372880e-03 +3.700000e+02 1.000000e+01 1.000000e+01 1.736000e-02 1.063438e-03 1.063438e-03 +3.900000e+02 1.000000e+01 1.000000e+01 1.424000e-02 8.420808e-04 8.420808e-04 +4.100000e+02 1.000000e+01 1.000000e+01 1.153000e-02 6.860029e-04 6.860029e-04 +4.300000e+02 1.000000e+01 1.000000e+01 9.292000e-03 5.948395e-04 5.948395e-04 +4.500000e+02 1.000000e+01 1.000000e+01 7.597000e-03 4.996299e-04 4.996299e-04 +4.700000e+02 1.000000e+01 1.000000e+01 6.245000e-03 3.982436e-04 3.982436e-04 +4.900000e+02 1.000000e+01 1.000000e+01 5.076000e-03 3.250200e-04 3.250200e-04 +5.150000e+02 1.500000e+01 1.500000e+01 4.229000e-03 2.813006e-04 2.813006e-04 +5.600000e+02 3.000000e+01 3.000000e+01 2.859000e-03 1.939716e-04 1.939716e-04 +6.350000e+02 4.500000e+01 4.500000e+01 1.604000e-03 1.161249e-04 1.161249e-04 +7.400000e+02 6.000000e+01 6.000000e+01 7.837000e-04 5.627264e-05 5.627264e-05 +9.000000e+02 1.000000e+02 1.000000e+02 2.700000e-04 2.715769e-05 2.715769e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d28-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d28-x01-y02 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.500000e+01 5.000000e+00 5.000000e+00 1.988000e+00 1.522432e-01 1.522432e-01 +4.500000e+01 5.000000e+00 5.000000e+00 1.053000e+00 6.818358e-02 6.818358e-02 +5.500000e+01 5.000000e+00 5.000000e+00 6.069000e-01 3.626596e-02 3.626596e-02 +6.500000e+01 5.000000e+00 5.000000e+00 4.533000e-01 2.992741e-02 2.992741e-02 +7.500000e+01 5.000000e+00 5.000000e+00 3.760000e-01 2.591177e-02 2.591177e-02 +8.500000e+01 5.000000e+00 5.000000e+00 2.945000e-01 2.029729e-02 2.029729e-02 +9.500000e+01 5.000000e+00 5.000000e+00 2.270000e-01 1.569267e-02 1.569267e-02 +1.050000e+02 5.000000e+00 5.000000e+00 1.833000e-01 1.298538e-02 1.298538e-02 +1.150000e+02 5.000000e+00 5.000000e+00 1.481000e-01 1.078425e-02 1.078425e-02 +1.250000e+02 5.000000e+00 5.000000e+00 1.200000e-01 8.764702e-03 8.764702e-03 +1.350000e+02 5.000000e+00 5.000000e+00 9.740000e-02 7.087849e-03 7.087849e-03 +1.450000e+02 5.000000e+00 5.000000e+00 8.169000e-02 6.045469e-03 6.045469e-03 +1.550000e+02 5.000000e+00 5.000000e+00 6.719000e-02 5.083788e-03 5.083788e-03 +1.650000e+02 5.000000e+00 5.000000e+00 5.669000e-02 4.381655e-03 4.381655e-03 +1.750000e+02 5.000000e+00 5.000000e+00 4.765000e-02 3.719745e-03 3.719745e-03 +1.850000e+02 5.000000e+00 5.000000e+00 4.016000e-02 3.115253e-03 3.115253e-03 +1.950000e+02 5.000000e+00 5.000000e+00 3.459000e-02 2.634407e-03 2.634407e-03 +2.100000e+02 1.000000e+01 1.000000e+01 2.725000e-02 1.991231e-03 1.991231e-03 +2.300000e+02 1.000000e+01 1.000000e+01 2.021000e-02 1.461267e-03 1.461267e-03 +2.500000e+02 1.000000e+01 1.000000e+01 1.578000e-02 1.177625e-03 1.177625e-03 +2.700000e+02 1.000000e+01 1.000000e+01 1.185000e-02 9.140022e-04 9.140022e-04 +2.900000e+02 1.000000e+01 1.000000e+01 9.436000e-03 7.400932e-04 7.400932e-04 +3.100000e+02 1.000000e+01 1.000000e+01 7.525000e-03 6.122589e-04 6.122589e-04 +3.300000e+02 1.000000e+01 1.000000e+01 5.844000e-03 4.806527e-04 4.806527e-04 +3.500000e+02 1.000000e+01 1.000000e+01 4.500000e-03 3.710377e-04 3.710377e-04 +3.700000e+02 1.000000e+01 1.000000e+01 3.650000e-03 3.090324e-04 3.090324e-04 +3.900000e+02 1.000000e+01 1.000000e+01 2.921000e-03 2.694531e-04 2.694531e-04 +4.200000e+02 2.000000e+01 2.000000e+01 2.237000e-03 1.751000e-04 1.751000e-04 +4.700000e+02 3.000000e+01 3.000000e+01 1.487000e-03 1.264595e-04 1.264595e-04 +5.750000e+02 7.500000e+01 7.500000e+01 6.027000e-04 5.720253e-05 5.720253e-05 +8.250000e+02 1.750000e+02 1.750000e+02 1.181000e-04 1.442255e-05 1.442255e-05 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d01-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d01-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +0.000000e+00 5.000000e-01 5.000000e-01 4.620000e+02 3.300000e+01 3.100000e+01 +1.000000e+00 5.000000e-01 5.000000e-01 6.513000e+01 4.923430e+00 4.923430e+00 +2.000000e+00 5.000000e-01 5.000000e-01 1.436000e+01 1.431850e+00 1.431850e+00 +3.000000e+00 5.000000e-01 5.000000e-01 2.972000e+00 3.850100e-01 3.850100e-01 +4.000000e+00 5.000000e-01 5.000000e-01 6.274000e-01 1.013970e-01 1.013970e-01 +5.000000e+00 5.000000e-01 5.000000e-01 1.327000e-01 2.649230e-02 2.649230e-02 +6.000000e+00 5.000000e-01 5.000000e-01 2.731000e-02 7.134230e-03 7.134230e-03 +7.000000e+00 5.000000e-01 5.000000e-01 6.616000e-03 2.909740e-03 2.909740e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d02-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d02-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 1.410000e-01 1.060472e-02 1.060472e-02 +2.000000e+00 5.000000e-01 5.000000e-01 2.204000e-01 6.884766e-03 6.884766e-03 +3.000000e+00 5.000000e-01 5.000000e-01 2.070000e-01 7.118286e-03 7.118286e-03 +4.000000e+00 5.000000e-01 5.000000e-01 2.111000e-01 8.902809e-03 8.902809e-03 +5.000000e+00 5.000000e-01 5.000000e-01 2.115000e-01 1.461882e-02 1.461882e-02 +6.000000e+00 5.000000e-01 5.000000e-01 2.058000e-01 2.767309e-02 2.767309e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d03-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d03-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +0.000000e+00 5.000000e-01 5.000000e-01 3.967000e+02 7.107039e+00 7.107039e+00 +1.000000e+00 5.000000e-01 5.000000e-01 5.078000e+01 3.533879e+00 3.533879e+00 +2.000000e+00 5.000000e-01 5.000000e-01 1.138000e+01 1.051903e+00 1.051903e+00 +3.000000e+00 5.000000e-01 5.000000e-01 2.344000e+00 2.861695e-01 2.861695e-01 +4.000000e+00 5.000000e-01 5.000000e-01 4.947000e-01 7.667601e-02 7.667601e-02 +5.000000e+00 5.000000e-01 5.000000e-01 1.054000e-01 2.067511e-02 2.067511e-02 +6.000000e+00 5.000000e-01 5.000000e-01 2.069000e-02 5.207591e-03 5.207591e-03 +7.000000e+00 5.000000e-01 5.000000e-01 4.934000e-03 2.411451e-03 2.411451e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d04-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d04-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 1.280000e-01 1.040961e-02 1.040961e-02 +2.000000e+00 5.000000e-01 5.000000e-01 2.242000e-01 7.547847e-03 7.547847e-03 +3.000000e+00 5.000000e-01 5.000000e-01 2.059000e-01 7.479305e-03 7.479305e-03 +4.000000e+00 5.000000e-01 5.000000e-01 2.110000e-01 1.029466e-02 1.029466e-02 +5.000000e+00 5.000000e-01 5.000000e-01 2.130000e-01 1.806156e-02 1.806156e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.964000e-01 3.363391e-02 3.363391e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d05-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d05-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 6.979000e-01 3.171577e-02 3.171577e-02 +2.000000e+00 5.000000e-01 5.000000e-01 7.165000e-01 3.996836e-02 3.996836e-02 +3.000000e+00 5.000000e-01 5.000000e-01 3.579000e-01 2.775356e-02 2.775356e-02 +4.000000e+00 5.000000e-01 5.000000e-01 1.329000e-01 1.574611e-02 1.574611e-02 +5.000000e+00 5.000000e-01 5.000000e-01 3.666000e-02 5.378624e-03 5.378624e-03 +6.000000e+00 5.000000e-01 5.000000e-01 1.252000e-02 2.882655e-03 2.882655e-03 +7.000000e+00 5.000000e-01 5.000000e-01 3.159000e-03 1.424619e-03 1.424619e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d06-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d06-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+00 5.000000e-01 5.000000e-01 1.026600e+00 4.872474e-02 4.872474e-02 +3.000000e+00 5.000000e-01 5.000000e-01 4.995000e-01 2.471315e-02 2.471315e-02 +4.000000e+00 5.000000e-01 5.000000e-01 3.713000e-01 2.708524e-02 2.708524e-02 +5.000000e+00 5.000000e-01 5.000000e-01 2.759000e-01 3.006177e-02 3.006177e-02 +6.000000e+00 5.000000e-01 5.000000e-01 3.416000e-01 6.294442e-02 6.294442e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d07-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d07-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+00 5.000000e-01 5.000000e-01 6.133000e-01 9.951131e-02 9.951131e-02 +3.000000e+00 5.000000e-01 5.000000e-01 1.692000e-01 2.759601e-02 2.759601e-02 +4.000000e+00 5.000000e-01 5.000000e-01 4.217000e-02 8.790722e-03 8.790722e-03 +5.000000e+00 5.000000e-01 5.000000e-01 1.238000e-02 3.641236e-03 3.641236e-03 +6.000000e+00 5.000000e-01 5.000000e-01 1.388000e-03 6.919371e-04 6.919371e-04 +7.000000e+00 5.000000e-01 5.000000e-01 2.739000e-04 3.853260e-04 3.853260e-04 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d08-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d08-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.000000e+00 5.000000e-01 5.000000e-01 2.492000e-01 2.773770e-02 2.773770e-02 +4.000000e+00 5.000000e-01 5.000000e-01 2.936000e-01 6.429380e-02 6.429380e-02 +5.000000e+00 5.000000e-01 5.000000e-01 1.121000e-01 5.456650e-02 5.456650e-02 +6.000000e+00 5.000000e-01 5.000000e-01 1.973000e-01 2.985550e-01 2.985550e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d09-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d09-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 2.586000e+00 2.223263e-01 2.223263e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.943000e+00 1.174819e-01 1.174819e-01 +4.500000e+01 5.000000e+00 5.000000e+00 1.352000e+00 7.128815e-02 7.128815e-02 +5.500000e+01 5.000000e+00 5.000000e+00 8.545000e-01 4.365513e-02 4.365513e-02 +6.500000e+01 5.000000e+00 5.000000e+00 5.660000e-01 2.866426e-02 2.866426e-02 +7.500000e+01 5.000000e+00 5.000000e+00 3.886000e-01 1.977498e-02 1.977498e-02 +9.000000e+01 1.000000e+01 1.000000e+01 2.322000e-01 1.149391e-02 1.149391e-02 +1.100000e+02 1.000000e+01 1.000000e+01 1.211000e-01 5.598214e-03 5.598214e-03 +1.300000e+02 1.000000e+01 1.000000e+01 7.072000e-02 3.348955e-03 3.348955e-03 +1.500000e+02 1.000000e+01 1.000000e+01 4.201000e-02 2.174075e-03 2.174075e-03 +1.700000e+02 1.000000e+01 1.000000e+01 2.586000e-02 1.461130e-03 1.461130e-03 +1.900000e+02 1.000000e+01 1.000000e+01 1.674000e-02 8.949860e-04 8.949860e-04 +2.100000e+02 1.000000e+01 1.000000e+01 1.129000e-02 7.419569e-04 7.419569e-04 +2.350000e+02 1.500000e+01 1.500000e+01 6.464000e-03 5.358545e-04 5.358545e-04 +2.650000e+02 1.500000e+01 1.500000e+01 3.592000e-03 2.766333e-04 2.766333e-04 +2.950000e+02 1.500000e+01 1.500000e+01 2.415000e-03 1.797498e-04 1.797498e-04 +3.250000e+02 1.500000e+01 1.500000e+01 1.646000e-03 1.791926e-04 1.791926e-04 +3.550000e+02 1.500000e+01 1.500000e+01 1.097000e-03 1.208346e-04 1.208346e-04 +3.850000e+02 1.500000e+01 1.500000e+01 6.521000e-04 9.168735e-05 9.168735e-05 +4.250000e+02 2.500000e+01 2.500000e+01 3.180000e-04 4.653977e-05 4.653977e-05 +4.750000e+02 2.500000e+01 2.500000e+01 2.907000e-04 5.653273e-05 5.653273e-05 +5.250000e+02 2.500000e+01 2.500000e+01 1.300000e-04 3.369941e-05 3.369941e-05 +6.250000e+02 7.500000e+01 7.500000e+01 2.368000e-05 1.066501e-05 1.066501e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d10-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d10-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 7.787000e-01 9.245112e-02 9.245112e-02 +3.750000e+01 2.500000e+00 2.500000e+00 5.158000e-01 4.701319e-02 4.701319e-02 +4.500000e+01 5.000000e+00 5.000000e+00 3.111000e-01 2.542617e-02 2.542617e-02 +5.500000e+01 5.000000e+00 5.000000e+00 1.655000e-01 1.193189e-02 1.193189e-02 +6.500000e+01 5.000000e+00 5.000000e+00 9.899000e-02 6.674676e-03 6.674676e-03 +7.500000e+01 5.000000e+00 5.000000e+00 6.326000e-02 4.071302e-03 4.071302e-03 +9.000000e+01 1.000000e+01 1.000000e+01 3.546000e-02 2.221463e-03 2.221463e-03 +1.100000e+02 1.000000e+01 1.000000e+01 1.727000e-02 1.178389e-03 1.178389e-03 +1.300000e+02 1.000000e+01 1.000000e+01 8.826000e-03 6.194715e-04 6.194715e-04 +1.500000e+02 1.000000e+01 1.000000e+01 5.482000e-03 3.825049e-04 3.825049e-04 +1.700000e+02 1.000000e+01 1.000000e+01 3.277000e-03 2.777211e-04 2.777211e-04 +1.900000e+02 1.000000e+01 1.000000e+01 2.016000e-03 2.006614e-04 2.006614e-04 +2.100000e+02 1.000000e+01 1.000000e+01 1.450000e-03 1.540811e-04 1.540811e-04 +2.350000e+02 1.500000e+01 1.500000e+01 9.162000e-04 1.119947e-04 1.119947e-04 +2.650000e+02 1.500000e+01 1.500000e+01 5.238000e-04 7.418167e-05 7.418167e-05 +2.950000e+02 1.500000e+01 1.500000e+01 3.428000e-04 6.801956e-05 6.801956e-05 +3.250000e+02 1.500000e+01 1.500000e+01 2.213000e-04 4.446426e-05 4.446426e-05 +3.700000e+02 3.000000e+01 3.000000e+01 1.154000e-04 3.075142e-05 3.075142e-05 +4.750000e+02 7.500000e+01 7.500000e+01 2.029000e-05 6.693362e-06 6.693362e-06 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d11-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d11-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 2.043000e-01 2.931911e-02 2.931911e-02 +3.750000e+01 2.500000e+00 2.500000e+00 1.220000e-01 1.483139e-02 1.483139e-02 +4.500000e+01 5.000000e+00 5.000000e+00 6.553000e-02 6.857857e-03 6.857857e-03 +5.500000e+01 5.000000e+00 5.000000e+00 3.108000e-02 3.107410e-03 3.107410e-03 +6.500000e+01 5.000000e+00 5.000000e+00 1.635000e-02 1.602654e-03 1.602654e-03 +7.500000e+01 5.000000e+00 5.000000e+00 9.069000e-03 8.344256e-04 8.344256e-04 +9.000000e+01 1.000000e+01 1.000000e+01 4.122000e-03 4.762373e-04 4.762373e-04 +1.100000e+02 1.000000e+01 1.000000e+01 1.334000e-03 2.049659e-04 2.049659e-04 +1.300000e+02 1.000000e+01 1.000000e+01 6.689000e-04 1.137111e-04 1.137111e-04 +1.500000e+02 1.000000e+01 1.000000e+01 3.571000e-04 8.353071e-05 8.353071e-05 +1.800000e+02 2.000000e+01 2.000000e+01 1.224000e-04 3.860181e-05 3.860181e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d12-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d12-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 4.948000e-02 8.505792e-03 8.505792e-03 +3.750000e+01 2.500000e+00 2.500000e+00 2.765000e-02 4.393290e-03 4.393290e-03 +4.500000e+01 5.000000e+00 5.000000e+00 1.263000e-02 1.864966e-03 1.864966e-03 +5.500000e+01 5.000000e+00 5.000000e+00 5.278000e-03 7.221696e-04 7.221696e-04 +6.500000e+01 5.000000e+00 5.000000e+00 2.400000e-03 3.169069e-04 3.169069e-04 +7.500000e+01 5.000000e+00 5.000000e+00 1.373000e-03 1.914497e-04 1.914497e-04 +9.000000e+01 1.000000e+01 1.000000e+01 6.032000e-04 1.247685e-04 1.247685e-04 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d13-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d13-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 2.491000e+00 1.925201e-01 1.925201e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.746000e+00 8.566213e-02 8.566213e-02 +4.500000e+01 5.000000e+00 5.000000e+00 1.121000e+00 4.456456e-02 4.456456e-02 +5.500000e+01 5.000000e+00 5.000000e+00 6.422000e-01 2.355844e-02 2.355844e-02 +6.500000e+01 5.000000e+00 5.000000e+00 3.915000e-01 1.433911e-02 1.433911e-02 +7.500000e+01 5.000000e+00 5.000000e+00 2.520000e-01 9.338094e-03 9.338094e-03 +9.000000e+01 1.000000e+01 1.000000e+01 1.370000e-01 5.334791e-03 5.334791e-03 +1.100000e+02 1.000000e+01 1.000000e+01 6.166000e-02 2.406034e-03 2.406034e-03 +1.300000e+02 1.000000e+01 1.000000e+01 3.235000e-02 1.460000e-03 1.460000e-03 +1.500000e+02 1.000000e+01 1.000000e+01 1.758000e-02 9.632238e-04 9.632238e-04 +1.700000e+02 1.000000e+01 1.000000e+01 1.032000e-02 5.911007e-04 5.911007e-04 +1.900000e+02 1.000000e+01 1.000000e+01 6.455000e-03 4.208575e-04 4.208575e-04 +2.100000e+02 1.000000e+01 1.000000e+01 3.910000e-03 3.780939e-04 3.780939e-04 +2.350000e+02 1.500000e+01 1.500000e+01 1.787000e-03 2.250067e-04 2.250067e-04 +2.650000e+02 1.500000e+01 1.500000e+01 9.798000e-04 1.366025e-04 1.366025e-04 +2.950000e+02 1.500000e+01 1.500000e+01 6.016000e-04 1.008788e-04 1.008788e-04 +3.250000e+02 1.500000e+01 1.500000e+01 3.178000e-04 7.749542e-05 7.749542e-05 +3.700000e+02 3.000000e+01 3.000000e+01 2.133000e-04 5.309972e-05 5.309972e-05 +4.750000e+02 7.500000e+01 7.500000e+01 4.091000e-05 1.436633e-05 1.436633e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d14-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d14-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-02 2.500000e-02 2.500000e-02 2.753000e-03 2.746248e-03 2.746248e-03 +7.500000e-02 2.500000e-02 2.500000e-02 1.372000e-01 2.635337e-02 2.635337e-02 +1.250000e-01 2.500000e-02 2.500000e-02 7.141000e-01 7.447557e-02 7.447557e-02 +1.750000e-01 2.500000e-02 2.500000e-02 1.936000e+00 1.701911e-01 1.701911e-01 +2.250000e-01 2.500000e-02 2.500000e-02 3.644000e+00 2.892698e-01 2.892698e-01 +2.750000e-01 2.500000e-02 2.500000e-02 5.820000e+00 4.761239e-01 4.761239e-01 +3.250000e-01 2.500000e-02 2.500000e-02 8.187000e+00 6.609758e-01 6.609758e-01 +3.750000e-01 2.500000e-02 2.500000e-02 1.046000e+01 8.316850e-01 8.316850e-01 +4.250000e-01 2.500000e-02 2.500000e-02 1.282000e+01 1.029029e+00 1.029029e+00 +4.750000e-01 2.500000e-02 2.500000e-02 1.505000e+01 1.238184e+00 1.238184e+00 +5.250000e-01 2.500000e-02 2.500000e-02 1.728000e+01 1.448447e+00 1.448447e+00 +5.750000e-01 2.500000e-02 2.500000e-02 1.908000e+01 1.648181e+00 1.648181e+00 +6.250000e-01 2.500000e-02 2.500000e-02 2.060000e+01 1.827375e+00 1.827375e+00 +6.750000e-01 2.500000e-02 2.500000e-02 2.205000e+01 2.007909e+00 2.007909e+00 +7.250000e-01 2.500000e-02 2.500000e-02 2.317000e+01 2.157892e+00 2.157892e+00 +7.750000e-01 2.500000e-02 2.500000e-02 2.422000e+01 2.307379e+00 2.307379e+00 +8.250000e-01 2.500000e-02 2.500000e-02 2.489000e+01 2.418160e+00 2.418160e+00 +8.750000e-01 2.500000e-02 2.500000e-02 2.580000e+01 2.548352e+00 2.548352e+00 +9.250000e-01 2.500000e-02 2.500000e-02 2.637000e+01 2.639204e+00 2.639204e+00 +9.750000e-01 2.500000e-02 2.500000e-02 2.646000e+01 2.670300e+00 2.670300e+00 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d15-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d15-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+01 2.000000e+01 2.000000e+01 5.875000e-01 7.932673e-02 7.932673e-02 +6.000000e+01 2.000000e+01 2.000000e+01 7.667000e-01 2.075211e-02 2.075211e-02 +1.000000e+02 2.000000e+01 2.000000e+01 1.859000e-01 2.891366e-03 2.891366e-03 +1.400000e+02 2.000000e+01 2.000000e+01 5.393000e-02 1.041825e-03 1.041825e-03 +1.800000e+02 2.000000e+01 2.000000e+01 1.937000e-02 4.958831e-04 4.958831e-04 +2.200000e+02 2.000000e+01 2.000000e+01 7.824000e-03 2.662743e-04 2.662743e-04 +2.600000e+02 2.000000e+01 2.000000e+01 3.392000e-03 2.003048e-04 2.003048e-04 +3.000000e+02 2.000000e+01 2.000000e+01 1.494000e-03 1.104989e-04 1.104989e-04 +3.400000e+02 2.000000e+01 2.000000e+01 7.038000e-04 6.706855e-05 6.706855e-05 +3.800000e+02 2.000000e+01 2.000000e+01 3.961000e-04 4.828468e-05 4.828468e-05 +4.200000e+02 2.000000e+01 2.000000e+01 2.174000e-04 4.373625e-05 4.373625e-05 +4.600000e+02 2.000000e+01 2.000000e+01 1.165000e-04 2.645714e-05 2.645714e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d16-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d16-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e+01 2.000000e+01 2.000000e+01 4.675000e-01 6.442763e-02 6.442763e-02 +6.000000e+01 2.000000e+01 2.000000e+01 6.369000e-01 1.283783e-02 1.283783e-02 +1.000000e+02 2.000000e+01 2.000000e+01 1.214000e-01 4.290688e-03 4.290688e-03 +1.400000e+02 2.000000e+01 2.000000e+01 2.741000e-02 1.208511e-03 1.208511e-03 +1.800000e+02 2.000000e+01 2.000000e+01 8.802000e-03 4.572374e-04 4.572374e-04 +2.200000e+02 2.000000e+01 2.000000e+01 2.945000e-03 1.981641e-04 1.981641e-04 +2.600000e+02 2.000000e+01 2.000000e+01 1.143000e-03 1.118660e-04 1.118660e-04 +3.000000e+02 2.000000e+01 2.000000e+01 4.466000e-04 7.032560e-05 7.032560e-05 +3.400000e+02 2.000000e+01 2.000000e+01 2.212000e-04 4.751400e-05 4.751400e-05 +3.800000e+02 2.000000e+01 2.000000e+01 8.828000e-05 2.807258e-05 2.807258e-05 +4.200000e+02 2.000000e+01 2.000000e+01 5.946000e-05 2.485501e-05 2.485501e-05 +4.600000e+02 2.000000e+01 2.000000e+01 2.757000e-05 1.508607e-05 1.508607e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d17-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d17-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 3.391000e+01 1.567354e+00 1.567354e+00 +3.000000e-01 1.000000e-01 1.000000e-01 3.284000e+01 1.542077e+00 1.542077e+00 +5.000000e-01 1.000000e-01 1.000000e-01 3.343000e+01 1.595744e+00 1.595744e+00 +7.000000e-01 1.000000e-01 1.000000e-01 3.135000e+01 1.499600e+00 1.499600e+00 +9.000000e-01 1.000000e-01 1.000000e-01 2.930000e+01 1.477024e+00 1.477024e+00 +1.100000e+00 1.000000e-01 1.000000e-01 2.580000e+01 1.380616e+00 1.380616e+00 +1.300000e+00 1.000000e-01 1.000000e-01 2.488000e+01 1.431468e+00 1.431468e+00 +1.500000e+00 1.000000e-01 1.000000e-01 2.186000e+01 1.295068e+00 1.295068e+00 +1.700000e+00 1.000000e-01 1.000000e-01 1.836000e+01 1.108648e+00 1.108648e+00 +1.900000e+00 1.000000e-01 1.000000e-01 1.642000e+01 1.163185e+00 1.163185e+00 +2.100000e+00 1.000000e-01 1.000000e-01 1.403000e+01 1.003095e+00 1.003095e+00 +2.300000e+00 1.000000e-01 1.000000e-01 1.121000e+01 9.211949e-01 9.211949e-01 +2.500000e+00 1.000000e-01 1.000000e-01 8.635000e+00 1.038348e+00 1.038348e+00 +2.700000e+00 1.000000e-01 1.000000e-01 6.830000e+00 1.014738e+00 1.014738e+00 +2.900000e+00 1.000000e-01 1.000000e-01 5.914000e+00 1.167425e+00 1.167425e+00 +3.200000e+00 2.000000e-01 2.000000e-01 3.421000e+00 6.993275e-01 6.993275e-01 +3.600000e+00 2.000000e-01 2.000000e-01 1.462000e+00 3.584118e-01 3.584118e-01 +4.100000e+00 3.000000e-01 3.000000e-01 4.650000e-01 1.814158e-01 1.814158e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d18-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d18-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 6.809000e+00 5.077105e-01 5.077105e-01 +3.000000e-01 1.000000e-01 1.000000e-01 6.581000e+00 4.787849e-01 4.787849e-01 +5.000000e-01 1.000000e-01 1.000000e-01 6.344000e+00 4.578450e-01 4.578450e-01 +7.000000e-01 1.000000e-01 1.000000e-01 6.277000e+00 4.799594e-01 4.799594e-01 +9.000000e-01 1.000000e-01 1.000000e-01 5.946000e+00 4.553120e-01 4.553120e-01 +1.100000e+00 1.000000e-01 1.000000e-01 5.444000e+00 4.512859e-01 4.512859e-01 +1.300000e+00 1.000000e-01 1.000000e-01 5.349000e+00 4.640528e-01 4.640528e-01 +1.500000e+00 1.000000e-01 1.000000e-01 4.834000e+00 4.005421e-01 4.005421e-01 +1.700000e+00 1.000000e-01 1.000000e-01 4.062000e+00 3.636001e-01 3.636001e-01 +1.900000e+00 1.000000e-01 1.000000e-01 3.866000e+00 3.614084e-01 3.614084e-01 +2.100000e+00 1.000000e-01 1.000000e-01 3.319000e+00 3.244873e-01 3.244873e-01 +2.300000e+00 1.000000e-01 1.000000e-01 2.891000e+00 2.936256e-01 2.936256e-01 +2.500000e+00 1.000000e-01 1.000000e-01 2.314000e+00 3.012275e-01 3.012275e-01 +2.700000e+00 1.000000e-01 1.000000e-01 1.962000e+00 2.823367e-01 2.823367e-01 +2.900000e+00 1.000000e-01 1.000000e-01 1.816000e+00 3.218478e-01 3.218478e-01 +3.200000e+00 2.000000e-01 2.000000e-01 1.139000e+00 2.016358e-01 2.016358e-01 +3.600000e+00 2.000000e-01 2.000000e-01 6.153000e-01 1.248029e-01 1.248029e-01 +4.100000e+00 3.000000e-01 3.000000e-01 2.035000e-01 5.505515e-02 5.505515e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d19-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d19-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 1.368000e+00 1.414496e-01 1.414496e-01 +6.000000e-01 2.000000e-01 2.000000e-01 1.294000e+00 1.386939e-01 1.386939e-01 +1.000000e+00 2.000000e-01 2.000000e-01 1.151000e+00 1.293213e-01 1.293213e-01 +1.400000e+00 2.000000e-01 2.000000e-01 9.907000e-01 1.214299e-01 1.214299e-01 +1.800000e+00 2.000000e-01 2.000000e-01 7.888000e-01 1.018169e-01 1.018169e-01 +2.200000e+00 2.000000e-01 2.000000e-01 7.251000e-01 9.703087e-02 9.703087e-02 +2.600000e+00 2.000000e-01 2.000000e-01 4.798000e-01 8.370335e-02 8.370335e-02 +3.000000e+00 2.000000e-01 2.000000e-01 3.664000e-01 7.855890e-02 7.855890e-02 +3.400000e+00 2.000000e-01 2.000000e-01 1.583000e-01 3.383652e-02 3.383652e-02 +3.800000e+00 2.000000e-01 2.000000e-01 8.799000e-02 2.306557e-02 2.306557e-02 +4.200000e+00 2.000000e-01 2.000000e-01 2.615000e-02 1.038927e-02 1.038927e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d20-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d20-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 2.956000e-01 4.512582e-02 4.512582e-02 +8.000000e-01 4.000000e-01 4.000000e-01 2.484000e-01 3.744409e-02 3.744409e-02 +1.600000e+00 4.000000e-01 4.000000e-01 1.957000e-01 3.266405e-02 3.266405e-02 +2.400000e+00 4.000000e-01 4.000000e-01 1.179000e-01 2.146462e-02 2.146462e-02 +3.200000e+00 4.000000e-01 4.000000e-01 5.705000e-02 1.664633e-02 1.664633e-02 +4.000000e+00 4.000000e-01 4.000000e-01 1.033000e-02 3.337514e-03 3.337514e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d21-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d21-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 5.874000e+00 5.142655e-01 5.142655e-01 +6.000000e-01 2.000000e-01 2.000000e-01 5.889000e+00 5.194035e-01 5.194035e-01 +1.000000e+00 2.000000e-01 2.000000e-01 5.179000e+00 4.223778e-01 4.223778e-01 +1.400000e+00 2.000000e-01 2.000000e-01 4.377000e+00 3.535039e-01 3.535039e-01 +1.800000e+00 2.000000e-01 2.000000e-01 3.798000e+00 3.105962e-01 3.105962e-01 +2.200000e+00 2.000000e-01 2.000000e-01 3.145000e+00 2.686522e-01 2.686522e-01 +2.600000e+00 2.000000e-01 2.000000e-01 2.488000e+00 2.374216e-01 2.374216e-01 +3.000000e+00 2.000000e-01 2.000000e-01 1.795000e+00 1.915463e-01 1.915463e-01 +3.400000e+00 2.000000e-01 2.000000e-01 1.301000e+00 1.612638e-01 1.612638e-01 +3.800000e+00 2.000000e-01 2.000000e-01 8.362000e-01 1.193325e-01 1.193325e-01 +4.200000e+00 2.000000e-01 2.000000e-01 5.547000e-01 9.214934e-02 9.214934e-02 +4.600000e+00 2.000000e-01 2.000000e-01 3.204000e-01 6.468392e-02 6.468392e-02 +5.000000e+00 2.000000e-01 2.000000e-01 1.800000e-01 4.200131e-02 4.200131e-02 +5.400000e+00 2.000000e-01 2.000000e-01 1.033000e-01 3.324726e-02 3.324726e-02 +5.800000e+00 2.000000e-01 2.000000e-01 6.334000e-02 2.723200e-02 2.723200e-02 +6.200000e+00 2.000000e-01 2.000000e-01 2.095000e-02 1.183342e-02 1.183342e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d22-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d22-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.250000e+01 1.250000e+01 1.250000e+01 2.312000e-03 7.542533e-04 7.542533e-04 +3.750000e+01 1.250000e+01 1.250000e+01 3.074000e-02 4.631911e-03 4.631911e-03 +6.250000e+01 1.250000e+01 1.250000e+01 5.364000e-02 6.391228e-03 6.391228e-03 +8.750000e+01 1.250000e+01 1.250000e+01 8.316000e-02 8.005923e-03 8.005923e-03 +1.125000e+02 1.250000e+01 1.250000e+01 7.944000e-02 6.677529e-03 6.677529e-03 +1.375000e+02 1.250000e+01 1.250000e+01 6.547000e-02 4.597673e-03 4.597673e-03 +1.625000e+02 1.250000e+01 1.250000e+01 5.144000e-02 4.050321e-03 4.050321e-03 +1.875000e+02 1.250000e+01 1.250000e+01 3.918000e-02 3.175059e-03 3.175059e-03 +2.125000e+02 1.250000e+01 1.250000e+01 3.045000e-02 2.419855e-03 2.419855e-03 +2.375000e+02 1.250000e+01 1.250000e+01 2.371000e-02 1.911361e-03 1.911361e-03 +2.625000e+02 1.250000e+01 1.250000e+01 1.923000e-02 1.534405e-03 1.534405e-03 +2.875000e+02 1.250000e+01 1.250000e+01 1.588000e-02 1.323405e-03 1.323405e-03 +3.125000e+02 1.250000e+01 1.250000e+01 1.261000e-02 1.240363e-03 1.240363e-03 +3.375000e+02 1.250000e+01 1.250000e+01 1.011000e-02 1.036629e-03 1.036629e-03 +3.625000e+02 1.250000e+01 1.250000e+01 8.303000e-03 7.876071e-04 7.876071e-04 +3.875000e+02 1.250000e+01 1.250000e+01 6.940000e-03 6.635804e-04 6.635804e-04 +4.250000e+02 2.500000e+01 2.500000e+01 5.383000e-03 5.342696e-04 5.342696e-04 +4.750000e+02 2.500000e+01 2.500000e+01 4.112000e-03 4.059717e-04 4.059717e-04 +5.375000e+02 3.750000e+01 3.750000e+01 2.946000e-03 3.631281e-04 3.631281e-04 +6.250000e+02 5.000000e+01 5.000000e+01 1.629000e-03 2.166403e-04 2.166403e-04 +7.375000e+02 6.250000e+01 6.250000e+01 8.785000e-04 1.205798e-04 1.205798e-04 +9.000000e+02 1.000000e+02 1.000000e+02 4.519000e-04 8.885325e-05 8.885325e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d23-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d23-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +9.820000e-02 9.820000e-02 9.810000e-02 2.084000e+00 2.927764e-01 2.927764e-01 +2.945000e-01 9.820000e-02 9.820000e-02 2.295000e+00 3.035556e-01 3.035556e-01 +4.909000e-01 9.820000e-02 9.810000e-02 2.744000e+00 3.695673e-01 3.695673e-01 +6.872000e-01 9.820000e-02 9.820000e-02 2.475000e+00 3.189498e-01 3.189498e-01 +8.836000e-01 9.820000e-02 9.810000e-02 2.372000e+00 2.904583e-01 2.904583e-01 +1.079900e+00 9.820000e-02 9.820000e-02 2.411000e+00 2.872682e-01 2.872682e-01 +1.276300e+00 9.820000e-02 9.810000e-02 2.559000e+00 2.871689e-01 2.871689e-01 +1.472600e+00 9.820000e-02 9.820000e-02 2.900000e+00 3.187821e-01 3.187821e-01 +1.669000e+00 9.820000e-02 9.810000e-02 3.365000e+00 3.564309e-01 3.564309e-01 +1.865300e+00 9.820000e-02 9.820000e-02 3.953000e+00 3.941079e-01 3.941079e-01 +2.061700e+00 9.820000e-02 9.810000e-02 4.662000e+00 4.378436e-01 4.378436e-01 +2.258000e+00 9.820000e-02 9.820000e-02 5.712000e+00 4.800375e-01 4.800375e-01 +2.454400e+00 9.820000e-02 9.810000e-02 6.966000e+00 5.433691e-01 5.433691e-01 +2.650700e+00 9.820000e-02 9.820000e-02 8.470000e+00 6.333475e-01 6.333475e-01 +2.847100e+00 9.820000e-02 9.810000e-02 1.012000e+01 7.601316e-01 7.601316e-01 +3.043400e+00 9.820000e-02 9.820000e-02 1.116000e+01 8.312039e-01 8.312039e-01 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d24-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d24-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +5.000000e-01 1.000000e-01 1.000000e-01 1.627000e+00 2.710221e-01 2.710221e-01 +7.000000e-01 1.000000e-01 1.000000e-01 1.825000e+00 2.949797e-01 2.949797e-01 +9.000000e-01 1.000000e-01 1.000000e-01 1.625000e+00 1.998149e-01 1.998149e-01 +1.100000e+00 1.000000e-01 1.000000e-01 1.702000e+00 2.060437e-01 2.060437e-01 +1.300000e+00 1.000000e-01 1.000000e-01 1.776000e+00 1.902236e-01 1.902236e-01 +1.500000e+00 1.000000e-01 1.000000e-01 1.930000e+00 2.059830e-01 2.059830e-01 +1.700000e+00 1.000000e-01 1.000000e-01 2.268000e+00 2.388242e-01 2.388242e-01 +1.900000e+00 1.000000e-01 1.000000e-01 2.568000e+00 2.425655e-01 2.425655e-01 +2.100000e+00 1.000000e-01 1.000000e-01 3.204000e+00 3.017184e-01 3.017184e-01 +2.300000e+00 1.000000e-01 1.000000e-01 3.941000e+00 3.336885e-01 3.336885e-01 +2.500000e+00 1.000000e-01 1.000000e-01 4.870000e+00 3.969093e-01 3.969093e-01 +2.700000e+00 1.000000e-01 1.000000e-01 5.935000e+00 4.854081e-01 4.854081e-01 +2.900000e+00 1.000000e-01 1.000000e-01 7.594000e+00 5.936379e-01 5.936379e-01 +3.100000e+00 1.000000e-01 1.000000e-01 8.249000e+00 6.290413e-01 6.290413e-01 +3.300000e+00 1.000000e-01 1.000000e-01 5.626000e+00 4.476304e-01 4.476304e-01 +3.500000e+00 1.000000e-01 1.000000e-01 4.086000e+00 3.360372e-01 3.360372e-01 +3.700000e+00 1.000000e-01 1.000000e-01 3.133000e+00 2.851193e-01 2.851193e-01 +3.900000e+00 1.000000e-01 1.000000e-01 2.445000e+00 2.401895e-01 2.401895e-01 +4.200000e+00 2.000000e-01 2.000000e-01 1.705000e+00 1.845047e-01 1.845047e-01 +4.600000e+00 2.000000e-01 2.000000e-01 9.869000e-01 1.328231e-01 1.328231e-01 +5.200000e+00 4.000000e-01 4.000000e-01 3.909000e-01 6.577211e-02 6.577211e-02 +6.100000e+00 5.000000e-01 5.000000e-01 9.876000e-02 2.956853e-02 2.956853e-02 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d25-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d25-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.250000e+01 2.500000e+00 2.500000e+00 1.371000e-02 2.895617e-03 2.895617e-03 +3.750000e+01 2.500000e+00 2.500000e+00 9.508000e-03 1.594161e-03 1.594161e-03 +4.500000e+01 5.000000e+00 5.000000e+00 5.455000e-03 8.459320e-04 8.459320e-04 +5.500000e+01 5.000000e+00 5.000000e+00 2.759000e-03 4.761628e-04 4.761628e-04 +6.500000e+01 5.000000e+00 5.000000e+00 1.456000e-03 2.389017e-04 2.389017e-04 +7.500000e+01 5.000000e+00 5.000000e+00 7.422000e-04 1.482037e-04 1.482037e-04 +9.000000e+01 1.000000e+01 1.000000e+01 2.734000e-04 8.295457e-05 8.295457e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d26-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d26-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.000000e-01 2.000000e-01 2.000000e-01 9.558000e-02 1.555369e-02 1.555369e-02 +8.000000e-01 4.000000e-01 4.000000e-01 9.710000e-02 1.412747e-02 1.412747e-02 +1.600000e+00 4.000000e-01 4.000000e-01 6.568000e-02 1.153096e-02 1.153096e-02 +2.400000e+00 4.000000e-01 4.000000e-01 4.423000e-02 9.734516e-03 9.734516e-03 +3.200000e+00 4.000000e-01 4.000000e-01 2.224000e-02 6.762307e-03 6.762307e-03 +4.000000e+00 4.000000e-01 4.000000e-01 4.977000e-03 2.256056e-03 2.256056e-03 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d27-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d27-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.500000e+01 5.000000e+00 5.000000e+00 7.685000e-03 1.181042e-03 1.181042e-03 +8.500000e+01 5.000000e+00 5.000000e+00 4.863000e-02 6.324405e-03 6.324405e-03 +9.500000e+01 5.000000e+00 5.000000e+00 1.350000e-01 1.578417e-02 1.578417e-02 +1.050000e+02 5.000000e+00 5.000000e+00 2.850000e-01 3.140366e-02 3.140366e-02 +1.150000e+02 5.000000e+00 5.000000e+00 5.212000e-01 4.919411e-02 4.919411e-02 +1.250000e+02 5.000000e+00 5.000000e+00 9.072000e-01 6.740460e-02 6.740460e-02 +1.350000e+02 5.000000e+00 5.000000e+00 8.972000e-01 4.996939e-02 4.996939e-02 +1.450000e+02 5.000000e+00 5.000000e+00 6.505000e-01 3.009335e-02 3.009335e-02 +1.550000e+02 5.000000e+00 5.000000e+00 4.920000e-01 2.246998e-02 2.246998e-02 +1.650000e+02 5.000000e+00 5.000000e+00 3.935000e-01 1.893568e-02 1.893568e-02 +1.750000e+02 5.000000e+00 5.000000e+00 3.220000e-01 1.553609e-02 1.553609e-02 +1.850000e+02 5.000000e+00 5.000000e+00 2.652000e-01 1.272360e-02 1.272360e-02 +1.950000e+02 5.000000e+00 5.000000e+00 2.179000e-01 1.082312e-02 1.082312e-02 +2.100000e+02 1.000000e+01 1.000000e+01 1.670000e-01 8.777813e-03 8.777813e-03 +2.300000e+02 1.000000e+01 1.000000e+01 1.171000e-01 6.186275e-03 6.186275e-03 +2.500000e+02 1.000000e+01 1.000000e+01 8.563000e-02 4.376802e-03 4.376802e-03 +2.700000e+02 1.000000e+01 1.000000e+01 6.431000e-02 3.197218e-03 3.197218e-03 +2.900000e+02 1.000000e+01 1.000000e+01 4.879000e-02 2.423840e-03 2.423840e-03 +3.100000e+02 1.000000e+01 1.000000e+01 3.769000e-02 1.803912e-03 1.803912e-03 +3.300000e+02 1.000000e+01 1.000000e+01 2.980000e-02 1.441319e-03 1.441319e-03 +3.500000e+02 1.000000e+01 1.000000e+01 2.383000e-02 1.202747e-03 1.202747e-03 +3.700000e+02 1.000000e+01 1.000000e+01 1.929000e-02 9.916148e-04 9.916148e-04 +3.900000e+02 1.000000e+01 1.000000e+01 1.544000e-02 8.514693e-04 8.514693e-04 +4.100000e+02 1.000000e+01 1.000000e+01 1.260000e-02 7.441102e-04 7.441102e-04 +4.300000e+02 1.000000e+01 1.000000e+01 1.017000e-02 6.126989e-04 6.126989e-04 +4.500000e+02 1.000000e+01 1.000000e+01 8.413000e-03 5.279451e-04 5.279451e-04 +4.700000e+02 1.000000e+01 1.000000e+01 6.789000e-03 4.254445e-04 4.254445e-04 +4.900000e+02 1.000000e+01 1.000000e+01 5.444000e-03 3.084283e-04 3.084283e-04 +5.150000e+02 1.500000e+01 1.500000e+01 4.455000e-03 2.242967e-04 2.242967e-04 +5.600000e+02 3.000000e+01 3.000000e+01 3.165000e-03 1.766494e-04 1.766494e-04 +6.350000e+02 4.500000e+01 4.500000e+01 1.713000e-03 1.124322e-04 1.124322e-04 +7.400000e+02 6.000000e+01 6.000000e+01 8.514000e-04 6.004423e-05 6.004423e-05 +9.000000e+02 1.000000e+02 1.000000e+02 2.825000e-04 2.661466e-05 2.661466e-05 +END YODA_SCATTER2D_V2 + +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2013_I1230812/d28-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2013_I1230812/d28-x01-y03 +Title: ~ +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +3.500000e+01 5.000000e+00 5.000000e+00 2.107000e+00 1.482194e-01 1.482194e-01 +4.500000e+01 5.000000e+00 5.000000e+00 1.118000e+00 6.220129e-02 6.220129e-02 +5.500000e+01 5.000000e+00 5.000000e+00 6.449000e-01 3.297545e-02 3.297545e-02 +6.500000e+01 5.000000e+00 5.000000e+00 4.782000e-01 2.802945e-02 2.802945e-02 +7.500000e+01 5.000000e+00 5.000000e+00 4.003000e-01 2.520179e-02 2.520179e-02 +8.500000e+01 5.000000e+00 5.000000e+00 3.137000e-01 1.969289e-02 1.969289e-02 +9.500000e+01 5.000000e+00 5.000000e+00 2.425000e-01 1.499700e-02 1.499700e-02 +1.050000e+02 5.000000e+00 5.000000e+00 1.926000e-01 1.209173e-02 1.209173e-02 +1.150000e+02 5.000000e+00 5.000000e+00 1.564000e-01 1.037931e-02 1.037931e-02 +1.250000e+02 5.000000e+00 5.000000e+00 1.275000e-01 8.576130e-03 8.576130e-03 +1.350000e+02 5.000000e+00 5.000000e+00 1.055000e-01 6.972087e-03 6.972087e-03 +1.450000e+02 5.000000e+00 5.000000e+00 8.702000e-02 5.663435e-03 5.663435e-03 +1.550000e+02 5.000000e+00 5.000000e+00 7.271000e-02 4.670632e-03 4.670632e-03 +1.650000e+02 5.000000e+00 5.000000e+00 6.180000e-02 3.965363e-03 3.965363e-03 +1.750000e+02 5.000000e+00 5.000000e+00 5.081000e-02 3.308081e-03 3.308081e-03 +1.850000e+02 5.000000e+00 5.000000e+00 4.368000e-02 2.975853e-03 2.975853e-03 +1.950000e+02 5.000000e+00 5.000000e+00 3.766000e-02 2.658082e-03 2.658082e-03 +2.100000e+02 1.000000e+01 1.000000e+01 2.997000e-02 2.210543e-03 2.210543e-03 +2.300000e+02 1.000000e+01 1.000000e+01 2.188000e-02 1.652786e-03 1.652786e-03 +2.500000e+02 1.000000e+01 1.000000e+01 1.657000e-02 1.144246e-03 1.144246e-03 +2.700000e+02 1.000000e+01 1.000000e+01 1.285000e-02 8.324662e-04 8.324662e-04 +2.900000e+02 1.000000e+01 1.000000e+01 9.974000e-03 6.537561e-04 6.537561e-04 +3.100000e+02 1.000000e+01 1.000000e+01 8.222000e-03 5.708502e-04 5.708502e-04 +3.300000e+02 1.000000e+01 1.000000e+01 6.500000e-03 4.522400e-04 4.522400e-04 +3.500000e+02 1.000000e+01 1.000000e+01 5.267000e-03 3.866588e-04 3.866588e-04 +3.700000e+02 1.000000e+01 1.000000e+01 4.037000e-03 3.112973e-04 3.112973e-04 +3.900000e+02 1.000000e+01 1.000000e+01 3.399000e-03 2.744012e-04 2.744012e-04 +4.200000e+02 2.000000e+01 2.000000e+01 2.473000e-03 1.686179e-04 1.686179e-04 +4.700000e+02 3.000000e+01 3.000000e+01 1.625000e-03 1.309847e-04 1.309847e-04 +5.750000e+02 7.500000e+01 7.500000e+01 6.772000e-04 5.565007e-05 5.565007e-05 +8.250000e+02 1.750000e+02 1.750000e+02 1.373000e-04 1.430420e-05 1.430420e-05 +END YODA_SCATTER2D_V2 diff --git a/analyses/pluginATLAS/ATLAS_2017_I1589844.cc b/analyses/pluginATLAS/ATLAS_2017_I1589844.cc --- a/analyses/pluginATLAS/ATLAS_2017_I1589844.cc +++ b/analyses/pluginATLAS/ATLAS_2017_I1589844.cc @@ -1,166 +1,166 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/FinalState.hh" #include "Rivet/Projections/IdentifiedFinalState.hh" #include "Rivet/Projections/DressedLeptons.hh" #include "Rivet/Projections/FastJets.hh" #include "Rivet/Projections/VetoedFinalState.hh" #include "Rivet/Projections/ChargedFinalState.hh" namespace Rivet { /// kT splittings in Z events at 8 TeV class ATLAS_2017_I1589844 : public Analysis { public: /// @name Constructors etc. //@{ /// Constructors - ATLAS_2017_I1589844(string name="ATLAS_2017_I1589844") : Analysis(name) { - _mode = 1; // pick electron channel by default + ATLAS_2017_I1589844(const string name="ATLAS_2017_I1589844", size_t channel = 0, + const string ref_data="ATLAS_2017_I1589844") : Analysis(name) { + _mode = channel; // pick electron channel by default + setRefDataName(ref_data); setNeedsCrossSection(true); } //@} /// @name Analysis methods //@{ /// Book histograms and initialise projections before the run void init() { const FinalState fs; const Cut cuts = (_mode) ? - Cuts::pT > 25*GeV && (Cuts::abseta <= 1.37 || (Cuts::abseta >= 1.52 && Cuts::abseta < 2.47)) : //< electron channel version - (Cuts::pT > 25*GeV) && (Cuts::abseta < 2.4); //< muon channel version + (Cuts::pT > 25*GeV) && (Cuts::abseta < 2.4) : //< muon channel version + Cuts::pT > 25*GeV && (Cuts::abseta <= 1.37 || (Cuts::abseta >= 1.52 && Cuts::abseta < 2.47)); //< electron channel version IdentifiedFinalState bareleptons(fs); - bareleptons.acceptIdPair(_mode? PID::ELECTRON : PID::MUON); + bareleptons.acceptIdPair(_mode? PID::MUON : PID::ELECTRON); const DressedLeptons leptons(fs, bareleptons, 0.1, cuts, true); declare(leptons, "leptons"); const ChargedFinalState cfs(Cuts::abseta < 2.5 && Cuts::pT > 0.4*GeV); VetoedFinalState jet_fs(cfs); jet_fs.addVetoOnThisFinalState(leptons); declare(FastJets(jet_fs, FastJets::KT, 0.4), "Kt04Jets"); declare(FastJets(jet_fs, FastJets::KT, 1.0), "Kt10Jets"); VetoedFinalState jet_fs_all(Cuts::abseta < 2.5 && Cuts::pT > 0.4*GeV); jet_fs_all.addVetoOnThisFinalState(leptons); FastJets jetpro04_all(jet_fs_all, FastJets::KT, 0.4); jetpro04_all.useInvisibles(); declare(jetpro04_all, "Kt04Jets_all"); FastJets jetpro10_all(jet_fs_all, FastJets::KT, 1.0); jetpro10_all.useInvisibles(); declare(jetpro10_all, "Kt10Jets_all"); // Histograms with data binning _ndij = 8; for (size_t i = 0; i < _ndij; ++i) { string label = "d" + to_str(i) + "_kT4"; _h[label] = bookHisto1D(i + 1, 1, _mode + 1); _h[label + "_all"] = bookHisto1D(i + 1, 1, _mode + 5); label = "d" + to_str(i) + "_kT10"; _h[label] = bookHisto1D(i + 1, 1, _mode + 3); _h[label + "_all"] = bookHisto1D(i + 1, 1, _mode + 7); } } /// Perform the per-event analysis void analyze(const Event& e) { // Check we have a Z candidate: const vector& leptons = apply(e, "leptons").dressedLeptons(); if (leptons.size() != 2) vetoEvent; if (leptons[0].charge3()*leptons[1].charge3() > 0) vetoEvent; const double dilepton_mass = (leptons[0].momentum() + leptons[1].momentum()).mass(); if (!inRange(dilepton_mass, 71*GeV, 111*GeV)) vetoEvent; const double weight = e.weight(); // Get kT splitting scales (charged particles only) const FastJets& jetpro04 = applyProjection(e, "Kt04Jets"); const shared_ptr seq04 = jetpro04.clusterSeq(); for (size_t i = 0; i < min(_ndij, (size_t)seq04->n_particles()); ++i) { const double dij = sqrt(seq04->exclusive_dmerge_max(i))/GeV; if (dij <= 0.0) continue; const string label = "d" + to_str(i) + "_kT4"; _h[label]->fill(dij, weight); } const FastJets& jetpro10 = applyProjection(e, "Kt10Jets"); const shared_ptr seq10 = jetpro10.clusterSeq(); for (size_t i = 0; i < min(_ndij, (size_t)seq10->n_particles()); ++i) { const double dij = sqrt(seq10->exclusive_dmerge_max(i))/GeV; if (dij <= 0.0) continue; const string label = "d" + to_str(i) + "_kT10"; _h[label]->fill(dij, weight); } // Get kT splitting scales (all particles) const FastJets& jetpro04_all = applyProjection(e, "Kt04Jets_all"); const shared_ptr seq04_all = jetpro04_all.clusterSeq(); for (size_t i = 0; i < min(_ndij, (size_t)seq04_all->n_particles()); ++i) { const double dij = sqrt(seq04_all->exclusive_dmerge_max(i))/GeV; if (dij <= 0.0) continue; const string label = "d" + to_str(i) + "_kT4_all"; _h[label]->fill(dij, weight); } const FastJets& jetpro10_all = applyProjection(e, "Kt10Jets_all"); const shared_ptr seq10_all = jetpro10_all.clusterSeq(); for (size_t i = 0; i < min(_ndij, (size_t)seq10_all->n_particles()); ++i) { const double dij = sqrt(seq10_all->exclusive_dmerge_max(i))/GeV; if (dij <= 0.0) continue; const string label = "d" + to_str(i) + "_kT10_all"; _h[label]->fill(dij, weight); } } /// Normalise histograms etc., after the run void finalize() { const double sf = crossSectionPerEvent(); for (auto& kv : _h) scale(kv.second, sf); } //@} protected: // Data members like post-cuts event weight counters go here size_t _mode, _ndij; private: // Histograms map _h; }; // The hook for the plugin system DECLARE_RIVET_PLUGIN(ATLAS_2017_I1589844); /// kT splittings in Z events at 8 TeV (electron channel) struct ATLAS_2017_I1589844_EL : public ATLAS_2017_I1589844 { - ATLAS_2017_I1589844_EL() : ATLAS_2017_I1589844("ATLAS_2017_I1589844_EL") { _mode = 1; } + ATLAS_2017_I1589844_EL() : ATLAS_2017_I1589844("ATLAS_2017_I1589844_EL", 0) { } }; DECLARE_RIVET_PLUGIN(ATLAS_2017_I1589844_EL); /// kT splittings in Z events at 8 TeV (muon channel) struct ATLAS_2017_I1589844_MU : public ATLAS_2017_I1589844 { - ATLAS_2017_I1589844_MU() : ATLAS_2017_I1589844("ATLAS_2017_I1589844_MU") { _mode = 0; } + ATLAS_2017_I1589844_MU() : ATLAS_2017_I1589844("ATLAS_2017_I1589844_MU", 1) { } }; DECLARE_RIVET_PLUGIN(ATLAS_2017_I1589844_MU); - - } diff --git a/analyses/pluginATLAS/ATLAS_2017_I1589844.yoda b/analyses/pluginATLAS/ATLAS_2017_I1589844.yoda --- a/analyses/pluginATLAS/ATLAS_2017_I1589844.yoda +++ b/analyses/pluginATLAS/ATLAS_2017_I1589844.yoda @@ -1,911 +1,1760 @@ +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d01-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t1 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.843191e+01 7.457050e-01 7.457050e-01 +1.300520e+00 1.120180e-01 1.120180e-01 2.441937e+01 8.251125e-01 8.251125e-01 +1.545671e+00 1.331330e-01 1.331330e-01 3.066112e+01 1.114318e+00 1.114318e+00 +1.837033e+00 1.582290e-01 1.582290e-01 4.064066e+01 1.394752e+00 1.394752e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.727946e+01 1.525490e+00 1.525490e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.446314e+01 1.778924e+00 1.778924e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.806647e+01 1.920201e+00 1.920201e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.538682e+01 1.723713e+00 1.723713e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.033783e+01 1.566466e+00 1.566466e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.086573e+01 1.290886e+00 1.290886e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.126881e+01 9.824324e-01 9.824324e-01 +7.313360e+00 6.299215e-01 6.299215e-01 2.267270e+01 7.502458e-01 7.502458e-01 +8.691945e+00 7.486635e-01 7.486635e-01 1.607494e+01 5.400484e-01 5.400484e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.169971e+01 4.021634e-01 4.021634e-01 +1.227769e+01 1.057515e+00 1.057515e+00 8.472988e+00 2.986059e-01 2.986059e-01 +1.459207e+01 1.256860e+00 1.256860e+00 5.892089e+00 2.098366e-01 2.098366e-01 +1.734271e+01 1.493780e+00 1.493780e+00 4.366320e+00 1.600385e-01 1.600385e-01 +2.061185e+01 1.775360e+00 1.775360e+00 3.112279e+00 1.174748e-01 1.174748e-01 +2.449723e+01 2.110020e+00 2.110020e+00 2.240750e+00 8.717211e-02 8.717211e-02 +2.911501e+01 2.507765e+00 2.507765e+00 1.534069e+00 6.318951e-02 6.318951e-02 +3.460326e+01 2.980480e+00 2.980480e+00 1.030531e+00 4.402922e-02 4.402922e-02 +4.112605e+01 3.542310e+00 3.542310e+00 6.834079e-01 2.963892e-02 2.963892e-02 +4.887840e+01 4.210040e+00 4.210040e+00 4.320688e-01 1.918555e-02 1.918555e-02 +5.809208e+01 5.003645e+00 5.003645e+00 2.666526e-01 1.245923e-02 1.245923e-02 +6.904257e+01 5.946845e+00 5.946845e+00 1.671143e-01 8.250283e-03 8.250283e-03 +8.205725e+01 7.067835e+00 7.067835e+00 9.339255e-02 4.677413e-03 4.677413e-03 +9.752524e+01 8.400155e+00 8.400155e+00 5.411575e-02 2.824554e-03 2.824554e-03 +1.159090e+02 9.983550e+00 9.983550e+00 2.782189e-02 1.487392e-03 1.487392e-03 +1.377580e+02 1.186555e+01 1.186555e+01 1.514939e-02 8.451217e-04 8.451217e-04 +1.961423e+02 4.651870e+01 4.651870e+01 4.275534e-03 2.531246e-04 2.531246e-04 +6.213305e+02 3.786695e+02 3.786695e+02 8.432581e-05 9.408548e-06 9.408548e-06 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d01-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t1 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.843191e+01 7.457050e-01 7.457050e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.441937e+01 8.251125e-01 8.251125e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.066112e+01 1.114318e+00 1.114318e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.064066e+01 1.394752e+00 1.394752e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.727946e+01 1.525491e+00 1.525491e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.446314e+01 1.778923e+00 1.778923e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.806647e+01 1.920201e+00 1.920201e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.538682e+01 1.723712e+00 1.723712e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.033783e+01 1.566466e+00 1.566466e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.086573e+01 1.290886e+00 1.290886e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.126881e+01 9.824325e-01 9.824325e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.267270e+01 7.502458e-01 7.502458e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.607494e+01 5.400483e-01 5.400483e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.169971e+01 4.021634e-01 4.021634e-01 -1.227770e+01 1.057515e+00 1.057515e+00 8.472988e+00 2.986058e-01 2.986058e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.892089e+00 2.098366e-01 2.098366e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.366320e+00 1.600385e-01 1.600385e-01 -2.061185e+01 1.775360e+00 1.775360e+00 3.112279e+00 1.174748e-01 1.174748e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.240750e+00 8.717211e-02 8.717211e-02 -2.911501e+01 2.507763e+00 2.507763e+00 1.534069e+00 6.318952e-02 6.318952e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.030531e+00 4.402922e-02 4.402922e-02 -4.112605e+01 3.542309e+00 3.542309e+00 6.834079e-01 2.963892e-02 2.963892e-02 -4.887840e+01 4.210043e+00 4.210043e+00 4.320688e-01 1.918555e-02 1.918555e-02 -5.809209e+01 5.003645e+00 5.003645e+00 2.666526e-01 1.245923e-02 1.245923e-02 -6.904258e+01 5.946843e+00 5.946843e+00 1.671143e-01 8.250283e-03 8.250283e-03 -8.205726e+01 7.067836e+00 7.067836e+00 9.339255e-02 4.677413e-03 4.677413e-03 -9.752523e+01 8.400139e+00 8.400139e+00 5.411575e-02 2.824555e-03 2.824555e-03 -1.159090e+02 9.983584e+00 9.983584e+00 2.782189e-02 1.487392e-03 1.487392e-03 -1.377581e+02 1.186551e+01 1.186551e+01 1.514939e-02 8.451217e-04 8.451217e-04 -1.961423e+02 4.651872e+01 4.651872e+01 4.275534e-03 2.531246e-04 2.531246e-04 -6.213305e+02 3.786695e+02 3.786695e+02 8.432581e-05 9.408547e-06 9.408547e-06 +1.094251e+00 9.425100e-02 9.425100e-02 2.001881e+01 8.542031e-01 8.542031e-01 +1.300520e+00 1.120180e-01 1.120180e-01 2.503687e+01 9.964634e-01 9.964634e-01 +1.545671e+00 1.331330e-01 1.331330e-01 3.368826e+01 1.299874e+00 1.299874e+00 +1.837033e+00 1.582290e-01 1.582290e-01 4.361032e+01 1.675156e+00 1.675156e+00 +2.183318e+00 1.880560e-01 1.880560e-01 5.149622e+01 1.938156e+00 1.938156e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.916733e+01 2.262821e+00 2.262821e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.326609e+01 2.458391e+00 2.458391e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.151831e+01 2.368061e+00 2.368061e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.472291e+01 2.129044e+00 2.129044e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.501374e+01 1.769908e+00 1.769908e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.417391e+01 1.383434e+00 1.383434e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.476525e+01 1.039816e+00 1.039816e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.794647e+01 7.442781e-01 7.442781e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.257154e+01 5.312211e-01 5.312211e-01 +1.227769e+01 1.057515e+00 1.057515e+00 9.130719e+00 3.900949e-01 3.900949e-01 +1.459207e+01 1.256860e+00 1.256860e+00 6.698984e+00 2.908222e-01 2.908222e-01 +1.734271e+01 1.493780e+00 1.493780e+00 4.848903e+00 2.140939e-01 2.140939e-01 +2.061185e+01 1.775360e+00 1.775360e+00 3.406882e+00 1.522475e-01 1.522475e-01 +2.449723e+01 2.110020e+00 2.110020e+00 2.432900e+00 1.099745e-01 1.099745e-01 +2.911501e+01 2.507765e+00 2.507765e+00 1.681932e+00 7.690784e-02 7.690784e-02 +3.460326e+01 2.980480e+00 2.980480e+00 1.155452e+00 5.351801e-02 5.351801e-02 +4.112605e+01 3.542310e+00 3.542310e+00 7.403272e-01 3.502677e-02 3.502677e-02 +4.887840e+01 4.210040e+00 4.210040e+00 4.881657e-01 2.336117e-02 2.336117e-02 +5.809208e+01 5.003645e+00 5.003645e+00 2.975893e-01 1.473468e-02 1.473468e-02 +6.904257e+01 5.946845e+00 5.946845e+00 1.781893e-01 9.064168e-03 9.064168e-03 +8.205725e+01 7.067835e+00 7.067835e+00 1.077474e-01 5.755423e-03 5.755423e-03 +9.752524e+01 8.400155e+00 8.400155e+00 6.013528e-02 3.397228e-03 3.397228e-03 +1.159090e+02 9.983550e+00 9.983550e+00 3.325420e-02 2.044038e-03 2.044038e-03 +1.377580e+02 1.186555e+01 1.186555e+01 1.926208e-02 1.337110e-03 1.337110e-03 +1.961423e+02 4.651870e+01 4.651870e+01 5.196224e-03 4.922186e-04 4.922186e-04 +6.213305e+02 3.786695e+02 3.786695e+02 1.242681e-04 5.732324e-05 5.732324e-05 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d01-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t1 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 8.131834e+00 4.490678e-01 4.490678e-01 +1.300520e+00 1.120180e-01 1.120180e-01 1.009730e+01 4.073898e-01 4.073898e-01 +1.545671e+00 1.331330e-01 1.331330e-01 1.143915e+01 5.885725e-01 5.885725e-01 +1.837033e+00 1.582290e-01 1.582290e-01 1.466143e+01 5.944605e-01 5.944605e-01 +2.183318e+00 1.880560e-01 1.880560e-01 1.782742e+01 6.701411e-01 6.701411e-01 +2.594879e+00 2.235045e-01 2.235045e-01 2.082979e+01 7.277524e-01 7.277524e-01 +3.084018e+00 2.656355e-01 2.656355e-01 2.538012e+01 9.136748e-01 9.136748e-01 +3.665363e+00 3.157090e-01 3.157090e-01 2.791683e+01 9.391385e-01 9.391385e-01 +4.356293e+00 3.752205e-01 3.752205e-01 3.061612e+01 9.748082e-01 9.748082e-01 +5.177463e+00 4.459500e-01 4.459500e-01 3.145211e+01 9.928744e-01 9.928744e-01 +6.153426e+00 5.300130e-01 5.300130e-01 3.162385e+01 9.857417e-01 9.857417e-01 +7.313360e+00 6.299215e-01 6.299215e-01 2.929418e+01 9.115539e-01 9.115539e-01 +8.691945e+00 7.486635e-01 7.486635e-01 2.545845e+01 8.282911e-01 8.282911e-01 +1.033039e+01 8.897855e-01 8.897855e-01 2.103254e+01 6.742779e-01 6.742779e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.604205e+01 5.290447e-01 5.290447e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.130196e+01 3.864420e-01 3.864420e-01 +1.734271e+01 1.493780e+00 1.493780e+00 7.816633e+00 2.789999e-01 2.789999e-01 +2.061185e+01 1.775360e+00 1.775360e+00 5.245804e+00 1.959936e-01 1.959936e-01 +2.449723e+01 2.110020e+00 2.110020e+00 3.466486e+00 1.362328e-01 1.362328e-01 +2.911501e+01 2.507765e+00 2.507765e+00 2.335649e+00 9.715039e-02 9.715039e-02 +3.460326e+01 2.980480e+00 2.980480e+00 1.476691e+00 6.452457e-02 6.452457e-02 +4.112605e+01 3.542310e+00 3.542310e+00 9.501897e-01 4.261564e-02 4.261564e-02 +4.887840e+01 4.210040e+00 4.210040e+00 5.877472e-01 2.727143e-02 2.727143e-02 +5.809208e+01 5.003645e+00 5.003645e+00 3.522312e-01 1.736717e-02 1.736717e-02 +6.904257e+01 5.946845e+00 5.946845e+00 2.218414e-01 1.140433e-02 1.140433e-02 +8.205725e+01 7.067835e+00 7.067835e+00 1.251722e-01 6.452849e-03 6.452849e-03 +9.752524e+01 8.400155e+00 8.400155e+00 6.951626e-02 3.670085e-03 3.670085e-03 +1.159090e+02 9.983550e+00 9.983550e+00 3.751489e-02 2.146711e-03 2.146711e-03 +1.377580e+02 1.186555e+01 1.186555e+01 2.007446e-02 1.180381e-03 1.180381e-03 +1.961423e+02 4.651870e+01 4.651870e+01 5.355213e-03 3.426689e-04 3.426689e-04 +6.213305e+02 3.786695e+02 3.786695e+02 1.064601e-04 1.463478e-05 1.463478e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d01-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t1 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.131834e+00 4.490677e-01 4.490677e-01 -1.300520e+00 1.120177e-01 1.120177e-01 1.009730e+01 4.073897e-01 4.073897e-01 -1.545671e+00 1.331332e-01 1.331332e-01 1.143915e+01 5.885724e-01 5.885724e-01 -1.837033e+00 1.582291e-01 1.582291e-01 1.466143e+01 5.944605e-01 5.944605e-01 -2.183318e+00 1.880557e-01 1.880557e-01 1.782742e+01 6.701411e-01 6.701411e-01 -2.594878e+00 2.235046e-01 2.235046e-01 2.082979e+01 7.277524e-01 7.277524e-01 -3.084019e+00 2.656357e-01 2.656357e-01 2.538012e+01 9.136748e-01 9.136748e-01 -3.665363e+00 3.157087e-01 3.157087e-01 2.791683e+01 9.391386e-01 9.391386e-01 -4.356292e+00 3.752204e-01 3.752204e-01 3.061612e+01 9.748082e-01 9.748082e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.145211e+01 9.928744e-01 9.928744e-01 -6.153426e+00 5.300130e-01 5.300130e-01 3.162385e+01 9.857417e-01 9.857417e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.929418e+01 9.115539e-01 9.115539e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.545845e+01 8.282911e-01 8.282911e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.103254e+01 6.742779e-01 6.742779e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.604205e+01 5.290447e-01 5.290447e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.130196e+01 3.864420e-01 3.864420e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.816633e+00 2.789999e-01 2.789999e-01 -2.061185e+01 1.775360e+00 1.775360e+00 5.245804e+00 1.959936e-01 1.959936e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.466486e+00 1.362328e-01 1.362328e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.335649e+00 9.715040e-02 9.715040e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.476691e+00 6.452457e-02 6.452457e-02 -4.112605e+01 3.542309e+00 3.542309e+00 9.501897e-01 4.261565e-02 4.261565e-02 -4.887840e+01 4.210043e+00 4.210043e+00 5.877472e-01 2.727143e-02 2.727143e-02 -5.809209e+01 5.003645e+00 5.003645e+00 3.522312e-01 1.736717e-02 1.736717e-02 -6.904258e+01 5.946843e+00 5.946843e+00 2.218414e-01 1.140433e-02 1.140433e-02 -8.205726e+01 7.067836e+00 7.067836e+00 1.251722e-01 6.452849e-03 6.452849e-03 -9.752523e+01 8.400139e+00 8.400139e+00 6.951626e-02 3.670086e-03 3.670086e-03 -1.159090e+02 9.983584e+00 9.983584e+00 3.751489e-02 2.146711e-03 2.146711e-03 -1.377581e+02 1.186551e+01 1.186551e+01 2.007446e-02 1.180381e-03 1.180381e-03 -1.961423e+02 4.651872e+01 4.651872e+01 5.355213e-03 3.426689e-04 3.426689e-04 -6.213305e+02 3.786695e+02 3.786695e+02 1.064601e-04 1.463478e-05 1.463478e-05 +1.094251e+00 9.425100e-02 9.425100e-02 8.432028e+00 7.452047e-01 7.452047e-01 +1.300520e+00 1.120180e-01 1.120180e-01 1.026981e+01 5.570202e-01 5.570202e-01 +1.545671e+00 1.331330e-01 1.331330e-01 1.351775e+01 7.216323e-01 7.216323e-01 +1.837033e+00 1.582290e-01 1.582290e-01 1.633021e+01 9.002750e-01 9.002750e-01 +2.183318e+00 1.880560e-01 1.880560e-01 1.970840e+01 8.505844e-01 8.505844e-01 +2.594879e+00 2.235045e-01 2.235045e-01 2.266304e+01 9.099966e-01 9.099966e-01 +3.084018e+00 2.656355e-01 2.656355e-01 2.681216e+01 1.026250e+00 1.026250e+00 +3.665363e+00 3.157090e-01 3.157090e-01 3.013696e+01 1.144489e+00 1.144489e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.344029e+01 1.260122e+00 1.260122e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.478594e+01 1.282246e+00 1.282246e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.471239e+01 1.287758e+00 1.287758e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.213183e+01 1.209090e+00 1.209090e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.816644e+01 1.087029e+00 1.087029e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.287126e+01 8.873489e-01 8.873489e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.741466e+01 6.910181e-01 6.910181e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.247950e+01 5.099456e-01 5.099456e-01 +1.734271e+01 1.493780e+00 1.493780e+00 8.693322e+00 3.773060e-01 3.773060e-01 +2.061185e+01 1.775360e+00 1.775360e+00 5.709563e+00 2.494262e-01 2.494262e-01 +2.449723e+01 2.110020e+00 2.110020e+00 3.842087e+00 1.720503e-01 1.720503e-01 +2.911501e+01 2.507765e+00 2.507765e+00 2.503184e+00 1.152528e-01 1.152528e-01 +3.460326e+01 2.980480e+00 2.980480e+00 1.635316e+00 7.766243e-02 7.766243e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.046964e+00 5.133116e-02 5.133116e-02 +4.887840e+01 4.210040e+00 4.210040e+00 6.409699e-01 3.262166e-02 3.262166e-02 +5.809208e+01 5.003645e+00 5.003645e+00 4.049207e-01 2.136257e-02 2.136257e-02 +6.904257e+01 5.946845e+00 5.946845e+00 2.354165e-01 1.293726e-02 1.293726e-02 +8.205725e+01 7.067835e+00 7.067835e+00 1.380692e-01 7.930022e-03 7.930022e-03 +9.752524e+01 8.400155e+00 8.400155e+00 7.849435e-02 4.772997e-03 4.772997e-03 +1.159090e+02 9.983550e+00 9.983550e+00 4.258501e-02 2.818951e-03 2.818951e-03 +1.377580e+02 1.186555e+01 1.186555e+01 2.379019e-02 1.724602e-03 1.724602e-03 +1.961423e+02 4.651870e+01 4.651870e+01 6.625397e-03 6.227200e-04 6.227200e-04 +6.213305e+02 3.786695e+02 3.786695e+02 1.632495e-04 6.369417e-05 6.369417e-05 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d01-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t1 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 5.026395e+00 1.088035e+00 1.088035e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.064791e+00 1.374790e+00 1.374790e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.011198e+01 1.769274e+00 1.769274e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.493136e+01 2.123086e+00 2.123086e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.935026e+01 2.419263e+00 2.419263e+00 +2.594879e+00 2.235045e-01 2.235045e-01 2.554289e+01 2.765194e+00 2.765194e+00 +3.084018e+00 2.656355e-01 2.656355e-01 3.185762e+01 3.110218e+00 3.110218e+00 +3.665363e+00 3.157090e-01 3.157090e-01 3.680790e+01 3.195725e+00 3.195725e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.925983e+01 3.072553e+00 3.072553e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.806103e+01 2.575429e+00 2.575429e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.437418e+01 2.069479e+00 2.069479e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.832551e+01 1.615817e+00 1.615817e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.125015e+01 1.215110e+00 1.215110e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.569831e+01 8.451886e-01 8.451886e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.146950e+01 5.609600e-01 5.609600e-01 +1.459207e+01 1.256860e+00 1.256860e+00 8.173606e+00 3.808497e-01 3.808497e-01 +1.734271e+01 1.493780e+00 1.493780e+00 6.084104e+00 2.857409e-01 2.857409e-01 +2.061185e+01 1.775360e+00 1.775360e+00 4.559399e+00 2.207886e-01 2.207886e-01 +2.449723e+01 2.110020e+00 2.110020e+00 3.438216e+00 1.651199e-01 1.651199e-01 +2.911501e+01 2.507765e+00 2.507765e+00 2.590863e+00 1.222656e-01 1.222656e-01 +3.460326e+01 2.980480e+00 2.980480e+00 1.894800e+00 8.940641e-02 8.940641e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.341776e+00 6.461222e-02 6.461222e-02 +4.887840e+01 4.210040e+00 4.210040e+00 9.108951e-01 4.483870e-02 4.483870e-02 +5.809208e+01 5.003645e+00 5.003645e+00 5.936520e-01 2.967579e-02 2.967579e-02 +6.904257e+01 5.946845e+00 5.946845e+00 3.875928e-01 1.953515e-02 1.953515e-02 +8.205725e+01 7.067835e+00 7.067835e+00 2.416991e-01 1.229416e-02 1.229416e-02 +9.752524e+01 8.400155e+00 8.400155e+00 1.484650e-01 7.730154e-03 7.730154e-03 +1.159090e+02 9.983550e+00 9.983550e+00 8.610534e-02 4.616770e-03 4.616770e-03 +1.377580e+02 1.186555e+01 1.186555e+01 4.948377e-02 2.725277e-03 2.725277e-03 +1.961423e+02 4.651870e+01 4.651870e+01 1.515177e-02 9.060884e-04 9.060884e-04 +6.213305e+02 3.786695e+02 3.786695e+02 4.511159e-04 4.891237e-05 4.891237e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d01-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t1 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.026395e+00 1.138510e+00 1.138510e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.064791e+00 1.377203e+00 1.377203e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.011198e+01 1.772341e+00 1.772341e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.493136e+01 2.131044e+00 2.131044e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.935026e+01 2.498820e+00 2.498820e+00 -2.594878e+00 2.235046e-01 2.235046e-01 2.554289e+01 2.917353e+00 2.917353e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.185762e+01 3.495927e+00 3.495927e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.680790e+01 3.417445e+00 3.417445e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.925983e+01 3.263206e+00 3.263206e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.806103e+01 2.585990e+00 2.585990e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.437418e+01 2.532062e+00 2.532062e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.832551e+01 2.932608e+00 2.932608e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.125015e+01 2.458701e+00 2.458701e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.569831e+01 1.772818e+00 1.772818e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.146950e+01 1.057360e+00 1.057360e+00 -1.459207e+01 1.256859e+00 1.256859e+00 8.173606e+00 3.808644e-01 3.808644e-01 -1.734271e+01 1.493779e+00 1.493779e+00 6.084104e+00 3.673885e-01 3.673885e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.559399e+00 3.934733e-01 3.934733e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.438216e+00 3.291714e-01 3.291714e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.590863e+00 2.375422e-01 2.375422e-01 -3.460326e+01 2.980482e+00 2.980482e+00 1.894800e+00 1.602624e-01 1.602624e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.341776e+00 1.010453e-01 1.010453e-01 -4.887840e+01 4.210043e+00 4.210043e+00 9.108951e-01 6.451331e-02 6.451331e-02 -5.809209e+01 5.003645e+00 5.003645e+00 5.936520e-01 3.993185e-02 3.993185e-02 -6.904258e+01 5.946843e+00 5.946843e+00 3.875928e-01 2.014963e-02 2.014963e-02 -8.205726e+01 7.067836e+00 7.067836e+00 2.416991e-01 1.231090e-02 1.231090e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.484650e-01 7.958954e-03 7.958954e-03 -1.159090e+02 9.983584e+00 9.983584e+00 8.610534e-02 4.620871e-03 4.620871e-03 -1.377581e+02 1.186551e+01 1.186551e+01 4.948377e-02 2.979784e-03 2.979784e-03 -1.961423e+02 4.651872e+01 4.651872e+01 1.515177e-02 1.007609e-03 1.007609e-03 -6.213305e+02 3.786695e+02 3.786695e+02 4.511159e-04 4.895730e-05 4.895730e-05 +1.094251e+00 9.425100e-02 9.425100e-02 5.167988e+00 1.248513e+00 1.248513e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.208618e+00 1.549716e+00 1.549716e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.065991e+01 2.035111e+00 2.035111e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.528796e+01 2.558758e+00 2.558758e+00 +2.183318e+00 1.880560e-01 1.880560e-01 2.077252e+01 3.032330e+00 3.032330e+00 +2.594879e+00 2.235045e-01 2.235045e-01 2.751268e+01 3.503479e+00 3.503479e+00 +3.084018e+00 2.656355e-01 2.656355e-01 3.523164e+01 4.012247e+00 4.012247e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.023787e+01 4.105572e+00 4.105572e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.270182e+01 3.874154e+00 3.874154e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.203944e+01 3.402445e+00 3.402445e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.746920e+01 2.719786e+00 2.719786e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.053262e+01 2.106819e+00 2.106819e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.370225e+01 1.599633e+00 1.599633e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.722117e+01 1.135165e+00 1.135165e+00 +1.227769e+01 1.057515e+00 1.057515e+00 1.239697e+01 7.788285e-01 7.788285e-01 +1.459207e+01 1.256860e+00 1.256860e+00 9.041636e+00 5.440725e-01 5.440725e-01 +1.734271e+01 1.493780e+00 1.493780e+00 6.702660e+00 4.071541e-01 4.071541e-01 +2.061185e+01 1.775360e+00 1.775360e+00 5.065017e+00 3.135831e-01 3.135831e-01 +2.449723e+01 2.110020e+00 2.110020e+00 3.835948e+00 2.339702e-01 2.339702e-01 +2.911501e+01 2.507765e+00 2.507765e+00 2.842551e+00 1.687329e-01 1.687329e-01 +3.460326e+01 2.980480e+00 2.980480e+00 2.076494e+00 1.222926e-01 1.222926e-01 +4.112605e+01 3.542310e+00 3.542310e+00 1.463517e+00 8.654508e-02 8.654508e-02 +4.887840e+01 4.210040e+00 4.210040e+00 1.010766e+00 5.986834e-02 5.986834e-02 +5.809208e+01 5.003645e+00 5.003645e+00 6.653914e-01 3.942003e-02 3.942003e-02 +6.904257e+01 5.946845e+00 5.946845e+00 4.250016e-01 2.531180e-02 2.531180e-02 +8.205725e+01 7.067835e+00 7.067835e+00 2.639709e-01 1.580559e-02 1.580559e-02 +9.752524e+01 8.400155e+00 8.400155e+00 1.594755e-01 9.715750e-03 9.715750e-03 +1.159090e+02 9.983550e+00 9.983550e+00 9.655651e-02 6.055635e-03 6.055635e-03 +1.377580e+02 1.186555e+01 1.186555e+01 5.515701e-02 3.624314e-03 3.624314e-03 +1.961423e+02 4.651870e+01 4.651870e+01 1.876746e-02 1.468876e-03 1.468876e-03 +6.213305e+02 3.786695e+02 3.786695e+02 6.120075e-04 1.748592e-04 1.748592e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d01-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t1 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 2.140524e+00 5.741005e-01 5.741005e-01 +1.300520e+00 1.120180e-01 1.120180e-01 2.642372e+00 6.428018e-01 6.428018e-01 +1.545671e+00 1.331330e-01 1.331330e-01 3.240243e+00 7.189322e-01 7.189322e-01 +1.837033e+00 1.582290e-01 1.582290e-01 4.493157e+00 8.594891e-01 8.594891e-01 +2.183318e+00 1.880560e-01 1.880560e-01 5.409410e+00 9.162978e-01 9.162978e-01 +2.594879e+00 2.235045e-01 2.235045e-01 7.443397e+00 1.083545e+00 1.083545e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.015570e+00 1.130811e+00 1.130811e+00 +3.665363e+00 3.157090e-01 3.157090e-01 1.216738e+01 1.322637e+00 1.322637e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.514874e+01 1.423294e+00 1.423294e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.744598e+01 1.405013e+00 1.405013e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.977819e+01 1.350678e+00 1.350678e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.103805e+01 1.226189e+00 1.226189e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.107483e+01 1.067546e+00 1.067546e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.997679e+01 9.117803e-01 9.117803e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.762803e+01 7.388730e-01 7.388730e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.481611e+01 5.805549e-01 5.805549e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.153820e+01 4.354057e-01 4.354057e-01 +2.061185e+01 1.775360e+00 1.775360e+00 8.572226e+00 3.207172e-01 3.207172e-01 +2.449723e+01 2.110020e+00 2.110020e+00 6.043360e+00 2.302249e-01 2.302249e-01 +2.911501e+01 2.507765e+00 2.507765e+00 4.264073e+00 1.687090e-01 1.687090e-01 +3.460326e+01 2.980480e+00 2.980480e+00 2.947890e+00 1.219271e-01 1.219271e-01 +4.112605e+01 3.542310e+00 3.542310e+00 1.996719e+00 8.626241e-02 8.626241e-02 +4.887840e+01 4.210040e+00 4.210040e+00 1.334860e+00 6.020781e-02 6.020781e-02 +5.809208e+01 5.003645e+00 5.003645e+00 8.462506e-01 4.016344e-02 4.016344e-02 +6.904257e+01 5.946845e+00 5.946845e+00 5.250550e-01 2.623165e-02 2.623165e-02 +8.205725e+01 7.067835e+00 7.067835e+00 3.261205e-01 1.683885e-02 1.683885e-02 +9.752524e+01 8.400155e+00 8.400155e+00 1.990265e-01 1.073516e-02 1.073516e-02 +1.159090e+02 9.983550e+00 9.983550e+00 1.165856e-01 6.553917e-03 6.553917e-03 +1.377580e+02 1.186555e+01 1.186555e+01 6.653251e-02 3.894057e-03 3.894057e-03 +1.961423e+02 4.651870e+01 4.651870e+01 2.095795e-02 1.340682e-03 1.340682e-03 +6.213305e+02 3.786695e+02 3.786695e+02 5.946527e-04 6.788567e-05 6.788567e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d01-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d01-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t1 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.140524e+00 8.120082e-01 8.120082e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.642372e+00 6.443953e-01 6.443953e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.240243e+00 7.587629e-01 7.587629e-01 -1.837033e+00 1.582291e-01 1.582291e-01 4.493157e+00 8.792785e-01 8.792785e-01 -2.183318e+00 1.880557e-01 1.880557e-01 5.409410e+00 9.191437e-01 9.191437e-01 -2.594878e+00 2.235046e-01 2.235046e-01 7.443397e+00 1.129511e+00 1.129511e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.015570e+00 1.172671e+00 1.172671e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.216738e+01 1.351261e+00 1.351261e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.514874e+01 1.504543e+00 1.504543e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.744598e+01 1.412676e+00 1.412676e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.977819e+01 1.471023e+00 1.471023e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.103805e+01 1.324354e+00 1.324354e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.107483e+01 1.223237e+00 1.223237e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.997679e+01 1.067052e+00 1.067052e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.762803e+01 8.065027e-01 8.065027e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.481611e+01 7.324409e-01 7.324409e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.153820e+01 4.853849e-01 4.853849e-01 -2.061185e+01 1.775360e+00 1.775360e+00 8.572226e+00 3.224268e-01 3.224268e-01 -2.449723e+01 2.110020e+00 2.110020e+00 6.043360e+00 2.697194e-01 2.697194e-01 -2.911501e+01 2.507763e+00 2.507763e+00 4.264073e+00 2.256532e-01 2.256532e-01 -3.460326e+01 2.980482e+00 2.980482e+00 2.947890e+00 1.660653e-01 1.660653e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.996719e+00 1.218428e-01 1.218428e-01 -4.887840e+01 4.210043e+00 4.210043e+00 1.334860e+00 7.509910e-02 7.509910e-02 -5.809209e+01 5.003645e+00 5.003645e+00 8.462506e-01 5.007346e-02 5.007346e-02 -6.904258e+01 5.946843e+00 5.946843e+00 5.250550e-01 3.429120e-02 3.429120e-02 -8.205726e+01 7.067836e+00 7.067836e+00 3.261205e-01 1.745130e-02 1.745130e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.990265e-01 1.079316e-02 1.079316e-02 -1.159090e+02 9.983584e+00 9.983584e+00 1.165856e-01 6.555164e-03 6.555164e-03 -1.377581e+02 1.186551e+01 1.186551e+01 6.653251e-02 4.147569e-03 4.147569e-03 -1.961423e+02 4.651872e+01 4.651872e+01 2.095795e-02 1.430811e-03 1.430811e-03 -6.213305e+02 3.786695e+02 3.786695e+02 5.946527e-04 6.802584e-05 6.802584e-05 +1.094251e+00 9.425100e-02 9.425100e-02 2.108687e+00 6.161525e-01 6.161525e-01 +1.300520e+00 1.120180e-01 1.120180e-01 2.808630e+00 6.953731e-01 6.953731e-01 +1.545671e+00 1.331330e-01 1.331330e-01 3.534358e+00 7.585615e-01 7.585615e-01 +1.837033e+00 1.582290e-01 1.582290e-01 4.639792e+00 8.657800e-01 8.657800e-01 +2.183318e+00 1.880560e-01 1.880560e-01 6.224516e+00 1.008554e+00 1.008554e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.807110e+00 1.097978e+00 1.097978e+00 +3.084018e+00 2.656355e-01 2.656355e-01 1.042378e+01 1.262978e+00 1.262978e+00 +3.665363e+00 3.157090e-01 3.157090e-01 1.239331e+01 1.297319e+00 1.297319e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.613229e+01 1.457607e+00 1.457607e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.898397e+01 1.484683e+00 1.484683e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.168322e+01 1.477186e+00 1.477186e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.295768e+01 1.377970e+00 1.377970e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.311337e+01 1.254824e+00 1.254824e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.199762e+01 1.120245e+00 1.120245e+00 +1.227769e+01 1.057515e+00 1.057515e+00 1.939597e+01 9.476420e-01 9.476420e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.621277e+01 7.664286e-01 7.664286e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.261600e+01 5.831197e-01 5.831197e-01 +2.061185e+01 1.775360e+00 1.775360e+00 9.454139e+00 4.368831e-01 4.368831e-01 +2.449723e+01 2.110020e+00 2.110020e+00 6.725150e+00 3.165567e-01 3.165567e-01 +2.911501e+01 2.507765e+00 2.507765e+00 4.677663e+00 2.251242e-01 2.251242e-01 +3.460326e+01 2.980480e+00 2.980480e+00 3.224615e+00 1.585395e-01 1.585395e-01 +4.112605e+01 3.542310e+00 3.542310e+00 2.160739e+00 1.094313e-01 1.094313e-01 +4.887840e+01 4.210040e+00 4.210040e+00 1.452435e+00 7.640830e-02 7.640830e-02 +5.809208e+01 5.003645e+00 5.003645e+00 9.331890e-01 5.110492e-02 5.110492e-02 +6.904257e+01 5.946845e+00 5.946845e+00 5.917180e-01 3.360258e-02 3.360258e-02 +8.205725e+01 7.067835e+00 7.067835e+00 3.565428e-01 2.096622e-02 2.096622e-02 +9.752524e+01 8.400155e+00 8.400155e+00 2.161881e-01 1.325612e-02 1.325612e-02 +1.159090e+02 9.983550e+00 9.983550e+00 1.287593e-01 8.244878e-03 8.244878e-03 +1.377580e+02 1.186555e+01 1.186555e+01 7.259382e-02 4.897494e-03 4.897494e-03 +1.961423e+02 4.651870e+01 4.651870e+01 2.420001e-02 1.884221e-03 1.884221e-03 +6.213305e+02 3.786695e+02 3.786695e+02 8.334036e-04 1.901283e-04 1.901283e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d02-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t2 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 4.251658e+01 1.566065e+00 1.566065e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.347048e+01 1.698262e+00 1.698262e+00 +1.545671e+00 1.331330e-01 1.331330e-01 6.865451e+01 2.399943e+00 2.399943e+00 +1.837033e+00 1.582290e-01 1.582290e-01 7.857296e+01 2.556877e+00 2.556877e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.720231e+01 2.750437e+00 2.750437e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.337012e+01 3.065478e+00 3.065478e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.859543e+01 2.897633e+00 2.897633e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.455953e+01 2.508455e+00 2.508455e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.829047e+01 1.991888e+00 1.991888e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.022941e+01 1.440183e+00 1.440183e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.504355e+01 9.844996e-01 9.844996e-01 +7.313360e+00 6.299215e-01 6.299215e-01 1.507121e+01 6.011463e-01 6.011463e-01 +8.691945e+00 7.486635e-01 7.486635e-01 8.787865e+00 3.656542e-01 3.656542e-01 +1.033039e+01 8.897855e-01 8.897855e-01 5.257721e+00 2.323279e-01 2.323279e-01 +1.227769e+01 1.057515e+00 1.057515e+00 3.288535e+00 1.580652e-01 1.580652e-01 +1.459207e+01 1.256860e+00 1.256860e+00 2.042152e+00 1.013972e-01 1.013972e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.274409e+00 6.704191e-02 6.704191e-02 +2.061185e+01 1.775360e+00 1.775360e+00 8.054232e-01 4.494587e-02 4.494587e-02 +2.449723e+01 2.110020e+00 2.110020e+00 4.916852e-01 2.996955e-02 2.996955e-02 +2.911501e+01 2.507765e+00 2.507765e+00 3.015235e-01 1.926580e-02 1.926580e-02 +3.460326e+01 2.980480e+00 2.980480e+00 1.787215e-01 1.213894e-02 1.213894e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.052898e-01 7.624179e-03 7.624179e-03 +4.887840e+01 4.210040e+00 4.210040e+00 6.465946e-02 5.033112e-03 5.033112e-03 +5.809208e+01 5.003645e+00 5.003645e+00 3.583416e-02 2.904991e-03 2.904991e-03 +6.904257e+01 5.946845e+00 5.946845e+00 1.924695e-02 1.704509e-03 1.704509e-03 +9.830401e+01 2.331459e+01 2.331459e+01 6.161733e-03 6.179331e-04 6.179331e-04 +3.114029e+02 1.897843e+02 1.897843e+02 2.084350e-04 5.042981e-05 5.042981e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d02-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t2 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.251658e+01 1.566065e+00 1.566065e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.347048e+01 1.698262e+00 1.698262e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.865451e+01 2.399943e+00 2.399943e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.857296e+01 2.556877e+00 2.556877e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.720231e+01 2.750437e+00 2.750437e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.337012e+01 3.065478e+00 3.065478e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.859543e+01 2.897633e+00 2.897633e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.455953e+01 2.508455e+00 2.508455e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.829047e+01 1.991888e+00 1.991888e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.022941e+01 1.440183e+00 1.440183e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.504355e+01 9.844996e-01 9.844996e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.507121e+01 6.011462e-01 6.011462e-01 -8.691946e+00 7.486632e-01 7.486632e-01 8.787865e+00 3.656542e-01 3.656542e-01 -1.033040e+01 8.897879e-01 8.897879e-01 5.257721e+00 2.323279e-01 2.323279e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.288535e+00 1.580652e-01 1.580652e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.042152e+00 1.013971e-01 1.013971e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.274409e+00 6.704191e-02 6.704191e-02 -2.061185e+01 1.775360e+00 1.775360e+00 8.054232e-01 4.494587e-02 4.494587e-02 -2.449723e+01 2.110020e+00 2.110020e+00 4.916852e-01 2.996955e-02 2.996955e-02 -2.911501e+01 2.507763e+00 2.507763e+00 3.015235e-01 1.926580e-02 1.926580e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.787215e-01 1.213894e-02 1.213894e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.052898e-01 7.624179e-03 7.624179e-03 -4.887840e+01 4.210043e+00 4.210043e+00 6.465946e-02 5.033112e-03 5.033112e-03 -5.809209e+01 5.003645e+00 5.003645e+00 3.583416e-02 2.904991e-03 2.904991e-03 -6.904258e+01 5.946843e+00 5.946843e+00 1.924695e-02 1.704510e-03 1.704510e-03 -9.830401e+01 2.331459e+01 2.331459e+01 6.161733e-03 6.179331e-04 6.179331e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.084350e-04 5.042981e-05 5.042981e-05 +1.094251e+00 9.425100e-02 9.425100e-02 4.509536e+01 1.978854e+00 1.978854e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.949634e+01 2.563499e+00 2.563499e+00 +1.545671e+00 1.331330e-01 1.331330e-01 7.160077e+01 2.916540e+00 2.916540e+00 +1.837033e+00 1.582290e-01 1.582290e-01 8.637347e+01 3.386872e+00 3.386872e+00 +2.183318e+00 1.880560e-01 1.880560e-01 9.553256e+01 3.596445e+00 3.596445e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.007083e+02 3.811366e+00 3.811366e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.671423e+01 3.719422e+00 3.719422e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.167211e+01 3.126072e+00 3.126072e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.338088e+01 2.477778e+00 2.477778e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.385672e+01 1.795056e+00 1.795056e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.806842e+01 1.181669e+00 1.181669e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.679873e+01 7.488626e-01 7.488626e-01 +8.691945e+00 7.486635e-01 7.486635e-01 9.969824e+00 4.609085e-01 4.609085e-01 +1.033039e+01 8.897855e-01 8.897855e-01 5.924794e+00 2.878831e-01 2.878831e-01 +1.227769e+01 1.057515e+00 1.057515e+00 3.585966e+00 1.846768e-01 1.846768e-01 +1.459207e+01 1.256860e+00 1.256860e+00 2.251790e+00 1.222110e-01 1.222110e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.415524e+00 8.134745e-02 8.134745e-02 +2.061185e+01 1.775360e+00 1.775360e+00 8.789656e-01 5.360864e-02 5.360864e-02 +2.449723e+01 2.110020e+00 2.110020e+00 5.424371e-01 3.488429e-02 3.488429e-02 +2.911501e+01 2.507765e+00 2.507765e+00 3.308341e-01 2.268837e-02 2.268837e-02 +3.460326e+01 2.980480e+00 2.980480e+00 2.033468e-01 1.474046e-02 1.474046e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.246833e-01 9.709753e-03 9.709753e-03 +4.887840e+01 4.210040e+00 4.210040e+00 6.964053e-02 5.828101e-03 5.828101e-03 +5.809208e+01 5.003645e+00 5.003645e+00 4.003562e-02 3.651565e-03 3.651565e-03 +6.904257e+01 5.946845e+00 5.946845e+00 2.209996e-02 2.233049e-03 2.233049e-03 +9.830401e+01 2.331459e+01 2.331459e+01 7.400473e-03 9.925869e-04 9.925869e-04 +3.114029e+02 1.897843e+02 1.897843e+02 2.548039e-04 1.451574e-04 1.451574e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d02-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t2 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 2.213549e+01 1.257319e+00 1.257319e+00 +1.300520e+00 1.120180e-01 1.120180e-01 2.578350e+01 9.251823e-01 9.251823e-01 +1.545671e+00 1.331330e-01 1.331330e-01 3.036665e+01 1.294972e+00 1.294972e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.572293e+01 1.370832e+00 1.370832e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.079239e+01 1.416067e+00 1.416067e+00 +2.594879e+00 2.235045e-01 2.235045e-01 4.456356e+01 1.315123e+00 1.315123e+00 +3.084018e+00 2.656355e-01 2.656355e-01 4.837683e+01 1.402558e+00 1.402558e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.148847e+01 1.505844e+00 1.505844e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.019930e+01 1.479742e+00 1.479742e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.733873e+01 1.443311e+00 1.443311e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.073097e+01 1.296580e+00 1.296580e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.224517e+01 1.087139e+00 1.087139e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.355572e+01 8.613873e-01 8.613873e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.561065e+01 5.915471e-01 5.915471e-01 +1.227769e+01 1.057515e+00 1.057515e+00 9.550952e+00 3.961028e-01 3.961028e-01 +1.459207e+01 1.256860e+00 1.256860e+00 5.369347e+00 2.376030e-01 2.376030e-01 +1.734271e+01 1.493780e+00 1.493780e+00 2.976504e+00 1.412455e-01 1.412455e-01 +2.061185e+01 1.775360e+00 1.775360e+00 1.628869e+00 8.204071e-02 8.204071e-02 +2.449723e+01 2.110020e+00 2.110020e+00 9.015307e-01 4.915483e-02 4.915483e-02 +2.911501e+01 2.507765e+00 2.507765e+00 4.935663e-01 2.931522e-02 2.931522e-02 +3.460326e+01 2.980480e+00 2.980480e+00 2.769087e-01 1.751636e-02 1.751636e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.599571e-01 1.084167e-02 1.084167e-02 +4.887840e+01 4.210040e+00 4.210040e+00 9.306745e-02 6.805732e-03 6.805732e-03 +5.809208e+01 5.003645e+00 5.003645e+00 5.227408e-02 4.043149e-03 4.043149e-03 +6.904257e+01 5.946845e+00 5.946845e+00 2.779982e-02 2.358778e-03 2.358778e-03 +9.830401e+01 2.331459e+01 2.331459e+01 8.619561e-03 8.318715e-04 8.318715e-04 +3.114029e+02 1.897843e+02 1.897843e+02 2.994644e-04 5.719088e-05 5.719088e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d02-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t2 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.213549e+01 1.257319e+00 1.257319e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.578350e+01 9.251823e-01 9.251823e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.036665e+01 1.294972e+00 1.294972e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.572293e+01 1.370832e+00 1.370832e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.079239e+01 1.416067e+00 1.416067e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.456356e+01 1.315123e+00 1.315123e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.837683e+01 1.402558e+00 1.402558e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.148847e+01 1.505844e+00 1.505844e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.019930e+01 1.479742e+00 1.479742e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.733873e+01 1.443311e+00 1.443311e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.073097e+01 1.296580e+00 1.296580e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.224517e+01 1.087139e+00 1.087139e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.355572e+01 8.613873e-01 8.613873e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.561065e+01 5.915471e-01 5.915471e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.550952e+00 3.961028e-01 3.961028e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.369347e+00 2.376030e-01 2.376030e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.976504e+00 1.412455e-01 1.412455e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.628869e+00 8.204071e-02 8.204071e-02 -2.449723e+01 2.110020e+00 2.110020e+00 9.015307e-01 4.915482e-02 4.915482e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.935663e-01 2.931522e-02 2.931522e-02 -3.460326e+01 2.980482e+00 2.980482e+00 2.769087e-01 1.751636e-02 1.751636e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.599571e-01 1.084167e-02 1.084167e-02 -4.887840e+01 4.210043e+00 4.210043e+00 9.306745e-02 6.805731e-03 6.805731e-03 -5.809209e+01 5.003645e+00 5.003645e+00 5.227408e-02 4.043149e-03 4.043149e-03 -6.904258e+01 5.946843e+00 5.946843e+00 2.779982e-02 2.358778e-03 2.358778e-03 -9.830401e+01 2.331459e+01 2.331459e+01 8.619561e-03 8.318715e-04 8.318715e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.994644e-04 5.719088e-05 5.719088e-05 +1.094251e+00 9.425100e-02 9.425100e-02 2.412102e+01 1.158118e+00 1.158118e+00 +1.300520e+00 1.120180e-01 1.120180e-01 2.861174e+01 1.255390e+00 1.255390e+00 +1.545671e+00 1.331330e-01 1.331330e-01 3.319670e+01 1.352769e+00 1.352769e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.819460e+01 1.439443e+00 1.439443e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.281387e+01 1.595254e+00 1.595254e+00 +2.594879e+00 2.235045e-01 2.235045e-01 4.940702e+01 1.795151e+00 1.795151e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.361152e+01 1.920478e+00 1.920478e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.550031e+01 1.969279e+00 1.969279e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.491434e+01 1.977064e+00 1.977064e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.167550e+01 1.909663e+00 1.909663e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.471568e+01 1.711637e+00 1.711637e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.534103e+01 1.443135e+00 1.443135e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.585849e+01 1.096946e+00 1.096946e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.735055e+01 7.696453e-01 7.696453e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.056286e+01 5.002836e-01 5.002836e-01 +1.459207e+01 1.256860e+00 1.256860e+00 5.981983e+00 2.992818e-01 2.992818e-01 +1.734271e+01 1.493780e+00 1.493780e+00 3.261613e+00 1.721445e-01 1.721445e-01 +2.061185e+01 1.775360e+00 1.775360e+00 1.759217e+00 9.878046e-02 9.878046e-02 +2.449723e+01 2.110020e+00 2.110020e+00 9.664077e-01 5.816969e-02 5.816969e-02 +2.911501e+01 2.507765e+00 2.507765e+00 5.448613e-01 3.450252e-02 3.450252e-02 +3.460326e+01 2.980480e+00 2.980480e+00 3.093451e-01 2.097763e-02 2.097763e-02 +4.112605e+01 3.542310e+00 3.542310e+00 1.790759e-01 1.313131e-02 1.313131e-02 +4.887840e+01 4.210040e+00 4.210040e+00 1.060545e-01 8.608010e-03 8.608010e-03 +5.809208e+01 5.003645e+00 5.003645e+00 5.755049e-02 4.869530e-03 4.869530e-03 +6.904257e+01 5.946845e+00 5.946845e+00 3.236525e-02 2.933619e-03 2.933619e-03 +9.830401e+01 2.331459e+01 2.331459e+01 1.031548e-02 1.222966e-03 1.222966e-03 +3.114029e+02 1.897843e+02 1.897843e+02 3.715845e-04 1.952826e-04 1.952826e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d02-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t2 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.489763e+01 2.042432e+00 2.042432e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.982360e+01 2.450016e+00 2.450016e+00 +1.545671e+00 1.331330e-01 1.331330e-01 2.587930e+01 2.877900e+00 2.877900e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.255242e+01 3.258813e+00 3.258813e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.233328e+01 3.772953e+00 3.772953e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.087246e+01 4.054233e+00 4.054233e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.801644e+01 4.169830e+00 4.169830e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.193357e+01 4.065897e+00 4.065897e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.020458e+01 3.674609e+00 3.674609e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.336661e+01 3.091468e+00 3.091468e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.188339e+01 2.355588e+00 2.355588e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.957067e+01 1.659365e+00 1.659365e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.901814e+01 1.086692e+00 1.086692e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.152678e+01 6.708764e-01 6.708764e-01 +1.227769e+01 1.057515e+00 1.057515e+00 6.944233e+00 4.017118e-01 4.017118e-01 +1.459207e+01 1.256860e+00 1.256860e+00 4.231061e+00 2.451920e-01 2.451920e-01 +1.734271e+01 1.493780e+00 1.493780e+00 2.727649e+00 1.639191e-01 1.639191e-01 +2.061185e+01 1.775360e+00 1.775360e+00 1.782786e+00 1.115995e-01 1.115995e-01 +2.449723e+01 2.110020e+00 2.110020e+00 1.175197e+00 7.324205e-02 7.324205e-02 +2.911501e+01 2.507765e+00 2.507765e+00 7.742704e-01 4.755472e-02 4.755472e-02 +3.460326e+01 2.980480e+00 2.980480e+00 5.012703e-01 3.111380e-02 3.111380e-02 +4.112605e+01 3.542310e+00 3.542310e+00 3.078006e-01 1.974790e-02 1.974790e-02 +4.887840e+01 4.210040e+00 4.210040e+00 1.839932e-01 1.244501e-02 1.244501e-02 +5.809208e+01 5.003645e+00 5.003645e+00 1.097354e-01 7.616645e-03 7.616645e-03 +6.904257e+01 5.946845e+00 5.946845e+00 6.628384e-02 4.703943e-03 4.703943e-03 +9.830401e+01 2.331459e+01 2.331459e+01 2.429788e-02 2.013816e-03 2.013816e-03 +3.114029e+02 1.897843e+02 1.897843e+02 1.114871e-03 3.087796e-04 3.087796e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d02-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t2 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.489763e+01 2.353181e+00 2.353181e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.982360e+01 2.603555e+00 2.603555e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.587930e+01 3.219879e+00 3.219879e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.255242e+01 3.668543e+00 3.668543e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.233328e+01 3.999467e+00 3.999467e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.087246e+01 4.713882e+00 4.713882e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.801644e+01 4.864634e+00 4.864634e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.193357e+01 4.588721e+00 4.588721e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.020458e+01 3.772272e+00 3.772272e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.336661e+01 3.275211e+00 3.275211e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.188339e+01 3.227490e+00 3.227490e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.957067e+01 2.899641e+00 2.899641e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.901814e+01 2.029827e+00 2.029827e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.152678e+01 9.587638e-01 9.587638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 6.944233e+00 4.382270e-01 4.382270e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.231061e+00 2.760548e-01 2.760548e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.727649e+00 2.140536e-01 2.140536e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.782786e+00 1.685825e-01 1.685825e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.175197e+00 1.042250e-01 1.042250e-01 -2.911501e+01 2.507763e+00 2.507763e+00 7.742704e-01 6.094456e-02 6.094456e-02 -3.460326e+01 2.980482e+00 2.980482e+00 5.012703e-01 3.459606e-02 3.459606e-02 -4.112605e+01 3.542309e+00 3.542309e+00 3.078006e-01 1.991102e-02 1.991102e-02 -4.887840e+01 4.210043e+00 4.210043e+00 1.839932e-01 1.264942e-02 1.264942e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.097354e-01 7.702506e-03 7.702506e-03 -6.904258e+01 5.946843e+00 5.946843e+00 6.628384e-02 4.968150e-03 4.968150e-03 -9.830401e+01 2.331459e+01 2.331459e+01 2.429788e-02 2.096348e-03 2.096348e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.114871e-03 3.088679e-04 3.088679e-04 +1.094251e+00 9.425100e-02 9.425100e-02 1.656042e+01 2.271092e+00 2.271092e+00 +1.300520e+00 1.120180e-01 1.120180e-01 2.173019e+01 2.721161e+00 2.721161e+00 +1.545671e+00 1.331330e-01 1.331330e-01 2.731229e+01 3.172777e+00 3.172777e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.588873e+01 3.752061e+00 3.752061e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.582596e+01 4.314643e+00 4.314643e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.498578e+01 4.634179e+00 4.634179e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.389382e+01 4.842023e+00 4.842023e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.765247e+01 4.644923e+00 4.644923e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.560146e+01 4.148010e+00 4.148010e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.715155e+01 3.393629e+00 3.393629e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.546649e+01 2.611988e+00 2.611988e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.267613e+01 1.878078e+00 1.878078e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.104742e+01 1.230055e+00 1.230055e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.293132e+01 7.643845e-01 7.643845e-01 +1.227769e+01 1.057515e+00 1.057515e+00 7.820431e+00 4.657923e-01 4.657923e-01 +1.459207e+01 1.256860e+00 1.256860e+00 4.795915e+00 2.904438e-01 2.904438e-01 +1.734271e+01 1.493780e+00 1.493780e+00 3.026571e+00 1.885913e-01 1.885913e-01 +2.061185e+01 1.775360e+00 1.775360e+00 1.981987e+00 1.255342e-01 1.255342e-01 +2.449723e+01 2.110020e+00 2.110020e+00 1.294332e+00 8.112926e-02 8.112926e-02 +2.911501e+01 2.507765e+00 2.507765e+00 8.499756e-01 5.215133e-02 5.215133e-02 +3.460326e+01 2.980480e+00 2.980480e+00 5.394212e-01 3.309233e-02 3.309233e-02 +4.112605e+01 3.542310e+00 3.542310e+00 3.398599e-01 2.119944e-02 2.119944e-02 +4.887840e+01 4.210040e+00 4.210040e+00 2.103875e-01 1.323901e-02 1.323901e-02 +5.809208e+01 5.003645e+00 5.003645e+00 1.309587e-01 8.319358e-03 8.319358e-03 +6.904257e+01 5.946845e+00 5.946845e+00 7.569980e-02 4.996009e-03 4.996009e-03 +9.830401e+01 2.331459e+01 2.331459e+01 2.704045e-02 2.136110e-03 2.136110e-03 +3.114029e+02 1.897843e+02 1.897843e+02 1.303918e-03 5.089613e-04 5.089613e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d02-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t2 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 8.049465e+00 1.601831e+00 1.601831e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.990596e+00 1.622804e+00 1.622804e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.076139e+01 1.766225e+00 1.766225e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.224761e+01 1.790836e+00 1.790836e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.547082e+01 1.999472e+00 1.999472e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.915081e+01 2.156399e+00 2.156399e+00 +3.084018e+00 2.656355e-01 2.656355e-01 2.210513e+01 2.149666e+00 2.149666e+00 +3.665363e+00 3.157090e-01 3.157090e-01 2.681122e+01 2.224422e+00 2.224422e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.082771e+01 2.167387e+00 2.167387e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.368383e+01 2.018204e+00 2.018204e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.408435e+01 1.774938e+00 1.774938e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.238250e+01 1.506088e+00 1.506088e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.943282e+01 1.270611e+00 1.270611e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.385918e+01 9.946736e-01 9.946736e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.797710e+01 7.343327e-01 7.343327e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.253059e+01 5.125731e-01 5.125731e-01 +1.734271e+01 1.493780e+00 1.493780e+00 7.964495e+00 3.348097e-01 3.348097e-01 +2.061185e+01 1.775360e+00 1.775360e+00 4.792676e+00 2.125187e-01 2.125187e-01 +2.449723e+01 2.110020e+00 2.110020e+00 2.751965e+00 1.283127e-01 1.283127e-01 +2.911501e+01 2.507765e+00 2.507765e+00 1.561784e+00 7.576427e-02 7.576427e-02 +3.460326e+01 2.980480e+00 2.980480e+00 9.004670e-01 4.558030e-02 4.558030e-02 +4.112605e+01 3.542310e+00 3.542310e+00 5.182805e-01 2.816354e-02 2.816354e-02 +4.887840e+01 4.210040e+00 4.210040e+00 2.938264e-01 1.743897e-02 1.743897e-02 +5.809208e+01 5.003645e+00 5.003645e+00 1.663662e-01 1.065088e-02 1.065088e-02 +6.904257e+01 5.946845e+00 5.946845e+00 9.636735e-02 6.525827e-03 6.525827e-03 +9.830401e+01 2.331459e+01 2.331459e+01 3.556128e-02 2.943924e-03 2.943924e-03 +3.114029e+02 1.897843e+02 1.897843e+02 1.537270e-03 4.325030e-04 4.325030e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d02-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d02-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t2 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.049465e+00 1.627731e+00 1.627731e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.990596e+00 1.624231e+00 1.624231e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.076139e+01 1.909451e+00 1.909451e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.224761e+01 2.313692e+00 2.313692e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.547082e+01 2.384618e+00 2.384618e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.915081e+01 2.414434e+00 2.414434e+00 -3.084019e+00 2.656357e-01 2.656357e-01 2.210513e+01 2.659900e+00 2.659900e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.681122e+01 2.366631e+00 2.366631e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.082771e+01 2.181140e+00 2.181140e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.368383e+01 2.067661e+00 2.067661e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.408435e+01 1.837770e+00 1.837770e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.238250e+01 1.563845e+00 1.563845e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.943282e+01 1.655684e+00 1.655684e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.385918e+01 1.174033e+00 1.174033e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.797710e+01 8.721781e-01 8.721781e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.253059e+01 5.659160e-01 5.659160e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.964495e+00 3.510716e-01 3.510716e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.792676e+00 2.437191e-01 2.437191e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.751965e+00 1.694596e-01 1.694596e-01 -2.911501e+01 2.507763e+00 2.507763e+00 1.561784e+00 1.081239e-01 1.081239e-01 -3.460326e+01 2.980482e+00 2.980482e+00 9.004670e-01 5.119386e-02 5.119386e-02 -4.112605e+01 3.542309e+00 3.542309e+00 5.182805e-01 2.835630e-02 2.835630e-02 -4.887840e+01 4.210043e+00 4.210043e+00 2.938264e-01 1.749024e-02 1.749024e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.663662e-01 1.081333e-02 1.081333e-02 -6.904258e+01 5.946843e+00 5.946843e+00 9.636735e-02 6.718521e-03 6.718521e-03 -9.830401e+01 2.331459e+01 2.331459e+01 3.556128e-02 3.074905e-03 3.074905e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.537270e-03 4.326461e-04 4.326461e-04 +1.094251e+00 9.425100e-02 9.425100e-02 8.901230e+00 1.518092e+00 1.518092e+00 +1.300520e+00 1.120180e-01 1.120180e-01 9.907889e+00 1.539837e+00 1.539837e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.177919e+01 1.669541e+00 1.669541e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.429835e+01 1.828197e+00 1.828197e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.679422e+01 1.913838e+00 1.913838e+00 +2.594879e+00 2.235045e-01 2.235045e-01 2.067479e+01 2.071124e+00 2.071124e+00 +3.084018e+00 2.656355e-01 2.656355e-01 2.484367e+01 2.158597e+00 2.158597e+00 +3.665363e+00 3.157090e-01 3.157090e-01 2.887465e+01 2.152732e+00 2.152732e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.310868e+01 2.121864e+00 2.121864e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.609491e+01 2.015121e+00 2.015121e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.742053e+01 1.862625e+00 1.862625e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.578381e+01 1.641770e+00 1.641770e+00 +8.691945e+00 7.486635e-01 7.486635e-01 3.190092e+01 1.406922e+00 1.406922e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.623921e+01 1.150324e+00 1.150324e+00 +1.227769e+01 1.057515e+00 1.057515e+00 1.983352e+01 8.793687e-01 8.793687e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.370135e+01 6.161122e-01 6.161122e-01 +1.734271e+01 1.493780e+00 1.493780e+00 8.867607e+00 4.113998e-01 4.113998e-01 +2.061185e+01 1.775360e+00 1.775360e+00 5.337684e+00 2.613408e-01 2.613408e-01 +2.449723e+01 2.110020e+00 2.110020e+00 3.041766e+00 1.560450e-01 1.560450e-01 +2.911501e+01 2.507765e+00 2.507765e+00 1.709191e+00 9.092876e-02 9.092876e-02 +3.460326e+01 2.980480e+00 2.980480e+00 9.842119e-01 5.479487e-02 5.479487e-02 +4.112605e+01 3.542310e+00 3.542310e+00 5.546756e-01 3.304285e-02 3.304285e-02 +4.887840e+01 4.210040e+00 4.210040e+00 3.174215e-01 2.054467e-02 2.054467e-02 +5.809208e+01 5.003645e+00 5.003645e+00 1.878762e-01 1.293741e-02 1.293741e-02 +6.904257e+01 5.946845e+00 5.946845e+00 1.127108e-01 8.384594e-03 8.384594e-03 +9.830401e+01 2.331459e+01 2.331459e+01 4.013331e-02 3.674806e-03 3.674806e-03 +3.114029e+02 1.897843e+02 1.897843e+02 1.852837e-03 6.165196e-04 6.165196e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d03-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t3 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 6.913391e+01 2.533522e+00 2.533522e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.657180e+01 3.283696e+00 3.283696e+00 +1.545671e+00 1.331330e-01 1.331330e-01 9.881895e+01 3.335522e+00 3.335522e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.131585e+02 3.660216e+00 3.660216e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.181065e+02 3.785198e+00 3.785198e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.138350e+02 3.772396e+00 3.772396e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.572317e+01 3.226374e+00 3.226374e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.176193e+01 2.561989e+00 2.561989e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.867972e+01 1.868981e+00 1.868981e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.846156e+01 1.188777e+00 1.188777e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.549413e+01 6.935612e-01 6.935612e-01 +7.313360e+00 6.299215e-01 6.299215e-01 7.874323e+00 3.838026e-01 3.838026e-01 +8.691945e+00 7.486635e-01 7.486635e-01 4.064096e+00 2.178716e-01 2.178716e-01 +1.033039e+01 8.897855e-01 8.897855e-01 2.139051e+00 1.241570e-01 1.241570e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.134773e+00 7.093575e-02 7.093575e-02 +1.459207e+01 1.256860e+00 1.256860e+00 6.540028e-01 4.373642e-02 4.373642e-02 +1.734271e+01 1.493780e+00 1.493780e+00 3.781698e-01 2.689146e-02 2.689146e-02 +2.061185e+01 1.775360e+00 1.775360e+00 2.121876e-01 1.593806e-02 1.593806e-02 +2.449723e+01 2.110020e+00 2.110020e+00 1.083296e-01 9.433377e-03 9.433377e-03 +2.911501e+01 2.507765e+00 2.507765e+00 6.069497e-02 5.303740e-03 5.303740e-03 +4.235561e+01 1.073283e+01 1.073283e+01 1.964958e-02 1.895753e-03 1.895753e-03 +1.521385e+02 9.905008e+01 9.905008e+01 4.600536e-04 9.522036e-05 9.522036e-05 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d03-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t3 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.913391e+01 2.533522e+00 2.533522e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.657180e+01 3.283696e+00 3.283696e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.881895e+01 3.335522e+00 3.335522e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.131585e+02 3.660216e+00 3.660216e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.181065e+02 3.785198e+00 3.785198e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.138350e+02 3.772396e+00 3.772396e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.572317e+01 3.226374e+00 3.226374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.176193e+01 2.561989e+00 2.561989e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.867972e+01 1.868982e+00 1.868982e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.846156e+01 1.188777e+00 1.188777e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.549413e+01 6.935612e-01 6.935612e-01 -7.313361e+00 6.299216e-01 6.299216e-01 7.874323e+00 3.838026e-01 3.838026e-01 -8.691946e+00 7.486632e-01 7.486632e-01 4.064096e+00 2.178716e-01 2.178716e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.139051e+00 1.241570e-01 1.241570e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.134773e+00 7.093575e-02 7.093575e-02 -1.459207e+01 1.256859e+00 1.256859e+00 6.540028e-01 4.373642e-02 4.373642e-02 -1.734271e+01 1.493779e+00 1.493779e+00 3.781698e-01 2.689145e-02 2.689145e-02 -2.061185e+01 1.775360e+00 1.775360e+00 2.121876e-01 1.593806e-02 1.593806e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.083296e-01 9.433377e-03 9.433377e-03 -2.911501e+01 2.507763e+00 2.507763e+00 6.069497e-02 5.303741e-03 5.303741e-03 -4.235561e+01 1.073283e+01 1.073283e+01 1.964958e-02 1.895753e-03 1.895753e-03 -1.521385e+02 9.905010e+01 9.905010e+01 4.600536e-04 9.522037e-05 9.522037e-05 +1.094251e+00 9.425100e-02 9.425100e-02 7.622855e+01 3.364890e+00 3.364890e+00 +1.300520e+00 1.120180e-01 1.120180e-01 9.414565e+01 4.233593e+00 4.233593e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.095125e+02 4.376439e+00 4.376439e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.225735e+02 4.767943e+00 4.767943e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.269284e+02 4.847782e+00 4.847782e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.222025e+02 4.651743e+00 4.651743e+00 +3.084018e+00 2.656355e-01 2.656355e-01 1.047390e+02 4.055920e+00 4.055920e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.982508e+01 3.184949e+00 3.184949e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.353913e+01 2.252447e+00 2.252447e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.173966e+01 1.431694e+00 1.431694e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.719672e+01 8.291283e-01 8.291283e-01 +7.313360e+00 6.299215e-01 6.299215e-01 8.865264e+00 4.684992e-01 4.684992e-01 +8.691945e+00 7.486635e-01 7.486635e-01 4.636531e+00 2.684914e-01 2.684914e-01 +1.033039e+01 8.897855e-01 8.897855e-01 2.362030e+00 1.456448e-01 1.456448e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.289825e+00 8.511387e-02 8.511387e-02 +1.459207e+01 1.256860e+00 1.256860e+00 7.250033e-01 5.064113e-02 5.064113e-02 +1.734271e+01 1.493780e+00 1.493780e+00 4.225081e-01 3.169764e-02 3.169764e-02 +2.061185e+01 1.775360e+00 1.775360e+00 2.323588e-01 1.763496e-02 1.763496e-02 +2.449723e+01 2.110020e+00 2.110020e+00 1.316878e-01 1.030266e-02 1.030266e-02 +2.911501e+01 2.507765e+00 2.507765e+00 6.840894e-02 5.828421e-03 5.828421e-03 +4.235561e+01 1.073283e+01 1.073283e+01 2.262729e-02 2.202867e-03 2.202867e-03 +1.521385e+02 9.905008e+01 9.905008e+01 5.648500e-04 5.168654e-04 5.168654e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d03-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t3 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 3.825805e+01 2.132330e+00 2.132330e+00 +1.300520e+00 1.120180e-01 1.120180e-01 4.456967e+01 1.874852e+00 1.874852e+00 +1.545671e+00 1.331330e-01 1.331330e-01 5.186146e+01 2.073565e+00 2.073565e+00 +1.837033e+00 1.582290e-01 1.582290e-01 5.725064e+01 2.240922e+00 2.240922e+00 +2.183318e+00 1.880560e-01 1.880560e-01 6.164457e+01 2.013365e+00 2.013365e+00 +2.594879e+00 2.235045e-01 2.235045e-01 6.581330e+01 1.969264e+00 1.969264e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.706655e+01 1.959374e+00 1.959374e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.342732e+01 1.889673e+00 1.889673e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.799750e+01 1.819163e+00 1.819163e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.842780e+01 1.617673e+00 1.617673e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.718619e+01 1.371325e+00 1.371325e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.584674e+01 1.036562e+00 1.036562e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.614116e+01 7.093522e-01 7.093522e-01 +1.033039e+01 8.897855e-01 8.897855e-01 9.045228e+00 4.474669e-01 4.474669e-01 +1.227769e+01 1.057515e+00 1.057515e+00 4.427789e+00 2.435579e-01 2.435579e-01 +1.459207e+01 1.256860e+00 1.256860e+00 2.019382e+00 1.234920e-01 1.234920e-01 +1.734271e+01 1.493780e+00 1.493780e+00 9.245877e-01 6.312702e-02 6.312702e-02 +2.061185e+01 1.775360e+00 1.775360e+00 4.259970e-01 3.223159e-02 3.223159e-02 +2.449723e+01 2.110020e+00 2.110020e+00 1.973009e-01 1.669273e-02 1.669273e-02 +2.911501e+01 2.507765e+00 2.507765e+00 9.582690e-02 9.407235e-03 9.407235e-03 +4.235561e+01 1.073283e+01 1.073283e+01 2.485965e-02 2.980908e-03 2.980908e-03 +1.521385e+02 9.905008e+01 9.905008e+01 6.553450e-04 2.239677e-04 2.239677e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d03-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t3 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 3.825805e+01 2.132329e+00 2.132329e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.456967e+01 1.874852e+00 1.874852e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.186146e+01 2.073565e+00 2.073565e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.725064e+01 2.240922e+00 2.240922e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.164457e+01 2.013365e+00 2.013365e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.581330e+01 1.969264e+00 1.969264e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.706655e+01 1.959374e+00 1.959374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.342732e+01 1.889673e+00 1.889673e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.799750e+01 1.819163e+00 1.819163e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.842780e+01 1.617673e+00 1.617673e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.718619e+01 1.371325e+00 1.371325e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.584674e+01 1.036562e+00 1.036562e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.614116e+01 7.093522e-01 7.093522e-01 -1.033040e+01 8.897879e-01 8.897879e-01 9.045228e+00 4.474669e-01 4.474669e-01 -1.227770e+01 1.057515e+00 1.057515e+00 4.427789e+00 2.435580e-01 2.435580e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.019382e+00 1.234920e-01 1.234920e-01 -1.734271e+01 1.493779e+00 1.493779e+00 9.245877e-01 6.312702e-02 6.312702e-02 -2.061185e+01 1.775360e+00 1.775360e+00 4.259970e-01 3.223159e-02 3.223159e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.973009e-01 1.669273e-02 1.669273e-02 -2.911501e+01 2.507763e+00 2.507763e+00 9.582690e-02 9.407234e-03 9.407234e-03 -4.235561e+01 1.073283e+01 1.073283e+01 2.485965e-02 2.980908e-03 2.980908e-03 -1.521385e+02 9.905010e+01 9.905010e+01 6.553450e-04 2.239677e-04 2.239677e-04 +1.094251e+00 9.425100e-02 9.425100e-02 4.293096e+01 2.110969e+00 2.110969e+00 +1.300520e+00 1.120180e-01 1.120180e-01 4.861914e+01 2.195320e+00 2.195320e+00 +1.545671e+00 1.331330e-01 1.331330e-01 5.609465e+01 2.545733e+00 2.545733e+00 +1.837033e+00 1.582290e-01 1.582290e-01 6.153895e+01 2.466814e+00 2.466814e+00 +2.183318e+00 1.880560e-01 1.880560e-01 6.701114e+01 2.540086e+00 2.540086e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.162482e+01 2.624353e+00 2.624353e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.193386e+01 2.613504e+00 2.613504e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.009972e+01 2.574767e+00 2.574767e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.352380e+01 2.411029e+00 2.411029e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.402443e+01 2.161510e+00 2.161510e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.118524e+01 1.760331e+00 1.760331e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.834015e+01 1.303844e+00 1.303844e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.757144e+01 8.684939e-01 8.684939e-01 +1.033039e+01 8.897855e-01 8.897855e-01 9.697945e+00 5.174777e-01 5.174777e-01 +1.227769e+01 1.057515e+00 1.057515e+00 4.935600e+00 2.853059e-01 2.853059e-01 +1.459207e+01 1.256860e+00 1.256860e+00 2.263465e+00 1.419259e-01 1.419259e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.014874e+00 6.779678e-02 6.779678e-02 +2.061185e+01 1.775360e+00 1.775360e+00 4.792074e-01 3.416910e-02 3.416910e-02 +2.449723e+01 2.110020e+00 2.110020e+00 2.281098e-01 1.750019e-02 1.750019e-02 +2.911501e+01 2.507765e+00 2.507765e+00 1.014171e-01 9.461653e-03 9.461653e-03 +4.235561e+01 1.073283e+01 1.073283e+01 2.928590e-02 2.888908e-03 2.888908e-03 +1.521385e+02 9.905008e+01 9.905008e+01 7.351820e-04 2.813170e-04 2.813170e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d03-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t3 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 2.881642e+01 3.087028e+00 3.087028e+00 +1.300520e+00 1.120180e-01 1.120180e-01 3.541813e+01 3.504118e+00 3.504118e+00 +1.545671e+00 1.331330e-01 1.331330e-01 4.309837e+01 3.922971e+00 3.922971e+00 +1.837033e+00 1.582290e-01 1.582290e-01 5.446910e+01 4.519699e+00 4.519699e+00 +2.183318e+00 1.880560e-01 1.880560e-01 6.478630e+01 4.867956e+00 4.867956e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.364876e+01 5.032232e+00 5.032232e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.815995e+01 4.910027e+00 4.910027e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.694848e+01 4.543025e+00 4.543025e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.738364e+01 3.835428e+00 3.835428e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.286911e+01 2.981522e+00 2.981522e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.679335e+01 2.099681e+00 2.099681e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.254818e+01 1.320902e+00 1.320902e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.275560e+01 7.729448e-01 7.729448e-01 +1.033039e+01 8.897855e-01 8.897855e-01 6.770748e+00 4.242428e-01 4.242428e-01 +1.227769e+01 1.057515e+00 1.057515e+00 3.611050e+00 2.341606e-01 2.341606e-01 +1.459207e+01 1.256860e+00 1.256860e+00 1.956713e+00 1.317280e-01 1.317280e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.102316e+00 7.694574e-02 7.694574e-02 +2.061185e+01 1.775360e+00 1.775360e+00 6.606707e-01 4.778213e-02 4.778213e-02 +2.449723e+01 2.110020e+00 2.110020e+00 3.906399e-01 2.888005e-02 2.888005e-02 +2.911501e+01 2.507765e+00 2.507765e+00 2.318652e-01 1.749068e-02 1.749068e-02 +4.235561e+01 1.073283e+01 1.073283e+01 7.602995e-02 6.437380e-03 6.437380e-03 +1.521385e+02 9.905008e+01 9.905008e+01 2.549474e-03 9.386827e-04 9.386827e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d03-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t3 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.881642e+01 3.184287e+00 3.184287e+00 -1.300520e+00 1.120177e-01 1.120177e-01 3.541813e+01 4.103723e+00 4.103723e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.309837e+01 4.948677e+00 4.948677e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.446910e+01 5.105418e+00 5.105418e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.478630e+01 5.780485e+00 5.780485e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.364876e+01 5.943595e+00 5.943595e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.815995e+01 5.620889e+00 5.620889e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.694848e+01 4.621943e+00 4.621943e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.738364e+01 3.852427e+00 3.852427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.286911e+01 3.498016e+00 3.498016e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.679335e+01 3.225438e+00 3.225438e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.254818e+01 2.250628e+00 2.250628e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.275560e+01 1.281082e+00 1.281082e+00 -1.033040e+01 8.897879e-01 8.897879e-01 6.770748e+00 5.681592e-01 5.681592e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.611050e+00 2.702737e-01 2.702737e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.956713e+00 1.317371e-01 1.317371e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.102316e+00 8.512634e-02 8.512634e-02 -2.061185e+01 1.775360e+00 1.775360e+00 6.606707e-01 5.283885e-02 5.283885e-02 -2.449723e+01 2.110020e+00 2.110020e+00 3.906399e-01 3.097488e-02 3.097488e-02 -2.911501e+01 2.507763e+00 2.507763e+00 2.318652e-01 1.783598e-02 1.783598e-02 -4.235561e+01 1.073283e+01 1.073283e+01 7.602995e-02 6.518094e-03 6.518094e-03 -1.521385e+02 9.905010e+01 9.905010e+01 2.549474e-03 9.406611e-04 9.406611e-04 +1.094251e+00 9.425100e-02 9.425100e-02 3.054415e+01 3.249874e+00 3.249874e+00 +1.300520e+00 1.120180e-01 1.120180e-01 3.895643e+01 3.853206e+00 3.853206e+00 +1.545671e+00 1.331330e-01 1.331330e-01 4.831488e+01 4.437400e+00 4.437400e+00 +1.837033e+00 1.582290e-01 1.582290e-01 5.889328e+01 4.981979e+00 4.981979e+00 +2.183318e+00 1.880560e-01 1.880560e-01 7.142207e+01 5.500780e+00 5.500780e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.082915e+01 5.654934e+00 5.654934e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.509163e+01 5.458915e+00 5.458915e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.237631e+01 4.947339e+00 4.947339e+00 +4.356293e+00 3.752205e-01 3.752205e-01 7.320272e+01 4.230066e+00 4.230066e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.792055e+01 3.317679e+00 3.317679e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.031634e+01 2.349643e+00 2.349643e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.525012e+01 1.533172e+00 1.533172e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.421738e+01 9.110141e-01 9.110141e-01 +1.033039e+01 8.897855e-01 8.897855e-01 7.636329e+00 5.199258e-01 5.199258e-01 +1.227769e+01 1.057515e+00 1.057515e+00 4.088181e+00 2.962577e-01 2.962577e-01 +1.459207e+01 1.256860e+00 1.256860e+00 2.175068e+00 1.684387e-01 1.684387e-01 +1.734271e+01 1.493780e+00 1.493780e+00 1.251217e+00 1.032032e-01 1.032032e-01 +2.061185e+01 1.775360e+00 1.775360e+00 7.286988e-01 6.362162e-02 6.362162e-02 +2.449723e+01 2.110020e+00 2.110020e+00 4.346953e-01 3.970041e-02 3.970041e-02 +2.911501e+01 2.507765e+00 2.507765e+00 2.554006e-01 2.422306e-02 2.422306e-02 +4.235561e+01 1.073283e+01 1.073283e+01 8.622328e-02 9.139957e-03 9.139957e-03 +1.521385e+02 9.905008e+01 9.905008e+01 3.104357e-03 1.318214e-03 1.318214e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d03-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t3 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.682484e+01 2.773024e+00 2.773024e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.828133e+01 2.762871e+00 2.762871e+00 +1.545671e+00 1.331330e-01 1.331330e-01 2.046424e+01 2.804589e+00 2.804589e+00 +1.837033e+00 1.582290e-01 1.582290e-01 2.362836e+01 2.875426e+00 2.875426e+00 +2.183318e+00 1.880560e-01 1.880560e-01 2.766107e+01 2.940943e+00 2.940943e+00 +2.594879e+00 2.235045e-01 2.235045e-01 3.191776e+01 2.908285e+00 2.908285e+00 +3.084018e+00 2.656355e-01 2.656355e-01 3.666802e+01 2.815931e+00 2.815931e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.147307e+01 2.656403e+00 2.656403e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.339596e+01 2.336582e+00 2.336582e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.334516e+01 2.024490e+00 2.024490e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.085062e+01 1.732362e+00 1.732362e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.558937e+01 1.441887e+00 1.441887e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.837609e+01 1.154952e+00 1.154952e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.084315e+01 8.708342e-01 8.708342e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.373487e+01 5.947813e-01 5.947813e-01 +1.459207e+01 1.256860e+00 1.256860e+00 8.163879e+00 3.771913e-01 3.771913e-01 +1.734271e+01 1.493780e+00 1.493780e+00 4.385102e+00 2.190721e-01 2.190721e-01 +2.061185e+01 1.775360e+00 1.775360e+00 2.196628e+00 1.176212e-01 1.176212e-01 +2.449723e+01 2.110020e+00 2.110020e+00 1.015347e+00 5.869818e-02 5.869818e-02 +2.911501e+01 2.507765e+00 2.507765e+00 4.771861e-01 2.965846e-02 2.965846e-02 +4.235561e+01 1.073283e+01 1.073283e+01 1.242446e-01 9.674939e-03 9.674939e-03 +1.521385e+02 9.905008e+01 9.905008e+01 3.307380e-03 1.240367e-03 1.240367e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d03-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d03-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t3 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.682484e+01 2.775045e+00 2.775045e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.828133e+01 2.959732e+00 2.959732e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.046424e+01 3.454675e+00 3.454675e+00 -1.837033e+00 1.582291e-01 1.582291e-01 2.362836e+01 3.753439e+00 3.753439e+00 -2.183318e+00 1.880557e-01 1.880557e-01 2.766107e+01 3.787512e+00 3.787512e+00 -2.594878e+00 2.235046e-01 2.235046e-01 3.191776e+01 3.914413e+00 3.914413e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.666802e+01 3.333615e+00 3.333615e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.147307e+01 2.770658e+00 2.770658e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.339596e+01 2.367097e+00 2.367097e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.334516e+01 2.025415e+00 2.025415e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.085062e+01 1.782907e+00 1.782907e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.558937e+01 1.627386e+00 1.627386e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.837609e+01 1.360519e+00 1.360519e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.084315e+01 1.203209e+00 1.203209e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.373487e+01 7.509009e-01 7.509009e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.163879e+00 3.989291e-01 3.989291e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.385102e+00 2.193429e-01 2.193429e-01 -2.061185e+01 1.775360e+00 1.775360e+00 2.196628e+00 1.176876e-01 1.176876e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.015347e+00 6.840886e-02 6.840886e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.771861e-01 3.368109e-02 3.368109e-02 -4.235561e+01 1.073283e+01 1.073283e+01 1.242446e-01 9.750337e-03 9.750337e-03 -1.521385e+02 9.905010e+01 9.905010e+01 3.307380e-03 1.247744e-03 1.247744e-03 +1.094251e+00 9.425100e-02 9.425100e-02 1.807404e+01 2.743010e+00 2.743010e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.974038e+01 2.765168e+00 2.765168e+00 +1.545671e+00 1.331330e-01 1.331330e-01 2.258086e+01 2.876975e+00 2.876975e+00 +1.837033e+00 1.582290e-01 1.582290e-01 2.631768e+01 3.000437e+00 3.000437e+00 +2.183318e+00 1.880560e-01 1.880560e-01 3.041710e+01 3.049389e+00 3.049389e+00 +2.594879e+00 2.235045e-01 2.235045e-01 3.545425e+01 3.063458e+00 3.063458e+00 +3.084018e+00 2.656355e-01 2.656355e-01 4.016491e+01 2.935571e+00 2.935571e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.413760e+01 2.709455e+00 2.709455e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.658950e+01 2.439278e+00 2.439278e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.733809e+01 2.197261e+00 2.197261e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.491304e+01 1.940286e+00 1.940286e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.939527e+01 1.665944e+00 1.665944e+00 +8.691945e+00 7.486635e-01 7.486635e-01 3.165172e+01 1.361287e+00 1.361287e+00 +1.033039e+01 8.897855e-01 8.897855e-01 2.292166e+01 1.024803e+00 1.024803e+00 +1.227769e+01 1.057515e+00 1.057515e+00 1.500764e+01 7.021121e-01 7.021121e-01 +1.459207e+01 1.256860e+00 1.256860e+00 8.872212e+00 4.355885e-01 4.355885e-01 +1.734271e+01 1.493780e+00 1.493780e+00 4.765093e+00 2.480922e-01 2.480922e-01 +2.061185e+01 1.775360e+00 1.775360e+00 2.406429e+00 1.352668e-01 1.352668e-01 +2.449723e+01 2.110020e+00 2.110020e+00 1.135963e+00 6.757665e-02 6.757665e-02 +2.911501e+01 2.507765e+00 2.507765e+00 5.431911e-01 3.371531e-02 3.371531e-02 +4.235561e+01 1.073283e+01 1.073283e+01 1.408271e-01 1.036551e-02 1.036551e-02 +1.521385e+02 9.905008e+01 9.905008e+01 3.860435e-03 1.351272e-03 1.351272e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d04-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t4 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 9.885554e+01 3.200561e+00 3.200561e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.162535e+02 3.652068e+00 3.652068e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.313626e+02 3.959102e+00 3.959102e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.383518e+02 4.186374e+00 4.186374e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.331527e+02 4.168645e+00 4.168645e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.164478e+02 3.919994e+00 3.919994e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.036059e+01 3.300917e+00 3.300917e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.110676e+01 2.499160e+00 2.499160e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.596948e+01 1.632962e+00 1.632962e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.816566e+01 9.529879e-01 9.529879e-01 +6.153426e+00 5.300130e-01 5.300130e-01 8.539847e+00 5.009957e-01 5.009957e-01 +7.313360e+00 6.299215e-01 6.299215e-01 3.888558e+00 2.581566e-01 2.581566e-01 +8.691945e+00 7.486635e-01 7.486635e-01 1.786535e+00 1.344000e-01 1.344000e-01 +1.033039e+01 8.897855e-01 8.897855e-01 8.314956e-01 6.952058e-02 6.952058e-02 +1.227769e+01 1.057515e+00 1.057515e+00 4.054816e-01 3.738897e-02 3.738897e-02 +1.459207e+01 1.256860e+00 1.256860e+00 2.128298e-01 2.141584e-02 2.141584e-02 +1.734271e+01 1.493780e+00 1.493780e+00 1.053347e-01 1.161575e-02 1.161575e-02 +2.578528e+01 6.948790e+00 6.948790e+00 2.816600e-02 3.624671e-03 3.624671e-03 +1.052810e+02 7.254691e+01 7.254691e+01 4.449689e-04 2.717053e-04 2.717053e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d04-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t4 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.885554e+01 3.200561e+00 3.200561e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.162535e+02 3.652068e+00 3.652068e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.313626e+02 3.959102e+00 3.959102e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.383518e+02 4.186373e+00 4.186373e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.331527e+02 4.168645e+00 4.168645e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.164478e+02 3.919994e+00 3.919994e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.036059e+01 3.300918e+00 3.300918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.110676e+01 2.499161e+00 2.499161e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.596948e+01 1.632962e+00 1.632962e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.816566e+01 9.529880e-01 9.529880e-01 -6.153426e+00 5.300130e-01 5.300130e-01 8.539847e+00 5.009957e-01 5.009957e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.888558e+00 2.581566e-01 2.581566e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.786535e+00 1.344000e-01 1.344000e-01 -1.033040e+01 8.897879e-01 8.897879e-01 8.314956e-01 6.952058e-02 6.952058e-02 -1.227770e+01 1.057515e+00 1.057515e+00 4.054816e-01 3.738897e-02 3.738897e-02 -1.459207e+01 1.256859e+00 1.256859e+00 2.128298e-01 2.141584e-02 2.141584e-02 -1.734271e+01 1.493779e+00 1.493779e+00 1.053347e-01 1.161575e-02 1.161575e-02 -2.578528e+01 6.948789e+00 6.948789e+00 2.816600e-02 3.624671e-03 3.624671e-03 -1.052810e+02 7.254694e+01 7.254694e+01 4.449689e-04 2.717053e-04 2.717053e-04 +1.094251e+00 9.425100e-02 9.425100e-02 1.079787e+02 4.989123e+00 4.989123e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.263857e+02 5.425003e+00 5.425003e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.434658e+02 6.000664e+00 6.000664e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.484398e+02 5.998707e+00 5.998707e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.461189e+02 5.774142e+00 5.774142e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.272327e+02 5.108486e+00 5.108486e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.903682e+01 4.113191e+00 4.113191e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.725462e+01 2.965163e+00 2.965163e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.964716e+01 1.894361e+00 1.894361e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.051853e+01 1.077560e+00 1.077560e+00 +6.153426e+00 5.300130e-01 5.300130e-01 9.645259e+00 5.647624e-01 5.647624e-01 +7.313360e+00 6.299215e-01 6.299215e-01 4.410872e+00 2.897027e-01 2.897027e-01 +8.691945e+00 7.486635e-01 7.486635e-01 1.987649e+00 1.465673e-01 1.465673e-01 +1.033039e+01 8.897855e-01 8.897855e-01 9.161403e-01 7.537564e-02 7.537564e-02 +1.227769e+01 1.057515e+00 1.057515e+00 4.604354e-01 4.196068e-02 4.196068e-02 +1.459207e+01 1.256860e+00 1.256860e+00 2.288308e-01 2.308427e-02 2.308427e-02 +1.734271e+01 1.493780e+00 1.493780e+00 1.266970e-01 1.422274e-02 1.422274e-02 +2.578528e+01 6.948790e+00 6.948790e+00 3.128341e-02 4.406323e-03 4.406323e-03 +1.052810e+02 7.254691e+01 7.254691e+01 6.087499e-04 2.340472e-04 2.340472e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d04-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t4 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 5.882263e+01 2.292783e+00 2.292783e+00 +1.300520e+00 1.120180e-01 1.120180e-01 6.470283e+01 2.500564e+00 2.500564e+00 +1.545671e+00 1.331330e-01 1.331330e-01 7.250723e+01 2.580587e+00 2.580587e+00 +1.837033e+00 1.582290e-01 1.582290e-01 7.702788e+01 2.377931e+00 2.377931e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.054703e+01 2.292748e+00 2.292748e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.048331e+01 2.228106e+00 2.228106e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.567593e+01 2.181178e+00 2.181178e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.775227e+01 2.095444e+00 2.095444e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.645931e+01 1.913337e+00 1.913337e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.313660e+01 1.628139e+00 1.628139e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.935159e+01 1.252820e+00 1.252820e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.791051e+01 8.553304e-01 8.553304e-01 +8.691945e+00 7.486635e-01 7.486635e-01 9.604666e+00 5.329800e-01 5.329800e-01 +1.033039e+01 8.897855e-01 8.897855e-01 4.453450e+00 2.837638e-01 2.837638e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.813519e+00 1.315454e-01 1.315454e-01 +1.459207e+01 1.256860e+00 1.256860e+00 6.817703e-01 5.765196e-02 5.765196e-02 +1.734271e+01 1.493780e+00 1.493780e+00 2.490194e-01 2.471691e-02 2.471691e-02 +2.578528e+01 6.948790e+00 6.948790e+00 4.029429e-02 5.628156e-03 5.628156e-03 +1.052810e+02 7.254691e+01 7.254691e+01 5.240726e-04 3.465856e-04 3.465856e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d04-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t4 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.882263e+01 2.292783e+00 2.292783e+00 -1.300520e+00 1.120177e-01 1.120177e-01 6.470283e+01 2.500564e+00 2.500564e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.250723e+01 2.580587e+00 2.580587e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.702788e+01 2.377931e+00 2.377931e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.054703e+01 2.292748e+00 2.292748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.048331e+01 2.228106e+00 2.228106e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.567593e+01 2.181178e+00 2.181178e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.775227e+01 2.095443e+00 2.095443e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.645931e+01 1.913337e+00 1.913337e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.313660e+01 1.628139e+00 1.628139e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.935159e+01 1.252820e+00 1.252820e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791051e+01 8.553304e-01 8.553304e-01 -8.691946e+00 7.486632e-01 7.486632e-01 9.604666e+00 5.329800e-01 5.329800e-01 -1.033040e+01 8.897879e-01 8.897879e-01 4.453450e+00 2.837638e-01 2.837638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.813519e+00 1.315454e-01 1.315454e-01 -1.459207e+01 1.256859e+00 1.256859e+00 6.817703e-01 5.765197e-02 5.765197e-02 -1.734271e+01 1.493779e+00 1.493779e+00 2.490194e-01 2.471691e-02 2.471691e-02 -2.578528e+01 6.948789e+00 6.948789e+00 4.029429e-02 5.628156e-03 5.628156e-03 -1.052810e+02 7.254694e+01 7.254694e+01 5.240726e-04 3.465856e-04 3.465856e-04 +1.094251e+00 9.425100e-02 9.425100e-02 6.405010e+01 3.305086e+00 3.305086e+00 +1.300520e+00 1.120180e-01 1.120180e-01 6.982975e+01 3.759749e+00 3.759749e+00 +1.545671e+00 1.331330e-01 1.331330e-01 7.889275e+01 4.096686e+00 4.096686e+00 +1.837033e+00 1.582290e-01 1.582290e-01 8.418519e+01 3.732333e+00 3.732333e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.709613e+01 3.388761e+00 3.388761e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.674182e+01 3.277572e+00 3.277572e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.310074e+01 3.145644e+00 3.145644e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.494931e+01 2.926590e+00 2.926590e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.245284e+01 2.568679e+00 2.568679e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.745896e+01 2.083924e+00 2.083924e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.245890e+01 1.550780e+00 1.550780e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.956062e+01 1.029051e+00 1.029051e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.052059e+01 6.077691e-01 6.077691e-01 +1.033039e+01 8.897855e-01 8.897855e-01 4.889040e+00 3.216290e-01 3.216290e-01 +1.227769e+01 1.057515e+00 1.057515e+00 2.006712e+00 1.454006e-01 1.454006e-01 +1.459207e+01 1.256860e+00 1.256860e+00 7.434723e-01 5.934733e-02 5.934733e-02 +1.734271e+01 1.493780e+00 1.493780e+00 2.778243e-01 2.511918e-02 2.511918e-02 +2.578528e+01 6.948790e+00 6.948790e+00 4.681878e-02 5.831705e-03 5.831705e-03 +1.052810e+02 7.254691e+01 7.254691e+01 6.275875e-04 4.172922e-04 4.172922e-04 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d04-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t4 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 4.435487e+01 3.745675e+00 3.745675e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.209309e+01 4.093803e+00 4.093803e+00 +1.545671e+00 1.331330e-01 1.331330e-01 6.287368e+01 4.565743e+00 4.565743e+00 +1.837033e+00 1.582290e-01 1.582290e-01 7.545967e+01 5.046374e+00 5.046374e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.598034e+01 5.287537e+00 5.287537e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.154772e+01 5.248568e+00 5.248568e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.997620e+01 4.970707e+00 4.970707e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.130906e+01 4.501212e+00 4.501212e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.498983e+01 3.705307e+00 3.705307e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.646111e+01 2.772935e+00 2.772935e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.878732e+01 1.816101e+00 1.816101e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.569215e+01 1.043871e+00 1.043871e+00 +8.691945e+00 7.486635e-01 7.486635e-01 7.814674e+00 5.452537e-01 5.452537e-01 +1.033039e+01 8.897855e-01 8.897855e-01 3.667297e+00 2.680264e-01 2.680264e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.739567e+00 1.333355e-01 1.333355e-01 +1.459207e+01 1.256860e+00 1.256860e+00 8.788418e-01 7.145866e-02 7.145866e-02 +1.734271e+01 1.493780e+00 1.493780e+00 4.568760e-01 3.989304e-02 3.989304e-02 +2.578528e+01 6.948790e+00 6.948790e+00 1.258431e-01 1.339778e-02 1.339778e-02 +1.052810e+02 7.254691e+01 7.254691e+01 2.892487e-03 1.463732e-03 1.463732e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d04-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t4 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.435487e+01 3.889083e+00 3.889083e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.209309e+01 4.855428e+00 4.855428e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.287368e+01 5.572386e+00 5.572386e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.545967e+01 6.059383e+00 6.059383e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.598034e+01 6.488784e+00 6.488784e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.154772e+01 6.141299e+00 6.141299e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.997620e+01 5.433714e+00 5.433714e+00 -3.665363e+00 3.157087e-01 3.157087e-01 8.130906e+01 4.501465e+00 4.501465e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.498983e+01 3.862690e+00 3.862690e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.646111e+01 3.652489e+00 3.652489e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.878732e+01 2.937814e+00 2.937814e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.569215e+01 1.807114e+00 1.807114e+00 -8.691946e+00 7.486632e-01 7.486632e-01 7.814674e+00 9.384991e-01 9.384991e-01 -1.033040e+01 8.897879e-01 8.897879e-01 3.667297e+00 3.611024e-01 3.611024e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.739567e+00 1.507552e-01 1.507552e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.788418e-01 7.414731e-02 7.414731e-02 -1.734271e+01 1.493779e+00 1.493779e+00 4.568760e-01 3.994794e-02 3.994794e-02 -2.578528e+01 6.948789e+00 6.948789e+00 1.258431e-01 1.477115e-02 1.477115e-02 -1.052810e+02 7.254694e+01 7.254694e+01 2.892487e-03 1.477522e-03 1.477522e-03 +1.094251e+00 9.425100e-02 9.425100e-02 4.762864e+01 4.209662e+00 4.209662e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.664556e+01 4.733728e+00 4.733728e+00 +1.545671e+00 1.331330e-01 1.331330e-01 6.914748e+01 5.454663e+00 5.454663e+00 +1.837033e+00 1.582290e-01 1.582290e-01 8.312393e+01 6.112697e+00 6.112697e+00 +2.183318e+00 1.880560e-01 1.880560e-01 9.331615e+01 6.342217e+00 6.342217e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.001164e+02 6.304133e+00 6.304133e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.802485e+01 5.861906e+00 5.861906e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.815435e+01 5.156781e+00 5.156781e+00 +4.356293e+00 3.752205e-01 3.752205e-01 7.084827e+01 4.171154e+00 4.171154e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.069082e+01 3.076295e+00 3.076295e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.188532e+01 2.022874e+00 2.022874e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.761366e+01 1.174841e+00 1.174841e+00 +8.691945e+00 7.486635e-01 7.486635e-01 8.878000e+00 6.241234e-01 6.241234e-01 +1.033039e+01 8.897855e-01 8.897855e-01 4.187439e+00 3.097750e-01 3.097750e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.985771e+00 1.545758e-01 1.545758e-01 +1.459207e+01 1.256860e+00 1.256860e+00 9.657775e-01 7.895146e-02 7.895146e-02 +1.734271e+01 1.493780e+00 1.493780e+00 4.995161e-01 4.280237e-02 4.280237e-02 +2.578528e+01 6.948790e+00 6.948790e+00 1.393391e-01 1.352599e-02 1.352599e-02 +1.052810e+02 7.254691e+01 7.254691e+01 3.436309e-03 2.007831e-03 2.007831e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d04-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t4 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 2.776041e+01 3.633048e+00 3.633048e+00 +1.300520e+00 1.120180e-01 1.120180e-01 2.870623e+01 3.426749e+00 3.426749e+00 +1.545671e+00 1.331330e-01 1.331330e-01 3.277519e+01 3.481665e+00 3.481665e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.618779e+01 3.355720e+00 3.355720e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.078765e+01 3.238283e+00 3.238283e+00 +2.594879e+00 2.235045e-01 2.235045e-01 4.594333e+01 3.063130e+00 3.063130e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.023071e+01 2.764967e+00 2.764967e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.215694e+01 2.402601e+00 2.402601e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.091776e+01 2.080922e+00 2.080922e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.784093e+01 1.869393e+00 1.869393e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.174255e+01 1.653855e+00 1.653855e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.366862e+01 1.404561e+00 1.404561e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.424719e+01 1.082463e+00 1.082463e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.564452e+01 7.528840e-01 7.528840e-01 +1.227769e+01 1.057515e+00 1.057515e+00 9.107407e+00 4.728829e-01 4.728829e-01 +1.459207e+01 1.256860e+00 1.256860e+00 4.760648e+00 2.722528e-01 2.722528e-01 +1.734271e+01 1.493780e+00 1.493780e+00 2.128365e+00 1.353544e-01 1.353544e-01 +2.578528e+01 6.948790e+00 6.948790e+00 3.678572e-01 2.838799e-02 2.838799e-02 +1.052810e+02 7.254691e+01 7.254691e+01 3.394696e-03 1.645979e-03 1.645979e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d04-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d04-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t4 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.776041e+01 3.719074e+00 3.719074e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.870623e+01 4.074104e+00 4.074104e+00 -1.545671e+00 1.331332e-01 1.331332e-01 3.277519e+01 4.122582e+00 4.122582e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.618779e+01 4.839969e+00 4.839969e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.078765e+01 4.392209e+00 4.392209e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.594333e+01 3.956333e+00 3.956333e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.023071e+01 3.190471e+00 3.190471e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.215694e+01 2.599895e+00 2.599895e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.091776e+01 2.394251e+00 2.394251e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.784093e+01 1.870451e+00 1.870451e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.174255e+01 1.756402e+00 1.756402e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.366862e+01 1.808922e+00 1.808922e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.424719e+01 1.453099e+00 1.453099e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.564452e+01 9.437791e-01 9.437791e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.107407e+00 5.754803e-01 5.754803e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.760648e+00 3.105451e-01 3.105451e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.128365e+00 1.355363e-01 1.355363e-01 -2.578528e+01 6.948789e+00 6.948789e+00 3.678572e-01 2.884769e-02 2.884769e-02 -1.052810e+02 7.254694e+01 7.254694e+01 3.394696e-03 1.648326e-03 1.648326e-03 +1.094251e+00 9.425100e-02 9.425100e-02 3.016161e+01 3.720705e+00 3.720705e+00 +1.300520e+00 1.120180e-01 1.120180e-01 3.196846e+01 3.654997e+00 3.654997e+00 +1.545671e+00 1.331330e-01 1.331330e-01 3.545942e+01 3.696277e+00 3.696277e+00 +1.837033e+00 1.582290e-01 1.582290e-01 3.931159e+01 3.672592e+00 3.672592e+00 +2.183318e+00 1.880560e-01 1.880560e-01 4.499675e+01 3.695665e+00 3.695665e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.018350e+01 3.540618e+00 3.540618e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.435936e+01 3.217843e+00 3.217843e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.593023e+01 2.791063e+00 2.791063e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.610249e+01 2.472712e+00 2.472712e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.223655e+01 2.161551e+00 2.161551e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.609282e+01 1.899682e+00 1.899682e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.692031e+01 1.576734e+00 1.576734e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.680363e+01 1.212458e+00 1.212458e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.736401e+01 8.479462e-01 8.479462e-01 +1.227769e+01 1.057515e+00 1.057515e+00 1.000143e+01 5.297374e-01 5.297374e-01 +1.459207e+01 1.256860e+00 1.256860e+00 5.172922e+00 3.011173e-01 3.011173e-01 +1.734271e+01 1.493780e+00 1.493780e+00 2.325926e+00 1.507078e-01 1.507078e-01 +2.578528e+01 6.948790e+00 6.948790e+00 4.074405e-01 3.060293e-02 3.060293e-02 +1.052810e+02 7.254691e+01 7.254691e+01 4.026210e-03 2.303790e-03 2.303790e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d05-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t5 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.282547e+02 4.495419e+00 4.495419e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.441616e+02 4.551329e+00 4.551329e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.554467e+02 4.930296e+00 4.930296e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.518138e+02 4.855627e+00 4.855627e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.381979e+02 4.674796e+00 4.674796e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.120464e+02 4.152742e+00 4.152742e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.927851e+01 3.243677e+00 3.243677e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.794843e+01 2.249475e+00 2.249475e+00 +4.356293e+00 3.752205e-01 3.752205e-01 2.456896e+01 1.325989e+00 1.325989e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.126478e+01 7.082665e-01 7.082665e-01 +6.153426e+00 5.300130e-01 5.300130e-01 4.576736e+00 3.390739e-01 3.390739e-01 +7.313360e+00 6.299215e-01 6.299215e-01 1.839542e+00 1.599528e-01 1.599528e-01 +8.691945e+00 7.486635e-01 7.486635e-01 7.291075e-01 7.403617e-02 7.403617e-02 +1.033039e+01 8.897855e-01 8.897855e-01 3.266208e-01 3.823044e-02 3.823044e-02 +1.470859e+01 3.488415e+00 3.488415e+00 8.094901e-02 1.213269e-02 1.213269e-02 +4.659322e+01 2.839621e+01 2.839620e+01 1.955645e-03 6.906708e-04 6.906708e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d05-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t5 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.282547e+02 4.495419e+00 4.495419e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.441616e+02 4.551329e+00 4.551329e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.554467e+02 4.930296e+00 4.930296e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.518138e+02 4.855627e+00 4.855627e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.381979e+02 4.674796e+00 4.674796e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.120464e+02 4.152741e+00 4.152741e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.927851e+01 3.243676e+00 3.243676e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.794843e+01 2.249475e+00 2.249475e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.456896e+01 1.325989e+00 1.325989e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.126478e+01 7.082665e-01 7.082665e-01 -6.153426e+00 5.300130e-01 5.300130e-01 4.576736e+00 3.390739e-01 3.390739e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.839542e+00 1.599527e-01 1.599527e-01 -8.691946e+00 7.486632e-01 7.486632e-01 7.291075e-01 7.403617e-02 7.403617e-02 -1.033040e+01 8.897879e-01 8.897879e-01 3.266208e-01 3.823044e-02 3.823044e-02 -1.470860e+01 3.488412e+00 3.488412e+00 8.094901e-02 1.213269e-02 1.213269e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.955645e-03 6.906708e-04 6.906708e-04 +1.094251e+00 9.425100e-02 9.425100e-02 1.395718e+02 6.405057e+00 6.405057e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.558903e+02 6.945840e+00 6.945840e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.673105e+02 7.029831e+00 7.029831e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.678157e+02 6.799416e+00 6.799416e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.512708e+02 6.149089e+00 6.149089e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.228637e+02 5.078318e+00 5.078318e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.667540e+01 3.769570e+00 3.769570e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.314198e+01 2.486737e+00 2.486737e+00 +4.356293e+00 3.752205e-01 3.752205e-01 2.759998e+01 1.424893e+00 1.424893e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.247692e+01 7.201134e-01 7.201134e-01 +6.153426e+00 5.300130e-01 5.300130e-01 5.184451e+00 3.439476e-01 3.439476e-01 +7.313360e+00 6.299215e-01 6.299215e-01 2.061741e+00 1.594196e-01 1.594196e-01 +8.691945e+00 7.486635e-01 7.486635e-01 8.589687e-01 7.649177e-02 7.649177e-02 +1.033039e+01 8.897855e-01 8.897855e-01 3.441581e-01 3.622475e-02 3.622475e-02 +1.470859e+01 3.488415e+00 3.488415e+00 8.863667e-02 1.185290e-02 1.185290e-02 +4.659322e+01 2.839621e+01 2.839620e+01 2.623259e-03 1.191193e-03 1.191193e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d05-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t5 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 7.784720e+01 3.466123e+00 3.466123e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.471003e+01 3.403124e+00 3.403124e+00 +1.545671e+00 1.331330e-01 1.331330e-01 9.270208e+01 3.409070e+00 3.409070e+00 +1.837033e+00 1.582290e-01 1.582290e-01 9.361033e+01 2.937066e+00 2.937066e+00 +2.183318e+00 1.880560e-01 1.880560e-01 9.303931e+01 2.684747e+00 2.684747e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.780759e+01 2.532749e+00 2.532749e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.869744e+01 2.422137e+00 2.422137e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.538040e+01 2.230595e+00 2.230595e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.021120e+01 1.934217e+00 1.934217e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.455953e+01 1.504869e+00 1.504869e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.137445e+01 1.058821e+00 1.058821e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.152285e+01 6.473931e-01 6.473931e-01 +8.691945e+00 7.486635e-01 7.486635e-01 5.180351e+00 3.424252e-01 3.424252e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.953442e+00 1.476519e-01 1.476519e-01 +1.470859e+01 3.488415e+00 3.488415e+00 2.899589e-01 3.034985e-02 3.034985e-02 +4.659322e+01 2.839621e+01 2.839620e+01 2.310976e-03 1.034278e-03 1.034278e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d05-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t5 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.784720e+01 3.466123e+00 3.466123e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.471003e+01 3.403124e+00 3.403124e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.270208e+01 3.409070e+00 3.409070e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.361033e+01 2.937067e+00 2.937067e+00 -2.183318e+00 1.880557e-01 1.880557e-01 9.303931e+01 2.684748e+00 2.684748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.780759e+01 2.532749e+00 2.532749e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.869744e+01 2.422137e+00 2.422137e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.538040e+01 2.230595e+00 2.230595e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.021120e+01 1.934217e+00 1.934217e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.455953e+01 1.504869e+00 1.504869e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.137445e+01 1.058821e+00 1.058821e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.152285e+01 6.473931e-01 6.473931e-01 -8.691946e+00 7.486632e-01 7.486632e-01 5.180351e+00 3.424252e-01 3.424252e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.953442e+00 1.476519e-01 1.476519e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.899589e-01 3.034985e-02 3.034985e-02 -4.659321e+01 2.839621e+01 2.839621e+01 2.310976e-03 1.034278e-03 1.034278e-03 +1.094251e+00 9.425100e-02 9.425100e-02 8.635057e+01 4.574929e+00 4.574929e+00 +1.300520e+00 1.120180e-01 1.120180e-01 9.324394e+01 5.005081e+00 5.005081e+00 +1.545671e+00 1.331330e-01 1.331330e-01 9.916695e+01 4.725947e+00 4.725947e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.025510e+02 4.405271e+00 4.405271e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.010255e+02 4.087662e+00 4.087662e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.557165e+01 3.776521e+00 3.776521e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.671854e+01 3.479497e+00 3.479497e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.284062e+01 3.052218e+00 3.052218e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.525195e+01 2.490535e+00 2.490535e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.817975e+01 1.881674e+00 1.881674e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.332998e+01 1.270457e+00 1.270457e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.231627e+01 7.576479e-01 7.576479e-01 +8.691945e+00 7.486635e-01 7.486635e-01 5.743059e+00 3.927521e-01 3.927521e-01 +1.033039e+01 8.897855e-01 8.897855e-01 2.296401e+00 2.069868e-01 2.069868e-01 +1.470859e+01 3.488415e+00 3.488415e+00 3.193594e-01 3.415192e-02 3.415192e-02 +4.659322e+01 2.839621e+01 2.839620e+01 2.760678e-03 1.805997e-03 1.805997e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d05-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t5 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 5.975401e+01 4.410433e+00 4.410433e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.037482e+01 4.820224e+00 4.820224e+00 +1.545671e+00 1.331330e-01 1.331330e-01 8.180272e+01 5.147867e+00 5.147867e+00 +1.837033e+00 1.582290e-01 1.582290e-01 9.500909e+01 5.461721e+00 5.461721e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.031646e+02 5.440189e+00 5.440189e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.037997e+02 5.204354e+00 5.204354e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.493794e+01 4.853788e+00 4.853788e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.917580e+01 4.372251e+00 4.372251e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.899103e+01 3.604816e+00 3.604816e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.807908e+01 2.575920e+00 2.575920e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.109440e+01 1.552826e+00 1.552826e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.046011e+01 8.161463e-01 8.161463e-01 +8.691945e+00 7.486635e-01 7.486635e-01 4.573584e+00 3.720519e-01 3.720519e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.947476e+00 1.639643e-01 1.639643e-01 +1.470859e+01 3.488415e+00 3.488415e+00 4.517690e-01 4.255710e-02 4.255710e-02 +4.659322e+01 2.839621e+01 2.839620e+01 1.251025e-02 6.054230e-03 6.054230e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d05-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t5 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.975401e+01 4.780191e+00 4.780191e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.037482e+01 5.031803e+00 5.031803e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.180272e+01 6.433829e+00 6.433829e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.500909e+01 6.471448e+00 6.471448e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.031646e+02 6.682150e+00 6.682150e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.037997e+02 5.923222e+00 5.923222e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.493794e+01 5.171054e+00 5.171054e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.917580e+01 4.403367e+00 4.403367e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.899103e+01 4.399506e+00 4.399506e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.807908e+01 3.763334e+00 3.763334e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.109440e+01 2.316910e+00 2.316910e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.046011e+01 1.423077e+00 1.423077e+00 -8.691946e+00 7.486632e-01 7.486632e-01 4.573584e+00 5.710347e-01 5.710347e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.947476e+00 2.191623e-01 2.191623e-01 -1.470860e+01 3.488412e+00 3.488412e+00 4.517690e-01 4.478067e-02 4.478067e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.251025e-02 6.122581e-03 6.122581e-03 +1.094251e+00 9.425100e-02 9.425100e-02 6.498880e+01 5.383582e+00 5.383582e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.532019e+01 5.900597e+00 5.900597e+00 +1.545671e+00 1.331330e-01 1.331330e-01 9.002886e+01 6.592533e+00 6.592533e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.027163e+02 6.954118e+00 6.954118e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.128741e+02 6.970006e+00 6.970006e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.136051e+02 6.491449e+00 6.491449e+00 +3.084018e+00 2.656355e-01 2.656355e-01 1.036311e+02 5.774917e+00 5.774917e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.663791e+01 4.953866e+00 4.953866e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.423013e+01 3.906268e+00 3.906268e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.196576e+01 2.769696e+00 2.769696e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.358113e+01 1.688299e+00 1.688299e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.166535e+01 8.969471e-01 8.969471e-01 +8.691945e+00 7.486635e-01 7.486635e-01 5.213879e+00 4.248236e-01 4.248236e-01 +1.033039e+01 8.897855e-01 8.897855e-01 2.217303e+00 1.913602e-01 1.913602e-01 +1.470859e+01 3.488415e+00 3.488415e+00 4.981092e-01 4.830775e-02 4.830775e-02 +4.659322e+01 2.839621e+01 2.839620e+01 1.480167e-02 5.955226e-03 5.955226e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d05-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t5 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 4.051657e+01 4.259140e+00 4.259140e+00 +1.300520e+00 1.120180e-01 1.120180e-01 4.214451e+01 4.070680e+00 4.070680e+00 +1.545671e+00 1.331330e-01 1.331330e-01 4.500144e+01 3.882422e+00 3.882422e+00 +1.837033e+00 1.582290e-01 1.582290e-01 4.997332e+01 3.755515e+00 3.755515e+00 +2.183318e+00 1.880560e-01 1.880560e-01 5.386147e+01 3.452119e+00 3.452119e+00 +2.594879e+00 2.235045e-01 2.235045e-01 5.801363e+01 3.078745e+00 3.078745e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.003854e+01 2.620103e+00 2.620103e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.921527e+01 2.241357e+00 2.241357e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.479089e+01 2.001998e+00 2.001998e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.818663e+01 1.846461e+00 1.846461e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.871403e+01 1.611246e+00 1.611246e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.857481e+01 1.309090e+00 1.309090e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.898611e+01 9.723641e-01 9.723641e-01 +1.033039e+01 8.897855e-01 8.897855e-01 1.114301e+01 6.348330e-01 6.348330e-01 +1.470859e+01 3.488415e+00 3.488415e+00 2.975518e+00 2.171901e-01 2.171901e-01 +4.659322e+01 2.839621e+01 2.839620e+01 3.408777e-02 1.251514e-02 1.251514e-02 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d05-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d05-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t5 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.051657e+01 4.331477e+00 4.331477e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.214451e+01 4.325586e+00 4.325586e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.500144e+01 5.369061e+00 5.369061e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.997332e+01 4.513757e+00 4.513757e+00 -2.183318e+00 1.880557e-01 1.880557e-01 5.386147e+01 4.881501e+00 4.881501e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.801363e+01 4.263432e+00 4.263432e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.003854e+01 3.248399e+00 3.248399e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.921527e+01 2.602904e+00 2.602904e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.479089e+01 2.198592e+00 2.198592e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.818663e+01 1.861504e+00 1.861504e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.871403e+01 1.744075e+00 1.744075e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.857481e+01 1.653738e+00 1.653738e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.898611e+01 1.313188e+00 1.313188e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.114301e+01 8.578990e-01 8.578990e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.975518e+00 2.320256e-01 2.320256e-01 -4.659321e+01 2.839621e+01 2.839621e+01 3.408777e-02 1.255299e-02 1.255299e-02 +1.094251e+00 9.425100e-02 9.425100e-02 4.354768e+01 4.889217e+00 4.889217e+00 +1.300520e+00 1.120180e-01 1.120180e-01 4.520445e+01 4.696602e+00 4.696602e+00 +1.545671e+00 1.331330e-01 1.331330e-01 4.876313e+01 4.578610e+00 4.578610e+00 +1.837033e+00 1.582290e-01 1.582290e-01 5.379519e+01 4.471230e+00 4.471230e+00 +2.183318e+00 1.880560e-01 1.880560e-01 5.934289e+01 4.253261e+00 4.253261e+00 +2.594879e+00 2.235045e-01 2.235045e-01 6.357298e+01 3.797789e+00 3.797789e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.545463e+01 3.214782e+00 3.214782e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.414850e+01 2.711473e+00 2.711473e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.065913e+01 2.418284e+00 2.418284e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.242332e+01 2.121054e+00 2.121054e+00 +6.153426e+00 5.300130e-01 5.300130e-01 4.322055e+01 1.856853e+00 1.856853e+00 +7.313360e+00 6.299215e-01 6.299215e-01 3.165498e+01 1.463863e+00 1.463863e+00 +8.691945e+00 7.486635e-01 7.486635e-01 2.087061e+01 1.064243e+00 1.064243e+00 +1.033039e+01 8.897855e-01 8.897855e-01 1.205807e+01 6.998072e-01 6.998072e-01 +1.470859e+01 3.488415e+00 3.488415e+00 3.268261e+00 2.357884e-01 2.357884e-01 +4.659322e+01 2.839621e+01 2.839620e+01 3.894609e-02 1.279519e-02 1.279519e-02 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d06-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t6 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.540999e+02 5.400660e+00 5.400660e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.677234e+02 5.670469e+00 5.670469e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.690748e+02 5.730830e+00 5.730830e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.605293e+02 5.573070e+00 5.573070e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.361445e+02 5.074010e+00 5.074010e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.018434e+02 4.222728e+00 4.222728e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.570199e+01 3.055339e+00 3.055339e+00 +3.665363e+00 3.157090e-01 3.157090e-01 3.587913e+01 1.938510e+00 1.938510e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.653357e+01 1.050642e+00 1.050642e+00 +5.177463e+00 4.459500e-01 4.459500e-01 6.614902e+00 5.066171e-01 5.066171e-01 +6.153426e+00 5.300130e-01 5.300130e-01 2.430457e+00 2.259669e-01 2.259669e-01 +7.313360e+00 6.299215e-01 6.299215e-01 8.518671e-01 9.737783e-02 9.737783e-02 +8.691945e+00 7.486635e-01 7.486635e-01 3.119018e-01 4.348546e-02 4.348546e-02 +1.186477e+01 2.424165e+00 2.424166e+00 7.097755e-02 1.314644e-02 1.314644e-02 +3.368869e+01 1.939975e+01 1.939975e+01 1.964470e-03 6.198766e-04 6.198766e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d06-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t6 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.540999e+02 5.400660e+00 5.400660e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.677234e+02 5.670468e+00 5.670468e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.690748e+02 5.730831e+00 5.730831e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.605293e+02 5.573070e+00 5.573070e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.361445e+02 5.074010e+00 5.074010e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.018434e+02 4.222728e+00 4.222728e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.570199e+01 3.055339e+00 3.055339e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.587913e+01 1.938509e+00 1.938509e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.653357e+01 1.050642e+00 1.050642e+00 -5.177463e+00 4.459503e-01 4.459503e-01 6.614902e+00 5.066172e-01 5.066172e-01 -6.153426e+00 5.300130e-01 5.300130e-01 2.430457e+00 2.259669e-01 2.259669e-01 -7.313361e+00 6.299216e-01 6.299216e-01 8.518671e-01 9.737783e-02 9.737783e-02 -8.691946e+00 7.486632e-01 7.486632e-01 3.119018e-01 4.348545e-02 4.348545e-02 -1.186477e+01 2.424165e+00 2.424165e+00 7.097755e-02 1.314645e-02 1.314645e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.964470e-03 6.198766e-04 6.198766e-04 +1.094251e+00 9.425100e-02 9.425100e-02 1.655369e+02 7.942126e+00 7.942126e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.797353e+02 8.317293e+00 8.317293e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.863861e+02 8.050782e+00 8.050782e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.767411e+02 7.399335e+00 7.399335e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.502191e+02 6.347744e+00 6.347744e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.118386e+02 4.930531e+00 4.930531e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.227413e+01 3.415321e+00 3.415321e+00 +3.665363e+00 3.157090e-01 3.157090e-01 3.968997e+01 2.065995e+00 2.065995e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.823870e+01 1.073622e+00 1.073622e+00 +5.177463e+00 4.459500e-01 4.459500e-01 7.428299e+00 5.058248e-01 5.058248e-01 +6.153426e+00 5.300130e-01 5.300130e-01 2.676561e+00 2.148400e-01 2.148400e-01 +7.313360e+00 6.299215e-01 6.299215e-01 9.265137e-01 8.938354e-02 8.938354e-02 +8.691945e+00 7.486635e-01 7.486635e-01 3.475978e-01 3.898784e-02 3.898784e-02 +1.186477e+01 2.424165e+00 2.424166e+00 8.339894e-02 1.274556e-02 1.274556e-02 +3.368869e+01 1.939975e+01 1.939975e+01 2.694413e-03 1.400858e-03 1.400858e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d06-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t6 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.009206e+02 4.254964e+00 4.254964e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.032097e+02 3.947937e+00 3.947937e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.078605e+02 3.754433e+00 3.754433e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.062566e+02 3.310802e+00 3.310802e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.003631e+02 3.032044e+00 3.032044e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.012799e+01 2.828788e+00 2.828788e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.600011e+01 2.605077e+00 2.605077e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.914099e+01 2.295534e+00 2.295534e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.145433e+01 1.824428e+00 1.824428e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.622124e+01 1.308171e+00 1.308171e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.445378e+01 8.218370e-01 8.218370e-01 +7.313360e+00 6.299215e-01 6.299215e-01 6.744587e+00 4.407551e-01 4.407551e-01 +8.691945e+00 7.486635e-01 7.486635e-01 2.587733e+00 2.032481e-01 2.032481e-01 +1.186477e+01 2.424165e+00 2.424166e+00 4.186745e-01 4.068445e-02 4.068445e-02 +3.368869e+01 1.939975e+01 1.939975e+01 3.066196e-03 1.368755e-03 1.368755e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d06-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t6 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.009206e+02 4.254964e+00 4.254964e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.032097e+02 3.947937e+00 3.947937e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.078605e+02 3.754433e+00 3.754433e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.062566e+02 3.310802e+00 3.310802e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.003631e+02 3.032044e+00 3.032044e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.012799e+01 2.828788e+00 2.828788e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.600011e+01 2.605077e+00 2.605077e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.914099e+01 2.295534e+00 2.295534e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.145433e+01 1.824427e+00 1.824427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.622124e+01 1.308172e+00 1.308172e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.445378e+01 8.218370e-01 8.218370e-01 -7.313361e+00 6.299216e-01 6.299216e-01 6.744587e+00 4.407550e-01 4.407550e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.587733e+00 2.032481e-01 2.032481e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.186745e-01 4.068445e-02 4.068445e-02 -3.368869e+01 1.939975e+01 1.939975e+01 3.066196e-03 1.368754e-03 1.368754e-03 +1.094251e+00 9.425100e-02 9.425100e-02 1.089671e+02 6.204661e+00 6.204661e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.117076e+02 6.005288e+00 6.005288e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.169400e+02 5.842534e+00 5.842534e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.168674e+02 5.222190e+00 5.222190e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.104588e+02 4.560269e+00 4.560269e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.852990e+01 4.048077e+00 4.048077e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.399214e+01 3.550379e+00 3.550379e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.569405e+01 2.948431e+00 2.948431e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.616995e+01 2.269135e+00 2.269135e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.869472e+01 1.560893e+00 1.560893e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.570045e+01 9.587347e-01 9.587347e-01 +7.313360e+00 6.299215e-01 6.299215e-01 7.281943e+00 4.895680e-01 4.895680e-01 +8.691945e+00 7.486635e-01 7.486635e-01 2.876508e+00 2.306174e-01 2.306174e-01 +1.186477e+01 2.424165e+00 2.424166e+00 4.563653e-01 4.294063e-02 4.294063e-02 +3.368869e+01 1.939975e+01 1.939975e+01 3.543595e-03 1.621125e-03 1.621125e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d06-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t6 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 7.816942e+01 4.681109e+00 4.681109e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.802211e+01 5.088906e+00 5.088906e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.004145e+02 5.525707e+00 5.525707e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.107356e+02 5.792059e+00 5.792059e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.148094e+02 5.771722e+00 5.771722e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.101778e+02 5.571220e+00 5.571220e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.611545e+01 5.239910e+00 5.239910e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.413204e+01 4.570699e+00 4.570699e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.036667e+01 3.559245e+00 3.559245e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.983214e+01 2.398296e+00 2.398296e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.521581e+01 1.356536e+00 1.356536e+00 +7.313360e+00 6.299215e-01 6.299215e-01 6.684109e+00 6.405742e-01 6.405742e-01 +8.691945e+00 7.486635e-01 7.486635e-01 2.668123e+00 2.707247e-01 2.707247e-01 +1.186477e+01 2.424165e+00 2.424166e+00 5.785726e-01 6.852686e-02 6.852686e-02 +3.368869e+01 1.939975e+01 1.939975e+01 1.434853e-02 7.275247e-03 7.275247e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d06-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t6 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.816942e+01 4.681306e+00 4.681306e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.802211e+01 5.394644e+00 5.394644e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.004145e+02 6.234345e+00 6.234345e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.107356e+02 7.174199e+00 7.174199e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.148094e+02 7.515589e+00 7.515589e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.101778e+02 6.107253e+00 6.107253e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.611545e+01 5.241688e+00 5.241688e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.413204e+01 4.937210e+00 4.937210e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.036667e+01 4.280500e+00 4.280500e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.983214e+01 3.363562e+00 3.363562e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.521581e+01 2.055670e+00 2.055670e+00 -7.313361e+00 6.299216e-01 6.299216e-01 6.684109e+00 9.724895e-01 9.724895e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.668123e+00 3.914825e-01 3.914825e-01 -1.186477e+01 2.424165e+00 2.424165e+00 5.785726e-01 7.952577e-02 7.952577e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.434853e-02 7.286712e-03 7.286712e-03 +1.094251e+00 9.425100e-02 9.425100e-02 8.421518e+01 6.008734e+00 6.008734e+00 +1.300520e+00 1.120180e-01 1.120180e-01 9.541443e+01 6.593611e+00 6.593611e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.082424e+02 7.120233e+00 7.120233e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.198276e+02 7.424853e+00 7.424853e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.264372e+02 7.339979e+00 7.339979e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.205515e+02 6.731780e+00 6.731780e+00 +3.084018e+00 2.656355e-01 2.656355e-01 1.047080e+02 5.953759e+00 5.953759e+00 +3.665363e+00 3.157090e-01 3.157090e-01 8.116297e+01 4.938064e+00 4.938064e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.597842e+01 3.747934e+00 3.747934e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.294646e+01 2.440521e+00 2.440521e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.681849e+01 1.365083e+00 1.365083e+00 +7.313360e+00 6.299215e-01 6.299215e-01 7.451027e+00 6.455997e-01 6.455997e-01 +8.691945e+00 7.486635e-01 7.486635e-01 2.992550e+00 2.733953e-01 2.733953e-01 +1.186477e+01 2.424165e+00 2.424166e+00 6.391812e-01 6.671076e-02 6.671076e-02 +3.368869e+01 1.939975e+01 1.939975e+01 1.719198e-02 7.624660e-03 7.624660e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d06-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t6 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 5.597449e+01 4.608834e+00 4.608834e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.513408e+01 4.244189e+00 4.244189e+00 +1.545671e+00 1.331330e-01 1.331330e-01 5.921102e+01 4.111878e+00 4.111878e+00 +1.837033e+00 1.582290e-01 1.582290e-01 6.188141e+01 3.749105e+00 3.749105e+00 +2.183318e+00 1.880560e-01 1.880560e-01 6.551176e+01 3.361675e+00 3.361675e+00 +2.594879e+00 2.235045e-01 2.235045e-01 6.821726e+01 2.868478e+00 2.868478e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.693019e+01 2.338025e+00 2.338025e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.262234e+01 2.040345e+00 2.040345e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.523497e+01 1.911263e+00 1.911263e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.544519e+01 1.762940e+00 1.762940e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.403018e+01 1.497976e+00 1.497976e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.316325e+01 1.160809e+00 1.160809e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.391094e+01 8.081862e-01 8.081862e-01 +1.186477e+01 2.424165e+00 2.424166e+00 4.480744e+00 3.605462e-01 3.605462e-01 +3.368869e+01 1.939975e+01 1.939975e+01 7.725229e-02 1.697720e-02 1.697720e-02 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d06-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d06-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t6 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.597449e+01 4.659709e+00 4.659709e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.513408e+01 4.570877e+00 4.570877e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.921102e+01 5.020556e+00 5.020556e+00 -1.837033e+00 1.582291e-01 1.582291e-01 6.188141e+01 5.372021e+00 5.372021e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.551176e+01 5.034736e+00 5.034736e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.821726e+01 3.726074e+00 3.726074e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.693019e+01 3.234644e+00 3.234644e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.262234e+01 2.609289e+00 2.609289e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.523497e+01 2.096434e+00 2.096434e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.544519e+01 1.784346e+00 1.784346e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.403018e+01 1.687228e+00 1.687228e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.316325e+01 1.624974e+00 1.624974e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.391094e+01 9.959515e-01 9.959515e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.480744e+00 4.266110e-01 4.266110e-01 -3.368869e+01 1.939975e+01 1.939975e+01 7.725229e-02 1.697997e-02 1.697997e-02 +1.094251e+00 9.425100e-02 9.425100e-02 5.899954e+01 5.958837e+00 5.958837e+00 +1.300520e+00 1.120180e-01 1.120180e-01 5.971152e+01 5.655447e+00 5.655447e+00 +1.545671e+00 1.331330e-01 1.331330e-01 6.243846e+01 5.369512e+00 5.369512e+00 +1.837033e+00 1.582290e-01 1.582290e-01 6.718523e+01 5.082742e+00 5.082742e+00 +2.183318e+00 1.880560e-01 1.880560e-01 7.184701e+01 4.651851e+00 4.651851e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.471690e+01 4.021438e+00 4.021438e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.320463e+01 3.280370e+00 3.280370e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.911519e+01 2.801671e+00 2.801671e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.034582e+01 2.467773e+00 2.467773e+00 +5.177463e+00 4.459500e-01 4.459500e-01 5.002549e+01 2.168629e+00 2.168629e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.812450e+01 1.810147e+00 1.810147e+00 +7.313360e+00 6.299215e-01 6.299215e-01 2.580941e+01 1.335655e+00 1.335655e+00 +8.691945e+00 7.486635e-01 7.486635e-01 1.506810e+01 8.842039e-01 8.842039e-01 +1.186477e+01 2.424165e+00 2.424166e+00 4.846775e+00 3.641807e-01 3.641807e-01 +3.368869e+01 1.939975e+01 1.939975e+01 8.587677e-02 1.550184e-02 1.550184e-02 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d07-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t7 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.759343e+02 6.050447e+00 6.050447e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.856361e+02 6.512081e+00 6.512081e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.788584e+02 6.292411e+00 6.292411e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.616639e+02 5.925943e+00 5.925943e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.290415e+02 5.183280e+00 5.183280e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.870707e+01 4.022019e+00 4.022019e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.233816e+01 2.698511e+00 2.698511e+00 +3.665363e+00 3.157090e-01 3.157090e-01 2.616244e+01 1.595398e+00 1.595398e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.072125e+01 7.762604e-01 7.762604e-01 +5.177463e+00 4.459500e-01 4.459500e-01 3.849885e+00 3.389972e-01 3.389972e-01 +6.153426e+00 5.300130e-01 5.300130e-01 1.257925e+00 1.358748e-01 1.358748e-01 +7.313360e+00 6.299215e-01 6.299215e-01 3.856912e-01 5.506100e-02 5.506100e-02 +9.982961e+00 2.039679e+00 2.039679e+00 6.705059e-02 1.281329e-02 1.281329e-02 +2.834550e+01 1.632286e+01 1.632286e+01 1.682703e-03 5.397319e-04 5.397319e-04 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d07-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t7 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.759343e+02 6.050447e+00 6.050447e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.856361e+02 6.512081e+00 6.512081e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.788584e+02 6.292412e+00 6.292412e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.616639e+02 5.925943e+00 5.925943e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.290415e+02 5.183279e+00 5.183279e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.870707e+01 4.022019e+00 4.022019e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.233816e+01 2.698511e+00 2.698511e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.616244e+01 1.595399e+00 1.595399e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.072125e+01 7.762603e-01 7.762603e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.849885e+00 3.389971e-01 3.389971e-01 -6.153426e+00 5.300130e-01 5.300130e-01 1.257925e+00 1.358748e-01 1.358748e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.856912e-01 5.506100e-02 5.506100e-02 -9.982963e+00 2.039681e+00 2.039681e+00 6.705059e-02 1.281328e-02 1.281328e-02 -2.834550e+01 1.632286e+01 1.632286e+01 1.682703e-03 5.397319e-04 5.397319e-04 +1.094251e+00 9.425100e-02 9.425100e-02 1.900507e+02 9.254206e+00 9.254206e+00 +1.300520e+00 1.120180e-01 1.120180e-01 2.009533e+02 9.285828e+00 9.285828e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.983874e+02 8.707455e+00 8.707455e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.783045e+02 7.785751e+00 7.785751e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.413299e+02 6.373780e+00 6.373780e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.754110e+01 4.696084e+00 4.696084e+00 +3.084018e+00 2.656355e-01 2.656355e-01 5.826301e+01 3.078064e+00 3.078064e+00 +3.665363e+00 3.157090e-01 3.157090e-01 2.877398e+01 1.724572e+00 1.724572e+00 +4.356293e+00 3.752205e-01 3.752205e-01 1.200920e+01 8.390537e-01 8.390537e-01 +5.177463e+00 4.459500e-01 4.459500e-01 4.180472e+00 3.471382e-01 3.471382e-01 +6.153426e+00 5.300130e-01 5.300130e-01 1.392347e+00 1.406963e-01 1.406963e-01 +7.313360e+00 6.299215e-01 6.299215e-01 4.399732e-01 5.534482e-02 5.534482e-02 +9.982961e+00 2.039679e+00 2.039679e+00 7.854688e-02 1.459906e-02 1.459906e-02 +2.834550e+01 1.632286e+01 1.632286e+01 2.025984e-03 1.695760e-03 1.695760e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d07-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t7 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.210685e+02 5.135350e+00 5.135350e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.196375e+02 4.702298e+00 4.702298e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.202971e+02 4.314884e+00 4.314884e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.146208e+02 3.834870e+00 3.834870e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.032945e+02 3.398661e+00 3.398661e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.755621e+01 3.053600e+00 3.053600e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.988633e+01 2.722166e+00 2.722166e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.045044e+01 2.194914e+00 2.194914e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.271330e+01 1.603923e+00 1.603923e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.877447e+01 1.050099e+00 1.050099e+00 +6.153426e+00 5.300130e-01 5.300130e-01 9.067463e+00 5.761428e-01 5.761428e-01 +7.313360e+00 6.299215e-01 6.299215e-01 3.727551e+00 2.805504e-01 2.805504e-01 +9.982961e+00 2.039679e+00 2.039679e+00 6.028162e-01 5.882826e-02 5.882826e-02 +2.834550e+01 1.632286e+01 1.632286e+01 3.291324e-03 1.615346e-03 1.615346e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d07-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t7 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.210685e+02 5.135350e+00 5.135350e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.196375e+02 4.702298e+00 4.702298e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.202971e+02 4.314884e+00 4.314884e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.146208e+02 3.834870e+00 3.834870e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.032945e+02 3.398660e+00 3.398660e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.755621e+01 3.053600e+00 3.053600e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.988633e+01 2.722166e+00 2.722166e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.045044e+01 2.194913e+00 2.194913e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.271330e+01 1.603923e+00 1.603923e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.877447e+01 1.050099e+00 1.050099e+00 -6.153426e+00 5.300130e-01 5.300130e-01 9.067463e+00 5.761428e-01 5.761428e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.727551e+00 2.805504e-01 2.805504e-01 -9.982963e+00 2.039681e+00 2.039681e+00 6.028162e-01 5.882826e-02 5.882826e-02 -2.834550e+01 1.632286e+01 1.632286e+01 3.291324e-03 1.615346e-03 1.615346e-03 +1.094251e+00 9.425100e-02 9.425100e-02 1.294339e+02 7.749451e+00 7.749451e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.291579e+02 7.278357e+00 7.278357e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.316671e+02 6.882668e+00 6.882668e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.261370e+02 5.933876e+00 5.933876e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.127818e+02 4.996571e+00 4.996571e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.652983e+01 4.282552e+00 4.282552e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.724702e+01 3.515361e+00 3.515361e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.610351e+01 2.736644e+00 2.736644e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.631759e+01 1.946592e+00 1.946592e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.030506e+01 1.210355e+00 1.210355e+00 +6.153426e+00 5.300130e-01 5.300130e-01 9.884796e+00 6.463365e-01 6.463365e-01 +7.313360e+00 6.299215e-01 6.299215e-01 4.080367e+00 3.000410e-01 3.000410e-01 +9.982961e+00 2.039679e+00 2.039679e+00 6.957242e-01 6.370531e-02 6.370531e-02 +2.834550e+01 1.632286e+01 1.632286e+01 3.571603e-03 1.916611e-03 1.916611e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d07-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t7 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 9.608449e+01 4.813031e+00 4.813031e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.064805e+02 5.292570e+00 5.292570e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.159591e+02 5.519388e+00 5.519388e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.229112e+02 5.653009e+00 5.653009e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.235612e+02 5.674843e+00 5.674843e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.132774e+02 5.486783e+00 5.486783e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.334269e+01 5.115085e+00 5.115085e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.603497e+01 4.261613e+00 4.261613e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.177559e+01 3.145680e+00 3.145680e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.293339e+01 1.975810e+00 1.975810e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.064159e+01 1.008402e+00 1.008402e+00 +7.313360e+00 6.299215e-01 6.299215e-01 4.176034e+00 4.198822e-01 4.198822e-01 +9.982961e+00 2.039679e+00 2.039679e+00 8.215343e-01 9.771203e-02 9.771203e-02 +2.834550e+01 1.632286e+01 1.632286e+01 1.280799e-02 7.200607e-03 7.200607e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d07-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t7 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.608449e+01 4.827833e+00 4.827833e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.064805e+02 5.299096e+00 5.299096e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.159591e+02 6.139813e+00 6.139813e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.229112e+02 7.364774e+00 7.364774e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.235612e+02 6.966558e+00 6.966558e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.132774e+02 5.660920e+00 5.660920e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.334269e+01 5.344903e+00 5.344903e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.603497e+01 4.576720e+00 4.576720e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.177559e+01 3.924106e+00 3.924106e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.293339e+01 2.831035e+00 2.831035e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.064159e+01 1.489597e+00 1.489597e+00 -7.313361e+00 6.299216e-01 6.299216e-01 4.176034e+00 6.002895e-01 6.002895e-01 -9.982963e+00 2.039681e+00 2.039681e+00 8.215343e-01 1.300944e-01 1.300944e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.280799e-02 7.200643e-03 7.200643e-03 +1.094251e+00 9.425100e-02 9.425100e-02 1.040865e+02 6.668248e+00 6.668248e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.132422e+02 7.171880e+00 7.171880e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.250150e+02 7.623420e+00 7.623420e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.345905e+02 7.808512e+00 7.808512e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.361278e+02 7.513134e+00 7.513134e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.235122e+02 6.756564e+00 6.756564e+00 +3.084018e+00 2.656355e-01 2.656355e-01 1.015124e+02 5.878279e+00 5.878279e+00 +3.665363e+00 3.157090e-01 3.157090e-01 7.325319e+01 4.713722e+00 4.713722e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.671941e+01 3.408573e+00 3.408573e+00 +5.177463e+00 4.459500e-01 4.459500e-01 2.520188e+01 2.087107e+00 2.087107e+00 +6.153426e+00 5.300130e-01 5.300130e-01 1.177673e+01 1.082863e+00 1.082863e+00 +7.313360e+00 6.299215e-01 6.299215e-01 4.722882e+00 4.673809e-01 4.673809e-01 +9.982961e+00 2.039679e+00 2.039679e+00 9.095219e-01 1.089192e-01 1.089192e-01 +2.834550e+01 1.632286e+01 1.632286e+01 1.525567e-02 1.004534e-02 1.004534e-02 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d07-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t7 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 6.977532e+01 5.058571e+00 5.058571e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.012209e+01 4.838786e+00 4.838786e+00 +1.545671e+00 1.331330e-01 1.331330e-01 7.257325e+01 4.560061e+00 4.560061e+00 +1.837033e+00 1.582290e-01 1.582290e-01 7.280953e+01 4.032326e+00 4.032326e+00 +2.183318e+00 1.880560e-01 1.880560e-01 7.581119e+01 3.591140e+00 3.591140e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.507146e+01 2.983969e+00 2.983969e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.151584e+01 2.490428e+00 2.490428e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.352803e+01 2.203628e+00 2.203628e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.274429e+01 1.997466e+00 1.997466e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.103944e+01 1.768771e+00 1.768771e+00 +6.153426e+00 5.300130e-01 5.300130e-01 2.842839e+01 1.372289e+00 1.372289e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.791404e+01 9.891698e-01 9.891698e-01 +9.982961e+00 2.039679e+00 2.039679e+00 6.064214e+00 5.092951e-01 5.092951e-01 +2.834550e+01 1.632286e+01 1.632286e+01 1.141068e-01 2.078678e-02 2.078678e-02 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d07-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d07-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t7 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.977532e+01 5.070344e+00 5.070344e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.012209e+01 4.888153e+00 4.888153e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.257325e+01 5.193705e+00 5.193705e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.280953e+01 6.350874e+00 6.350874e+00 -2.183318e+00 1.880557e-01 1.880557e-01 7.581119e+01 4.934556e+00 4.934556e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.507146e+01 4.540748e+00 4.540748e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.151584e+01 3.430829e+00 3.430829e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.352803e+01 2.650984e+00 2.650984e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.274429e+01 2.111299e+00 2.111299e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.103944e+01 1.991946e+00 1.991946e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.842839e+01 1.581016e+00 1.581016e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791404e+01 1.291442e+00 1.291442e+00 -9.982963e+00 2.039681e+00 2.039681e+00 6.064214e+00 5.879142e-01 5.879142e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.141068e-01 2.082417e-02 2.082417e-02 +1.094251e+00 9.425100e-02 9.425100e-02 7.493478e+01 6.592685e+00 6.592685e+00 +1.300520e+00 1.120180e-01 1.120180e-01 7.440960e+01 6.219112e+00 6.219112e+00 +1.545671e+00 1.331330e-01 1.331330e-01 7.778900e+01 5.967981e+00 5.967981e+00 +1.837033e+00 1.582290e-01 1.582290e-01 7.963152e+01 5.451921e+00 5.451921e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.216407e+01 4.896425e+00 4.896425e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.254576e+01 4.203267e+00 4.203267e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.864394e+01 3.488433e+00 3.488433e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.968266e+01 2.961502e+00 2.961502e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.803020e+01 2.541323e+00 2.541323e+00 +5.177463e+00 4.459500e-01 4.459500e-01 4.532798e+01 2.133424e+00 2.133424e+00 +6.153426e+00 5.300130e-01 5.300130e-01 3.174785e+01 1.624210e+00 1.624210e+00 +7.313360e+00 6.299215e-01 6.299215e-01 1.959788e+01 1.106059e+00 1.106059e+00 +9.982961e+00 2.039679e+00 2.039679e+00 6.545619e+00 5.131962e-01 5.131962e-01 +2.834550e+01 1.632286e+01 1.632286e+01 1.319523e-01 1.498972e-02 1.498972e-02 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d08-x01-y01 +Title: doi:10.17182/hepdata.76966.v1/t8 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.978115e+02 6.660942e+00 6.660942e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.991621e+02 7.098890e+00 7.098890e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.843633e+02 6.639094e+00 6.639094e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.558113e+02 6.127223e+00 6.127223e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.178095e+02 5.225446e+00 5.225446e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.589992e+01 3.803266e+00 3.803266e+00 +3.084018e+00 2.656355e-01 2.656355e-01 4.153019e+01 2.421910e+00 2.421910e+00 +3.665363e+00 3.157090e-01 3.157090e-01 1.850972e+01 1.257970e+00 1.257970e+00 +4.356293e+00 3.752205e-01 3.752205e-01 6.719661e+00 5.417020e-01 5.417020e-01 +5.177463e+00 4.459500e-01 4.459500e-01 2.144778e+00 2.102336e-01 2.102336e-01 +7.067397e+00 1.443984e+00 1.443983e+00 3.049476e-01 4.520666e-02 4.520666e-02 +2.006708e+01 1.155570e+01 1.155570e+01 3.726200e-03 1.772634e-03 1.772634e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y02 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d08-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t8 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.978115e+02 6.660942e+00 6.660942e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.991621e+02 7.098890e+00 7.098890e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.843633e+02 6.639094e+00 6.639094e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.558113e+02 6.127222e+00 6.127222e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.178095e+02 5.225446e+00 5.225446e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.589992e+01 3.803267e+00 3.803267e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.153019e+01 2.421911e+00 2.421911e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.850972e+01 1.257970e+00 1.257970e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.719661e+00 5.417020e-01 5.417020e-01 -5.177463e+00 4.459503e-01 4.459503e-01 2.144778e+00 2.102337e-01 2.102337e-01 -7.067397e+00 1.443984e+00 1.443984e+00 3.049476e-01 4.520666e-02 4.520666e-02 -2.006708e+01 1.155570e+01 1.155570e+01 3.726200e-03 1.772634e-03 1.772634e-03 +1.094251e+00 9.425100e-02 9.425100e-02 2.117302e+02 1.023279e+01 1.023279e+01 +1.300520e+00 1.120180e-01 1.120180e-01 2.150173e+02 9.913461e+00 9.913461e+00 +1.545671e+00 1.331330e-01 1.331330e-01 2.042550e+02 9.052968e+00 9.052968e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.728880e+02 7.696092e+00 7.696092e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.307502e+02 6.053300e+00 6.053300e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.345822e+01 4.169683e+00 4.169683e+00 +3.084018e+00 2.656355e-01 2.656355e-01 4.556878e+01 2.520305e+00 2.520305e+00 +3.665363e+00 3.157090e-01 3.157090e-01 2.028986e+01 1.269712e+00 1.269712e+00 +4.356293e+00 3.752205e-01 3.752205e-01 7.464855e+00 5.374039e-01 5.374039e-01 +5.177463e+00 4.459500e-01 4.459500e-01 2.463804e+00 2.116933e-01 2.116933e-01 +7.067397e+00 1.443984e+00 1.443983e+00 3.451294e-01 4.511361e-02 4.511361e-02 +2.006708e+01 1.155570e+01 1.155570e+01 4.599763e-03 3.636282e-03 3.636282e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d08-x01-y03 +Title: doi:10.17182/hepdata.76966.v1/t8 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.368852e+02 9.996343e+00 9.996343e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.328523e+02 9.398905e+00 9.398905e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.295284e+02 4.906095e+00 4.906095e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.185704e+02 4.185466e+00 4.185466e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.019678e+02 3.637688e+00 3.637688e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.251027e+01 3.222399e+00 3.222399e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.116879e+01 2.675630e+00 2.675630e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.100568e+01 2.033730e+00 2.033730e+00 +4.356293e+00 3.752205e-01 3.752205e-01 2.443362e+01 1.367748e+00 1.367748e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.289250e+01 8.075437e-01 8.075437e-01 +7.067397e+00 1.443984e+00 1.443983e+00 2.981475e+00 2.342487e-01 2.342487e-01 +2.006708e+01 1.155570e+01 1.155570e+01 2.753442e-02 7.523117e-03 7.523117e-03 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y04 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d08-x01-y04 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t8 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.368852e+02 9.996343e+00 9.996343e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.328523e+02 9.398905e+00 9.398905e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295284e+02 4.906095e+00 4.906095e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.185704e+02 4.185466e+00 4.185466e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.019678e+02 3.637688e+00 3.637688e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.251027e+01 3.222399e+00 3.222399e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.116879e+01 2.675631e+00 2.675631e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.100568e+01 2.033729e+00 2.033729e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.443362e+01 1.367747e+00 1.367747e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.289250e+01 8.075437e-01 8.075437e-01 -7.067397e+00 1.443984e+00 1.443984e+00 2.981475e+00 2.342487e-01 2.342487e-01 -2.006708e+01 1.155570e+01 1.155570e+01 2.753442e-02 7.523117e-03 7.523117e-03 +1.094251e+00 9.425100e-02 9.425100e-02 1.479035e+02 9.279983e+00 9.279983e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.439367e+02 8.347010e+00 8.347010e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.433563e+02 7.517132e+00 7.517132e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.294512e+02 6.106717e+00 6.106717e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.118073e+02 5.076929e+00 5.076929e+00 +2.594879e+00 2.235045e-01 2.235045e-01 9.106785e+01 4.190014e+00 4.190014e+00 +3.084018e+00 2.656355e-01 2.656355e-01 6.766270e+01 3.282716e+00 3.282716e+00 +3.665363e+00 3.157090e-01 3.157090e-01 4.584730e+01 2.439525e+00 2.439525e+00 +4.356293e+00 3.752205e-01 3.752205e-01 2.687897e+01 1.581433e+00 1.581433e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.376162e+01 9.082788e-01 9.082788e-01 +7.067397e+00 1.443984e+00 1.443983e+00 3.322805e+00 2.681348e-01 2.681348e-01 +2.006708e+01 1.155570e+01 1.155570e+01 3.075283e-02 6.602386e-03 6.602386e-03 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d08-x01-y05 +Title: doi:10.17182/hepdata.76966.v1/t8 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 1.152471e+02 4.735626e+00 4.735626e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.224623e+02 5.160044e+00 5.160044e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.295730e+02 5.298579e+00 5.298579e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.342186e+02 5.502594e+00 5.502594e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.286992e+02 5.413337e+00 5.413337e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.121986e+02 5.198876e+00 5.198876e+00 +3.084018e+00 2.656355e-01 2.656355e-01 8.570830e+01 4.733764e+00 4.733764e+00 +3.665363e+00 3.157090e-01 3.157090e-01 5.835079e+01 3.918162e+00 3.918162e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.471582e+01 2.832457e+00 2.832457e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.736571e+01 1.688523e+00 1.688523e+00 +7.067397e+00 1.443984e+00 1.443983e+00 4.033761e+00 5.087075e-01 5.087075e-01 +2.006708e+01 1.155570e+01 1.155570e+01 4.859065e-02 2.410630e-02 2.410630e-02 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y06 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d08-x01-y06 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t8 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.152471e+02 6.177147e+00 6.177147e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.224623e+02 5.160137e+00 5.160137e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295730e+02 6.490904e+00 6.490904e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.342186e+02 6.852017e+00 6.852017e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.286992e+02 6.509619e+00 6.509619e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.121986e+02 5.204103e+00 5.204103e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.570830e+01 4.833779e+00 4.833779e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.835079e+01 4.602612e+00 4.602612e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.471582e+01 3.676361e+00 3.676361e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.736571e+01 2.307098e+00 2.307098e+00 -7.067397e+00 1.443984e+00 1.443984e+00 4.033761e+00 6.721175e-01 6.721175e-01 -2.006708e+01 1.155570e+01 1.155570e+01 4.859065e-02 2.435393e-02 2.435393e-02 +1.094251e+00 9.425100e-02 9.425100e-02 1.221736e+02 6.947713e+00 6.947713e+00 +1.300520e+00 1.120180e-01 1.120180e-01 1.314231e+02 7.512991e+00 7.512991e+00 +1.545671e+00 1.331330e-01 1.331330e-01 1.399180e+02 7.832792e+00 7.832792e+00 +1.837033e+00 1.582290e-01 1.582290e-01 1.460000e+02 7.963208e+00 7.963208e+00 +2.183318e+00 1.880560e-01 1.880560e-01 1.408314e+02 7.512771e+00 7.512771e+00 +2.594879e+00 2.235045e-01 2.235045e-01 1.230113e+02 6.729747e+00 6.729747e+00 +3.084018e+00 2.656355e-01 2.656355e-01 9.542252e+01 5.663179e+00 5.663179e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.534746e+01 4.383281e+00 4.383281e+00 +4.356293e+00 3.752205e-01 3.752205e-01 3.791773e+01 2.937511e+00 2.937511e+00 +5.177463e+00 4.459500e-01 4.459500e-01 1.882123e+01 1.691417e+00 1.691417e+00 +7.067397e+00 1.443984e+00 1.443983e+00 4.487586e+00 5.178804e-01 5.178804e-01 +2.006708e+01 1.155570e+01 1.155570e+01 5.677470e-02 2.562433e-02 2.562433e-02 END YODA_SCATTER2D_V2 - +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2017_I1589844/d08-x01-y07 +Title: doi:10.17182/hepdata.76966.v1/t8 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.094251e+00 9.425100e-02 9.425100e-02 8.475220e+01 5.902205e+00 5.902205e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.444817e+01 5.640498e+00 5.640498e+00 +1.545671e+00 1.331330e-01 1.331330e-01 8.394995e+01 5.108917e+00 5.108917e+00 +1.837033e+00 1.582290e-01 1.582290e-01 8.274077e+01 4.429943e+00 4.429943e+00 +2.183318e+00 1.880560e-01 1.880560e-01 8.339998e+01 3.783984e+00 3.783984e+00 +2.594879e+00 2.235045e-01 2.235045e-01 7.988968e+01 3.069977e+00 3.069977e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.378467e+01 2.559547e+00 2.559547e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.239436e+01 2.228361e+00 2.228361e+00 +4.356293e+00 3.752205e-01 3.752205e-01 4.887237e+01 1.983721e+00 1.983721e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.490555e+01 1.620961e+00 1.620961e+00 +7.067397e+00 1.443984e+00 1.443983e+00 1.571370e+01 1.014620e+00 1.014620e+00 +2.006708e+01 1.155570e+01 1.155570e+01 5.534319e-01 8.390847e-02 8.390847e-02 +END YODA_SCATTER2D_V2 BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844/d08-x01-y08 IsRef: 1 Path: /REF/ATLAS_2017_I1589844/d08-x01-y08 -Title: ~ +Title: doi:10.17182/hepdata.76966.v1/t8 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.475220e+01 5.902977e+00 5.902977e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.444817e+01 5.649440e+00 5.649440e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.394995e+01 6.247410e+00 6.247410e+00 -1.837033e+00 1.582291e-01 1.582291e-01 8.274077e+01 6.867471e+00 6.867471e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.339998e+01 5.445627e+00 5.445627e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.988968e+01 5.028314e+00 5.028314e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.378467e+01 3.120918e+00 3.120918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.239436e+01 2.439881e+00 2.439881e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.887237e+01 1.989183e+00 1.989183e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.490555e+01 1.748288e+00 1.748288e+00 -7.067397e+00 1.443984e+00 1.443984e+00 1.571370e+01 1.195915e+00 1.195915e+00 -2.006708e+01 1.155570e+01 1.155570e+01 5.534319e-01 8.594294e-02 8.594294e-02 +1.094251e+00 9.425100e-02 9.425100e-02 9.160328e+01 7.662831e+00 7.662831e+00 +1.300520e+00 1.120180e-01 1.120180e-01 8.832628e+01 7.101282e+00 7.101282e+00 +1.545671e+00 1.331330e-01 1.331330e-01 9.093070e+01 6.747019e+00 6.747019e+00 +1.837033e+00 1.582290e-01 1.582290e-01 9.144638e+01 6.050134e+00 6.050134e+00 +2.183318e+00 1.880560e-01 1.880560e-01 9.093631e+01 5.192710e+00 5.192710e+00 +2.594879e+00 2.235045e-01 2.235045e-01 8.836519e+01 4.271860e+00 4.271860e+00 +3.084018e+00 2.656355e-01 2.656355e-01 7.948057e+01 3.407969e+00 3.407969e+00 +3.665363e+00 3.157090e-01 3.157090e-01 6.861742e+01 2.917816e+00 2.917816e+00 +4.356293e+00 3.752205e-01 3.752205e-01 5.405558e+01 2.444767e+00 2.444767e+00 +5.177463e+00 4.459500e-01 4.459500e-01 3.935320e+01 1.960979e+00 1.960979e+00 +7.067397e+00 1.443984e+00 1.443983e+00 1.712960e+01 1.064018e+00 1.064018e+00 +2.006708e+01 1.155570e+01 1.155570e+01 6.116617e-01 9.004133e-02 9.004133e-02 END YODA_SCATTER2D_V2 diff --git a/analyses/pluginATLAS/ATLAS_2017_I1589844_EL.yoda b/analyses/pluginATLAS/ATLAS_2017_I1589844_EL.yoda deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1589844_EL.yoda +++ /dev/null @@ -1,911 +0,0 @@ -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d01-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d01-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.843191e+01 7.457050e-01 7.457050e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.441937e+01 8.251125e-01 8.251125e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.066112e+01 1.114318e+00 1.114318e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.064066e+01 1.394752e+00 1.394752e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.727946e+01 1.525491e+00 1.525491e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.446314e+01 1.778923e+00 1.778923e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.806647e+01 1.920201e+00 1.920201e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.538682e+01 1.723712e+00 1.723712e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.033783e+01 1.566466e+00 1.566466e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.086573e+01 1.290886e+00 1.290886e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.126881e+01 9.824325e-01 9.824325e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.267270e+01 7.502458e-01 7.502458e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.607494e+01 5.400483e-01 5.400483e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.169971e+01 4.021634e-01 4.021634e-01 -1.227770e+01 1.057515e+00 1.057515e+00 8.472988e+00 2.986058e-01 2.986058e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.892089e+00 2.098366e-01 2.098366e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.366320e+00 1.600385e-01 1.600385e-01 -2.061185e+01 1.775360e+00 1.775360e+00 3.112279e+00 1.174748e-01 1.174748e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.240750e+00 8.717211e-02 8.717211e-02 -2.911501e+01 2.507763e+00 2.507763e+00 1.534069e+00 6.318952e-02 6.318952e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.030531e+00 4.402922e-02 4.402922e-02 -4.112605e+01 3.542309e+00 3.542309e+00 6.834079e-01 2.963892e-02 2.963892e-02 -4.887840e+01 4.210043e+00 4.210043e+00 4.320688e-01 1.918555e-02 1.918555e-02 -5.809209e+01 5.003645e+00 5.003645e+00 2.666526e-01 1.245923e-02 1.245923e-02 -6.904258e+01 5.946843e+00 5.946843e+00 1.671143e-01 8.250283e-03 8.250283e-03 -8.205726e+01 7.067836e+00 7.067836e+00 9.339255e-02 4.677413e-03 4.677413e-03 -9.752523e+01 8.400139e+00 8.400139e+00 5.411575e-02 2.824555e-03 2.824555e-03 -1.159090e+02 9.983584e+00 9.983584e+00 2.782189e-02 1.487392e-03 1.487392e-03 -1.377581e+02 1.186551e+01 1.186551e+01 1.514939e-02 8.451217e-04 8.451217e-04 -1.961423e+02 4.651872e+01 4.651872e+01 4.275534e-03 2.531246e-04 2.531246e-04 -6.213305e+02 3.786695e+02 3.786695e+02 8.432581e-05 9.408547e-06 9.408547e-06 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d01-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d01-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.131834e+00 4.490677e-01 4.490677e-01 -1.300520e+00 1.120177e-01 1.120177e-01 1.009730e+01 4.073897e-01 4.073897e-01 -1.545671e+00 1.331332e-01 1.331332e-01 1.143915e+01 5.885724e-01 5.885724e-01 -1.837033e+00 1.582291e-01 1.582291e-01 1.466143e+01 5.944605e-01 5.944605e-01 -2.183318e+00 1.880557e-01 1.880557e-01 1.782742e+01 6.701411e-01 6.701411e-01 -2.594878e+00 2.235046e-01 2.235046e-01 2.082979e+01 7.277524e-01 7.277524e-01 -3.084019e+00 2.656357e-01 2.656357e-01 2.538012e+01 9.136748e-01 9.136748e-01 -3.665363e+00 3.157087e-01 3.157087e-01 2.791683e+01 9.391386e-01 9.391386e-01 -4.356292e+00 3.752204e-01 3.752204e-01 3.061612e+01 9.748082e-01 9.748082e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.145211e+01 9.928744e-01 9.928744e-01 -6.153426e+00 5.300130e-01 5.300130e-01 3.162385e+01 9.857417e-01 9.857417e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.929418e+01 9.115539e-01 9.115539e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.545845e+01 8.282911e-01 8.282911e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.103254e+01 6.742779e-01 6.742779e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.604205e+01 5.290447e-01 5.290447e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.130196e+01 3.864420e-01 3.864420e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.816633e+00 2.789999e-01 2.789999e-01 -2.061185e+01 1.775360e+00 1.775360e+00 5.245804e+00 1.959936e-01 1.959936e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.466486e+00 1.362328e-01 1.362328e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.335649e+00 9.715040e-02 9.715040e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.476691e+00 6.452457e-02 6.452457e-02 -4.112605e+01 3.542309e+00 3.542309e+00 9.501897e-01 4.261565e-02 4.261565e-02 -4.887840e+01 4.210043e+00 4.210043e+00 5.877472e-01 2.727143e-02 2.727143e-02 -5.809209e+01 5.003645e+00 5.003645e+00 3.522312e-01 1.736717e-02 1.736717e-02 -6.904258e+01 5.946843e+00 5.946843e+00 2.218414e-01 1.140433e-02 1.140433e-02 -8.205726e+01 7.067836e+00 7.067836e+00 1.251722e-01 6.452849e-03 6.452849e-03 -9.752523e+01 8.400139e+00 8.400139e+00 6.951626e-02 3.670086e-03 3.670086e-03 -1.159090e+02 9.983584e+00 9.983584e+00 3.751489e-02 2.146711e-03 2.146711e-03 -1.377581e+02 1.186551e+01 1.186551e+01 2.007446e-02 1.180381e-03 1.180381e-03 -1.961423e+02 4.651872e+01 4.651872e+01 5.355213e-03 3.426689e-04 3.426689e-04 -6.213305e+02 3.786695e+02 3.786695e+02 1.064601e-04 1.463478e-05 1.463478e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d01-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d01-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.026395e+00 1.138510e+00 1.138510e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.064791e+00 1.377203e+00 1.377203e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.011198e+01 1.772341e+00 1.772341e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.493136e+01 2.131044e+00 2.131044e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.935026e+01 2.498820e+00 2.498820e+00 -2.594878e+00 2.235046e-01 2.235046e-01 2.554289e+01 2.917353e+00 2.917353e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.185762e+01 3.495927e+00 3.495927e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.680790e+01 3.417445e+00 3.417445e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.925983e+01 3.263206e+00 3.263206e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.806103e+01 2.585990e+00 2.585990e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.437418e+01 2.532062e+00 2.532062e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.832551e+01 2.932608e+00 2.932608e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.125015e+01 2.458701e+00 2.458701e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.569831e+01 1.772818e+00 1.772818e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.146950e+01 1.057360e+00 1.057360e+00 -1.459207e+01 1.256859e+00 1.256859e+00 8.173606e+00 3.808644e-01 3.808644e-01 -1.734271e+01 1.493779e+00 1.493779e+00 6.084104e+00 3.673885e-01 3.673885e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.559399e+00 3.934733e-01 3.934733e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.438216e+00 3.291714e-01 3.291714e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.590863e+00 2.375422e-01 2.375422e-01 -3.460326e+01 2.980482e+00 2.980482e+00 1.894800e+00 1.602624e-01 1.602624e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.341776e+00 1.010453e-01 1.010453e-01 -4.887840e+01 4.210043e+00 4.210043e+00 9.108951e-01 6.451331e-02 6.451331e-02 -5.809209e+01 5.003645e+00 5.003645e+00 5.936520e-01 3.993185e-02 3.993185e-02 -6.904258e+01 5.946843e+00 5.946843e+00 3.875928e-01 2.014963e-02 2.014963e-02 -8.205726e+01 7.067836e+00 7.067836e+00 2.416991e-01 1.231090e-02 1.231090e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.484650e-01 7.958954e-03 7.958954e-03 -1.159090e+02 9.983584e+00 9.983584e+00 8.610534e-02 4.620871e-03 4.620871e-03 -1.377581e+02 1.186551e+01 1.186551e+01 4.948377e-02 2.979784e-03 2.979784e-03 -1.961423e+02 4.651872e+01 4.651872e+01 1.515177e-02 1.007609e-03 1.007609e-03 -6.213305e+02 3.786695e+02 3.786695e+02 4.511159e-04 4.895730e-05 4.895730e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d01-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d01-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.140524e+00 8.120082e-01 8.120082e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.642372e+00 6.443953e-01 6.443953e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.240243e+00 7.587629e-01 7.587629e-01 -1.837033e+00 1.582291e-01 1.582291e-01 4.493157e+00 8.792785e-01 8.792785e-01 -2.183318e+00 1.880557e-01 1.880557e-01 5.409410e+00 9.191437e-01 9.191437e-01 -2.594878e+00 2.235046e-01 2.235046e-01 7.443397e+00 1.129511e+00 1.129511e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.015570e+00 1.172671e+00 1.172671e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.216738e+01 1.351261e+00 1.351261e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.514874e+01 1.504543e+00 1.504543e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.744598e+01 1.412676e+00 1.412676e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.977819e+01 1.471023e+00 1.471023e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.103805e+01 1.324354e+00 1.324354e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.107483e+01 1.223237e+00 1.223237e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.997679e+01 1.067052e+00 1.067052e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.762803e+01 8.065027e-01 8.065027e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.481611e+01 7.324409e-01 7.324409e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.153820e+01 4.853849e-01 4.853849e-01 -2.061185e+01 1.775360e+00 1.775360e+00 8.572226e+00 3.224268e-01 3.224268e-01 -2.449723e+01 2.110020e+00 2.110020e+00 6.043360e+00 2.697194e-01 2.697194e-01 -2.911501e+01 2.507763e+00 2.507763e+00 4.264073e+00 2.256532e-01 2.256532e-01 -3.460326e+01 2.980482e+00 2.980482e+00 2.947890e+00 1.660653e-01 1.660653e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.996719e+00 1.218428e-01 1.218428e-01 -4.887840e+01 4.210043e+00 4.210043e+00 1.334860e+00 7.509910e-02 7.509910e-02 -5.809209e+01 5.003645e+00 5.003645e+00 8.462506e-01 5.007346e-02 5.007346e-02 -6.904258e+01 5.946843e+00 5.946843e+00 5.250550e-01 3.429120e-02 3.429120e-02 -8.205726e+01 7.067836e+00 7.067836e+00 3.261205e-01 1.745130e-02 1.745130e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.990265e-01 1.079316e-02 1.079316e-02 -1.159090e+02 9.983584e+00 9.983584e+00 1.165856e-01 6.555164e-03 6.555164e-03 -1.377581e+02 1.186551e+01 1.186551e+01 6.653251e-02 4.147569e-03 4.147569e-03 -1.961423e+02 4.651872e+01 4.651872e+01 2.095795e-02 1.430811e-03 1.430811e-03 -6.213305e+02 3.786695e+02 3.786695e+02 5.946527e-04 6.802584e-05 6.802584e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d02-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d02-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.251658e+01 1.566065e+00 1.566065e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.347048e+01 1.698262e+00 1.698262e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.865451e+01 2.399943e+00 2.399943e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.857296e+01 2.556877e+00 2.556877e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.720231e+01 2.750437e+00 2.750437e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.337012e+01 3.065478e+00 3.065478e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.859543e+01 2.897633e+00 2.897633e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.455953e+01 2.508455e+00 2.508455e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.829047e+01 1.991888e+00 1.991888e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.022941e+01 1.440183e+00 1.440183e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.504355e+01 9.844996e-01 9.844996e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.507121e+01 6.011462e-01 6.011462e-01 -8.691946e+00 7.486632e-01 7.486632e-01 8.787865e+00 3.656542e-01 3.656542e-01 -1.033040e+01 8.897879e-01 8.897879e-01 5.257721e+00 2.323279e-01 2.323279e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.288535e+00 1.580652e-01 1.580652e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.042152e+00 1.013971e-01 1.013971e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.274409e+00 6.704191e-02 6.704191e-02 -2.061185e+01 1.775360e+00 1.775360e+00 8.054232e-01 4.494587e-02 4.494587e-02 -2.449723e+01 2.110020e+00 2.110020e+00 4.916852e-01 2.996955e-02 2.996955e-02 -2.911501e+01 2.507763e+00 2.507763e+00 3.015235e-01 1.926580e-02 1.926580e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.787215e-01 1.213894e-02 1.213894e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.052898e-01 7.624179e-03 7.624179e-03 -4.887840e+01 4.210043e+00 4.210043e+00 6.465946e-02 5.033112e-03 5.033112e-03 -5.809209e+01 5.003645e+00 5.003645e+00 3.583416e-02 2.904991e-03 2.904991e-03 -6.904258e+01 5.946843e+00 5.946843e+00 1.924695e-02 1.704510e-03 1.704510e-03 -9.830401e+01 2.331459e+01 2.331459e+01 6.161733e-03 6.179331e-04 6.179331e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.084350e-04 5.042981e-05 5.042981e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d02-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d02-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.213549e+01 1.257319e+00 1.257319e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.578350e+01 9.251823e-01 9.251823e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.036665e+01 1.294972e+00 1.294972e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.572293e+01 1.370832e+00 1.370832e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.079239e+01 1.416067e+00 1.416067e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.456356e+01 1.315123e+00 1.315123e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.837683e+01 1.402558e+00 1.402558e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.148847e+01 1.505844e+00 1.505844e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.019930e+01 1.479742e+00 1.479742e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.733873e+01 1.443311e+00 1.443311e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.073097e+01 1.296580e+00 1.296580e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.224517e+01 1.087139e+00 1.087139e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.355572e+01 8.613873e-01 8.613873e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.561065e+01 5.915471e-01 5.915471e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.550952e+00 3.961028e-01 3.961028e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.369347e+00 2.376030e-01 2.376030e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.976504e+00 1.412455e-01 1.412455e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.628869e+00 8.204071e-02 8.204071e-02 -2.449723e+01 2.110020e+00 2.110020e+00 9.015307e-01 4.915482e-02 4.915482e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.935663e-01 2.931522e-02 2.931522e-02 -3.460326e+01 2.980482e+00 2.980482e+00 2.769087e-01 1.751636e-02 1.751636e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.599571e-01 1.084167e-02 1.084167e-02 -4.887840e+01 4.210043e+00 4.210043e+00 9.306745e-02 6.805731e-03 6.805731e-03 -5.809209e+01 5.003645e+00 5.003645e+00 5.227408e-02 4.043149e-03 4.043149e-03 -6.904258e+01 5.946843e+00 5.946843e+00 2.779982e-02 2.358778e-03 2.358778e-03 -9.830401e+01 2.331459e+01 2.331459e+01 8.619561e-03 8.318715e-04 8.318715e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.994644e-04 5.719088e-05 5.719088e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d02-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d02-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.489763e+01 2.353181e+00 2.353181e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.982360e+01 2.603555e+00 2.603555e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.587930e+01 3.219879e+00 3.219879e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.255242e+01 3.668543e+00 3.668543e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.233328e+01 3.999467e+00 3.999467e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.087246e+01 4.713882e+00 4.713882e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.801644e+01 4.864634e+00 4.864634e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.193357e+01 4.588721e+00 4.588721e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.020458e+01 3.772272e+00 3.772272e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.336661e+01 3.275211e+00 3.275211e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.188339e+01 3.227490e+00 3.227490e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.957067e+01 2.899641e+00 2.899641e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.901814e+01 2.029827e+00 2.029827e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.152678e+01 9.587638e-01 9.587638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 6.944233e+00 4.382270e-01 4.382270e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.231061e+00 2.760548e-01 2.760548e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.727649e+00 2.140536e-01 2.140536e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.782786e+00 1.685825e-01 1.685825e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.175197e+00 1.042250e-01 1.042250e-01 -2.911501e+01 2.507763e+00 2.507763e+00 7.742704e-01 6.094456e-02 6.094456e-02 -3.460326e+01 2.980482e+00 2.980482e+00 5.012703e-01 3.459606e-02 3.459606e-02 -4.112605e+01 3.542309e+00 3.542309e+00 3.078006e-01 1.991102e-02 1.991102e-02 -4.887840e+01 4.210043e+00 4.210043e+00 1.839932e-01 1.264942e-02 1.264942e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.097354e-01 7.702506e-03 7.702506e-03 -6.904258e+01 5.946843e+00 5.946843e+00 6.628384e-02 4.968150e-03 4.968150e-03 -9.830401e+01 2.331459e+01 2.331459e+01 2.429788e-02 2.096348e-03 2.096348e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.114871e-03 3.088679e-04 3.088679e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d02-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d02-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.049465e+00 1.627731e+00 1.627731e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.990596e+00 1.624231e+00 1.624231e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.076139e+01 1.909451e+00 1.909451e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.224761e+01 2.313692e+00 2.313692e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.547082e+01 2.384618e+00 2.384618e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.915081e+01 2.414434e+00 2.414434e+00 -3.084019e+00 2.656357e-01 2.656357e-01 2.210513e+01 2.659900e+00 2.659900e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.681122e+01 2.366631e+00 2.366631e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.082771e+01 2.181140e+00 2.181140e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.368383e+01 2.067661e+00 2.067661e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.408435e+01 1.837770e+00 1.837770e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.238250e+01 1.563845e+00 1.563845e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.943282e+01 1.655684e+00 1.655684e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.385918e+01 1.174033e+00 1.174033e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.797710e+01 8.721781e-01 8.721781e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.253059e+01 5.659160e-01 5.659160e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.964495e+00 3.510716e-01 3.510716e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.792676e+00 2.437191e-01 2.437191e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.751965e+00 1.694596e-01 1.694596e-01 -2.911501e+01 2.507763e+00 2.507763e+00 1.561784e+00 1.081239e-01 1.081239e-01 -3.460326e+01 2.980482e+00 2.980482e+00 9.004670e-01 5.119386e-02 5.119386e-02 -4.112605e+01 3.542309e+00 3.542309e+00 5.182805e-01 2.835630e-02 2.835630e-02 -4.887840e+01 4.210043e+00 4.210043e+00 2.938264e-01 1.749024e-02 1.749024e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.663662e-01 1.081333e-02 1.081333e-02 -6.904258e+01 5.946843e+00 5.946843e+00 9.636735e-02 6.718521e-03 6.718521e-03 -9.830401e+01 2.331459e+01 2.331459e+01 3.556128e-02 3.074905e-03 3.074905e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.537270e-03 4.326461e-04 4.326461e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d03-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d03-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.913391e+01 2.533522e+00 2.533522e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.657180e+01 3.283696e+00 3.283696e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.881895e+01 3.335522e+00 3.335522e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.131585e+02 3.660216e+00 3.660216e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.181065e+02 3.785198e+00 3.785198e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.138350e+02 3.772396e+00 3.772396e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.572317e+01 3.226374e+00 3.226374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.176193e+01 2.561989e+00 2.561989e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.867972e+01 1.868982e+00 1.868982e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.846156e+01 1.188777e+00 1.188777e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.549413e+01 6.935612e-01 6.935612e-01 -7.313361e+00 6.299216e-01 6.299216e-01 7.874323e+00 3.838026e-01 3.838026e-01 -8.691946e+00 7.486632e-01 7.486632e-01 4.064096e+00 2.178716e-01 2.178716e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.139051e+00 1.241570e-01 1.241570e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.134773e+00 7.093575e-02 7.093575e-02 -1.459207e+01 1.256859e+00 1.256859e+00 6.540028e-01 4.373642e-02 4.373642e-02 -1.734271e+01 1.493779e+00 1.493779e+00 3.781698e-01 2.689145e-02 2.689145e-02 -2.061185e+01 1.775360e+00 1.775360e+00 2.121876e-01 1.593806e-02 1.593806e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.083296e-01 9.433377e-03 9.433377e-03 -2.911501e+01 2.507763e+00 2.507763e+00 6.069497e-02 5.303741e-03 5.303741e-03 -4.235561e+01 1.073283e+01 1.073283e+01 1.964958e-02 1.895753e-03 1.895753e-03 -1.521385e+02 9.905010e+01 9.905010e+01 4.600536e-04 9.522037e-05 9.522037e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d03-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d03-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 3.825805e+01 2.132329e+00 2.132329e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.456967e+01 1.874852e+00 1.874852e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.186146e+01 2.073565e+00 2.073565e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.725064e+01 2.240922e+00 2.240922e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.164457e+01 2.013365e+00 2.013365e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.581330e+01 1.969264e+00 1.969264e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.706655e+01 1.959374e+00 1.959374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.342732e+01 1.889673e+00 1.889673e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.799750e+01 1.819163e+00 1.819163e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.842780e+01 1.617673e+00 1.617673e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.718619e+01 1.371325e+00 1.371325e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.584674e+01 1.036562e+00 1.036562e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.614116e+01 7.093522e-01 7.093522e-01 -1.033040e+01 8.897879e-01 8.897879e-01 9.045228e+00 4.474669e-01 4.474669e-01 -1.227770e+01 1.057515e+00 1.057515e+00 4.427789e+00 2.435580e-01 2.435580e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.019382e+00 1.234920e-01 1.234920e-01 -1.734271e+01 1.493779e+00 1.493779e+00 9.245877e-01 6.312702e-02 6.312702e-02 -2.061185e+01 1.775360e+00 1.775360e+00 4.259970e-01 3.223159e-02 3.223159e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.973009e-01 1.669273e-02 1.669273e-02 -2.911501e+01 2.507763e+00 2.507763e+00 9.582690e-02 9.407234e-03 9.407234e-03 -4.235561e+01 1.073283e+01 1.073283e+01 2.485965e-02 2.980908e-03 2.980908e-03 -1.521385e+02 9.905010e+01 9.905010e+01 6.553450e-04 2.239677e-04 2.239677e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d03-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d03-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.881642e+01 3.184287e+00 3.184287e+00 -1.300520e+00 1.120177e-01 1.120177e-01 3.541813e+01 4.103723e+00 4.103723e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.309837e+01 4.948677e+00 4.948677e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.446910e+01 5.105418e+00 5.105418e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.478630e+01 5.780485e+00 5.780485e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.364876e+01 5.943595e+00 5.943595e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.815995e+01 5.620889e+00 5.620889e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.694848e+01 4.621943e+00 4.621943e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.738364e+01 3.852427e+00 3.852427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.286911e+01 3.498016e+00 3.498016e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.679335e+01 3.225438e+00 3.225438e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.254818e+01 2.250628e+00 2.250628e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.275560e+01 1.281082e+00 1.281082e+00 -1.033040e+01 8.897879e-01 8.897879e-01 6.770748e+00 5.681592e-01 5.681592e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.611050e+00 2.702737e-01 2.702737e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.956713e+00 1.317371e-01 1.317371e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.102316e+00 8.512634e-02 8.512634e-02 -2.061185e+01 1.775360e+00 1.775360e+00 6.606707e-01 5.283885e-02 5.283885e-02 -2.449723e+01 2.110020e+00 2.110020e+00 3.906399e-01 3.097488e-02 3.097488e-02 -2.911501e+01 2.507763e+00 2.507763e+00 2.318652e-01 1.783598e-02 1.783598e-02 -4.235561e+01 1.073283e+01 1.073283e+01 7.602995e-02 6.518094e-03 6.518094e-03 -1.521385e+02 9.905010e+01 9.905010e+01 2.549474e-03 9.406611e-04 9.406611e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d03-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d03-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.682484e+01 2.775045e+00 2.775045e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.828133e+01 2.959732e+00 2.959732e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.046424e+01 3.454675e+00 3.454675e+00 -1.837033e+00 1.582291e-01 1.582291e-01 2.362836e+01 3.753439e+00 3.753439e+00 -2.183318e+00 1.880557e-01 1.880557e-01 2.766107e+01 3.787512e+00 3.787512e+00 -2.594878e+00 2.235046e-01 2.235046e-01 3.191776e+01 3.914413e+00 3.914413e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.666802e+01 3.333615e+00 3.333615e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.147307e+01 2.770658e+00 2.770658e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.339596e+01 2.367097e+00 2.367097e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.334516e+01 2.025415e+00 2.025415e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.085062e+01 1.782907e+00 1.782907e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.558937e+01 1.627386e+00 1.627386e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.837609e+01 1.360519e+00 1.360519e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.084315e+01 1.203209e+00 1.203209e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.373487e+01 7.509009e-01 7.509009e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.163879e+00 3.989291e-01 3.989291e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.385102e+00 2.193429e-01 2.193429e-01 -2.061185e+01 1.775360e+00 1.775360e+00 2.196628e+00 1.176876e-01 1.176876e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.015347e+00 6.840886e-02 6.840886e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.771861e-01 3.368109e-02 3.368109e-02 -4.235561e+01 1.073283e+01 1.073283e+01 1.242446e-01 9.750337e-03 9.750337e-03 -1.521385e+02 9.905010e+01 9.905010e+01 3.307380e-03 1.247744e-03 1.247744e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d04-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d04-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.885554e+01 3.200561e+00 3.200561e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.162535e+02 3.652068e+00 3.652068e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.313626e+02 3.959102e+00 3.959102e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.383518e+02 4.186373e+00 4.186373e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.331527e+02 4.168645e+00 4.168645e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.164478e+02 3.919994e+00 3.919994e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.036059e+01 3.300918e+00 3.300918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.110676e+01 2.499161e+00 2.499161e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.596948e+01 1.632962e+00 1.632962e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.816566e+01 9.529880e-01 9.529880e-01 -6.153426e+00 5.300130e-01 5.300130e-01 8.539847e+00 5.009957e-01 5.009957e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.888558e+00 2.581566e-01 2.581566e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.786535e+00 1.344000e-01 1.344000e-01 -1.033040e+01 8.897879e-01 8.897879e-01 8.314956e-01 6.952058e-02 6.952058e-02 -1.227770e+01 1.057515e+00 1.057515e+00 4.054816e-01 3.738897e-02 3.738897e-02 -1.459207e+01 1.256859e+00 1.256859e+00 2.128298e-01 2.141584e-02 2.141584e-02 -1.734271e+01 1.493779e+00 1.493779e+00 1.053347e-01 1.161575e-02 1.161575e-02 -2.578528e+01 6.948789e+00 6.948789e+00 2.816600e-02 3.624671e-03 3.624671e-03 -1.052810e+02 7.254694e+01 7.254694e+01 4.449689e-04 2.717053e-04 2.717053e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d04-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d04-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.882263e+01 2.292783e+00 2.292783e+00 -1.300520e+00 1.120177e-01 1.120177e-01 6.470283e+01 2.500564e+00 2.500564e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.250723e+01 2.580587e+00 2.580587e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.702788e+01 2.377931e+00 2.377931e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.054703e+01 2.292748e+00 2.292748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.048331e+01 2.228106e+00 2.228106e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.567593e+01 2.181178e+00 2.181178e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.775227e+01 2.095443e+00 2.095443e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.645931e+01 1.913337e+00 1.913337e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.313660e+01 1.628139e+00 1.628139e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.935159e+01 1.252820e+00 1.252820e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791051e+01 8.553304e-01 8.553304e-01 -8.691946e+00 7.486632e-01 7.486632e-01 9.604666e+00 5.329800e-01 5.329800e-01 -1.033040e+01 8.897879e-01 8.897879e-01 4.453450e+00 2.837638e-01 2.837638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.813519e+00 1.315454e-01 1.315454e-01 -1.459207e+01 1.256859e+00 1.256859e+00 6.817703e-01 5.765197e-02 5.765197e-02 -1.734271e+01 1.493779e+00 1.493779e+00 2.490194e-01 2.471691e-02 2.471691e-02 -2.578528e+01 6.948789e+00 6.948789e+00 4.029429e-02 5.628156e-03 5.628156e-03 -1.052810e+02 7.254694e+01 7.254694e+01 5.240726e-04 3.465856e-04 3.465856e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d04-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d04-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.435487e+01 3.889083e+00 3.889083e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.209309e+01 4.855428e+00 4.855428e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.287368e+01 5.572386e+00 5.572386e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.545967e+01 6.059383e+00 6.059383e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.598034e+01 6.488784e+00 6.488784e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.154772e+01 6.141299e+00 6.141299e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.997620e+01 5.433714e+00 5.433714e+00 -3.665363e+00 3.157087e-01 3.157087e-01 8.130906e+01 4.501465e+00 4.501465e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.498983e+01 3.862690e+00 3.862690e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.646111e+01 3.652489e+00 3.652489e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.878732e+01 2.937814e+00 2.937814e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.569215e+01 1.807114e+00 1.807114e+00 -8.691946e+00 7.486632e-01 7.486632e-01 7.814674e+00 9.384991e-01 9.384991e-01 -1.033040e+01 8.897879e-01 8.897879e-01 3.667297e+00 3.611024e-01 3.611024e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.739567e+00 1.507552e-01 1.507552e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.788418e-01 7.414731e-02 7.414731e-02 -1.734271e+01 1.493779e+00 1.493779e+00 4.568760e-01 3.994794e-02 3.994794e-02 -2.578528e+01 6.948789e+00 6.948789e+00 1.258431e-01 1.477115e-02 1.477115e-02 -1.052810e+02 7.254694e+01 7.254694e+01 2.892487e-03 1.477522e-03 1.477522e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d04-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d04-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.776041e+01 3.719074e+00 3.719074e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.870623e+01 4.074104e+00 4.074104e+00 -1.545671e+00 1.331332e-01 1.331332e-01 3.277519e+01 4.122582e+00 4.122582e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.618779e+01 4.839969e+00 4.839969e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.078765e+01 4.392209e+00 4.392209e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.594333e+01 3.956333e+00 3.956333e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.023071e+01 3.190471e+00 3.190471e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.215694e+01 2.599895e+00 2.599895e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.091776e+01 2.394251e+00 2.394251e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.784093e+01 1.870451e+00 1.870451e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.174255e+01 1.756402e+00 1.756402e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.366862e+01 1.808922e+00 1.808922e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.424719e+01 1.453099e+00 1.453099e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.564452e+01 9.437791e-01 9.437791e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.107407e+00 5.754803e-01 5.754803e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.760648e+00 3.105451e-01 3.105451e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.128365e+00 1.355363e-01 1.355363e-01 -2.578528e+01 6.948789e+00 6.948789e+00 3.678572e-01 2.884769e-02 2.884769e-02 -1.052810e+02 7.254694e+01 7.254694e+01 3.394696e-03 1.648326e-03 1.648326e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d05-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d05-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.282547e+02 4.495419e+00 4.495419e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.441616e+02 4.551329e+00 4.551329e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.554467e+02 4.930296e+00 4.930296e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.518138e+02 4.855627e+00 4.855627e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.381979e+02 4.674796e+00 4.674796e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.120464e+02 4.152741e+00 4.152741e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.927851e+01 3.243676e+00 3.243676e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.794843e+01 2.249475e+00 2.249475e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.456896e+01 1.325989e+00 1.325989e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.126478e+01 7.082665e-01 7.082665e-01 -6.153426e+00 5.300130e-01 5.300130e-01 4.576736e+00 3.390739e-01 3.390739e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.839542e+00 1.599527e-01 1.599527e-01 -8.691946e+00 7.486632e-01 7.486632e-01 7.291075e-01 7.403617e-02 7.403617e-02 -1.033040e+01 8.897879e-01 8.897879e-01 3.266208e-01 3.823044e-02 3.823044e-02 -1.470860e+01 3.488412e+00 3.488412e+00 8.094901e-02 1.213269e-02 1.213269e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.955645e-03 6.906708e-04 6.906708e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d05-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d05-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.784720e+01 3.466123e+00 3.466123e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.471003e+01 3.403124e+00 3.403124e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.270208e+01 3.409070e+00 3.409070e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.361033e+01 2.937067e+00 2.937067e+00 -2.183318e+00 1.880557e-01 1.880557e-01 9.303931e+01 2.684748e+00 2.684748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.780759e+01 2.532749e+00 2.532749e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.869744e+01 2.422137e+00 2.422137e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.538040e+01 2.230595e+00 2.230595e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.021120e+01 1.934217e+00 1.934217e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.455953e+01 1.504869e+00 1.504869e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.137445e+01 1.058821e+00 1.058821e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.152285e+01 6.473931e-01 6.473931e-01 -8.691946e+00 7.486632e-01 7.486632e-01 5.180351e+00 3.424252e-01 3.424252e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.953442e+00 1.476519e-01 1.476519e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.899589e-01 3.034985e-02 3.034985e-02 -4.659321e+01 2.839621e+01 2.839621e+01 2.310976e-03 1.034278e-03 1.034278e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d05-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d05-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.975401e+01 4.780191e+00 4.780191e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.037482e+01 5.031803e+00 5.031803e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.180272e+01 6.433829e+00 6.433829e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.500909e+01 6.471448e+00 6.471448e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.031646e+02 6.682150e+00 6.682150e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.037997e+02 5.923222e+00 5.923222e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.493794e+01 5.171054e+00 5.171054e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.917580e+01 4.403367e+00 4.403367e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.899103e+01 4.399506e+00 4.399506e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.807908e+01 3.763334e+00 3.763334e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.109440e+01 2.316910e+00 2.316910e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.046011e+01 1.423077e+00 1.423077e+00 -8.691946e+00 7.486632e-01 7.486632e-01 4.573584e+00 5.710347e-01 5.710347e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.947476e+00 2.191623e-01 2.191623e-01 -1.470860e+01 3.488412e+00 3.488412e+00 4.517690e-01 4.478067e-02 4.478067e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.251025e-02 6.122581e-03 6.122581e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d05-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d05-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.051657e+01 4.331477e+00 4.331477e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.214451e+01 4.325586e+00 4.325586e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.500144e+01 5.369061e+00 5.369061e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.997332e+01 4.513757e+00 4.513757e+00 -2.183318e+00 1.880557e-01 1.880557e-01 5.386147e+01 4.881501e+00 4.881501e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.801363e+01 4.263432e+00 4.263432e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.003854e+01 3.248399e+00 3.248399e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.921527e+01 2.602904e+00 2.602904e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.479089e+01 2.198592e+00 2.198592e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.818663e+01 1.861504e+00 1.861504e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.871403e+01 1.744075e+00 1.744075e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.857481e+01 1.653738e+00 1.653738e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.898611e+01 1.313188e+00 1.313188e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.114301e+01 8.578990e-01 8.578990e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.975518e+00 2.320256e-01 2.320256e-01 -4.659321e+01 2.839621e+01 2.839621e+01 3.408777e-02 1.255299e-02 1.255299e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d06-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d06-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.540999e+02 5.400660e+00 5.400660e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.677234e+02 5.670468e+00 5.670468e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.690748e+02 5.730831e+00 5.730831e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.605293e+02 5.573070e+00 5.573070e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.361445e+02 5.074010e+00 5.074010e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.018434e+02 4.222728e+00 4.222728e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.570199e+01 3.055339e+00 3.055339e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.587913e+01 1.938509e+00 1.938509e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.653357e+01 1.050642e+00 1.050642e+00 -5.177463e+00 4.459503e-01 4.459503e-01 6.614902e+00 5.066172e-01 5.066172e-01 -6.153426e+00 5.300130e-01 5.300130e-01 2.430457e+00 2.259669e-01 2.259669e-01 -7.313361e+00 6.299216e-01 6.299216e-01 8.518671e-01 9.737783e-02 9.737783e-02 -8.691946e+00 7.486632e-01 7.486632e-01 3.119018e-01 4.348545e-02 4.348545e-02 -1.186477e+01 2.424165e+00 2.424165e+00 7.097755e-02 1.314645e-02 1.314645e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.964470e-03 6.198766e-04 6.198766e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d06-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d06-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.009206e+02 4.254964e+00 4.254964e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.032097e+02 3.947937e+00 3.947937e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.078605e+02 3.754433e+00 3.754433e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.062566e+02 3.310802e+00 3.310802e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.003631e+02 3.032044e+00 3.032044e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.012799e+01 2.828788e+00 2.828788e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.600011e+01 2.605077e+00 2.605077e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.914099e+01 2.295534e+00 2.295534e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.145433e+01 1.824427e+00 1.824427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.622124e+01 1.308172e+00 1.308172e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.445378e+01 8.218370e-01 8.218370e-01 -7.313361e+00 6.299216e-01 6.299216e-01 6.744587e+00 4.407550e-01 4.407550e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.587733e+00 2.032481e-01 2.032481e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.186745e-01 4.068445e-02 4.068445e-02 -3.368869e+01 1.939975e+01 1.939975e+01 3.066196e-03 1.368754e-03 1.368754e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d06-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d06-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.816942e+01 4.681306e+00 4.681306e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.802211e+01 5.394644e+00 5.394644e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.004145e+02 6.234345e+00 6.234345e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.107356e+02 7.174199e+00 7.174199e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.148094e+02 7.515589e+00 7.515589e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.101778e+02 6.107253e+00 6.107253e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.611545e+01 5.241688e+00 5.241688e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.413204e+01 4.937210e+00 4.937210e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.036667e+01 4.280500e+00 4.280500e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.983214e+01 3.363562e+00 3.363562e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.521581e+01 2.055670e+00 2.055670e+00 -7.313361e+00 6.299216e-01 6.299216e-01 6.684109e+00 9.724895e-01 9.724895e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.668123e+00 3.914825e-01 3.914825e-01 -1.186477e+01 2.424165e+00 2.424165e+00 5.785726e-01 7.952577e-02 7.952577e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.434853e-02 7.286712e-03 7.286712e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d06-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d06-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.597449e+01 4.659709e+00 4.659709e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.513408e+01 4.570877e+00 4.570877e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.921102e+01 5.020556e+00 5.020556e+00 -1.837033e+00 1.582291e-01 1.582291e-01 6.188141e+01 5.372021e+00 5.372021e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.551176e+01 5.034736e+00 5.034736e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.821726e+01 3.726074e+00 3.726074e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.693019e+01 3.234644e+00 3.234644e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.262234e+01 2.609289e+00 2.609289e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.523497e+01 2.096434e+00 2.096434e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.544519e+01 1.784346e+00 1.784346e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.403018e+01 1.687228e+00 1.687228e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.316325e+01 1.624974e+00 1.624974e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.391094e+01 9.959515e-01 9.959515e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.480744e+00 4.266110e-01 4.266110e-01 -3.368869e+01 1.939975e+01 1.939975e+01 7.725229e-02 1.697997e-02 1.697997e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d07-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d07-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.759343e+02 6.050447e+00 6.050447e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.856361e+02 6.512081e+00 6.512081e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.788584e+02 6.292412e+00 6.292412e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.616639e+02 5.925943e+00 5.925943e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.290415e+02 5.183279e+00 5.183279e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.870707e+01 4.022019e+00 4.022019e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.233816e+01 2.698511e+00 2.698511e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.616244e+01 1.595399e+00 1.595399e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.072125e+01 7.762603e-01 7.762603e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.849885e+00 3.389971e-01 3.389971e-01 -6.153426e+00 5.300130e-01 5.300130e-01 1.257925e+00 1.358748e-01 1.358748e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.856912e-01 5.506100e-02 5.506100e-02 -9.982963e+00 2.039681e+00 2.039681e+00 6.705059e-02 1.281328e-02 1.281328e-02 -2.834550e+01 1.632286e+01 1.632286e+01 1.682703e-03 5.397319e-04 5.397319e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d07-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d07-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.210685e+02 5.135350e+00 5.135350e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.196375e+02 4.702298e+00 4.702298e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.202971e+02 4.314884e+00 4.314884e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.146208e+02 3.834870e+00 3.834870e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.032945e+02 3.398660e+00 3.398660e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.755621e+01 3.053600e+00 3.053600e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.988633e+01 2.722166e+00 2.722166e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.045044e+01 2.194913e+00 2.194913e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.271330e+01 1.603923e+00 1.603923e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.877447e+01 1.050099e+00 1.050099e+00 -6.153426e+00 5.300130e-01 5.300130e-01 9.067463e+00 5.761428e-01 5.761428e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.727551e+00 2.805504e-01 2.805504e-01 -9.982963e+00 2.039681e+00 2.039681e+00 6.028162e-01 5.882826e-02 5.882826e-02 -2.834550e+01 1.632286e+01 1.632286e+01 3.291324e-03 1.615346e-03 1.615346e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d07-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d07-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.608449e+01 4.827833e+00 4.827833e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.064805e+02 5.299096e+00 5.299096e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.159591e+02 6.139813e+00 6.139813e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.229112e+02 7.364774e+00 7.364774e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.235612e+02 6.966558e+00 6.966558e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.132774e+02 5.660920e+00 5.660920e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.334269e+01 5.344903e+00 5.344903e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.603497e+01 4.576720e+00 4.576720e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.177559e+01 3.924106e+00 3.924106e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.293339e+01 2.831035e+00 2.831035e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.064159e+01 1.489597e+00 1.489597e+00 -7.313361e+00 6.299216e-01 6.299216e-01 4.176034e+00 6.002895e-01 6.002895e-01 -9.982963e+00 2.039681e+00 2.039681e+00 8.215343e-01 1.300944e-01 1.300944e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.280799e-02 7.200643e-03 7.200643e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d07-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d07-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.977532e+01 5.070344e+00 5.070344e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.012209e+01 4.888153e+00 4.888153e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.257325e+01 5.193705e+00 5.193705e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.280953e+01 6.350874e+00 6.350874e+00 -2.183318e+00 1.880557e-01 1.880557e-01 7.581119e+01 4.934556e+00 4.934556e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.507146e+01 4.540748e+00 4.540748e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.151584e+01 3.430829e+00 3.430829e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.352803e+01 2.650984e+00 2.650984e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.274429e+01 2.111299e+00 2.111299e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.103944e+01 1.991946e+00 1.991946e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.842839e+01 1.581016e+00 1.581016e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791404e+01 1.291442e+00 1.291442e+00 -9.982963e+00 2.039681e+00 2.039681e+00 6.064214e+00 5.879142e-01 5.879142e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.141068e-01 2.082417e-02 2.082417e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d08-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d08-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.978115e+02 6.660942e+00 6.660942e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.991621e+02 7.098890e+00 7.098890e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.843633e+02 6.639094e+00 6.639094e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.558113e+02 6.127222e+00 6.127222e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.178095e+02 5.225446e+00 5.225446e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.589992e+01 3.803267e+00 3.803267e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.153019e+01 2.421911e+00 2.421911e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.850972e+01 1.257970e+00 1.257970e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.719661e+00 5.417020e-01 5.417020e-01 -5.177463e+00 4.459503e-01 4.459503e-01 2.144778e+00 2.102337e-01 2.102337e-01 -7.067397e+00 1.443984e+00 1.443984e+00 3.049476e-01 4.520666e-02 4.520666e-02 -2.006708e+01 1.155570e+01 1.155570e+01 3.726200e-03 1.772634e-03 1.772634e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d08-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d08-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.368852e+02 9.996343e+00 9.996343e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.328523e+02 9.398905e+00 9.398905e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295284e+02 4.906095e+00 4.906095e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.185704e+02 4.185466e+00 4.185466e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.019678e+02 3.637688e+00 3.637688e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.251027e+01 3.222399e+00 3.222399e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.116879e+01 2.675631e+00 2.675631e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.100568e+01 2.033729e+00 2.033729e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.443362e+01 1.367747e+00 1.367747e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.289250e+01 8.075437e-01 8.075437e-01 -7.067397e+00 1.443984e+00 1.443984e+00 2.981475e+00 2.342487e-01 2.342487e-01 -2.006708e+01 1.155570e+01 1.155570e+01 2.753442e-02 7.523117e-03 7.523117e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d08-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d08-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.152471e+02 6.177147e+00 6.177147e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.224623e+02 5.160137e+00 5.160137e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295730e+02 6.490904e+00 6.490904e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.342186e+02 6.852017e+00 6.852017e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.286992e+02 6.509619e+00 6.509619e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.121986e+02 5.204103e+00 5.204103e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.570830e+01 4.833779e+00 4.833779e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.835079e+01 4.602612e+00 4.602612e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.471582e+01 3.676361e+00 3.676361e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.736571e+01 2.307098e+00 2.307098e+00 -7.067397e+00 1.443984e+00 1.443984e+00 4.033761e+00 6.721175e-01 6.721175e-01 -2.006708e+01 1.155570e+01 1.155570e+01 4.859065e-02 2.435393e-02 2.435393e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_EL/d08-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_EL/d08-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.475220e+01 5.902977e+00 5.902977e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.444817e+01 5.649440e+00 5.649440e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.394995e+01 6.247410e+00 6.247410e+00 -1.837033e+00 1.582291e-01 1.582291e-01 8.274077e+01 6.867471e+00 6.867471e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.339998e+01 5.445627e+00 5.445627e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.988968e+01 5.028314e+00 5.028314e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.378467e+01 3.120918e+00 3.120918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.239436e+01 2.439881e+00 2.439881e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.887237e+01 1.989183e+00 1.989183e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.490555e+01 1.748288e+00 1.748288e+00 -7.067397e+00 1.443984e+00 1.443984e+00 1.571370e+01 1.195915e+00 1.195915e+00 -2.006708e+01 1.155570e+01 1.155570e+01 5.534319e-01 8.594294e-02 8.594294e-02 -END YODA_SCATTER2D_V2 diff --git a/analyses/pluginATLAS/ATLAS_2017_I1589844_MU.yoda b/analyses/pluginATLAS/ATLAS_2017_I1589844_MU.yoda deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2017_I1589844_MU.yoda +++ /dev/null @@ -1,911 +0,0 @@ -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d01-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d01-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.843191e+01 7.457050e-01 7.457050e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.441937e+01 8.251125e-01 8.251125e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.066112e+01 1.114318e+00 1.114318e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.064066e+01 1.394752e+00 1.394752e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.727946e+01 1.525491e+00 1.525491e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.446314e+01 1.778923e+00 1.778923e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.806647e+01 1.920201e+00 1.920201e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.538682e+01 1.723712e+00 1.723712e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.033783e+01 1.566466e+00 1.566466e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.086573e+01 1.290886e+00 1.290886e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.126881e+01 9.824325e-01 9.824325e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.267270e+01 7.502458e-01 7.502458e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.607494e+01 5.400483e-01 5.400483e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.169971e+01 4.021634e-01 4.021634e-01 -1.227770e+01 1.057515e+00 1.057515e+00 8.472988e+00 2.986058e-01 2.986058e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.892089e+00 2.098366e-01 2.098366e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.366320e+00 1.600385e-01 1.600385e-01 -2.061185e+01 1.775360e+00 1.775360e+00 3.112279e+00 1.174748e-01 1.174748e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.240750e+00 8.717211e-02 8.717211e-02 -2.911501e+01 2.507763e+00 2.507763e+00 1.534069e+00 6.318952e-02 6.318952e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.030531e+00 4.402922e-02 4.402922e-02 -4.112605e+01 3.542309e+00 3.542309e+00 6.834079e-01 2.963892e-02 2.963892e-02 -4.887840e+01 4.210043e+00 4.210043e+00 4.320688e-01 1.918555e-02 1.918555e-02 -5.809209e+01 5.003645e+00 5.003645e+00 2.666526e-01 1.245923e-02 1.245923e-02 -6.904258e+01 5.946843e+00 5.946843e+00 1.671143e-01 8.250283e-03 8.250283e-03 -8.205726e+01 7.067836e+00 7.067836e+00 9.339255e-02 4.677413e-03 4.677413e-03 -9.752523e+01 8.400139e+00 8.400139e+00 5.411575e-02 2.824555e-03 2.824555e-03 -1.159090e+02 9.983584e+00 9.983584e+00 2.782189e-02 1.487392e-03 1.487392e-03 -1.377581e+02 1.186551e+01 1.186551e+01 1.514939e-02 8.451217e-04 8.451217e-04 -1.961423e+02 4.651872e+01 4.651872e+01 4.275534e-03 2.531246e-04 2.531246e-04 -6.213305e+02 3.786695e+02 3.786695e+02 8.432581e-05 9.408547e-06 9.408547e-06 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d01-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d01-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.131834e+00 4.490677e-01 4.490677e-01 -1.300520e+00 1.120177e-01 1.120177e-01 1.009730e+01 4.073897e-01 4.073897e-01 -1.545671e+00 1.331332e-01 1.331332e-01 1.143915e+01 5.885724e-01 5.885724e-01 -1.837033e+00 1.582291e-01 1.582291e-01 1.466143e+01 5.944605e-01 5.944605e-01 -2.183318e+00 1.880557e-01 1.880557e-01 1.782742e+01 6.701411e-01 6.701411e-01 -2.594878e+00 2.235046e-01 2.235046e-01 2.082979e+01 7.277524e-01 7.277524e-01 -3.084019e+00 2.656357e-01 2.656357e-01 2.538012e+01 9.136748e-01 9.136748e-01 -3.665363e+00 3.157087e-01 3.157087e-01 2.791683e+01 9.391386e-01 9.391386e-01 -4.356292e+00 3.752204e-01 3.752204e-01 3.061612e+01 9.748082e-01 9.748082e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.145211e+01 9.928744e-01 9.928744e-01 -6.153426e+00 5.300130e-01 5.300130e-01 3.162385e+01 9.857417e-01 9.857417e-01 -7.313361e+00 6.299216e-01 6.299216e-01 2.929418e+01 9.115539e-01 9.115539e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.545845e+01 8.282911e-01 8.282911e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.103254e+01 6.742779e-01 6.742779e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.604205e+01 5.290447e-01 5.290447e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.130196e+01 3.864420e-01 3.864420e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.816633e+00 2.789999e-01 2.789999e-01 -2.061185e+01 1.775360e+00 1.775360e+00 5.245804e+00 1.959936e-01 1.959936e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.466486e+00 1.362328e-01 1.362328e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.335649e+00 9.715040e-02 9.715040e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.476691e+00 6.452457e-02 6.452457e-02 -4.112605e+01 3.542309e+00 3.542309e+00 9.501897e-01 4.261565e-02 4.261565e-02 -4.887840e+01 4.210043e+00 4.210043e+00 5.877472e-01 2.727143e-02 2.727143e-02 -5.809209e+01 5.003645e+00 5.003645e+00 3.522312e-01 1.736717e-02 1.736717e-02 -6.904258e+01 5.946843e+00 5.946843e+00 2.218414e-01 1.140433e-02 1.140433e-02 -8.205726e+01 7.067836e+00 7.067836e+00 1.251722e-01 6.452849e-03 6.452849e-03 -9.752523e+01 8.400139e+00 8.400139e+00 6.951626e-02 3.670086e-03 3.670086e-03 -1.159090e+02 9.983584e+00 9.983584e+00 3.751489e-02 2.146711e-03 2.146711e-03 -1.377581e+02 1.186551e+01 1.186551e+01 2.007446e-02 1.180381e-03 1.180381e-03 -1.961423e+02 4.651872e+01 4.651872e+01 5.355213e-03 3.426689e-04 3.426689e-04 -6.213305e+02 3.786695e+02 3.786695e+02 1.064601e-04 1.463478e-05 1.463478e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d01-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d01-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.026395e+00 1.138510e+00 1.138510e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.064791e+00 1.377203e+00 1.377203e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.011198e+01 1.772341e+00 1.772341e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.493136e+01 2.131044e+00 2.131044e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.935026e+01 2.498820e+00 2.498820e+00 -2.594878e+00 2.235046e-01 2.235046e-01 2.554289e+01 2.917353e+00 2.917353e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.185762e+01 3.495927e+00 3.495927e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.680790e+01 3.417445e+00 3.417445e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.925983e+01 3.263206e+00 3.263206e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.806103e+01 2.585990e+00 2.585990e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.437418e+01 2.532062e+00 2.532062e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.832551e+01 2.932608e+00 2.932608e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.125015e+01 2.458701e+00 2.458701e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.569831e+01 1.772818e+00 1.772818e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.146950e+01 1.057360e+00 1.057360e+00 -1.459207e+01 1.256859e+00 1.256859e+00 8.173606e+00 3.808644e-01 3.808644e-01 -1.734271e+01 1.493779e+00 1.493779e+00 6.084104e+00 3.673885e-01 3.673885e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.559399e+00 3.934733e-01 3.934733e-01 -2.449723e+01 2.110020e+00 2.110020e+00 3.438216e+00 3.291714e-01 3.291714e-01 -2.911501e+01 2.507763e+00 2.507763e+00 2.590863e+00 2.375422e-01 2.375422e-01 -3.460326e+01 2.980482e+00 2.980482e+00 1.894800e+00 1.602624e-01 1.602624e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.341776e+00 1.010453e-01 1.010453e-01 -4.887840e+01 4.210043e+00 4.210043e+00 9.108951e-01 6.451331e-02 6.451331e-02 -5.809209e+01 5.003645e+00 5.003645e+00 5.936520e-01 3.993185e-02 3.993185e-02 -6.904258e+01 5.946843e+00 5.946843e+00 3.875928e-01 2.014963e-02 2.014963e-02 -8.205726e+01 7.067836e+00 7.067836e+00 2.416991e-01 1.231090e-02 1.231090e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.484650e-01 7.958954e-03 7.958954e-03 -1.159090e+02 9.983584e+00 9.983584e+00 8.610534e-02 4.620871e-03 4.620871e-03 -1.377581e+02 1.186551e+01 1.186551e+01 4.948377e-02 2.979784e-03 2.979784e-03 -1.961423e+02 4.651872e+01 4.651872e+01 1.515177e-02 1.007609e-03 1.007609e-03 -6.213305e+02 3.786695e+02 3.786695e+02 4.511159e-04 4.895730e-05 4.895730e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d01-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d01-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.140524e+00 8.120082e-01 8.120082e-01 -1.300520e+00 1.120177e-01 1.120177e-01 2.642372e+00 6.443953e-01 6.443953e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.240243e+00 7.587629e-01 7.587629e-01 -1.837033e+00 1.582291e-01 1.582291e-01 4.493157e+00 8.792785e-01 8.792785e-01 -2.183318e+00 1.880557e-01 1.880557e-01 5.409410e+00 9.191437e-01 9.191437e-01 -2.594878e+00 2.235046e-01 2.235046e-01 7.443397e+00 1.129511e+00 1.129511e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.015570e+00 1.172671e+00 1.172671e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.216738e+01 1.351261e+00 1.351261e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.514874e+01 1.504543e+00 1.504543e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.744598e+01 1.412676e+00 1.412676e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.977819e+01 1.471023e+00 1.471023e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.103805e+01 1.324354e+00 1.324354e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.107483e+01 1.223237e+00 1.223237e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.997679e+01 1.067052e+00 1.067052e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.762803e+01 8.065027e-01 8.065027e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.481611e+01 7.324409e-01 7.324409e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.153820e+01 4.853849e-01 4.853849e-01 -2.061185e+01 1.775360e+00 1.775360e+00 8.572226e+00 3.224268e-01 3.224268e-01 -2.449723e+01 2.110020e+00 2.110020e+00 6.043360e+00 2.697194e-01 2.697194e-01 -2.911501e+01 2.507763e+00 2.507763e+00 4.264073e+00 2.256532e-01 2.256532e-01 -3.460326e+01 2.980482e+00 2.980482e+00 2.947890e+00 1.660653e-01 1.660653e-01 -4.112605e+01 3.542309e+00 3.542309e+00 1.996719e+00 1.218428e-01 1.218428e-01 -4.887840e+01 4.210043e+00 4.210043e+00 1.334860e+00 7.509910e-02 7.509910e-02 -5.809209e+01 5.003645e+00 5.003645e+00 8.462506e-01 5.007346e-02 5.007346e-02 -6.904258e+01 5.946843e+00 5.946843e+00 5.250550e-01 3.429120e-02 3.429120e-02 -8.205726e+01 7.067836e+00 7.067836e+00 3.261205e-01 1.745130e-02 1.745130e-02 -9.752523e+01 8.400139e+00 8.400139e+00 1.990265e-01 1.079316e-02 1.079316e-02 -1.159090e+02 9.983584e+00 9.983584e+00 1.165856e-01 6.555164e-03 6.555164e-03 -1.377581e+02 1.186551e+01 1.186551e+01 6.653251e-02 4.147569e-03 4.147569e-03 -1.961423e+02 4.651872e+01 4.651872e+01 2.095795e-02 1.430811e-03 1.430811e-03 -6.213305e+02 3.786695e+02 3.786695e+02 5.946527e-04 6.802584e-05 6.802584e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d02-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d02-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.251658e+01 1.566065e+00 1.566065e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.347048e+01 1.698262e+00 1.698262e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.865451e+01 2.399943e+00 2.399943e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.857296e+01 2.556877e+00 2.556877e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.720231e+01 2.750437e+00 2.750437e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.337012e+01 3.065478e+00 3.065478e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.859543e+01 2.897633e+00 2.897633e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.455953e+01 2.508455e+00 2.508455e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.829047e+01 1.991888e+00 1.991888e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.022941e+01 1.440183e+00 1.440183e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.504355e+01 9.844996e-01 9.844996e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.507121e+01 6.011462e-01 6.011462e-01 -8.691946e+00 7.486632e-01 7.486632e-01 8.787865e+00 3.656542e-01 3.656542e-01 -1.033040e+01 8.897879e-01 8.897879e-01 5.257721e+00 2.323279e-01 2.323279e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.288535e+00 1.580652e-01 1.580652e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.042152e+00 1.013971e-01 1.013971e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.274409e+00 6.704191e-02 6.704191e-02 -2.061185e+01 1.775360e+00 1.775360e+00 8.054232e-01 4.494587e-02 4.494587e-02 -2.449723e+01 2.110020e+00 2.110020e+00 4.916852e-01 2.996955e-02 2.996955e-02 -2.911501e+01 2.507763e+00 2.507763e+00 3.015235e-01 1.926580e-02 1.926580e-02 -3.460326e+01 2.980482e+00 2.980482e+00 1.787215e-01 1.213894e-02 1.213894e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.052898e-01 7.624179e-03 7.624179e-03 -4.887840e+01 4.210043e+00 4.210043e+00 6.465946e-02 5.033112e-03 5.033112e-03 -5.809209e+01 5.003645e+00 5.003645e+00 3.583416e-02 2.904991e-03 2.904991e-03 -6.904258e+01 5.946843e+00 5.946843e+00 1.924695e-02 1.704510e-03 1.704510e-03 -9.830401e+01 2.331459e+01 2.331459e+01 6.161733e-03 6.179331e-04 6.179331e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.084350e-04 5.042981e-05 5.042981e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d02-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d02-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.213549e+01 1.257319e+00 1.257319e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.578350e+01 9.251823e-01 9.251823e-01 -1.545671e+00 1.331332e-01 1.331332e-01 3.036665e+01 1.294972e+00 1.294972e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.572293e+01 1.370832e+00 1.370832e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.079239e+01 1.416067e+00 1.416067e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.456356e+01 1.315123e+00 1.315123e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.837683e+01 1.402558e+00 1.402558e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.148847e+01 1.505844e+00 1.505844e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.019930e+01 1.479742e+00 1.479742e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.733873e+01 1.443311e+00 1.443311e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.073097e+01 1.296580e+00 1.296580e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.224517e+01 1.087139e+00 1.087139e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.355572e+01 8.613873e-01 8.613873e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.561065e+01 5.915471e-01 5.915471e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.550952e+00 3.961028e-01 3.961028e-01 -1.459207e+01 1.256859e+00 1.256859e+00 5.369347e+00 2.376030e-01 2.376030e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.976504e+00 1.412455e-01 1.412455e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.628869e+00 8.204071e-02 8.204071e-02 -2.449723e+01 2.110020e+00 2.110020e+00 9.015307e-01 4.915482e-02 4.915482e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.935663e-01 2.931522e-02 2.931522e-02 -3.460326e+01 2.980482e+00 2.980482e+00 2.769087e-01 1.751636e-02 1.751636e-02 -4.112605e+01 3.542309e+00 3.542309e+00 1.599571e-01 1.084167e-02 1.084167e-02 -4.887840e+01 4.210043e+00 4.210043e+00 9.306745e-02 6.805731e-03 6.805731e-03 -5.809209e+01 5.003645e+00 5.003645e+00 5.227408e-02 4.043149e-03 4.043149e-03 -6.904258e+01 5.946843e+00 5.946843e+00 2.779982e-02 2.358778e-03 2.358778e-03 -9.830401e+01 2.331459e+01 2.331459e+01 8.619561e-03 8.318715e-04 8.318715e-04 -3.114029e+02 1.897843e+02 1.897843e+02 2.994644e-04 5.719088e-05 5.719088e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d02-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d02-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.489763e+01 2.353181e+00 2.353181e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.982360e+01 2.603555e+00 2.603555e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.587930e+01 3.219879e+00 3.219879e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.255242e+01 3.668543e+00 3.668543e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.233328e+01 3.999467e+00 3.999467e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.087246e+01 4.713882e+00 4.713882e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.801644e+01 4.864634e+00 4.864634e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.193357e+01 4.588721e+00 4.588721e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.020458e+01 3.772272e+00 3.772272e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.336661e+01 3.275211e+00 3.275211e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.188339e+01 3.227490e+00 3.227490e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.957067e+01 2.899641e+00 2.899641e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.901814e+01 2.029827e+00 2.029827e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.152678e+01 9.587638e-01 9.587638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 6.944233e+00 4.382270e-01 4.382270e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.231061e+00 2.760548e-01 2.760548e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.727649e+00 2.140536e-01 2.140536e-01 -2.061185e+01 1.775360e+00 1.775360e+00 1.782786e+00 1.685825e-01 1.685825e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.175197e+00 1.042250e-01 1.042250e-01 -2.911501e+01 2.507763e+00 2.507763e+00 7.742704e-01 6.094456e-02 6.094456e-02 -3.460326e+01 2.980482e+00 2.980482e+00 5.012703e-01 3.459606e-02 3.459606e-02 -4.112605e+01 3.542309e+00 3.542309e+00 3.078006e-01 1.991102e-02 1.991102e-02 -4.887840e+01 4.210043e+00 4.210043e+00 1.839932e-01 1.264942e-02 1.264942e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.097354e-01 7.702506e-03 7.702506e-03 -6.904258e+01 5.946843e+00 5.946843e+00 6.628384e-02 4.968150e-03 4.968150e-03 -9.830401e+01 2.331459e+01 2.331459e+01 2.429788e-02 2.096348e-03 2.096348e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.114871e-03 3.088679e-04 3.088679e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d02-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d02-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.049465e+00 1.627731e+00 1.627731e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.990596e+00 1.624231e+00 1.624231e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.076139e+01 1.909451e+00 1.909451e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.224761e+01 2.313692e+00 2.313692e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.547082e+01 2.384618e+00 2.384618e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.915081e+01 2.414434e+00 2.414434e+00 -3.084019e+00 2.656357e-01 2.656357e-01 2.210513e+01 2.659900e+00 2.659900e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.681122e+01 2.366631e+00 2.366631e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.082771e+01 2.181140e+00 2.181140e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.368383e+01 2.067661e+00 2.067661e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.408435e+01 1.837770e+00 1.837770e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.238250e+01 1.563845e+00 1.563845e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.943282e+01 1.655684e+00 1.655684e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.385918e+01 1.174033e+00 1.174033e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.797710e+01 8.721781e-01 8.721781e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.253059e+01 5.659160e-01 5.659160e-01 -1.734271e+01 1.493779e+00 1.493779e+00 7.964495e+00 3.510716e-01 3.510716e-01 -2.061185e+01 1.775360e+00 1.775360e+00 4.792676e+00 2.437191e-01 2.437191e-01 -2.449723e+01 2.110020e+00 2.110020e+00 2.751965e+00 1.694596e-01 1.694596e-01 -2.911501e+01 2.507763e+00 2.507763e+00 1.561784e+00 1.081239e-01 1.081239e-01 -3.460326e+01 2.980482e+00 2.980482e+00 9.004670e-01 5.119386e-02 5.119386e-02 -4.112605e+01 3.542309e+00 3.542309e+00 5.182805e-01 2.835630e-02 2.835630e-02 -4.887840e+01 4.210043e+00 4.210043e+00 2.938264e-01 1.749024e-02 1.749024e-02 -5.809209e+01 5.003645e+00 5.003645e+00 1.663662e-01 1.081333e-02 1.081333e-02 -6.904258e+01 5.946843e+00 5.946843e+00 9.636735e-02 6.718521e-03 6.718521e-03 -9.830401e+01 2.331459e+01 2.331459e+01 3.556128e-02 3.074905e-03 3.074905e-03 -3.114029e+02 1.897843e+02 1.897843e+02 1.537270e-03 4.326461e-04 4.326461e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d03-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d03-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.913391e+01 2.533522e+00 2.533522e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.657180e+01 3.283696e+00 3.283696e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.881895e+01 3.335522e+00 3.335522e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.131585e+02 3.660216e+00 3.660216e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.181065e+02 3.785198e+00 3.785198e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.138350e+02 3.772396e+00 3.772396e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.572317e+01 3.226374e+00 3.226374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.176193e+01 2.561989e+00 2.561989e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.867972e+01 1.868982e+00 1.868982e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.846156e+01 1.188777e+00 1.188777e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.549413e+01 6.935612e-01 6.935612e-01 -7.313361e+00 6.299216e-01 6.299216e-01 7.874323e+00 3.838026e-01 3.838026e-01 -8.691946e+00 7.486632e-01 7.486632e-01 4.064096e+00 2.178716e-01 2.178716e-01 -1.033040e+01 8.897879e-01 8.897879e-01 2.139051e+00 1.241570e-01 1.241570e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.134773e+00 7.093575e-02 7.093575e-02 -1.459207e+01 1.256859e+00 1.256859e+00 6.540028e-01 4.373642e-02 4.373642e-02 -1.734271e+01 1.493779e+00 1.493779e+00 3.781698e-01 2.689145e-02 2.689145e-02 -2.061185e+01 1.775360e+00 1.775360e+00 2.121876e-01 1.593806e-02 1.593806e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.083296e-01 9.433377e-03 9.433377e-03 -2.911501e+01 2.507763e+00 2.507763e+00 6.069497e-02 5.303741e-03 5.303741e-03 -4.235561e+01 1.073283e+01 1.073283e+01 1.964958e-02 1.895753e-03 1.895753e-03 -1.521385e+02 9.905010e+01 9.905010e+01 4.600536e-04 9.522037e-05 9.522037e-05 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d03-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d03-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 3.825805e+01 2.132329e+00 2.132329e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.456967e+01 1.874852e+00 1.874852e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.186146e+01 2.073565e+00 2.073565e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.725064e+01 2.240922e+00 2.240922e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.164457e+01 2.013365e+00 2.013365e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.581330e+01 1.969264e+00 1.969264e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.706655e+01 1.959374e+00 1.959374e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.342732e+01 1.889673e+00 1.889673e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.799750e+01 1.819163e+00 1.819163e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.842780e+01 1.617673e+00 1.617673e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.718619e+01 1.371325e+00 1.371325e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.584674e+01 1.036562e+00 1.036562e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.614116e+01 7.093522e-01 7.093522e-01 -1.033040e+01 8.897879e-01 8.897879e-01 9.045228e+00 4.474669e-01 4.474669e-01 -1.227770e+01 1.057515e+00 1.057515e+00 4.427789e+00 2.435580e-01 2.435580e-01 -1.459207e+01 1.256859e+00 1.256859e+00 2.019382e+00 1.234920e-01 1.234920e-01 -1.734271e+01 1.493779e+00 1.493779e+00 9.245877e-01 6.312702e-02 6.312702e-02 -2.061185e+01 1.775360e+00 1.775360e+00 4.259970e-01 3.223159e-02 3.223159e-02 -2.449723e+01 2.110020e+00 2.110020e+00 1.973009e-01 1.669273e-02 1.669273e-02 -2.911501e+01 2.507763e+00 2.507763e+00 9.582690e-02 9.407234e-03 9.407234e-03 -4.235561e+01 1.073283e+01 1.073283e+01 2.485965e-02 2.980908e-03 2.980908e-03 -1.521385e+02 9.905010e+01 9.905010e+01 6.553450e-04 2.239677e-04 2.239677e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d03-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d03-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.881642e+01 3.184287e+00 3.184287e+00 -1.300520e+00 1.120177e-01 1.120177e-01 3.541813e+01 4.103723e+00 4.103723e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.309837e+01 4.948677e+00 4.948677e+00 -1.837033e+00 1.582291e-01 1.582291e-01 5.446910e+01 5.105418e+00 5.105418e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.478630e+01 5.780485e+00 5.780485e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.364876e+01 5.943595e+00 5.943595e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.815995e+01 5.620889e+00 5.620889e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.694848e+01 4.621943e+00 4.621943e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.738364e+01 3.852427e+00 3.852427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 5.286911e+01 3.498016e+00 3.498016e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.679335e+01 3.225438e+00 3.225438e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.254818e+01 2.250628e+00 2.250628e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.275560e+01 1.281082e+00 1.281082e+00 -1.033040e+01 8.897879e-01 8.897879e-01 6.770748e+00 5.681592e-01 5.681592e-01 -1.227770e+01 1.057515e+00 1.057515e+00 3.611050e+00 2.702737e-01 2.702737e-01 -1.459207e+01 1.256859e+00 1.256859e+00 1.956713e+00 1.317371e-01 1.317371e-01 -1.734271e+01 1.493779e+00 1.493779e+00 1.102316e+00 8.512634e-02 8.512634e-02 -2.061185e+01 1.775360e+00 1.775360e+00 6.606707e-01 5.283885e-02 5.283885e-02 -2.449723e+01 2.110020e+00 2.110020e+00 3.906399e-01 3.097488e-02 3.097488e-02 -2.911501e+01 2.507763e+00 2.507763e+00 2.318652e-01 1.783598e-02 1.783598e-02 -4.235561e+01 1.073283e+01 1.073283e+01 7.602995e-02 6.518094e-03 6.518094e-03 -1.521385e+02 9.905010e+01 9.905010e+01 2.549474e-03 9.406611e-04 9.406611e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d03-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d03-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.682484e+01 2.775045e+00 2.775045e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.828133e+01 2.959732e+00 2.959732e+00 -1.545671e+00 1.331332e-01 1.331332e-01 2.046424e+01 3.454675e+00 3.454675e+00 -1.837033e+00 1.582291e-01 1.582291e-01 2.362836e+01 3.753439e+00 3.753439e+00 -2.183318e+00 1.880557e-01 1.880557e-01 2.766107e+01 3.787512e+00 3.787512e+00 -2.594878e+00 2.235046e-01 2.235046e-01 3.191776e+01 3.914413e+00 3.914413e+00 -3.084019e+00 2.656357e-01 2.656357e-01 3.666802e+01 3.333615e+00 3.333615e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.147307e+01 2.770658e+00 2.770658e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.339596e+01 2.367097e+00 2.367097e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.334516e+01 2.025415e+00 2.025415e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.085062e+01 1.782907e+00 1.782907e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.558937e+01 1.627386e+00 1.627386e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.837609e+01 1.360519e+00 1.360519e+00 -1.033040e+01 8.897879e-01 8.897879e-01 2.084315e+01 1.203209e+00 1.203209e+00 -1.227770e+01 1.057515e+00 1.057515e+00 1.373487e+01 7.509009e-01 7.509009e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.163879e+00 3.989291e-01 3.989291e-01 -1.734271e+01 1.493779e+00 1.493779e+00 4.385102e+00 2.193429e-01 2.193429e-01 -2.061185e+01 1.775360e+00 1.775360e+00 2.196628e+00 1.176876e-01 1.176876e-01 -2.449723e+01 2.110020e+00 2.110020e+00 1.015347e+00 6.840886e-02 6.840886e-02 -2.911501e+01 2.507763e+00 2.507763e+00 4.771861e-01 3.368109e-02 3.368109e-02 -4.235561e+01 1.073283e+01 1.073283e+01 1.242446e-01 9.750337e-03 9.750337e-03 -1.521385e+02 9.905010e+01 9.905010e+01 3.307380e-03 1.247744e-03 1.247744e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d04-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d04-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.885554e+01 3.200561e+00 3.200561e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.162535e+02 3.652068e+00 3.652068e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.313626e+02 3.959102e+00 3.959102e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.383518e+02 4.186373e+00 4.186373e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.331527e+02 4.168645e+00 4.168645e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.164478e+02 3.919994e+00 3.919994e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.036059e+01 3.300918e+00 3.300918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.110676e+01 2.499161e+00 2.499161e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.596948e+01 1.632962e+00 1.632962e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.816566e+01 9.529880e-01 9.529880e-01 -6.153426e+00 5.300130e-01 5.300130e-01 8.539847e+00 5.009957e-01 5.009957e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.888558e+00 2.581566e-01 2.581566e-01 -8.691946e+00 7.486632e-01 7.486632e-01 1.786535e+00 1.344000e-01 1.344000e-01 -1.033040e+01 8.897879e-01 8.897879e-01 8.314956e-01 6.952058e-02 6.952058e-02 -1.227770e+01 1.057515e+00 1.057515e+00 4.054816e-01 3.738897e-02 3.738897e-02 -1.459207e+01 1.256859e+00 1.256859e+00 2.128298e-01 2.141584e-02 2.141584e-02 -1.734271e+01 1.493779e+00 1.493779e+00 1.053347e-01 1.161575e-02 1.161575e-02 -2.578528e+01 6.948789e+00 6.948789e+00 2.816600e-02 3.624671e-03 3.624671e-03 -1.052810e+02 7.254694e+01 7.254694e+01 4.449689e-04 2.717053e-04 2.717053e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d04-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d04-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.882263e+01 2.292783e+00 2.292783e+00 -1.300520e+00 1.120177e-01 1.120177e-01 6.470283e+01 2.500564e+00 2.500564e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.250723e+01 2.580587e+00 2.580587e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.702788e+01 2.377931e+00 2.377931e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.054703e+01 2.292748e+00 2.292748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.048331e+01 2.228106e+00 2.228106e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.567593e+01 2.181178e+00 2.181178e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.775227e+01 2.095443e+00 2.095443e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.645931e+01 1.913337e+00 1.913337e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.313660e+01 1.628139e+00 1.628139e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.935159e+01 1.252820e+00 1.252820e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791051e+01 8.553304e-01 8.553304e-01 -8.691946e+00 7.486632e-01 7.486632e-01 9.604666e+00 5.329800e-01 5.329800e-01 -1.033040e+01 8.897879e-01 8.897879e-01 4.453450e+00 2.837638e-01 2.837638e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.813519e+00 1.315454e-01 1.315454e-01 -1.459207e+01 1.256859e+00 1.256859e+00 6.817703e-01 5.765197e-02 5.765197e-02 -1.734271e+01 1.493779e+00 1.493779e+00 2.490194e-01 2.471691e-02 2.471691e-02 -2.578528e+01 6.948789e+00 6.948789e+00 4.029429e-02 5.628156e-03 5.628156e-03 -1.052810e+02 7.254694e+01 7.254694e+01 5.240726e-04 3.465856e-04 3.465856e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d04-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d04-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.435487e+01 3.889083e+00 3.889083e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.209309e+01 4.855428e+00 4.855428e+00 -1.545671e+00 1.331332e-01 1.331332e-01 6.287368e+01 5.572386e+00 5.572386e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.545967e+01 6.059383e+00 6.059383e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.598034e+01 6.488784e+00 6.488784e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.154772e+01 6.141299e+00 6.141299e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.997620e+01 5.433714e+00 5.433714e+00 -3.665363e+00 3.157087e-01 3.157087e-01 8.130906e+01 4.501465e+00 4.501465e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.498983e+01 3.862690e+00 3.862690e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.646111e+01 3.652489e+00 3.652489e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.878732e+01 2.937814e+00 2.937814e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.569215e+01 1.807114e+00 1.807114e+00 -8.691946e+00 7.486632e-01 7.486632e-01 7.814674e+00 9.384991e-01 9.384991e-01 -1.033040e+01 8.897879e-01 8.897879e-01 3.667297e+00 3.611024e-01 3.611024e-01 -1.227770e+01 1.057515e+00 1.057515e+00 1.739567e+00 1.507552e-01 1.507552e-01 -1.459207e+01 1.256859e+00 1.256859e+00 8.788418e-01 7.414731e-02 7.414731e-02 -1.734271e+01 1.493779e+00 1.493779e+00 4.568760e-01 3.994794e-02 3.994794e-02 -2.578528e+01 6.948789e+00 6.948789e+00 1.258431e-01 1.477115e-02 1.477115e-02 -1.052810e+02 7.254694e+01 7.254694e+01 2.892487e-03 1.477522e-03 1.477522e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d04-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d04-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 2.776041e+01 3.719074e+00 3.719074e+00 -1.300520e+00 1.120177e-01 1.120177e-01 2.870623e+01 4.074104e+00 4.074104e+00 -1.545671e+00 1.331332e-01 1.331332e-01 3.277519e+01 4.122582e+00 4.122582e+00 -1.837033e+00 1.582291e-01 1.582291e-01 3.618779e+01 4.839969e+00 4.839969e+00 -2.183318e+00 1.880557e-01 1.880557e-01 4.078765e+01 4.392209e+00 4.392209e+00 -2.594878e+00 2.235046e-01 2.235046e-01 4.594333e+01 3.956333e+00 3.956333e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.023071e+01 3.190471e+00 3.190471e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.215694e+01 2.599895e+00 2.599895e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.091776e+01 2.394251e+00 2.394251e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.784093e+01 1.870451e+00 1.870451e+00 -6.153426e+00 5.300130e-01 5.300130e-01 4.174255e+01 1.756402e+00 1.756402e+00 -7.313361e+00 6.299216e-01 6.299216e-01 3.366862e+01 1.808922e+00 1.808922e+00 -8.691946e+00 7.486632e-01 7.486632e-01 2.424719e+01 1.453099e+00 1.453099e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.564452e+01 9.437791e-01 9.437791e-01 -1.227770e+01 1.057515e+00 1.057515e+00 9.107407e+00 5.754803e-01 5.754803e-01 -1.459207e+01 1.256859e+00 1.256859e+00 4.760648e+00 3.105451e-01 3.105451e-01 -1.734271e+01 1.493779e+00 1.493779e+00 2.128365e+00 1.355363e-01 1.355363e-01 -2.578528e+01 6.948789e+00 6.948789e+00 3.678572e-01 2.884769e-02 2.884769e-02 -1.052810e+02 7.254694e+01 7.254694e+01 3.394696e-03 1.648326e-03 1.648326e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d05-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d05-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.282547e+02 4.495419e+00 4.495419e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.441616e+02 4.551329e+00 4.551329e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.554467e+02 4.930296e+00 4.930296e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.518138e+02 4.855627e+00 4.855627e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.381979e+02 4.674796e+00 4.674796e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.120464e+02 4.152741e+00 4.152741e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.927851e+01 3.243676e+00 3.243676e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.794843e+01 2.249475e+00 2.249475e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.456896e+01 1.325989e+00 1.325989e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.126478e+01 7.082665e-01 7.082665e-01 -6.153426e+00 5.300130e-01 5.300130e-01 4.576736e+00 3.390739e-01 3.390739e-01 -7.313361e+00 6.299216e-01 6.299216e-01 1.839542e+00 1.599527e-01 1.599527e-01 -8.691946e+00 7.486632e-01 7.486632e-01 7.291075e-01 7.403617e-02 7.403617e-02 -1.033040e+01 8.897879e-01 8.897879e-01 3.266208e-01 3.823044e-02 3.823044e-02 -1.470860e+01 3.488412e+00 3.488412e+00 8.094901e-02 1.213269e-02 1.213269e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.955645e-03 6.906708e-04 6.906708e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d05-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d05-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.784720e+01 3.466123e+00 3.466123e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.471003e+01 3.403124e+00 3.403124e+00 -1.545671e+00 1.331332e-01 1.331332e-01 9.270208e+01 3.409070e+00 3.409070e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.361033e+01 2.937067e+00 2.937067e+00 -2.183318e+00 1.880557e-01 1.880557e-01 9.303931e+01 2.684748e+00 2.684748e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.780759e+01 2.532749e+00 2.532749e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.869744e+01 2.422137e+00 2.422137e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.538040e+01 2.230595e+00 2.230595e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.021120e+01 1.934217e+00 1.934217e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.455953e+01 1.504869e+00 1.504869e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.137445e+01 1.058821e+00 1.058821e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.152285e+01 6.473931e-01 6.473931e-01 -8.691946e+00 7.486632e-01 7.486632e-01 5.180351e+00 3.424252e-01 3.424252e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.953442e+00 1.476519e-01 1.476519e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.899589e-01 3.034985e-02 3.034985e-02 -4.659321e+01 2.839621e+01 2.839621e+01 2.310976e-03 1.034278e-03 1.034278e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d05-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d05-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.975401e+01 4.780191e+00 4.780191e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.037482e+01 5.031803e+00 5.031803e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.180272e+01 6.433829e+00 6.433829e+00 -1.837033e+00 1.582291e-01 1.582291e-01 9.500909e+01 6.471448e+00 6.471448e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.031646e+02 6.682150e+00 6.682150e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.037997e+02 5.923222e+00 5.923222e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.493794e+01 5.171054e+00 5.171054e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.917580e+01 4.403367e+00 4.403367e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.899103e+01 4.399506e+00 4.399506e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.807908e+01 3.763334e+00 3.763334e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.109440e+01 2.316910e+00 2.316910e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.046011e+01 1.423077e+00 1.423077e+00 -8.691946e+00 7.486632e-01 7.486632e-01 4.573584e+00 5.710347e-01 5.710347e-01 -1.033040e+01 8.897879e-01 8.897879e-01 1.947476e+00 2.191623e-01 2.191623e-01 -1.470860e+01 3.488412e+00 3.488412e+00 4.517690e-01 4.478067e-02 4.478067e-02 -4.659321e+01 2.839621e+01 2.839621e+01 1.251025e-02 6.122581e-03 6.122581e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d05-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d05-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 4.051657e+01 4.331477e+00 4.331477e+00 -1.300520e+00 1.120177e-01 1.120177e-01 4.214451e+01 4.325586e+00 4.325586e+00 -1.545671e+00 1.331332e-01 1.331332e-01 4.500144e+01 5.369061e+00 5.369061e+00 -1.837033e+00 1.582291e-01 1.582291e-01 4.997332e+01 4.513757e+00 4.513757e+00 -2.183318e+00 1.880557e-01 1.880557e-01 5.386147e+01 4.881501e+00 4.881501e+00 -2.594878e+00 2.235046e-01 2.235046e-01 5.801363e+01 4.263432e+00 4.263432e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.003854e+01 3.248399e+00 3.248399e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.921527e+01 2.602904e+00 2.602904e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.479089e+01 2.198592e+00 2.198592e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.818663e+01 1.861504e+00 1.861504e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.871403e+01 1.744075e+00 1.744075e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.857481e+01 1.653738e+00 1.653738e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.898611e+01 1.313188e+00 1.313188e+00 -1.033040e+01 8.897879e-01 8.897879e-01 1.114301e+01 8.578990e-01 8.578990e-01 -1.470860e+01 3.488412e+00 3.488412e+00 2.975518e+00 2.320256e-01 2.320256e-01 -4.659321e+01 2.839621e+01 2.839621e+01 3.408777e-02 1.255299e-02 1.255299e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d06-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d06-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.540999e+02 5.400660e+00 5.400660e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.677234e+02 5.670468e+00 5.670468e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.690748e+02 5.730831e+00 5.730831e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.605293e+02 5.573070e+00 5.573070e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.361445e+02 5.074010e+00 5.074010e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.018434e+02 4.222728e+00 4.222728e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.570199e+01 3.055339e+00 3.055339e+00 -3.665363e+00 3.157087e-01 3.157087e-01 3.587913e+01 1.938509e+00 1.938509e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.653357e+01 1.050642e+00 1.050642e+00 -5.177463e+00 4.459503e-01 4.459503e-01 6.614902e+00 5.066172e-01 5.066172e-01 -6.153426e+00 5.300130e-01 5.300130e-01 2.430457e+00 2.259669e-01 2.259669e-01 -7.313361e+00 6.299216e-01 6.299216e-01 8.518671e-01 9.737783e-02 9.737783e-02 -8.691946e+00 7.486632e-01 7.486632e-01 3.119018e-01 4.348545e-02 4.348545e-02 -1.186477e+01 2.424165e+00 2.424165e+00 7.097755e-02 1.314645e-02 1.314645e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.964470e-03 6.198766e-04 6.198766e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d06-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d06-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.009206e+02 4.254964e+00 4.254964e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.032097e+02 3.947937e+00 3.947937e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.078605e+02 3.754433e+00 3.754433e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.062566e+02 3.310802e+00 3.310802e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.003631e+02 3.032044e+00 3.032044e+00 -2.594878e+00 2.235046e-01 2.235046e-01 9.012799e+01 2.828788e+00 2.828788e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.600011e+01 2.605077e+00 2.605077e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.914099e+01 2.295534e+00 2.295534e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.145433e+01 1.824427e+00 1.824427e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.622124e+01 1.308172e+00 1.308172e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.445378e+01 8.218370e-01 8.218370e-01 -7.313361e+00 6.299216e-01 6.299216e-01 6.744587e+00 4.407550e-01 4.407550e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.587733e+00 2.032481e-01 2.032481e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.186745e-01 4.068445e-02 4.068445e-02 -3.368869e+01 1.939975e+01 1.939975e+01 3.066196e-03 1.368754e-03 1.368754e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d06-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d06-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 7.816942e+01 4.681306e+00 4.681306e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.802211e+01 5.394644e+00 5.394644e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.004145e+02 6.234345e+00 6.234345e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.107356e+02 7.174199e+00 7.174199e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.148094e+02 7.515589e+00 7.515589e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.101778e+02 6.107253e+00 6.107253e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.611545e+01 5.241688e+00 5.241688e+00 -3.665363e+00 3.157087e-01 3.157087e-01 7.413204e+01 4.937210e+00 4.937210e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.036667e+01 4.280500e+00 4.280500e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.983214e+01 3.363562e+00 3.363562e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.521581e+01 2.055670e+00 2.055670e+00 -7.313361e+00 6.299216e-01 6.299216e-01 6.684109e+00 9.724895e-01 9.724895e-01 -8.691946e+00 7.486632e-01 7.486632e-01 2.668123e+00 3.914825e-01 3.914825e-01 -1.186477e+01 2.424165e+00 2.424165e+00 5.785726e-01 7.952577e-02 7.952577e-02 -3.368869e+01 1.939975e+01 1.939975e+01 1.434853e-02 7.286712e-03 7.286712e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d06-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d06-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 5.597449e+01 4.659709e+00 4.659709e+00 -1.300520e+00 1.120177e-01 1.120177e-01 5.513408e+01 4.570877e+00 4.570877e+00 -1.545671e+00 1.331332e-01 1.331332e-01 5.921102e+01 5.020556e+00 5.020556e+00 -1.837033e+00 1.582291e-01 1.582291e-01 6.188141e+01 5.372021e+00 5.372021e+00 -2.183318e+00 1.880557e-01 1.880557e-01 6.551176e+01 5.034736e+00 5.034736e+00 -2.594878e+00 2.235046e-01 2.235046e-01 6.821726e+01 3.726074e+00 3.726074e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.693019e+01 3.234644e+00 3.234644e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.262234e+01 2.609289e+00 2.609289e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.523497e+01 2.096434e+00 2.096434e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.544519e+01 1.784346e+00 1.784346e+00 -6.153426e+00 5.300130e-01 5.300130e-01 3.403018e+01 1.687228e+00 1.687228e+00 -7.313361e+00 6.299216e-01 6.299216e-01 2.316325e+01 1.624974e+00 1.624974e+00 -8.691946e+00 7.486632e-01 7.486632e-01 1.391094e+01 9.959515e-01 9.959515e-01 -1.186477e+01 2.424165e+00 2.424165e+00 4.480744e+00 4.266110e-01 4.266110e-01 -3.368869e+01 1.939975e+01 1.939975e+01 7.725229e-02 1.697997e-02 1.697997e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d07-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d07-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.759343e+02 6.050447e+00 6.050447e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.856361e+02 6.512081e+00 6.512081e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.788584e+02 6.292412e+00 6.292412e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.616639e+02 5.925943e+00 5.925943e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.290415e+02 5.183279e+00 5.183279e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.870707e+01 4.022019e+00 4.022019e+00 -3.084019e+00 2.656357e-01 2.656357e-01 5.233816e+01 2.698511e+00 2.698511e+00 -3.665363e+00 3.157087e-01 3.157087e-01 2.616244e+01 1.595399e+00 1.595399e+00 -4.356292e+00 3.752204e-01 3.752204e-01 1.072125e+01 7.762603e-01 7.762603e-01 -5.177463e+00 4.459503e-01 4.459503e-01 3.849885e+00 3.389971e-01 3.389971e-01 -6.153426e+00 5.300130e-01 5.300130e-01 1.257925e+00 1.358748e-01 1.358748e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.856912e-01 5.506100e-02 5.506100e-02 -9.982963e+00 2.039681e+00 2.039681e+00 6.705059e-02 1.281328e-02 1.281328e-02 -2.834550e+01 1.632286e+01 1.632286e+01 1.682703e-03 5.397319e-04 5.397319e-04 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d07-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d07-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.210685e+02 5.135350e+00 5.135350e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.196375e+02 4.702298e+00 4.702298e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.202971e+02 4.314884e+00 4.314884e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.146208e+02 3.834870e+00 3.834870e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.032945e+02 3.398660e+00 3.398660e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.755621e+01 3.053600e+00 3.053600e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.988633e+01 2.722166e+00 2.722166e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.045044e+01 2.194913e+00 2.194913e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.271330e+01 1.603923e+00 1.603923e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.877447e+01 1.050099e+00 1.050099e+00 -6.153426e+00 5.300130e-01 5.300130e-01 9.067463e+00 5.761428e-01 5.761428e-01 -7.313361e+00 6.299216e-01 6.299216e-01 3.727551e+00 2.805504e-01 2.805504e-01 -9.982963e+00 2.039681e+00 2.039681e+00 6.028162e-01 5.882826e-02 5.882826e-02 -2.834550e+01 1.632286e+01 1.632286e+01 3.291324e-03 1.615346e-03 1.615346e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d07-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d07-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 9.608449e+01 4.827833e+00 4.827833e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.064805e+02 5.299096e+00 5.299096e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.159591e+02 6.139813e+00 6.139813e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.229112e+02 7.364774e+00 7.364774e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.235612e+02 6.966558e+00 6.966558e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.132774e+02 5.660920e+00 5.660920e+00 -3.084019e+00 2.656357e-01 2.656357e-01 9.334269e+01 5.344903e+00 5.344903e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.603497e+01 4.576720e+00 4.576720e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.177559e+01 3.924106e+00 3.924106e+00 -5.177463e+00 4.459503e-01 4.459503e-01 2.293339e+01 2.831035e+00 2.831035e+00 -6.153426e+00 5.300130e-01 5.300130e-01 1.064159e+01 1.489597e+00 1.489597e+00 -7.313361e+00 6.299216e-01 6.299216e-01 4.176034e+00 6.002895e-01 6.002895e-01 -9.982963e+00 2.039681e+00 2.039681e+00 8.215343e-01 1.300944e-01 1.300944e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.280799e-02 7.200643e-03 7.200643e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d07-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d07-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 6.977532e+01 5.070344e+00 5.070344e+00 -1.300520e+00 1.120177e-01 1.120177e-01 7.012209e+01 4.888153e+00 4.888153e+00 -1.545671e+00 1.331332e-01 1.331332e-01 7.257325e+01 5.193705e+00 5.193705e+00 -1.837033e+00 1.582291e-01 1.582291e-01 7.280953e+01 6.350874e+00 6.350874e+00 -2.183318e+00 1.880557e-01 1.880557e-01 7.581119e+01 4.934556e+00 4.934556e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.507146e+01 4.540748e+00 4.540748e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.151584e+01 3.430829e+00 3.430829e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.352803e+01 2.650984e+00 2.650984e+00 -4.356292e+00 3.752204e-01 3.752204e-01 5.274429e+01 2.111299e+00 2.111299e+00 -5.177463e+00 4.459503e-01 4.459503e-01 4.103944e+01 1.991946e+00 1.991946e+00 -6.153426e+00 5.300130e-01 5.300130e-01 2.842839e+01 1.581016e+00 1.581016e+00 -7.313361e+00 6.299216e-01 6.299216e-01 1.791404e+01 1.291442e+00 1.291442e+00 -9.982963e+00 2.039681e+00 2.039681e+00 6.064214e+00 5.879142e-01 5.879142e-01 -2.834550e+01 1.632286e+01 1.632286e+01 1.141068e-01 2.082417e-02 2.082417e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d08-x01-y02 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d08-x01-y02 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.978115e+02 6.660942e+00 6.660942e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.991621e+02 7.098890e+00 7.098890e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.843633e+02 6.639094e+00 6.639094e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.558113e+02 6.127222e+00 6.127222e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.178095e+02 5.225446e+00 5.225446e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.589992e+01 3.803267e+00 3.803267e+00 -3.084019e+00 2.656357e-01 2.656357e-01 4.153019e+01 2.421911e+00 2.421911e+00 -3.665363e+00 3.157087e-01 3.157087e-01 1.850972e+01 1.257970e+00 1.257970e+00 -4.356292e+00 3.752204e-01 3.752204e-01 6.719661e+00 5.417020e-01 5.417020e-01 -5.177463e+00 4.459503e-01 4.459503e-01 2.144778e+00 2.102337e-01 2.102337e-01 -7.067397e+00 1.443984e+00 1.443984e+00 3.049476e-01 4.520666e-02 4.520666e-02 -2.006708e+01 1.155570e+01 1.155570e+01 3.726200e-03 1.772634e-03 1.772634e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d08-x01-y04 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d08-x01-y04 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.368852e+02 9.996343e+00 9.996343e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.328523e+02 9.398905e+00 9.398905e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295284e+02 4.906095e+00 4.906095e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.185704e+02 4.185466e+00 4.185466e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.019678e+02 3.637688e+00 3.637688e+00 -2.594878e+00 2.235046e-01 2.235046e-01 8.251027e+01 3.222399e+00 3.222399e+00 -3.084019e+00 2.656357e-01 2.656357e-01 6.116879e+01 2.675631e+00 2.675631e+00 -3.665363e+00 3.157087e-01 3.157087e-01 4.100568e+01 2.033729e+00 2.033729e+00 -4.356292e+00 3.752204e-01 3.752204e-01 2.443362e+01 1.367747e+00 1.367747e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.289250e+01 8.075437e-01 8.075437e-01 -7.067397e+00 1.443984e+00 1.443984e+00 2.981475e+00 2.342487e-01 2.342487e-01 -2.006708e+01 1.155570e+01 1.155570e+01 2.753442e-02 7.523117e-03 7.523117e-03 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d08-x01-y06 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d08-x01-y06 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 1.152471e+02 6.177147e+00 6.177147e+00 -1.300520e+00 1.120177e-01 1.120177e-01 1.224623e+02 5.160137e+00 5.160137e+00 -1.545671e+00 1.331332e-01 1.331332e-01 1.295730e+02 6.490904e+00 6.490904e+00 -1.837033e+00 1.582291e-01 1.582291e-01 1.342186e+02 6.852017e+00 6.852017e+00 -2.183318e+00 1.880557e-01 1.880557e-01 1.286992e+02 6.509619e+00 6.509619e+00 -2.594878e+00 2.235046e-01 2.235046e-01 1.121986e+02 5.204103e+00 5.204103e+00 -3.084019e+00 2.656357e-01 2.656357e-01 8.570830e+01 4.833779e+00 4.833779e+00 -3.665363e+00 3.157087e-01 3.157087e-01 5.835079e+01 4.602612e+00 4.602612e+00 -4.356292e+00 3.752204e-01 3.752204e-01 3.471582e+01 3.676361e+00 3.676361e+00 -5.177463e+00 4.459503e-01 4.459503e-01 1.736571e+01 2.307098e+00 2.307098e+00 -7.067397e+00 1.443984e+00 1.443984e+00 4.033761e+00 6.721175e-01 6.721175e-01 -2.006708e+01 1.155570e+01 1.155570e+01 4.859065e-02 2.435393e-02 2.435393e-02 -END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2017_I1589844_MU/d08-x01-y08 -IsRef: 1 -Path: /REF/ATLAS_2017_I1589844_MU/d08-x01-y08 -Title: ~ -Type: Scatter2D ---- -# xval xerr- xerr+ yval yerr- yerr+ -1.094251e+00 9.425111e-02 9.425111e-02 8.475220e+01 5.902977e+00 5.902977e+00 -1.300520e+00 1.120177e-01 1.120177e-01 8.444817e+01 5.649440e+00 5.649440e+00 -1.545671e+00 1.331332e-01 1.331332e-01 8.394995e+01 6.247410e+00 6.247410e+00 -1.837033e+00 1.582291e-01 1.582291e-01 8.274077e+01 6.867471e+00 6.867471e+00 -2.183318e+00 1.880557e-01 1.880557e-01 8.339998e+01 5.445627e+00 5.445627e+00 -2.594878e+00 2.235046e-01 2.235046e-01 7.988968e+01 5.028314e+00 5.028314e+00 -3.084019e+00 2.656357e-01 2.656357e-01 7.378467e+01 3.120918e+00 3.120918e+00 -3.665363e+00 3.157087e-01 3.157087e-01 6.239436e+01 2.439881e+00 2.439881e+00 -4.356292e+00 3.752204e-01 3.752204e-01 4.887237e+01 1.989183e+00 1.989183e+00 -5.177463e+00 4.459503e-01 4.459503e-01 3.490555e+01 1.748288e+00 1.748288e+00 -7.067397e+00 1.443984e+00 1.443984e+00 1.571370e+01 1.195915e+00 1.195915e+00 -2.006708e+01 1.155570e+01 1.155570e+01 5.534319e-01 8.594294e-02 8.594294e-02 -END YODA_SCATTER2D_V2 diff --git a/include/Rivet/Analysis.hh b/include/Rivet/Analysis.hh --- a/include/Rivet/Analysis.hh +++ b/include/Rivet/Analysis.hh @@ -1,1102 +1,1112 @@ // -*- C++ -*- #ifndef RIVET_Analysis_HH #define RIVET_Analysis_HH #include "Rivet/Config/RivetCommon.hh" #include "Rivet/AnalysisInfo.hh" #include "Rivet/Event.hh" #include "Rivet/Projection.hh" #include "Rivet/ProjectionApplier.hh" #include "Rivet/ProjectionHandler.hh" #include "Rivet/AnalysisLoader.hh" #include "Rivet/Tools/Cuts.hh" #include "Rivet/Tools/Logging.hh" #include "Rivet/Tools/ParticleUtils.hh" #include "Rivet/Tools/BinnedHistogram.hh" #include "Rivet/Tools/RivetMT2.hh" #include "Rivet/Tools/RivetYODA.hh" /// @def vetoEvent /// Preprocessor define for vetoing events, including the log message and return. #define vetoEvent \ do { MSG_DEBUG("Vetoing event on line " << __LINE__ << " of " << __FILE__); return; } while(0) namespace Rivet { // Forward declaration class AnalysisHandler; /// @brief This is the base class of all analysis classes in Rivet. /// /// There are /// three virtual functions which should be implemented in base classes: /// /// void init() is called by Rivet before a run is started. Here the /// analysis class should book necessary histograms. The needed /// projections should probably rather be constructed in the /// constructor. /// /// void analyze(const Event&) is called once for each event. Here the /// analysis class should apply the necessary Projections and fill the /// histograms. /// /// void finalize() is called after a run is finished. Here the analysis /// class should do whatever manipulations are necessary on the /// histograms. Writing the histograms to a file is, however, done by /// the Rivet class. class Analysis : public ProjectionApplier { /// The AnalysisHandler is a friend. friend class AnalysisHandler; public: /// @name Standard constructors and destructors. //@{ // /// The default constructor. // Analysis(); /// Constructor Analysis(const std::string& name); /// The destructor. virtual ~Analysis() {} //@} public: /// @name Main analysis methods //@{ /// Initialize this analysis object. A concrete class should here /// book all necessary histograms. An overridden function must make /// sure it first calls the base class function. virtual void init() { } /// Analyze one event. A concrete class should here apply the /// necessary projections on the \a event and fill the relevant /// histograms. An overridden function must make sure it first calls /// the base class function. virtual void analyze(const Event& event) = 0; /// Finalize this analysis object. A concrete class should here make /// all necessary operations on the histograms. Writing the /// histograms to a file is, however, done by the Rivet class. An /// overridden function must make sure it first calls the base class /// function. virtual void finalize() { } //@} public: /// @name Metadata /// Metadata is used for querying from the command line and also for /// building web pages and the analysis pages in the Rivet manual. //@{ /// Get the actual AnalysisInfo object in which all this metadata is stored. const AnalysisInfo& info() const { assert(_info && "No AnalysisInfo object :O"); return *_info; } /// @brief Get the name of the analysis. /// /// By default this is computed by combining the results of the /// experiment, year and Spires ID metadata methods and you should /// only override it if there's a good reason why those won't /// work. If options has been set for this instance, a /// corresponding string is appended at the end. virtual std::string name() const { return ( (info().name().empty()) ? _defaultname : info().name() ) + _optstring; } + // get name of reference data file, which could be different from plugin name + virtual std::string getRefDataName() const { + return (info().getRefDataName().empty()) ? _defaultname : info().getRefDataName(); + } + + // set name of reference data file, which could be different from plugin name + virtual void setRefDataName(const std::string& ref_data="") { + info().setRefDataName(!ref_data.empty() ? ref_data : name()); + } + /// Get the Inspire ID code for this analysis. virtual std::string inspireId() const { return info().inspireId(); } /// Get the SPIRES ID code for this analysis (~deprecated). virtual std::string spiresId() const { return info().spiresId(); } /// @brief Names & emails of paper/analysis authors. /// /// Names and email of authors in 'NAME \' format. The first /// name in the list should be the primary contact person. virtual std::vector authors() const { return info().authors(); } /// @brief Get a short description of the analysis. /// /// Short (one sentence) description used as an index entry. /// Use @a description() to provide full descriptive paragraphs /// of analysis details. virtual std::string summary() const { return info().summary(); } /// @brief Get a full description of the analysis. /// /// Full textual description of this analysis, what it is useful for, /// what experimental techniques are applied, etc. Should be treated /// as a chunk of restructuredText (http://docutils.sourceforge.net/rst.html), /// with equations to be rendered as LaTeX with amsmath operators. virtual std::string description() const { return info().description(); } /// @brief Information about the events needed as input for this analysis. /// /// Event types, energies, kinematic cuts, particles to be considered /// stable, etc. etc. Should be treated as a restructuredText bullet list /// (http://docutils.sourceforge.net/rst.html) virtual std::string runInfo() const { return info().runInfo(); } /// Experiment which performed and published this analysis. virtual std::string experiment() const { return info().experiment(); } /// Collider on which the experiment ran. virtual std::string collider() const { return info().collider(); } /// When the original experimental analysis was published. virtual std::string year() const { return info().year(); } /// The luminosity in inverse femtobarn virtual std::string luminosityfb() const { return info().luminosityfb(); } /// Journal, and preprint references. virtual std::vector references() const { return info().references(); } /// BibTeX citation key for this article. virtual std::string bibKey() const { return info().bibKey(); } /// BibTeX citation entry for this article. virtual std::string bibTeX() const { return info().bibTeX(); } /// Whether this analysis is trusted (in any way!) virtual std::string status() const { return (info().status().empty()) ? "UNVALIDATED" : info().status(); } /// Any work to be done on this analysis. virtual std::vector todos() const { return info().todos(); } /// Return the allowed pairs of incoming beams required by this analysis. virtual const std::vector& requiredBeams() const { return info().beams(); } /// Declare the allowed pairs of incoming beams required by this analysis. virtual Analysis& setRequiredBeams(const std::vector& requiredBeams) { info().setBeams(requiredBeams); return *this; } /// Sets of valid beam energy pairs, in GeV virtual const std::vector >& requiredEnergies() const { return info().energies(); } /// Get vector of analysis keywords virtual const std::vector & keywords() const { return info().keywords(); } /// Declare the list of valid beam energy pairs, in GeV virtual Analysis& setRequiredEnergies(const std::vector >& requiredEnergies) { info().setEnergies(requiredEnergies); return *this; } /// Return true if this analysis needs to know the process cross-section. /// @todo Remove this and require HepMC >= 2.06 bool needsCrossSection() const { return info().needsCrossSection(); } /// Declare whether this analysis needs to know the process cross-section from the generator. /// @todo Remove this and require HepMC >= 2.06 Analysis& setNeedsCrossSection(bool needed=true) { info().setNeedsCrossSection(needed); return *this; } //@} /// @name Internal metadata modifying methods //@{ /// Get the actual AnalysisInfo object in which all this metadata is stored (non-const). AnalysisInfo& info() { assert(_info && "No AnalysisInfo object :O"); return *_info; } //@} /// @name Run conditions //@{ /// Incoming beams for this run const ParticlePair& beams() const; /// Incoming beam IDs for this run const PdgIdPair beamIds() const; /// Centre of mass energy for this run double sqrtS() const; //@} /// @name Analysis / beam compatibility testing //@{ /// Check if analysis is compatible with the provided beam particle IDs and energies bool isCompatible(const ParticlePair& beams) const; /// Check if analysis is compatible with the provided beam particle IDs and energies bool isCompatible(PdgId beam1, PdgId beam2, double e1, double e2) const; /// Check if analysis is compatible with the provided beam particle IDs and energies bool isCompatible(const PdgIdPair& beams, const std::pair& energies) const; //@} /// Set the cross section from the generator Analysis& setCrossSection(double xs); /// Access the controlling AnalysisHandler object. AnalysisHandler& handler() const { return *_analysishandler; } protected: /// Get a Log object based on the name() property of the calling analysis object. Log& getLog() const; /// Get the process cross-section in pb. Throws if this hasn't been set. double crossSection() const; /// Get the process cross-section per generated event in pb. Throws if this /// hasn't been set. double crossSectionPerEvent() const; /// @brief Get the number of events seen (via the analysis handler). /// /// @note Use in the finalize phase only. size_t numEvents() const; /// @brief Get the sum of event weights seen (via the analysis handler). /// /// @note Use in the finalize phase only. double sumW() const; /// Alias double sumOfWeights() const { return sumW(); } /// @brief Get the sum of squared event weights seen (via the analysis handler). /// /// @note Use in the finalize phase only. double sumW2() const; protected: /// @name Histogram paths //@{ /// Get the canonical histogram "directory" path for this analysis. const std::string histoDir() const; /// Get the canonical histogram path for the named histogram in this analysis. const std::string histoPath(const std::string& hname) const; /// Get the canonical histogram path for the numbered histogram in this analysis. const std::string histoPath(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const; /// Get the internal histogram name for given d, x and y (cf. HepData) const std::string mkAxisCode(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const; /// Alias /// @deprecated Prefer the "mk" form, consistent with other "making function" names const std::string makeAxisCode(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return mkAxisCode(datasetId, xAxisId, yAxisId); } //@} /// @name Histogram reference data //@{ /// Get reference data for a named histo /// @todo SFINAE to ensure that the type inherits from YODA::AnalysisObject? template const T& refData(const string& hname) const { _cacheRefData(); MSG_TRACE("Using histo bin edges for " << name() << ":" << hname); if (!_refdata[hname]) { MSG_ERROR("Can't find reference histogram " << hname); throw Exception("Reference data " + hname + " not found."); } return dynamic_cast(*_refdata[hname]); } /// Get reference data for a numbered histo /// @todo SFINAE to ensure that the type inherits from YODA::AnalysisObject? template const T& refData(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { const string hname = makeAxisCode(datasetId, xAxisId, yAxisId); return refData(hname); } //@} /// @name Counter booking //@{ /// Book a counter. CounterPtr bookCounter(const std::string& name, const std::string& title=""); // const std::string& valtitle="" /// Book a counter, using a path generated from the dataset and axis ID codes /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. CounterPtr bookCounter(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const std::string& title=""); // const std::string& valtitle="" //@} /// @name 1D histogram booking //@{ /// Book a 1D histogram with @a nbins uniformly distributed across the range @a lower - @a upper . Histo1DPtr bookHisto1D(const std::string& name, size_t nbins, double lower, double upper, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D histogram with non-uniform bins defined by the vector of bin edges @a binedges . Histo1DPtr bookHisto1D(const std::string& name, const std::vector& binedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D histogram with non-uniform bins defined by the vector of bin edges @a binedges . Histo1DPtr bookHisto1D(const std::string& name, const std::initializer_list& binedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D histogram with binning from a reference scatter. Histo1DPtr bookHisto1D(const std::string& name, const Scatter2D& refscatter, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D histogram, using the binnings in the reference data histogram. Histo1DPtr bookHisto1D(const std::string& name, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D histogram, using the binnings in the reference data histogram. /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. Histo1DPtr bookHisto1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); //@} /// @name 2D histogram booking //@{ /// Book a 2D histogram with @a nxbins and @a nybins uniformly /// distributed across the ranges @a xlower - @a xupper and @a /// ylower - @a yupper respectively along the x- and y-axis. Histo2DPtr bookHisto2D(const std::string& name, size_t nxbins, double xlower, double xupper, size_t nybins, double ylower, double yupper, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D histogram with non-uniform bins defined by the /// vectors of bin edges @a xbinedges and @a ybinedges. Histo2DPtr bookHisto2D(const std::string& name, const std::vector& xbinedges, const std::vector& ybinedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D histogram with non-uniform bins defined by the /// vectors of bin edges @a xbinedges and @a ybinedges. Histo2DPtr bookHisto2D(const std::string& name, const std::initializer_list& xbinedges, const std::initializer_list& ybinedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D histogram with binning from a reference scatter. Histo2DPtr bookHisto2D(const std::string& name, const Scatter3D& refscatter, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D histogram, using the binnings in the reference data histogram. Histo2DPtr bookHisto2D(const std::string& name, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D histogram, using the binnings in the reference data histogram. /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. Histo2DPtr bookHisto2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); //@} /// @name 1D profile histogram booking //@{ /// Book a 1D profile histogram with @a nbins uniformly distributed across the range @a lower - @a upper . Profile1DPtr bookProfile1D(const std::string& name, size_t nbins, double lower, double upper, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D profile histogram with non-uniform bins defined by the vector of bin edges @a binedges . Profile1DPtr bookProfile1D(const std::string& name, const std::vector& binedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D profile histogram with non-uniform bins defined by the vector of bin edges @a binedges . Profile1DPtr bookProfile1D(const std::string& name, const std::initializer_list& binedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D profile histogram with binning from a reference scatter. Profile1DPtr bookProfile1D(const std::string& name, const Scatter2D& refscatter, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D profile histogram, using the binnings in the reference data histogram. Profile1DPtr bookProfile1D(const std::string& name, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// Book a 1D profile histogram, using the binnings in the reference data histogram. /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. Profile1DPtr bookProfile1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); //@} /// @name 2D profile histogram booking //@{ /// Book a 2D profile histogram with @a nxbins and @a nybins uniformly /// distributed across the ranges @a xlower - @a xupper and @a ylower - @a /// yupper respectively along the x- and y-axis. Profile2DPtr bookProfile2D(const std::string& name, size_t nxbins, double xlower, double xupper, size_t nybins, double ylower, double yupper, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D profile histogram with non-uniform bins defined by the vectorx /// of bin edges @a xbinedges and @a ybinedges. Profile2DPtr bookProfile2D(const std::string& name, const std::vector& xbinedges, const std::vector& ybinedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D profile histogram with non-uniform bins defined by the vectorx /// of bin edges @a xbinedges and @a ybinedges. Profile2DPtr bookProfile2D(const std::string& name, const std::initializer_list& xbinedges, const std::initializer_list& ybinedges, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D profile histogram with binning from a reference scatter. Profile2DPtr bookProfile2D(const std::string& name, const Scatter3D& refscatter, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D profile histogram, using the binnings in the reference data histogram. Profile2DPtr bookProfile2D(const std::string& name, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); /// Book a 2D profile histogram, using the binnings in the reference data histogram. /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. Profile2DPtr bookProfile2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const std::string& title="", const std::string& xtitle="", const std::string& ytitle="", const std::string& ztitle=""); //@} /// @name 2D scatter booking //@{ /// @brief Book a 2-dimensional data point set with the given name. /// /// @note Unlike histogram booking, scatter booking by default makes no /// attempt to use reference data to pre-fill the data object. If you want /// this, which is sometimes useful e.g. when the x-position is not really /// meaningful and can't be extracted from the data, then set the @a /// copy_pts parameter to true. This creates points to match the reference /// data's x values and errors, but with the y values and errors zeroed... /// assuming that there is a reference histo with the same name: if there /// isn't, an exception will be thrown. Scatter2DPtr bookScatter2D(const std::string& name, bool copy_pts=false, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// @brief Book a 2-dimensional data point set, using the binnings in the reference data histogram. /// /// The paper, dataset and x/y-axis IDs will be used to build the histo name in the HepData standard way. /// /// @note Unlike histogram booking, scatter booking by default makes no /// attempt to use reference data to pre-fill the data object. If you want /// this, which is sometimes useful e.g. when the x-position is not really /// meaningful and can't be extracted from the data, then set the @a /// copy_pts parameter to true. This creates points to match the reference /// data's x values and errors, but with the y values and errors zeroed. Scatter2DPtr bookScatter2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, bool copy_pts=false, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// @brief Book a 2-dimensional data point set with equally spaced x-points in a range. /// /// The y values and errors will be set to 0. Scatter2DPtr bookScatter2D(const std::string& name, size_t npts, double lower, double upper, const std::string& title="", const std::string& xtitle="", const std::string& ytitle=""); /// @brief Book a 2-dimensional data point set based on provided contiguous "bin edges". /// /// The y values and errors will be set to 0. Scatter2DPtr bookScatter2D(const std::string& hname, const std::vector& binedges, const std::string& title, const std::string& xtitle, const std::string& ytitle); //@} public: /// @name accessing options for this Anslysis instance. //@{ /// Get an option for this analysis instance as a string. std::string getOption(std::string optname) { if ( _options.find(optname) != _options.end() ) return _options.find(optname)->second; return ""; } /// Get an option for this analysis instance converted to a /// specific type (given by the specified @a def value). template T getOption(std::string optname, T def) { if (_options.find(optname) == _options.end()) return def; std::stringstream ss; ss << _options.find(optname)->second; T ret; ss >> ret; return ret; } //@} /// @name Analysis object manipulation /// @todo Should really be protected: only public to keep BinnedHistogram happy for now... //@{ /// Multiplicatively scale the given counter, @a cnt, by factor @s factor. void scale(CounterPtr cnt, double factor); /// Multiplicatively scale the given counters, @a cnts, by factor @s factor. /// @note Constness intentional, if weird, to allow passing rvalue refs of smart ptrs (argh) /// @todo Use SFINAE for a generic iterable of CounterPtrs void scale(const std::vector& cnts, double factor) { for (auto& c : cnts) scale(c, factor); } /// @todo YUCK! template void scale(const CounterPtr (&cnts)[array_size], double factor) { // for (size_t i = 0; i < std::extent::value; ++i) scale(cnts[i], factor); for (auto& c : cnts) scale(c, factor); } /// Normalize the given histogram, @a histo, to area = @a norm. void normalize(Histo1DPtr histo, double norm=1.0, bool includeoverflows=true); /// Normalize the given histograms, @a histos, to area = @a norm. /// @note Constness intentional, if weird, to allow passing rvalue refs of smart ptrs (argh) /// @todo Use SFINAE for a generic iterable of Histo1DPtrs void normalize(const std::vector& histos, double norm=1.0, bool includeoverflows=true) { for (auto& h : histos) normalize(h, norm, includeoverflows); } /// @todo YUCK! template void normalize(const Histo1DPtr (&histos)[array_size], double norm=1.0, bool includeoverflows=true) { for (auto& h : histos) normalize(h, norm, includeoverflows); } /// Multiplicatively scale the given histogram, @a histo, by factor @s factor. void scale(Histo1DPtr histo, double factor); /// Multiplicatively scale the given histograms, @a histos, by factor @s factor. /// @note Constness intentional, if weird, to allow passing rvalue refs of smart ptrs (argh) /// @todo Use SFINAE for a generic iterable of Histo1DPtrs void scale(const std::vector& histos, double factor) { for (auto& h : histos) scale(h, factor); } /// @todo YUCK! template void scale(const Histo1DPtr (&histos)[array_size], double factor) { for (auto& h : histos) scale(h, factor); } /// Normalize the given histogram, @a histo, to area = @a norm. void normalize(Histo2DPtr histo, double norm=1.0, bool includeoverflows=true); /// Normalize the given histograms, @a histos, to area = @a norm. /// @note Constness intentional, if weird, to allow passing rvalue refs of smart ptrs (argh) /// @todo Use SFINAE for a generic iterable of Histo2DPtrs void normalize(const std::vector& histos, double norm=1.0, bool includeoverflows=true) { for (auto& h : histos) normalize(h, norm, includeoverflows); } /// @todo YUCK! template void normalize(const Histo2DPtr (&histos)[array_size], double norm=1.0, bool includeoverflows=true) { for (auto& h : histos) normalize(h, norm, includeoverflows); } /// Multiplicatively scale the given histogram, @a histo, by factor @s factor. void scale(Histo2DPtr histo, double factor); /// Multiplicatively scale the given histograms, @a histos, by factor @s factor. /// @note Constness intentional, if weird, to allow passing rvalue refs of smart ptrs (argh) /// @todo Use SFINAE for a generic iterable of Histo2DPtrs void scale(const std::vector& histos, double factor) { for (auto& h : histos) scale(h, factor); } /// @todo YUCK! template void scale(const Histo2DPtr (&histos)[array_size], double factor) { for (auto& h : histos) scale(h, factor); } /// Helper for counter division. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(CounterPtr c1, CounterPtr c2, Scatter1DPtr s) const; /// Helper for histogram division with raw YODA objects. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(const YODA::Counter& c1, const YODA::Counter& c2, Scatter1DPtr s) const; /// Helper for histogram division. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const; /// Helper for histogram division with raw YODA objects. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(const YODA::Histo1D& h1, const YODA::Histo1D& h2, Scatter2DPtr s) const; /// Helper for profile histogram division. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(Profile1DPtr p1, Profile1DPtr p2, Scatter2DPtr s) const; /// Helper for profile histogram division with raw YODA objects. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(const YODA::Profile1D& p1, const YODA::Profile1D& p2, Scatter2DPtr s) const; /// Helper for 2D histogram division. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(Histo2DPtr h1, Histo2DPtr h2, Scatter3DPtr s) const; /// Helper for 2D histogram division with raw YODA objects. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(const YODA::Histo2D& h1, const YODA::Histo2D& h2, Scatter3DPtr s) const; /// Helper for 2D profile histogram division. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(Profile2DPtr p1, Profile2DPtr p2, Scatter3DPtr s) const; /// Helper for 2D profile histogram division with raw YODA objects /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void divide(const YODA::Profile2D& p1, const YODA::Profile2D& p2, Scatter3DPtr s) const; /// Helper for histogram efficiency calculation. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void efficiency(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const; /// Helper for histogram efficiency calculation. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void efficiency(const YODA::Histo1D& h1, const YODA::Histo1D& h2, Scatter2DPtr s) const; /// Helper for histogram asymmetry calculation. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void asymm(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const; /// Helper for histogram asymmetry calculation. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void asymm(const YODA::Histo1D& h1, const YODA::Histo1D& h2, Scatter2DPtr s) const; /// Helper for converting a differential histo to an integral one. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void integrate(Histo1DPtr h, Scatter2DPtr s) const; /// Helper for converting a differential histo to an integral one. /// /// @note Assigns to the (already registered) output scatter, @a s. Preserves the path information of the target. void integrate(const Histo1D& h, Scatter2DPtr s) const; //@} public: /// List of registered analysis data objects const vector& analysisObjects() const { return _analysisobjects; } protected: /// @name Data object registration, retrieval, and removal //@{ /// Register a data object in the histogram system void addAnalysisObject(AnalysisObjectPtr ao); /// Get a data object from the histogram system template const std::shared_ptr getAnalysisObject(const std::string& name) const { foreach (const AnalysisObjectPtr& ao, analysisObjects()) { if (ao->path() == histoPath(name)) return dynamic_pointer_cast(ao); } throw Exception("Data object " + histoPath(name) + " not found"); } /// Get a data object from the histogram system (non-const) template std::shared_ptr getAnalysisObject(const std::string& name) { foreach (const AnalysisObjectPtr& ao, analysisObjects()) { if (ao->path() == histoPath(name)) return dynamic_pointer_cast(ao); } throw Exception("Data object " + histoPath(name) + " not found"); } /// Unregister a data object from the histogram system (by name) void removeAnalysisObject(const std::string& path); /// Unregister a data object from the histogram system (by pointer) void removeAnalysisObject(AnalysisObjectPtr ao); /// Get a named Histo1D object from the histogram system const Histo1DPtr getHisto1D(const std::string& name) const { return getAnalysisObject(name); } /// Get a named Histo1D object from the histogram system (non-const) Histo1DPtr getHisto1D(const std::string& name) { return getAnalysisObject(name); } /// Get a Histo1D object from the histogram system by axis ID codes (non-const) const Histo1DPtr getHisto1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a Histo1D object from the histogram system by axis ID codes (non-const) Histo1DPtr getHisto1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a named Histo2D object from the histogram system const Histo2DPtr getHisto2D(const std::string& name) const { return getAnalysisObject(name); } /// Get a named Histo2D object from the histogram system (non-const) Histo2DPtr getHisto2D(const std::string& name) { return getAnalysisObject(name); } /// Get a Histo2D object from the histogram system by axis ID codes (non-const) const Histo2DPtr getHisto2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a Histo2D object from the histogram system by axis ID codes (non-const) Histo2DPtr getHisto2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a named Profile1D object from the histogram system const Profile1DPtr getProfile1D(const std::string& name) const { return getAnalysisObject(name); } /// Get a named Profile1D object from the histogram system (non-const) Profile1DPtr getProfile1D(const std::string& name) { return getAnalysisObject(name); } /// Get a Profile1D object from the histogram system by axis ID codes (non-const) const Profile1DPtr getProfile1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a Profile1D object from the histogram system by axis ID codes (non-const) Profile1DPtr getProfile1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a named Profile2D object from the histogram system const Profile2DPtr getProfile2D(const std::string& name) const { return getAnalysisObject(name); } /// Get a named Profile2D object from the histogram system (non-const) Profile2DPtr getProfile2D(const std::string& name) { return getAnalysisObject(name); } /// Get a Profile2D object from the histogram system by axis ID codes (non-const) const Profile2DPtr getProfile2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a Profile2D object from the histogram system by axis ID codes (non-const) Profile2DPtr getProfile2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a named Scatter2D object from the histogram system const Scatter2DPtr getScatter2D(const std::string& name) const { return getAnalysisObject(name); } /// Get a named Scatter2D object from the histogram system (non-const) Scatter2DPtr getScatter2D(const std::string& name) { return getAnalysisObject(name); } /// Get a Scatter2D object from the histogram system by axis ID codes (non-const) const Scatter2DPtr getScatter2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } /// Get a Scatter2D object from the histogram system by axis ID codes (non-const) Scatter2DPtr getScatter2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) { return getAnalysisObject(makeAxisCode(datasetId, xAxisId, yAxisId)); } //@} private: /// Name passed to constructor (used to find .info analysis data file, and as a fallback) string _defaultname; /// Pointer to analysis metadata object unique_ptr _info; /// Storage of all plot objects /// @todo Make this a map for fast lookup by path? vector _analysisobjects; /// @name Cross-section variables //@{ double _crossSection; bool _gotCrossSection; //@} /// The controlling AnalysisHandler object. AnalysisHandler* _analysishandler; /// Collection of cached refdata to speed up many autobookings: the /// reference data file should only be read once. mutable std::map _refdata; /// Options the (this instance of) the analysis map _options; /// The string of options. string _optstring; private: /// @name Utility functions //@{ /// Get the reference data for this paper and cache it. void _cacheRefData() const; //@} /// The assignment operator is private and must never be called. /// In fact, it should not even be implemented. Analysis& operator=(const Analysis&); }; } // Include definition of analysis plugin system so that analyses automatically see it when including Analysis.hh #include "Rivet/AnalysisBuilder.hh" /// @def DECLARE_RIVET_PLUGIN /// Preprocessor define to prettify the global-object plugin hook mechanism. #define DECLARE_RIVET_PLUGIN(clsname) Rivet::AnalysisBuilder plugin_ ## clsname /// @def DECLARE_ALIASED_RIVET_PLUGIN /// Preprocessor define to prettify the global-object plugin hook mechanism, with an extra alias name for this analysis. // #define DECLARE_ALIASED_RIVET_PLUGIN(clsname, alias) Rivet::AnalysisBuilder plugin_ ## clsname ## ( ## #alias ## ) #define DECLARE_ALIASED_RIVET_PLUGIN(clsname, alias) DECLARE_RIVET_PLUGIN(clsname)( #alias ) /// @def DEFAULT_RIVET_ANALYSIS_CONSTRUCTOR /// Preprocessor define to prettify the manky constructor with name string argument #define DEFAULT_RIVET_ANALYSIS_CONSTRUCTOR(clsname) clsname() : Analysis(# clsname) {} /// @def DEFAULT_RIVET_ANALYSIS_CTOR /// Slight abbreviation for DEFAULT_RIVET_ANALYSIS_CONSTRUCTOR #define DEFAULT_RIVET_ANALYSIS_CTOR(clsname) DEFAULT_RIVET_ANALYSIS_CONSTRUCTOR(clsname) #endif diff --git a/include/Rivet/AnalysisInfo.hh b/include/Rivet/AnalysisInfo.hh --- a/include/Rivet/AnalysisInfo.hh +++ b/include/Rivet/AnalysisInfo.hh @@ -1,279 +1,289 @@ // -*- C++ -*- #ifndef RIVET_AnalysisInfo_HH #define RIVET_AnalysisInfo_HH #include "Rivet/Config/RivetCommon.hh" #include namespace Rivet { class AnalysisInfo { public: /// Static factory method: returns null pointer if no metadata found static unique_ptr make(const std::string& name); /// @name Standard constructors and destructors. //@{ /// The default constructor. AnalysisInfo() { clear(); } /// The destructor. ~AnalysisInfo() { } //@} public: /// @name Metadata /// Metadata is used for querying from the command line and also for /// building web pages and the analysis pages in the Rivet manual. //@{ /// Get the name of the analysis. By default this is computed using the /// experiment, year and Inspire/Spires ID metadata methods. std::string name() const { if (!_name.empty()) return _name; if (!experiment().empty() && !year().empty()) { if (!inspireId().empty()) { return experiment() + "_" + year() + "_I" + inspireId(); } else if (!spiresId().empty()) { return experiment() + "_" + year() + "_S" + spiresId(); } } return ""; } /// Set the name of the analysis. void setName(const std::string& name) { _name = name; } + /// Get the reference data name of the analysis (if different from plugin name). + std::string getRefDataName() const { + if (!_refDataName.empty()) return _refDataName; + return name(); + } + + /// Set the reference data name of the analysis (if different from plugin name). + void setRefDataName(const std::string& name) { _refDataName = name; } /// Get the Inspire (SPIRES replacement) ID code for this analysis. const std::string& inspireId() const { return _inspireId; } /// Set the Inspire (SPIRES replacement) ID code for this analysis. void setInspireId(const std::string& inspireId) { _inspireId = inspireId; } /// Get the SPIRES ID code for this analysis. const std::string& spiresId() const { return _spiresId; } /// Set the SPIRES ID code for this analysis. void setSpiresId(const std::string& spiresId) { _spiresId = spiresId; } /// @brief Names & emails of paper/analysis authors. /// Names and email of authors in 'NAME \' format. The first /// name in the list should be the primary contact person. const std::vector& authors() const { return _authors; } /// Set the author list. void setAuthors(const std::vector& authors) { _authors = authors; } /// @brief Get a short description of the analysis. /// Short (one sentence) description used as an index entry. /// Use @a description() to provide full descriptive paragraphs /// of analysis details. const std::string& summary() const { return _summary; } /// Set the short description for this analysis. void setSummary(const std::string& summary) { _summary = summary; } /// @brief Get a full description of the analysis. /// Full textual description of this analysis, what it is useful for, /// what experimental techniques are applied, etc. Should be treated /// as a chunk of restructuredText (http://docutils.sourceforge.net/rst.html), /// with equations to be rendered as LaTeX with amsmath operators. const std::string& description() const { return _description; } /// Set the full description for this analysis. void setDescription(const std::string& description) { _description = description; } /// @brief Information about the events needed as input for this analysis. /// Event types, energies, kinematic cuts, particles to be considered /// stable, etc. etc. Should be treated as a restructuredText bullet list /// (http://docutils.sourceforge.net/rst.html) const std::string& runInfo() const { return _runInfo; } /// Set the full description for this analysis. void setRunInfo(const std::string& runInfo) { _runInfo = runInfo; } /// Beam particle types const std::vector& beams() const { return _beams; } /// Set beam particle types void setBeams(const std::vector& beams) { _beams = beams; } /// Sets of valid beam energies const std::vector >& energies() const { return _energies; } /// Set the valid beam energies void setEnergies(const std::vector >& energies) { _energies = energies; } /// Experiment which performed and published this analysis. const std::string& experiment() const { return _experiment; } /// Set the experiment which performed and published this analysis. void setExperiment(const std::string& experiment) { _experiment = experiment; } /// Collider on which the experiment ran. const std::string& collider() const { return _collider; } /// Set the collider on which the experiment ran. void setCollider(const std::string& collider) { _collider = collider; } /// @brief When the original experimental analysis was published. /// When the refereed paper on which this is based was published, /// according to SPIRES. const std::string& year() const { return _year; } /// Set the year in which the original experimental analysis was published. void setYear(const std::string& year) { _year = year; } /// The integrated data luminosity of the data set const std::string& luminosityfb() const { return _luminosityfb; } /// Set the integrated data luminosity of the data set void setLuminosityfb(const std::string& luminosityfb) { _luminosityfb = luminosityfb; } /// Journal and preprint references. const std::vector& references() const { return _references; } /// Set the journal and preprint reference list. void setReferences(const std::vector& references) { _references = references; } /// Analysis Keywords for grouping etc const std::vector& keywords() const { return _keywords; } /// BibTeX citation key for this article. const std::string& bibKey() const { return _bibKey;} /// Set the BibTeX citation key for this article. void setBibKey(const std::string& bibKey) { _bibKey = bibKey; } /// BibTeX citation entry for this article. const std::string& bibTeX() const { return _bibTeX; } /// Set the BibTeX citation entry for this article. void setBibTeX(const std::string& bibTeX) { _bibTeX = bibTeX; } /// Whether this analysis is trusted (in any way!) const std::string& status() const { return _status; } /// Set the analysis code status. void setStatus(const std::string& status) { _status = status; } /// Any work to be done on this analysis. const std::vector& todos() const { return _todos; } /// Set the to-do list. void setTodos(const std::vector& todos) { _todos = todos; } /// Get the option list. const std::vector& options() const { return _options; } /// Check if the given option is valid. bool validOption(std::string key, std::string val) const; /// Set the option list. void setOptions(const std::vector& opts) { _options = opts; buildOptionMap(); } /// Build a map of options to facilitate checking. void buildOptionMap(); /// Return true if this analysis needs to know the process cross-section. bool needsCrossSection() const { return _needsCrossSection; } /// Return true if this analysis needs to know the process cross-section. void setNeedsCrossSection(bool needXsec) { _needsCrossSection = needXsec; } //@} private: std::string _name; + std::string _refDataName; std::string _spiresId, _inspireId; std::vector _authors; std::string _summary; std::string _description; std::string _runInfo; std::string _experiment; std::string _collider; std::vector > _beams; std::vector > _energies; std::string _year; std::string _luminosityfb; std::vector _references; std::vector _keywords; std::string _bibKey; std::string _bibTeX; //std::string _bibTeXBody; ///< Was thinking of avoiding duplication of BibKey... std::string _status; std::vector _todos; bool _needsCrossSection; std::vector _options; std::map< std::string, std::set > _optionmap; void clear() { _name = ""; + _refDataName = ""; _spiresId = ""; _inspireId = ""; _authors.clear(); _summary = ""; _description = ""; _runInfo = ""; _experiment = ""; _collider = ""; _beams.clear(); _energies.clear(); _year = ""; _luminosityfb = ""; _references.clear(); _keywords.clear(); _bibKey = ""; _bibTeX = ""; //_bibTeXBody = ""; _status = ""; _todos.clear(); _needsCrossSection = false; _options.clear(); _optionmap.clear(); } }; /// String representation std::string toString(const AnalysisInfo& ai); /// Stream an AnalysisInfo as a text description inline std::ostream& operator<<(std::ostream& os, const AnalysisInfo& ai) { os << toString(ai); return os; } } #endif diff --git a/src/Core/Analysis.cc b/src/Core/Analysis.cc --- a/src/Core/Analysis.cc +++ b/src/Core/Analysis.cc @@ -1,895 +1,896 @@ // -*- C++ -*- #include "Rivet/Config/RivetCommon.hh" #include "Rivet/Analysis.hh" #include "Rivet/AnalysisHandler.hh" #include "Rivet/AnalysisInfo.hh" #include "Rivet/Tools/BeamConstraint.hh" namespace Rivet { Analysis::Analysis(const string& name) : _crossSection(-1.0), _gotCrossSection(false), _analysishandler(NULL) { ProjectionApplier::_allowProjReg = false; _defaultname = name; unique_ptr ai = AnalysisInfo::make(name); assert(ai); _info = move(ai); assert(_info); } double Analysis::sqrtS() const { return handler().sqrtS(); } const ParticlePair& Analysis::beams() const { return handler().beams(); } const PdgIdPair Analysis::beamIds() const { return handler().beamIds(); } const string Analysis::histoDir() const { /// @todo Cache in a member variable string _histoDir; if (_histoDir.empty()) { _histoDir = "/" + name(); if (handler().runName().length() > 0) { _histoDir = "/" + handler().runName() + _histoDir; } replace_all(_histoDir, "//", "/"); //< iterates until none } return _histoDir; } const string Analysis::histoPath(const string& hname) const { const string path = histoDir() + "/" + hname; return path; } const string Analysis::histoPath(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { return histoDir() + "/" + mkAxisCode(datasetId, xAxisId, yAxisId); } const string Analysis::mkAxisCode(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId) const { stringstream axisCode; axisCode << "d"; if (datasetId < 10) axisCode << 0; axisCode << datasetId; axisCode << "-x"; if (xAxisId < 10) axisCode << 0; axisCode << xAxisId; axisCode << "-y"; if (yAxisId < 10) axisCode << 0; axisCode << yAxisId; return axisCode.str(); } Log& Analysis::getLog() const { string logname = "Rivet.Analysis." + name(); return Log::getLog(logname); } /////////////////////////////////////////// size_t Analysis::numEvents() const { return handler().numEvents(); } double Analysis::sumW() const { return handler().sumW(); } double Analysis::sumW2() const { return handler().sumW(); } /////////////////////////////////////////// bool Analysis::isCompatible(const ParticlePair& beams) const { return isCompatible(beams.first.pid(), beams.second.pid(), beams.first.energy(), beams.second.energy()); } bool Analysis::isCompatible(PdgId beam1, PdgId beam2, double e1, double e2) const { PdgIdPair beams(beam1, beam2); pair energies(e1, e2); return isCompatible(beams, energies); } bool Analysis::isCompatible(const PdgIdPair& beams, const pair& energies) const { // First check the beam IDs bool beamIdsOk = false; foreach (const PdgIdPair& bp, requiredBeams()) { if (compatible(beams, bp)) { beamIdsOk = true; break; } } if (!beamIdsOk) return false; // Next check that the energies are compatible (within 1% or 1 GeV, whichever is larger, for a bit of UI forgiveness) /// @todo Use some sort of standard ordering to improve comparisons, esp. when the two beams are different particles bool beamEnergiesOk = requiredEnergies().size() > 0 ? false : true; typedef pair DoublePair; foreach (const DoublePair& ep, requiredEnergies()) { if ((fuzzyEquals(ep.first, energies.first, 0.01) && fuzzyEquals(ep.second, energies.second, 0.01)) || (fuzzyEquals(ep.first, energies.second, 0.01) && fuzzyEquals(ep.second, energies.first, 0.01)) || (abs(ep.first - energies.first) < 1*GeV && abs(ep.second - energies.second) < 1*GeV) || (abs(ep.first - energies.second) < 1*GeV && abs(ep.second - energies.first) < 1*GeV)) { beamEnergiesOk = true; break; } } return beamEnergiesOk; /// @todo Need to also check internal consistency of the analysis' /// beam requirements with those of the projections it uses. } /////////////////////////////////////////// Analysis& Analysis::setCrossSection(double xs) { _crossSection = xs; _gotCrossSection = true; return *this; } double Analysis::crossSection() const { if (!_gotCrossSection || std::isnan(_crossSection)) { string errMsg = "You did not set the cross section for the analysis " + name(); throw Error(errMsg); } return _crossSection; } double Analysis::crossSectionPerEvent() const { const double sumW = sumOfWeights(); assert(sumW != 0.0); return _crossSection / sumW; } //////////////////////////////////////////////////////////// // Histogramming void Analysis::_cacheRefData() const { if (_refdata.empty()) { MSG_TRACE("Getting refdata cache for paper " << name()); - _refdata = getRefData(( (info().name().empty()) ? _defaultname : info().name() )); + //_refdata = getRefData(( (info().name().empty()) ? _defaultname : info().name() )); + _refdata = getRefData(getRefDataName()); } } CounterPtr Analysis::bookCounter(const string& cname, const string& title) { // const string& xtitle, // const string& ytitle) { const string path = histoPath(cname); CounterPtr ctr = make_shared(path, title); addAnalysisObject(ctr); MSG_TRACE("Made counter " << cname << " for " << name()); // hist->setAnnotation("XLabel", xtitle); // hist->setAnnotation("YLabel", ytitle); return ctr; } CounterPtr Analysis::bookCounter(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const string& title) { // const string& xtitle, // const string& ytitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookCounter(axisCode, title); } Histo1DPtr Analysis::bookHisto1D(const string& hname, size_t nbins, double lower, double upper, const string& title, const string& xtitle, const string& ytitle) { Histo1DPtr hist; try { // try to bind to pre-existing // AnalysisObjectPtr ao = getAnalysisObject(path); // hist = dynamic_pointer_cast(ao); hist = getHisto1D(hname); /// @todo Test that cast worked /// @todo Also test that binning is as expected? MSG_TRACE("Bound pre-existing histogram " << hname << " for " << name()); } catch (...) { // binding failed; make it from scratch hist = make_shared(nbins, lower, upper, histoPath(hname), title); addAnalysisObject(hist); MSG_TRACE("Made histogram " << hname << " for " << name()); } hist->setTitle(title); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); return hist; } Histo1DPtr Analysis::bookHisto1D(const string& hname, const vector& binedges, const string& title, const string& xtitle, const string& ytitle) { Histo1DPtr hist; try { // try to bind to pre-existing // AnalysisObjectPtr ao = getAnalysisObject(path); // hist = dynamic_pointer_cast(ao); hist = getHisto1D(hname); /// @todo Test that cast worked /// @todo Also test that binning is as expected? MSG_TRACE("Bound pre-existing histogram " << hname << " for " << name()); } catch (...) { // binding failed; make it from scratch hist = make_shared(binedges, histoPath(hname), title); addAnalysisObject(hist); MSG_TRACE("Made histogram " << hname << " for " << name()); } hist->setTitle(title); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); return hist; } Histo1DPtr Analysis::bookHisto1D(const string& hname, const initializer_list& binedges, const string& title, const string& xtitle, const string& ytitle) { return bookHisto1D(hname, vector{binedges}, title, xtitle, ytitle); } Histo1DPtr Analysis::bookHisto1D(const string& hname, const Scatter2D& refscatter, const string& title, const string& xtitle, const string& ytitle) { Histo1DPtr hist; try { // try to bind to pre-existing // AnalysisObjectPtr ao = getAnalysisObject(path); // hist = dynamic_pointer_cast(ao); hist = getHisto1D(hname); /// @todo Test that cast worked /// @todo Also test that binning is as expected? MSG_TRACE("Bound pre-existing histogram " << hname << " for " << name()); } catch (...) { // binding failed; make it from scratch hist = make_shared(refscatter, histoPath(hname)); if (hist->hasAnnotation("IsRef")) hist->rmAnnotation("IsRef"); addAnalysisObject(hist); MSG_TRACE("Made histogram " << hname << " for " << name()); } hist->setTitle(title); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); return hist; } Histo1DPtr Analysis::bookHisto1D(const string& hname, const string& title, const string& xtitle, const string& ytitle) { const Scatter2D& refdata = refData(hname); return bookHisto1D(hname, refdata, title, xtitle, ytitle); } Histo1DPtr Analysis::bookHisto1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const string& title, const string& xtitle, const string& ytitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookHisto1D(axisCode, title, xtitle, ytitle); } /// @todo Add booking methods which take a path, titles and *a reference Scatter from which to book* ///////////////// Histo2DPtr Analysis::bookHisto2D(const string& hname, size_t nxbins, double xlower, double xupper, size_t nybins, double ylower, double yupper, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Histo2DPtr hist = make_shared(nxbins, xlower, xupper, nybins, ylower, yupper, path, title); addAnalysisObject(hist); MSG_TRACE("Made 2D histogram " << hname << " for " << name()); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); hist->setAnnotation("ZLabel", ztitle); return hist; } Histo2DPtr Analysis::bookHisto2D(const string& hname, const vector& xbinedges, const vector& ybinedges, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Histo2DPtr hist = make_shared(xbinedges, ybinedges, path, title); addAnalysisObject(hist); MSG_TRACE("Made 2D histogram " << hname << " for " << name()); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); hist->setAnnotation("ZLabel", ztitle); return hist; } Histo2DPtr Analysis::bookHisto2D(const string& hname, const initializer_list& xbinedges, const initializer_list& ybinedges, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { return bookHisto2D(hname, vector{xbinedges}, vector{ybinedges}, title, xtitle, ytitle, ztitle); } Histo2DPtr Analysis::bookHisto2D(const string& hname, const Scatter3D& refscatter, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Histo2DPtr hist( new Histo2D(refscatter, path) ); addAnalysisObject(hist); MSG_TRACE("Made 2D histogram " << hname << " for " << name()); if (hist->hasAnnotation("IsRef")) hist->rmAnnotation("IsRef"); hist->setTitle(title); hist->setAnnotation("XLabel", xtitle); hist->setAnnotation("YLabel", ytitle); hist->setAnnotation("ZLabel", ztitle); return hist; } Histo2DPtr Analysis::bookHisto2D(const string& hname, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const Scatter3D& refdata = refData(hname); return bookHisto2D(hname, refdata, title, xtitle, ytitle, ztitle); } Histo2DPtr Analysis::bookHisto2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookHisto2D(axisCode, title, xtitle, ytitle, ztitle); } ///////////////// Profile1DPtr Analysis::bookProfile1D(const string& hname, size_t nbins, double lower, double upper, const string& title, const string& xtitle, const string& ytitle) { const string path = histoPath(hname); Profile1DPtr prof = make_shared(nbins, lower, upper, path, title); addAnalysisObject(prof); MSG_TRACE("Made profile histogram " << hname << " for " << name()); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); return prof; } Profile1DPtr Analysis::bookProfile1D(const string& hname, const vector& binedges, const string& title, const string& xtitle, const string& ytitle) { const string path = histoPath(hname); Profile1DPtr prof = make_shared(binedges, path, title); addAnalysisObject(prof); MSG_TRACE("Made profile histogram " << hname << " for " << name()); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); return prof; } Profile1DPtr Analysis::bookProfile1D(const string& hname, const initializer_list& binedges, const string& title, const string& xtitle, const string& ytitle) { return bookProfile1D(hname, vector{binedges}, title, xtitle, ytitle); } Profile1DPtr Analysis::bookProfile1D(const string& hname, const Scatter2D& refscatter, const string& title, const string& xtitle, const string& ytitle) { const string path = histoPath(hname); Profile1DPtr prof = make_shared(refscatter, path); addAnalysisObject(prof); MSG_TRACE("Made profile histogram " << hname << " for " << name()); if (prof->hasAnnotation("IsRef")) prof->rmAnnotation("IsRef"); prof->setTitle(title); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); return prof; } Profile1DPtr Analysis::bookProfile1D(const string& hname, const string& title, const string& xtitle, const string& ytitle) { const Scatter2D& refdata = refData(hname); return bookProfile1D(hname, refdata, title, xtitle, ytitle); } Profile1DPtr Analysis::bookProfile1D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const string& title, const string& xtitle, const string& ytitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookProfile1D(axisCode, title, xtitle, ytitle); } /////////////////// Profile2DPtr Analysis::bookProfile2D(const string& hname, size_t nxbins, double xlower, double xupper, size_t nybins, double ylower, double yupper, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Profile2DPtr prof = make_shared(nxbins, xlower, xupper, nybins, ylower, yupper, path, title); addAnalysisObject(prof); MSG_TRACE("Made 2D profile histogram " << hname << " for " << name()); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); prof->setAnnotation("ZLabel", ztitle); return prof; } Profile2DPtr Analysis::bookProfile2D(const string& hname, const vector& xbinedges, const vector& ybinedges, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Profile2DPtr prof = make_shared(xbinedges, ybinedges, path, title); addAnalysisObject(prof); MSG_TRACE("Made 2D profile histogram " << hname << " for " << name()); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); prof->setAnnotation("ZLabel", ztitle); return prof; } Profile2DPtr Analysis::bookProfile2D(const string& hname, const initializer_list& xbinedges, const initializer_list& ybinedges, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { return bookProfile2D(hname, vector{xbinedges}, vector{ybinedges}, title, xtitle, ytitle, ztitle); } Profile2DPtr Analysis::bookProfile2D(const string& hname, const Scatter3D& refscatter, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string path = histoPath(hname); Profile2DPtr prof( new Profile2D(refscatter, path) ); addAnalysisObject(prof); MSG_TRACE("Made 2D profile histogram " << hname << " for " << name()); if (prof->hasAnnotation("IsRef")) prof->rmAnnotation("IsRef"); prof->setTitle(title); prof->setAnnotation("XLabel", xtitle); prof->setAnnotation("YLabel", ytitle); prof->setAnnotation("ZLabel", ztitle); return prof; } Profile2DPtr Analysis::bookProfile2D(const string& hname, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const Scatter3D& refdata = refData(hname); return bookProfile2D(hname, refdata, title, xtitle, ytitle, ztitle); } Profile2DPtr Analysis::bookProfile2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, const string& title, const string& xtitle, const string& ytitle, const string& ztitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookProfile2D(axisCode, title, xtitle, ytitle, ztitle); } ///////////////// Scatter2DPtr Analysis::bookScatter2D(unsigned int datasetId, unsigned int xAxisId, unsigned int yAxisId, bool copy_pts, const string& title, const string& xtitle, const string& ytitle) { const string axisCode = mkAxisCode(datasetId, xAxisId, yAxisId); return bookScatter2D(axisCode, copy_pts, title, xtitle, ytitle); } Scatter2DPtr Analysis::bookScatter2D(const string& hname, bool copy_pts, const string& title, const string& xtitle, const string& ytitle) { Scatter2DPtr s; const string path = histoPath(hname); if (copy_pts) { const Scatter2D& refdata = refData(hname); s = make_shared(refdata, path); for (Point2D& p : s->points()) p.setY(0, 0); } else { s = make_shared(path); } addAnalysisObject(s); MSG_TRACE("Made scatter " << hname << " for " << name()); if (s->hasAnnotation("IsRef")) s->rmAnnotation("IsRef"); s->setTitle(title); s->setAnnotation("XLabel", xtitle); s->setAnnotation("YLabel", ytitle); return s; } Scatter2DPtr Analysis::bookScatter2D(const string& hname, size_t npts, double lower, double upper, const string& title, const string& xtitle, const string& ytitle) { Scatter2DPtr s; const string path = histoPath(hname); try { // try to bind to pre-existing s = getAnalysisObject(hname); /// @todo Also test that binning is as expected? MSG_TRACE("Bound pre-existing scatter " << path << " for " << name()); } catch (...) { // binding failed; make it from scratch s = make_shared(path); const double binwidth = (upper-lower)/npts; for (size_t pt = 0; pt < npts; ++pt) { const double bincentre = lower + (pt + 0.5) * binwidth; s->addPoint(bincentre, 0, binwidth/2.0, 0); } addAnalysisObject(s); MSG_TRACE("Made scatter " << hname << " for " << name()); } s->setTitle(title); s->setAnnotation("XLabel", xtitle); s->setAnnotation("YLabel", ytitle); return s; } Scatter2DPtr Analysis::bookScatter2D(const string& hname, const vector& binedges, const string& title, const string& xtitle, const string& ytitle) { const string path = histoPath(hname); Scatter2DPtr s = make_shared(path); for (size_t pt = 0; pt < binedges.size()-1; ++pt) { const double bincentre = (binedges[pt] + binedges[pt+1]) / 2.0; const double binwidth = binedges[pt+1] - binedges[pt]; s->addPoint(bincentre, 0, binwidth/2.0, 0); } addAnalysisObject(s); MSG_TRACE("Made scatter " << hname << " for " << name()); s->setTitle(title); s->setAnnotation("XLabel", xtitle); s->setAnnotation("YLabel", ytitle); return s; } ///////////////////// void Analysis::divide(CounterPtr c1, CounterPtr c2, Scatter1DPtr s) const { const string path = s->path(); *s = *c1 / *c2; s->setPath(path); } void Analysis::divide(const Counter& c1, const Counter& c2, Scatter1DPtr s) const { const string path = s->path(); *s = c1 / c2; s->setPath(path); } void Analysis::divide(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const { const string path = s->path(); *s = *h1 / *h2; s->setPath(path); } void Analysis::divide(const Histo1D& h1, const Histo1D& h2, Scatter2DPtr s) const { const string path = s->path(); *s = h1 / h2; s->setPath(path); } void Analysis::divide(Profile1DPtr p1, Profile1DPtr p2, Scatter2DPtr s) const { const string path = s->path(); *s = *p1 / *p2; s->setPath(path); } void Analysis::divide(const Profile1D& p1, const Profile1D& p2, Scatter2DPtr s) const { const string path = s->path(); *s = p1 / p2; s->setPath(path); } void Analysis::divide(Histo2DPtr h1, Histo2DPtr h2, Scatter3DPtr s) const { const string path = s->path(); *s = *h1 / *h2; s->setPath(path); } void Analysis::divide(const Histo2D& h1, const Histo2D& h2, Scatter3DPtr s) const { const string path = s->path(); *s = h1 / h2; s->setPath(path); } void Analysis::divide(Profile2DPtr p1, Profile2DPtr p2, Scatter3DPtr s) const { const string path = s->path(); *s = *p1 / *p2; s->setPath(path); } void Analysis::divide(const Profile2D& p1, const Profile2D& p2, Scatter3DPtr s) const { const string path = s->path(); *s = p1 / p2; s->setPath(path); } /// @todo Counter and Histo2D efficiencies and asymms void Analysis::efficiency(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const { const string path = s->path(); *s = YODA::efficiency(*h1, *h2); s->setPath(path); } void Analysis::efficiency(const Histo1D& h1, const Histo1D& h2, Scatter2DPtr s) const { const string path = s->path(); *s = YODA::efficiency(h1, h2); s->setPath(path); } void Analysis::asymm(Histo1DPtr h1, Histo1DPtr h2, Scatter2DPtr s) const { const string path = s->path(); *s = YODA::asymm(*h1, *h2); s->setPath(path); } void Analysis::asymm(const Histo1D& h1, const Histo1D& h2, Scatter2DPtr s) const { const string path = s->path(); *s = YODA::asymm(h1, h2); s->setPath(path); } void Analysis::scale(CounterPtr cnt, double factor) { if (!cnt) { MSG_WARNING("Failed to scale counter=NULL in analysis " << name() << " (scale=" << factor << ")"); return; } if (std::isnan(factor) || std::isinf(factor)) { MSG_WARNING("Failed to scale counter=" << cnt->path() << " in analysis: " << name() << " (invalid scale factor = " << factor << ")"); factor = 0; } MSG_TRACE("Scaling counter " << cnt->path() << " by factor " << factor); try { cnt->scaleW(factor); } catch (YODA::Exception& we) { MSG_WARNING("Could not scale counter " << cnt->path()); return; } } void Analysis::normalize(Histo1DPtr histo, double norm, bool includeoverflows) { if (!histo) { MSG_WARNING("Failed to normalize histo=NULL in analysis " << name() << " (norm=" << norm << ")"); return; } MSG_TRACE("Normalizing histo " << histo->path() << " to " << norm); try { histo->normalize(norm, includeoverflows); } catch (YODA::Exception& we) { MSG_WARNING("Could not normalize histo " << histo->path()); return; } } void Analysis::scale(Histo1DPtr histo, double factor) { if (!histo) { MSG_WARNING("Failed to scale histo=NULL in analysis " << name() << " (scale=" << factor << ")"); return; } if (std::isnan(factor) || std::isinf(factor)) { MSG_WARNING("Failed to scale histo=" << histo->path() << " in analysis: " << name() << " (invalid scale factor = " << factor << ")"); factor = 0; } MSG_TRACE("Scaling histo " << histo->path() << " by factor " << factor); try { histo->scaleW(factor); } catch (YODA::Exception& we) { MSG_WARNING("Could not scale histo " << histo->path()); return; } } void Analysis::normalize(Histo2DPtr histo, double norm, bool includeoverflows) { if (!histo) { MSG_ERROR("Failed to normalize histo=NULL in analysis " << name() << " (norm=" << norm << ")"); return; } MSG_TRACE("Normalizing histo " << histo->path() << " to " << norm); try { histo->normalize(norm, includeoverflows); } catch (YODA::Exception& we) { MSG_WARNING("Could not normalize histo " << histo->path()); return; } } void Analysis::scale(Histo2DPtr histo, double factor) { if (!histo) { MSG_ERROR("Failed to scale histo=NULL in analysis " << name() << " (scale=" << factor << ")"); return; } if (std::isnan(factor) || std::isinf(factor)) { MSG_ERROR("Failed to scale histo=" << histo->path() << " in analysis: " << name() << " (invalid scale factor = " << factor << ")"); factor = 0; } MSG_TRACE("Scaling histo " << histo->path() << " by factor " << factor); try { histo->scaleW(factor); } catch (YODA::Exception& we) { MSG_WARNING("Could not scale histo " << histo->path()); return; } } void Analysis::integrate(Histo1DPtr h, Scatter2DPtr s) const { // preserve the path info const string path = s->path(); *s = toIntegralHisto(*h); s->setPath(path); } void Analysis::integrate(const Histo1D& h, Scatter2DPtr s) const { // preserve the path info const string path = s->path(); *s = toIntegralHisto(h); s->setPath(path); } /// @todo 2D versions of integrate... defined how, exactly?!? ////////////////////////////////// void Analysis::addAnalysisObject(AnalysisObjectPtr ao) { _analysisobjects.push_back(ao); } void Analysis::removeAnalysisObject(const string& path) { for (vector::iterator it = _analysisobjects.begin(); it != _analysisobjects.end(); ++it) { if ((*it)->path() == path) { _analysisobjects.erase(it); break; } } } void Analysis::removeAnalysisObject(AnalysisObjectPtr ao) { for (vector::iterator it = _analysisobjects.begin(); it != _analysisobjects.end(); ++it) { if (*it == ao) { _analysisobjects.erase(it); break; } } } }