Page Menu
Home
HEPForge
Search
Configure Global Search
Log In
Files
F7879376
No One
Temporary
Actions
View File
Edit File
Delete File
View Transforms
Subscribe
Mute Notifications
Award Token
Flag For Later
Size
88 KB
Subscribers
None
View Options
Index: trunk/code/ATLAS_2018_I1673184.cc
===================================================================
--- trunk/code/ATLAS_2018_I1673184.cc (revision 0)
+++ trunk/code/ATLAS_2018_I1673184.cc (revision 466)
@@ -0,0 +1,155 @@
+// -*- C++ -*-
+#include "Rivet/Analysis.hh"
+#include "Rivet/Projections/FinalState.hh"
+#include "Rivet/Projections/FastJets.hh"
+
+namespace Rivet {
+
+
+using namespace fastjet;
+
+ struct FourMomComp {
+ bool operator() (const FourMomentum& p1, const FourMomentum& p2) const
+ {return p1.pT()<p2.pT();}
+ };
+
+ class ATLAS_2018_I1673184 : public Analysis {
+ public:
+
+ /// Constructor
+ ATLAS_2018_I1673184()
+ : Analysis("ATLAS_2018_I1673184")
+ { }
+
+
+ /// @name Analysis methods
+ //@{
+
+ /// Book histograms and initialise projections before the run
+ void init() {
+
+ _ptedges += 158., 200., 251., 316., 562.;
+ _nptbins = _ptedges.size()-1;
+
+
+ FinalState fs(-5.0, 5.0, 0.*GeV);
+ FastJets fj(fs, FastJets::ANTIKT, 0.4);
+ fj.useInvisibles();
+ addProjection(fj, "Jets");
+
+ _h_pt_pp = bookHisto1D(4, 1, 1);
+ _h_pt_PbPb = bookHisto1D(11, 1, 1);
+ _h_RAA = bookHisto1D(19, 1, 1);
+ for (int i = 0; i < _nptbins; ++i) {
+ _h_RAA_ptbins[i] = bookHisto1D(27, 1, i+1);
+ }
+ }
+
+ map<FourMomentum, FourMomentum, FourMomComp> buildDummyThermalMap(const Event & event) {
+ map<FourMomentum, FourMomentum, FourMomComp> dummythermmap;
+ vector<FourMomentum> thermom;
+ size_t j(0);
+ foreach (const HepMC::GenParticle* p, particles(event.genEvent())) {
+ FourMomentum mom(p->momentum());
+ if (p->status() == 3) {
+ thermom.push_back(mom);
+ }
+ else if (fuzzyEquals(mom.E(),1e-6,1e-3)) {
+ dummythermmap[mom] = thermom[j];
+ j++;
+ }
+ }
+ return dummythermmap;
+ }
+
+ /// 4-momentum subtraction
+ FourMomentum SubtractJetMom(Jet jet, map<FourMomentum, FourMomentum, FourMomComp> * dummythermmap) {
+ if (dummythermmap->empty()) return jet.momentum();
+ FourMomentum sub(0.,0.,0.,0.);
+ foreach (Particle part, jet.constituents()) {
+ if (fuzzyEquals(part.E(),1e-6,1e-3)) {
+ map<FourMomentum, FourMomentum, FourMomComp>::iterator mapit;
+ mapit = (*dummythermmap).find(part.momentum());
+ if (mapit == (*dummythermmap).end()) cout<<"Error: did not find matching scattering centre in map.\n"<<part.momentum()<<endl;
+ else sub += mapit->second;
+ }
+ }
+ FourMomentum jetmom(jet.momentum());
+ //cout<<"Original momentum: "<<jetmom<<endl;
+ jetmom -= sub;
+ //cout<<"subtracted momentum: "<<jetmom<<endl;
+ //cout<<"Subtracted pt: "<<jetmom.pT()<<" "<<jet.pt()<<endl;
+ return jetmom;
+ }
+
+
+ /// Perform the per-event analysis
+ void analyze(const Event& event) {
+ const double weight = event.weight();
+ const double cent = (event.genEvent()->heavy_ion()?event.genEvent()->heavy_ion()->impact_parameter():-1.);
+
+ if (cent > 0.1) vetoEvent;
+
+ map<FourMomentum, FourMomentum, FourMomComp> dummythermmap = buildDummyThermalMap(event);
+
+ Cut cuts = Cuts::pt > 20.*GeV;
+ Jets unsubjets = applyProjection<FastJets>(event, "Jets").jetsByPt(cuts);
+ Jets subjets;
+ foreach (Jet jet, unsubjets) {
+ FourMomentum jetsub = SubtractJetMom(jet, &dummythermmap);
+ if (fabs(jetsub.eta()) < 2.8 && jetsub.pT() > 40.*GeV) subjets.push_back(Jet(jetsub));
+ }
+
+ foreach (Jet jet, subjets) {
+ double pt = jet.momentum().pT();
+
+ int ptbin(-1);
+ for (int i = 0; i < _nptbins; ++i) {
+ if (pt > _ptedges[i] && pt < _ptedges[i+1]) ptbin = i;
+ }
+
+ if (cent < 0) _h_pt_pp->fill(pt, weight);
+ else _h_pt_PbPb->fill(pt,weight);
+ _h_RAA->fill(pt, weight);
+ if (ptbin >= 0) {
+ double eta(jet.momentum().eta());
+ _h_RAA_ptbins[ptbin]->fill(eta, weight);
+ }
+ }
+
+ }
+
+
+ void finalize() {
+
+ scale(_h_pt_pp, crossSection()/(sumOfWeights()*2*2.8));
+ scale(_h_pt_PbPb, 1./(sumOfWeights()*2*2.8));
+ scale(_h_RAA, crossSection()/(sumOfWeights()*2*2.8));
+ for (int i = 0; i < _nptbins; ++i) {
+ scale(_h_RAA_ptbins[i], crossSection()/sumOfWeights()*2*2.8);
+ }
+
+ }
+
+ //@}
+
+
+ private:
+
+ vector<double> _ptedges;
+ int _nptbins;
+
+ Histo1DPtr _h_pt_pp, _h_pt_PbPb;
+ Histo1DPtr _h_RAA;
+ Histo1DPtr _h_RAA_ptbins[4];
+
+
+ };
+
+
+
+ // The hook for the plugin system
+ DECLARE_RIVET_PLUGIN(ATLAS_2018_I1673184);
+
+
+}
Index: trunk/code/ATLAS_2017_I1511869.cc
===================================================================
--- trunk/code/ATLAS_2017_I1511869.cc (revision 0)
+++ trunk/code/ATLAS_2017_I1511869.cc (revision 466)
@@ -0,0 +1,461 @@
+// -*- C++ -*-
+#include "Rivet/Analysis.hh"
+#include "Rivet/Projections/FinalState.hh"
+#include "Rivet/Projections/ChargedFinalState.hh"
+#include "Rivet/Projections/FastJets.hh"
+
+namespace Rivet {
+
+using namespace fastjet;
+
+ struct FourMomComp {
+ bool operator() (const FourMomentum& p1, const FourMomentum& p2) const
+ {return p1.pT()<p2.pT();}
+ };
+
+
+ struct My4Mom {
+ double pt;
+ double mdelta;
+ double phi;
+ double y;
+ } ;
+
+ struct MyPart {
+ double pt;
+ double mdelta;
+ double phi;
+ double y;
+ PdgId id;
+ } ;
+
+ struct MyDist {
+ double dR;
+ size_t ipart;
+ size_t ighost;
+ } ;
+
+ bool MyDistComp (const MyDist& dist1, const MyDist& dist2) {
+ return dist1.dR < dist2.dR;
+ }
+
+
+ class ATLAS_2017_I1511869 : public Analysis {
+ public:
+
+ /// Constructor
+ ATLAS_2017_I1511869()
+ : Analysis("ATLAS_2017_I1511869")
+ {
+ _jetR=0.4; _trackptmin=1.; _etamin=0.; _etamax=2.1; _etagapmin=0.8; _etagapmax=1.2; _ptmin=100.; _ptmax=398.;
+ _Nptbins=4; _Netabins=4;
+ _etaloose=2.8; _ptminloose=70.; _dRloose=0.8;
+ }
+
+
+ /// @name Analysis methods
+ //@{
+
+ /// Book histograms and initialise projections before the run
+ void init() {
+
+ _ptedges += 100.0, 126.0, 158.0, 398.0;
+ _Njets_pt.resize(_Nptbins, 0.0);
+ _Njets_eta.resize(_Netabins, 0.0);
+
+ FinalState fs(-_etaloose, _etaloose, 0.*GeV);
+ addProjection(fs, "FS");
+ ChargedFinalState cfs(-_etaloose, _etaloose, _trackptmin*GeV);
+ addProjection(cfs, "CFS");
+
+ FastJets fj(fs, FastJets::ANTIKT, _jetR);
+ addProjection(fj, "Jets");
+
+ for (size_t i = 0; i < _Netabins; ++i) {
+ _h_pt_etabins_pp[i] = bookHisto1D(i+1, 1, 1);
+ _h_pt_etabins_PbPb[i] = bookHisto1D(i+1, 1, 2);
+ _h_z_etabins_pp[i] = bookHisto1D(i+5, 1, 1);
+ _h_z_etabins_PbPb[i] = bookHisto1D(i+5, 1, 2);
+ _h_pt_etabins_ratio[i] = bookHisto1D(i*4+9, 1, 1);
+ _h_z_etabins_ratio[i] = bookHisto1D(i*4+25, 1, 1);
+ }
+ for (size_t i = 0; i < _Nptbins; ++i) {
+ _h_pt_ptbins_ratio[i] = bookHisto1D(i*4+41, 1, 1);
+ _h_z_ptbins_ratio[i] = bookHisto1D(i*4+57, 1, 1);
+ }
+
+ }
+
+
+
+ /// extract thermal momenta, that should be subtracted, from HepMC event
+ vector<FourMomentum> extractThermalMomenta(const Event & event) {
+ vector<FourMomentum> thermom;
+ foreach (const HepMC::GenParticle* p, particles(event.genEvent())) {
+ FourMomentum mom(p->momentum());
+ if (p->status() == 3) {
+ thermom.push_back(mom);
+ }
+ }
+ return thermom;
+ }
+
+
+ /// build map from dummy particles to thermal momenta to speed up subtraction
+ map<FourMomentum, FourMomentum, FourMomComp> buildThMomMap(const Event & event, const vector<FourMomentum> * thermom) {
+ map<FourMomentum, FourMomentum, FourMomComp> thmap;
+ size_t j(0);
+ foreach (const HepMC::GenParticle* p, particles(event.genEvent())) {
+ FourMomentum mom(p->momentum());
+ if (fuzzyEquals(mom.E(), 1e-6)) {
+ if (j == thermom->size()) {
+ cout<<"Error: number of dummies does not match number of subtractions, will veto Event"<<endl;
+ thmap.clear();
+ return thmap;
+ }
+ FourMomentum sc((*thermom)[j]);
+ thmap[mom]=sc;
+ j++;
+ }
+ }
+ return thmap;
+ }
+
+
+ /// 4-momentum subtraction
+ FourMomentum SubtractJetMom(Jet jet, map<FourMomentum, FourMomentum, FourMomComp> * tmmap) {
+ if (tmmap->empty()) return jet.momentum();
+ FourMomentum sub(0.,0.,0.,0.);
+ foreach (Particle part, jet.constituents()) {
+ if (fuzzyEquals(part.E(), 1e-6)) {
+ map<FourMomentum, FourMomentum, FourMomComp>::iterator mapit;
+ mapit = (*tmmap).find(part.momentum());
+ if (mapit == (*tmmap).end()) cout<<"Error: did not find matching scattering centre in map.\n"<<part.momentum()<<endl;
+ else sub += mapit->second;
+ }
+ }
+ FourMomentum jetmom(jet.momentum());
+ //cout<<"Original momentum: "<<jetmom<<endl;
+ jetmom -= sub;
+ //cout<<"subtracted momentum: "<<jetmom<<endl;
+ //cout<<"Subtracted pt: "<<subpt<<" "<<pjet.pt()<<endl;
+ return jetmom;
+ }
+
+
+
+ /// event-wise Constituent subtraction based on Particles
+ Particles ConstSubPartEvent(const Particles particles, PseudoJets pjghosts) {
+ // sort constituents into two vectors: particles and ghosts (subtraction momenta)
+ Particles subevent;
+ vector<MyPart> parts;
+ vector<My4Mom> ghosts;
+
+ foreach (Particle p, particles) {
+ FourMomentum partmom = p.momentum();
+ if (fuzzyEquals(partmom.E(),1e-6)) continue;
+ if (partmom.E() - fabs(partmom.pz()) > 0.) {
+ MyPart part;
+ part.id = p.pid();
+ part.pt = partmom.pT();
+ part.mdelta = sqrt(partmom.mass2() + sqr(partmom.pT())) - partmom.pT();
+ part.phi = partmom.p3().phi();
+ part.y = partmom.rapidity();
+ //if (abs(part.y) > 5.) {
+ // cout<<"particle rapidity: "<<part.y<<" "<<partmom.E()-partmom.pz()<<endl;
+ // cout<<partmom<<" "<<part.pt<<endl;
+ //}
+ parts.push_back(part);
+ }
+ else {
+ subevent.push_back(p);
+ }
+ }
+
+ foreach (PseudoJet pj, pjghosts) {
+ FourMomentum submom = Get4Mom(pj);
+ if (submom.E() - fabs(submom.pz()) > 0.) {
+ My4Mom ghost;
+ ghost.pt = submom.pT();
+ ghost.mdelta = sqrt(submom.mass2() + sqr(submom.pT())) - submom.pT();
+ ghost.phi = submom.p3().phi();
+ ghost.y = submom.rapidity();
+ //cout<<"ghost rapidity: "<<ghost.y<<endl;
+ ghosts.push_back(ghost);
+ }
+ else {
+ PdgId ghostid;
+ if (rand()/RAND_MAX < 1./3.) ghostid = PID::PIPLUS;
+ else if (rand()/RAND_MAX < 2./3.) ghostid = PID::PIMINUS;
+ else ghostid = PID::PI0;
+ Particle pg(ghostid,Get4Mom(pj));
+ subevent.push_back(pg);
+ }
+ }
+
+ //cout<<"number of particles: "<<parts.size()<<endl;
+ //cout<<"number of ghosts: "<<ghosts.size()<<endl;
+
+ //create list with all particle-ghosts distances and sort it
+ vector<MyDist> dists;
+ for (size_t i=0; i < parts.size(); ++i) {
+ for (size_t j=0; j < ghosts.size(); ++j) {
+ //cout<<"i, j = "<<i<<" "<<j<<endl;
+ MyDist dist;
+ double Deltaphi(abs(parts[i].phi-ghosts[j].phi));
+ if (Deltaphi > M_PI) Deltaphi = 2.*M_PI - Deltaphi;
+ dist.dR = sqrt(sqr(Deltaphi) + sqr(parts[i].y-ghosts[j].y));
+ dist.ipart = i;
+ dist.ighost = j;
+ //cout<<"distance: "<<dist.dR<<endl;
+ dists.push_back(dist);
+ }
+ }
+ //cout<<"number of pairs: "<<dists.size()<<endl;
+ //dists.sort(MyDistComp);
+ std::sort(dists.begin(),dists.end(),MyDistComp);
+
+ //go through all particle-ghost pairs and re-distribute momentum and mass
+ for (vector<MyDist>::iterator liter=dists.begin(); liter != dists.end(); ++liter) {
+ //cout<<"dealing with dist "<<liter->dR<<endl;
+ if (liter->dR > _dRloose) break;
+ size_t pnum = liter->ipart;
+ size_t gnum = liter->ighost;
+ double ptp = parts[pnum].pt;
+ double ptg = ghosts[gnum].pt;
+ //cout<<"pts: "<<ptp<<" vs "<<ptg<<endl;
+ if (ptp > ptg) {
+ parts[pnum].pt -= ptg;
+ ghosts[gnum].pt = 0.;
+ }
+ else {
+ ghosts[gnum].pt -= ptp;
+ parts[pnum].pt = 0.;
+ }
+ double mdp = parts[pnum].mdelta;
+ double mdg = ghosts[gnum].mdelta;
+ //cout<<"masses: "<<mdp<<" vs "<<mdg<<endl;
+ if (mdp > mdg) {
+ parts[pnum].mdelta -= mdg;
+ ghosts[gnum].mdelta = 0.;
+ }
+ else {
+ ghosts[gnum].mdelta -= mdp;
+ parts[pnum].mdelta = 0.;
+ }
+
+ }
+
+ //sum up resulting 4-momenta to get subtracted jet momentum
+ int nparts(0);
+ for (size_t i=0; i < parts.size(); ++i) {
+ if (parts[i].pt > 0.) {
+ FourMomentum mom((parts[i].pt+parts[i].mdelta)*cosh(parts[i].y),
+ parts[i].pt*cos(parts[i].phi),
+ parts[i].pt*sin(parts[i].phi),
+ (parts[i].pt+parts[i].mdelta)*sinh(parts[i].y));
+ //cout<<"particle rapidity: "<<mom.rapidity()<<" "<<parts[i].y<<endl;
+ Particle outpart(parts[i].id,mom);
+ subevent.push_back(outpart);
+ nparts++;
+ }
+ }
+ int nghost(0);
+ for (size_t i=0; i < ghosts.size(); ++i) {
+ if (ghosts[i].pt > 0.) {
+ FourMomentum mom((ghosts[i].pt+ghosts[i].mdelta)*cosh(ghosts[i].y),
+ ghosts[i].pt*cos(ghosts[i].phi),
+ ghosts[i].pt*sin(ghosts[i].phi),
+ (ghosts[i].pt+ghosts[i].mdelta)*sinh(ghosts[i].y));
+ //cout<<"ghost rapidity: "<<mom.rapidity()<<" "<<ghosts[i].y<<endl;
+ PdgId ghostid;
+ if (rand()/RAND_MAX < 1./3.) ghostid = PID::PIPLUS;
+ else if (rand()/RAND_MAX < 2./3.) ghostid = PID::PIMINUS;
+ else ghostid = PID::PI0;
+ Particle outpart(ghostid,mom);
+ subevent.push_back(outpart);
+ nghost++;
+ }
+ //else cout<<ghosts[i].mdelta<<endl;
+ }
+ //cout<<nghost<<" / "<<ghosts.size()+1<<" vs. "<<nparts<<" / "<<parts.size()<<endl;
+ return subevent;
+ }
+
+
+
+/// 4-momentum adapter
+ FourMomentum Get4Mom(PseudoJet pjet){
+ FourMomentum mom(pjet.E(), pjet.px(), pjet.py(), pjet.pz());
+ return mom;
+ }
+
+
+
+
+ /// Perform the per-event analysis
+ void analyze(const Event& event) {
+ const double weight = event.weight();
+ const double cent = (event.genEvent()->heavy_ion()?event.genEvent()->heavy_ion()->impact_parameter():-1.);
+ if (cent > 0.1) vetoEvent;
+ Particles tracks;
+ Jets jetssub;
+
+#if MODE==0
+ const ChargedFinalState cfs = applyProjection<ChargedFinalState>(event, "CFS");
+ tracks = cfs.particles();
+ const Jets alljets = applyProjection<FastJets>(event, "Jets").jetsByPt(_ptminloose);
+
+ vector<FourMomentum> thermom = extractThermalMomenta(event);
+ map<FourMomentum, FourMomentum, FourMomComp> thmommap = buildThMomMap(event, &thermom);
+ foreach (Jet jet, alljets) {
+ FourMomentum jetsub = SubtractJetMom(jet, &thmommap);
+ jetssub.push_back(Jet(jetsub));
+ }
+
+#elif MODE==1
+ const FinalState fs = applyProjection<FinalState>(event, "FS");
+ const Jets loosejets = applyProjection<FastJets>(event, "Jets").jetsByPt(_ptminloose);
+
+ Particles origevent;
+ PseudoJets ghosts;
+
+ foreach (Jet jet, loosejets) {
+
+ foreach (Particle part, fs.particles()) {
+ if (deltaR(part.momentum(),jet.momentum()) < _dRloose) origevent.push_back(part);
+ }
+
+ foreach (const HepMC::GenParticle* p, particles(event.genEvent())) {
+ FourMomentum mom(p->momentum());
+ if (deltaR(mom,jet.momentum()) < _dRloose && p->status() == 3) {
+ PseudoJet pjet(mom.px(),mom.py(),mom.pz(),mom.E());
+ ghosts.push_back(pjet);
+ }
+ }
+ }
+
+ Particles subevent = ConstSubPartEvent(origevent, ghosts);
+
+ PseudoJets newevent;
+ foreach (Particle part, subevent) {
+ newevent.push_back(PseudoJet(part.px(), part.py(), part.pz(), part.E()));
+ if (isCharged(part) && (part.pT() > _trackptmin)) tracks.push_back(part);
+ }
+
+ JetDefinition jet_def(antikt_algorithm, _jetR);
+ ClusterSequence cs(newevent, jet_def);
+ PseudoJets pjets;
+ pjets = cs.inclusive_jets(_ptminloose);
+
+ foreach (PseudoJet pj, pjets) {
+ jetssub.push_back(Jet(pj));
+ }
+
+#endif
+
+ foreach (Jet jet, jetssub) {
+ double jetpt = jet.pT();
+ double jeteta = abs(jet.eta());
+
+ if (jetpt < _ptmin || jetpt > _ptmax ||
+ jeteta < _etamin || jeteta > _etamax ||
+ (jeteta > _etagapmin && jeteta < _etagapmax)) continue;
+
+ int ptbin(-1), etabin(-1);
+ if (jeteta < 0.3) etabin = 1;
+ else if (jeteta < 0.8) etabin = 2;
+ else etabin = 3;
+
+ for (size_t l = 0; l < _Nptbins; ++l) {
+ if (jetpt >= _ptedges[l] && jetpt < _ptedges[l+1]) ptbin=l;
+ }
+ //shift: first histo is inclusive
+ if (ptbin >= 0) ptbin+=1;
+ if (ptbin < 0 || etabin < 0) continue;
+ _Njets_eta[0]+=weight;
+ _Njets_eta[etabin]+=weight;
+ _Njets_pt[0]+=weight;
+ _Njets_pt[ptbin]+=weight;
+
+ foreach (Particle part, tracks){
+ double dR(deltaR(part,jet));
+ if (dR >= _jetR) continue;
+ double z;
+ z = part.pT()*cos(dR)/jetpt;
+
+ if (cent < 0.) {
+ _h_pt_etabins_pp[0]->fill(part.pT(), weight);
+ _h_pt_etabins_pp[etabin]->fill(part.pT(), weight);
+ _h_z_etabins_pp[0]->fill(z, weight);
+ _h_z_etabins_pp[etabin]->fill(z, weight);
+ }
+ else {
+ _h_pt_etabins_PbPb[0]->fill(part.pT(), weight);
+ _h_pt_etabins_PbPb[etabin]->fill(part.pT(), weight);
+ _h_z_etabins_PbPb[0]->fill(z, weight);
+ _h_z_etabins_PbPb[etabin]->fill(z, weight);
+ }
+ _h_pt_etabins_ratio[0]->fill(part.pT(), weight);
+ _h_pt_etabins_ratio[etabin]->fill(part.pT(), weight);
+ _h_z_etabins_ratio[0]->fill(z, weight);
+ _h_z_etabins_ratio[etabin]->fill(z, weight);
+ _h_pt_ptbins_ratio[0]->fill(part.pT(), weight);
+ _h_pt_ptbins_ratio[ptbin]->fill(part.pT(), weight);
+ _h_z_ptbins_ratio[0]->fill(z, weight);
+ _h_z_ptbins_ratio[ptbin]->fill(z, weight);
+ }
+ }
+
+
+
+ }
+
+
+ /// Normalise histograms etc., after the run
+ void finalize() {
+
+ for (size_t i = 0; i < _Netabins; ++i) {
+ if (_Njets_eta[i]==0.) _Njets_eta[i]=1.;
+ scale(_h_pt_etabins_pp[i],1./_Njets_eta[i]);
+ scale(_h_pt_etabins_PbPb[i],1./_Njets_eta[i]);
+ scale(_h_z_etabins_pp[i],1./_Njets_eta[i]);
+ scale(_h_z_etabins_PbPb[i],1./_Njets_eta[i]);
+ scale(_h_pt_etabins_ratio[i],1./_Njets_eta[i]);
+ scale(_h_z_etabins_ratio[i],1./_Njets_eta[i]);
+ }
+ for (size_t i = 0; i < _Nptbins; ++i) {
+ if (_Njets_pt[i]==0.) _Njets_pt[i]=1.;
+ scale(_h_pt_ptbins_ratio[i],1./_Njets_pt[i]);
+ scale(_h_z_ptbins_ratio[i],1./_Njets_pt[i]);
+ }
+ }
+
+ //@}
+
+
+ private:
+
+ vector<double> _Njets_pt, _Njets_eta, _ptedges;
+ double _jetR, _trackptmin, _etamin, _etamax, _etagapmin, _etagapmax, _ptmin, _ptmax;
+ double _etaloose, _ptminloose, _dRloose;
+ size_t _Nptbins, _Netabins;
+
+
+ Histo1DPtr _h_pt_etabins_pp[4], _h_pt_etabins_PbPb[4];
+ Histo1DPtr _h_z_etabins_pp[4], _h_z_etabins_PbPb[4];
+ Histo1DPtr _h_pt_etabins_ratio[4];
+ Histo1DPtr _h_z_etabins_ratio[4];
+ Histo1DPtr _h_pt_ptbins_ratio[4];
+ Histo1DPtr _h_z_ptbins_ratio[4];
+
+
+ };
+
+
+
+ // The hook for the plugin system
+ DECLARE_RIVET_PLUGIN(ATLAS_2017_I1511869);
+
+
+}
Index: trunk/code/ATLAS_2018_I1673184.plot
===================================================================
--- trunk/code/ATLAS_2018_I1673184.plot (revision 0)
+++ trunk/code/ATLAS_2018_I1673184.plot (revision 466)
@@ -0,0 +1,3 @@
+# BEGIN PLOT /ATLAS_2018_I1673184/d19-x01-y01
+LogY=0
+# END PLOT
Index: trunk/code/ATLAS_2017_I1511869.plot
===================================================================
--- trunk/code/ATLAS_2017_I1511869.plot (revision 0)
+++ trunk/code/ATLAS_2017_I1511869.plot (revision 466)
@@ -0,0 +1,258 @@
+# BEGIN PLOT /ATLAS_2017_I1511869/d01-x01-y01
+Title=p+p; $|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d01-x01-y02
+Title=Pb+Pb 0-10; $|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d02-x01-y01
+Title=p+p; $|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d02-x01-y02
+Title=Pb+Pb 0-10; $|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d03-x01-y01
+Title=p+p; $0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d03-x01-y02
+Title=Pb+Pb 0-10; $0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d04-x01-y01
+Title=p+p; $1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d04-x01-y02
+Title=Pb+Pb 0-10; $1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=$D(p_\perp)$
+LogX=1
+LogY=1
+# END PLOT
+
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d05-x01-y01
+Title=p+p; $|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d05-x01-y02
+Title=Pb+Pb 0-10; $|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d06-x01-y01
+Title=p+p; $|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d06-x01-y02
+Title=Pb+Pb 0-10; $|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d07-x01-y01
+Title=p+p; $0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d07-x01-y02
+Title=Pb+Pb 0-10; $0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d08-x01-y01
+Title=p+p; $1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d08-x01-y02
+Title=Pb+Pb 0-10; $1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=$D(z)$
+LogX=1
+LogY=1
+# END PLOT
+
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d09-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d13-x01-y01
+Title=$|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d17-x01-y01
+Title=$0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d21-x01-y01
+Title=$1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d25-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d29-x01-y01
+Title=$|\eta| < 0.3$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d33-x01-y01
+Title=$0.3 < |\eta| < 0.8$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d37-x01-y01
+Title=$1.2 < |\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d41-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d45-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 126\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d49-x01-y01
+Title=$|\eta| < 2.1$; $126\,\text{GeV} < p_\perp < 158\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d53-x01-y01
+Title=$|\eta| < 2.1$; $158\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$p_\perp\ [\text{GeV}]$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d57-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d61-x01-y01
+Title=$|\eta| < 2.1$; $100\,\text{GeV} < p_\perp < 126\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d65-x01-y01
+Title=$|\eta| < 2.1$; $126\,\text{GeV} < p_\perp < 158\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
+# BEGIN PLOT /ATLAS_2017_I1511869/d69-x01-y01
+Title=$|\eta| < 2.1$; $158\,\text{GeV} < p_\perp < 398\,\text{GeV}$
+XLabel=$z$
+YLabel=PbPb / pp
+LogX=1
+LogY=0
+# END PLOT
+
Index: trunk/code/ATLAS_2013_I1240088.cc
===================================================================
--- trunk/code/ATLAS_2013_I1240088.cc (revision 465)
+++ trunk/code/ATLAS_2013_I1240088.cc (revision 466)
@@ -1,125 +1,124 @@
// -*- C++ -*-
#include "Rivet/Analysis.hh"
#include "Rivet/Tools/Logging.hh"
#include "Rivet/Projections/FinalState.hh"
#include "Rivet/Projections/FastJets.hh"
#include <boost/lexical_cast.hpp>
/// @todo Include more projections as required, e.g. ChargedFinalState, FastJets, ZFinder...
namespace Rivet {
class ATLAS_2013_I1240088 : public Analysis {
public:
/// @name Constructors etc.
//@{
/// Constructor
ATLAS_2013_I1240088()
: Analysis("ATLAS_2013_I1240088")
{
+ normalise = false;
}
//@}
public:
/// @name Analysis methods
//@{
/// Book histograms and initialise projections before the run
void init() {
FinalState fs(-4.0, 4.0, 0.*GeV);
addProjection(fs, "FS");
FastJets fj02(fs, FastJets::ANTIKT, 0.2);
fj02.useInvisibles();
addProjection(fj02, "Jets02");
- //_centedges += 0.05, 0.1, 0.2, 0.3, 0.4, 0.5, 0.6;
- _centedges += 0.05, 0.1;
+ _centedges += 0.05, 0.1, 0.2, 0.3, 0.4, 0.5, 0.6;
_ptedges += 45.0, 60.0, 80.0, 110.0, 160.0;
_ncentbins = _centedges.size()-1;
_nptbins = _ptedges.size()-1;
for (size_t i = 0; i < _ncentbins; ++i) {
for (size_t j = 0; j < _nptbins; ++j) {
- normalise[i][j] = false;
_histos[i][j] = bookHisto1D(i+1, 2, j+1);
}
}
}
/// Perform the per-event analysis
void analyze(const Event& event) {
const double weight = event.weight();
const double cent = (event.genEvent()->heavy_ion()?event.genEvent()->heavy_ion()->impact_parameter():-1.);
Cut cuts = Cuts::abseta < 2.1 && Cuts::pT > _ptedges.front()*GeV && Cuts::pT < _ptedges.back()*GeV;
Jets alljets = applyProjection<FastJets>(event, "Jets02").jetsByPt(cuts);
for (size_t i = 0; i < _ncentbins; ++i) {
if (cent < 0. || (cent >= _centedges[i] && cent < _centedges[i+1])) {
for (size_t j = 0; j < _nptbins; ++j) {
foreach (Jet jet, alljets) {
double pt(jet.momentum().pT());
if (pt > _ptedges[j]*GeV && pt < _ptedges[j+1]*GeV) {
- normalise[i][j] = true;
+ normalise = true;
double phi(jet.phi());
if (phi > M_PI/2. && phi < M_PI) phi = M_PI - phi;
if (phi > M_PI && phi < 3.*M_PI/2.) phi = phi - M_PI;
if (phi > 3.*M_PI/2.) phi = 2.*M_PI - phi;
_histos[i][j]->fill(phi,weight);
}
}
}
}
}
}
/// Normalise histograms etc., after the run
void finalize() {
- //if (!normalise) return;
+ if (!normalise) return;
for (size_t i = 0; i < _ncentbins; ++i) {
for (size_t j = 0; j < _nptbins; ++j) {
- if (normalise[i][j]) normalize(_histos[i][j]);
+ normalize(_histos[i][j]);
}
}
}
//@}
private:
// Data members like post-cuts event weight counters go here
vector<double> _ptedges;
vector<double> _centedges;
size_t _ncentbins, _nptbins;
- bool normalise[1][4];
+ bool normalise;
private:
/// @name Histograms
//@{
- Histo1DPtr _histos[1][4];
+ Histo1DPtr _histos[6][4];
//@}
};
// The hook for the plugin system
DECLARE_RIVET_PLUGIN(ATLAS_2013_I1240088);
}
Index: trunk/code/ATLAS_2018_I1673184.info
===================================================================
--- trunk/code/ATLAS_2018_I1673184.info (revision 0)
+++ trunk/code/ATLAS_2018_I1673184.info (revision 466)
@@ -0,0 +1,50 @@
+Name: ATLAS_2018_I1673184
+Year: 2018
+Summary: <Insert short ATLAS_2018_I1673184 description>
+Experiment: ATLAS
+Collider: LHC
+InspireID: 1673184
+Status: UNVALIDATED
+Authors:
+ - Your Name <your@email.address>
+#References:
+# - <Example: Phys.Lett.B639:151-158,2006, Erratum-ibid.B658:285-289,2008>
+# - <Example: doi:10.1016/j.physletb.2006.04.048>
+# - <Example: arXiv:hep-ex/0511054 (plus erratum)>
+RunInfo:
+ <Insert event types (not gen-specific), energy, any kinematic
+ efficiency cut(s) that may be needed; essentially any details needed to set
+ up a generator to reproduce the data.>
+NumEvents: 1000000
+NeedCrossSection: no
+#Beams: <Insert beam pair(s), e.g. [p-, p+] or [[p-, e-], [p-, e+]]>
+#Energies: <Insert list of run energies or beam energy pairs in GeV,
+# e.g. [1960] or [[8.0, 3.5]] or [630, 1800]. Order pairs to match "Beams">
+#PtCuts: <Insert list of kinematic pT cuts in GeV, e.g. [0, 20]>
+#NeedCrossSection: True
+Description:
+ '<Insert a fairly long description, including what is measured
+ and if possible what it is useful for in terms of MC validation
+ and tuning. Use LaTeX for maths like $\pT > 50\;\GeV$.
+ Use single quotes around the block if required (see http://www.yaml.org)>'
+BibKey: Aaboud:2018twu
+BibTeX: '@article{Aaboud:2018twu,
+ author = "Aaboud, Morad and others",
+ title = "{Measurement of the nuclear modification factor for
+ inclusive jets in Pb+Pb collisions at
+ $\sqrt{s_\mathrm{NN}}=5.02$ TeV with the ATLAS detector}",
+ collaboration = "ATLAS",
+ journal = "Phys. Lett.",
+ volume = "B790",
+ year = "2019",
+ pages = "108-128",
+ doi = "10.1016/j.physletb.2018.10.076",
+ eprint = "1805.05635",
+ archivePrefix = "arXiv",
+ primaryClass = "nucl-ex",
+ reportNumber = "CERN-EP-2018-105",
+ SLACcitation = "%%CITATION = ARXIV:1805.05635;%%"
+}'
+ToDo:
+ - Implement the analysis, test it, remove this ToDo, and mark as VALIDATED :-)
+
Index: trunk/code/ATLAS_2017_I1511869.info
===================================================================
--- trunk/code/ATLAS_2017_I1511869.info (revision 0)
+++ trunk/code/ATLAS_2017_I1511869.info (revision 466)
@@ -0,0 +1,34 @@
+Name: ATLAS_2017_I1511869
+Year: 2017
+Summary: <Insert short ATLAS_2017_I1511869 description>
+Experiment: ATLAS
+Collider: LHC
+InspireID: 1511869
+Status: UNVALIDATED
+Authors:
+ - Your Name <your@email.address>
+#References:
+# - <Example: Phys.Lett.B639:151-158,2006, Erratum-ibid.B658:285-289,2008>
+# - <Example: doi:10.1016/j.physletb.2006.04.048>
+# - <Example: arXiv:hep-ex/0511054 (plus erratum)>
+RunInfo:
+ <Insert event types (not gen-specific), energy, any kinematic
+ efficiency cut(s) that may be needed; essentially any details needed to set
+ up a generator to reproduce the data.>
+NumEvents: 1000000
+NeedCrossSection: no
+#Beams: <Insert beam pair(s), e.g. [p-, p+] or [[p-, e-], [p-, e+]]>
+#Energies: <Insert list of run energies or beam energy pairs in GeV,
+# e.g. [1960] or [[8.0, 3.5]] or [630, 1800]. Order pairs to match "Beams">
+#PtCuts: <Insert list of kinematic pT cuts in GeV, e.g. [0, 20]>
+#NeedCrossSection: True
+Description:
+ '<Insert a fairly long description, including what is measured
+ and if possible what it is useful for in terms of MC validation
+ and tuning. Use LaTeX for maths like $\pT > 50\;\GeV$.
+ Use single quotes around the block if required (see http://www.yaml.org)>'
+BibKey:
+BibTeX: ''
+ToDo:
+ - Implement the analysis, test it, remove this ToDo, and mark as VALIDATED :-)
+
Index: trunk/code/ATLAS_2018_I1673184.yoda
===================================================================
--- trunk/code/ATLAS_2018_I1673184.yoda (revision 0)
+++ trunk/code/ATLAS_2018_I1673184.yoda (revision 466)
@@ -0,0 +1,117 @@
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d04-x01-y01
+Path=/REF/ATLAS_2018_I1673184/d04-x01-y01
+Title=doi:10.17182/hepdata.84819.v1/t4
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+4.500000e+01 5.000000e+00 5.000000e+00 1.361100e+02 2.131543e+01 2.238793e+01
+5.650000e+01 6.500000e+00 6.500000e+00 4.362000e+01 5.729302e+00 6.016444e+00
+7.100000e+01 8.000000e+00 8.000000e+00 1.374900e+01 1.627702e+00 1.684001e+00
+8.950000e+01 1.050000e+01 1.050000e+01 4.051000e+00 4.307865e-01 4.455581e-01
+1.130000e+02 1.300000e+01 1.300000e+01 1.154300e+00 1.187099e-01 1.211684e-01
+1.420000e+02 1.600000e+01 1.600000e+01 3.131000e-01 2.999033e-02 3.106944e-02
+1.790000e+02 2.100000e+01 2.100000e+01 8.267000e-02 7.973544e-03 8.042207e-03
+2.255000e+02 2.550000e+01 2.550000e+01 2.019000e-02 1.850432e-03 1.879787e-03
+2.835000e+02 3.250000e+01 3.250000e+01 4.644000e-03 4.265993e-04 4.314881e-04
+3.570000e+02 4.100000e+01 4.100000e+01 9.610000e-04 8.832327e-05 8.929726e-05
+4.495000e+02 5.150000e+01 5.150000e+01 1.850000e-04 1.772005e-05 1.868154e-05
+5.660000e+02 6.500000e+01 6.500000e+01 3.610000e-05 3.781534e-06 3.871692e-06
+7.155000e+02 8.450000e+01 8.450000e+01 4.500000e-06 7.141428e-07 7.874008e-07
+9.000000e+02 1.000000e+02 1.000000e+02 4.800000e-07 1.489966e-07 1.489966e-07
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d11-x01-y01
+Path=/REF/ATLAS_2018_I1673184/d11-x01-y01
+Title=doi:10.17182/hepdata.84819.v1/t11
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.130000e+02 1.300000e+01 1.300000e+01 5.157000e-01 4.752368e-02 4.892300e-02
+1.420000e+02 1.600000e+01 1.600000e+01 1.537000e-01 1.360919e-02 1.320947e-02
+1.790000e+02 2.100000e+01 2.100000e+01 4.313000e-02 3.554068e-03 3.574045e-03
+2.255000e+02 2.550000e+01 2.550000e+01 1.134000e-02 9.525755e-04 9.226592e-04
+2.835000e+02 3.250000e+01 3.250000e+01 2.607000e-03 2.299652e-04 2.230269e-04
+3.570000e+02 4.100000e+01 4.100000e+01 5.670000e-04 4.876474e-05 4.684015e-05
+4.495000e+02 5.150000e+01 5.150000e+01 1.100000e-04 1.208305e-05 1.118034e-05
+5.660000e+02 6.500000e+01 6.500000e+01 2.020000e-05 2.561250e-06 2.500000e-06
+7.155000e+02 8.450000e+01 8.450000e+01 2.600000e-06 7.615773e-07 7.615773e-07
+9.000000e+02 1.000000e+02 1.000000e+02 5.200000e-07 2.745906e-07 2.745906e-07
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d19-x01-y01
+Path=/REF/ATLAS_2018_I1673184/d19-x01-y01
+Title=doi:10.17182/hepdata.84819.v1/t19
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.060000e+02 6.000000e+00 6.000000e+00 4.381000e-01 1.679613e-02 1.714235e-02
+1.185000e+02 6.500000e+00 6.500000e+00 4.633000e-01 1.733522e-02 1.740402e-02
+1.330000e+02 8.000000e+00 8.000000e+00 4.847000e-01 1.784124e-02 1.763576e-02
+1.495000e+02 8.500000e+00 8.500000e+00 5.023000e-01 1.797081e-02 1.777020e-02
+1.675000e+02 9.500000e+00 9.500000e+00 5.151000e-01 1.779522e-02 1.779522e-02
+1.880000e+02 1.100000e+01 1.100000e+01 5.350000e-01 1.832184e-02 1.832184e-02
+2.110000e+02 1.200000e+01 1.200000e+01 5.570000e-01 2.043747e-02 2.043747e-02
+2.370000e+02 1.400000e+01 1.400000e+01 5.720000e-01 2.169539e-02 2.169539e-02
+2.660000e+02 1.500000e+01 1.500000e+01 5.610000e-01 2.242075e-02 2.242075e-02
+2.985000e+02 1.750000e+01 1.750000e+01 5.630000e-01 2.378424e-02 2.378424e-02
+3.350000e+02 1.900000e+01 1.900000e+01 5.890000e-01 2.845505e-02 2.845505e-02
+3.760000e+02 2.200000e+01 2.200000e+01 5.890000e-01 3.459321e-02 3.459321e-02
+4.495000e+02 5.150000e+01 5.150000e+01 5.930000e-01 3.759907e-02 3.759907e-02
+5.655000e+02 6.450000e+01 6.450000e+01 5.600000e-01 6.461958e-02 6.461958e-02
+8.145000e+02 1.845000e+02 1.845000e+02 6.200000e-01 1.617890e-01 1.617890e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d27-x01-y01
+Path=/REF/ATLAS_2018_I1673184/d27-x01-y01
+Title=doi:10.17182/hepdata.84819.v1/t27
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.500000e-01 1.500000e-01 1.500000e-01 1.000000e+00 0.000000e+00 0.000000e+00
+5.500000e-01 2.500000e-01 2.500000e-01 1.014000e+00 1.431782e-02 1.431782e-02
+1.000000e+00 2.000000e-01 2.000000e-01 9.990000e-01 1.486607e-02 1.523155e-02
+1.400000e+00 2.000000e-01 2.000000e-01 1.042000e+00 1.700000e-02 1.749286e-02
+1.850000e+00 2.500000e-01 2.500000e-01 9.990000e-01 1.886796e-02 1.835756e-02
+2.450000e+00 3.500000e-01 3.500000e-01 1.015000e+00 3.047950e-02 2.745906e-02
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d27-x01-y02
+Path=/REF/ATLAS_2018_I1673184/d27-x01-y02
+Title=doi:10.17182/hepdata.84819.v1/t27
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.500000e-01 1.500000e-01 1.500000e-01 1.000000e+00 0.000000e+00 0.000000e+00
+5.500000e-01 2.500000e-01 2.500000e-01 1.029000e+00 2.061553e-02 2.061553e-02
+1.000000e+00 2.000000e-01 2.000000e-01 1.016000e+00 2.137756e-02 2.137756e-02
+1.400000e+00 2.000000e-01 2.000000e-01 1.024000e+00 2.507987e-02 2.435159e-02
+1.850000e+00 2.500000e-01 2.500000e-01 9.680000e-01 2.751363e-02 2.720294e-02
+2.450000e+00 3.500000e-01 3.500000e-01 1.036000e+00 5.371220e-02 5.124451e-02
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d27-x01-y03
+Path=/REF/ATLAS_2018_I1673184/d27-x01-y03
+Title=doi:10.17182/hepdata.84819.v1/t27
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.500000e-01 1.500000e-01 1.500000e-01 1.000000e+00 0.000000e+00 0.000000e+00
+5.500000e-01 2.500000e-01 2.500000e-01 1.044000e+00 3.649658e-02 3.649658e-02
+1.000000e+00 2.000000e-01 2.000000e-01 9.600000e-01 3.765634e-02 3.748333e-02
+1.400000e+00 2.000000e-01 2.000000e-01 9.710000e-01 4.220190e-02 4.220190e-02
+1.850000e+00 2.500000e-01 2.500000e-01 9.300000e-01 5.197115e-02 5.217279e-02
+2.450000e+00 3.500000e-01 3.500000e-01 9.440000e-01 1.369452e-01 1.361947e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2018_I1673184/d27-x01-y04
+Path=/REF/ATLAS_2018_I1673184/d27-x01-y04
+Title=doi:10.17182/hepdata.84819.v1/t27
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.500000e-01 1.500000e-01 1.500000e-01 1.000000e+00 0.000000e+00 0.000000e+00
+5.500000e-01 2.500000e-01 2.500000e-01 1.050000e+00 6.040695e-02 6.040695e-02
+1.000000e+00 2.000000e-01 2.000000e-01 1.035000e+00 6.774216e-02 6.736468e-02
+1.400000e+00 2.000000e-01 2.000000e-01 8.740000e-01 7.071068e-02 7.045566e-02
+1.850000e+00 2.500000e-01 2.500000e-01 6.830000e-01 9.419129e-02 9.442987e-02
+2.450000e+00 3.500000e-01 3.500000e-01 6.360000e-01 4.590534e-01 4.590697e-01
+END YODA_SCATTER2D
Index: trunk/code/ATLAS_2017_I1511869.yoda
===================================================================
--- trunk/code/ATLAS_2017_I1511869.yoda (revision 0)
+++ trunk/code/ATLAS_2017_I1511869.yoda (revision 466)
@@ -0,0 +1,608 @@
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d01-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d01-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t1
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.798000e+00 4.079216e-02 3.104835e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.380000e+00 2.647640e-02 2.353720e-02
+3.250000e+00 7.500000e-01 7.500000e-01 9.411000e-01 1.511092e-02 1.433388e-02
+5.150000e+00 1.150000e+00 1.150000e+00 5.920000e-01 8.489994e-03 7.242237e-03
+8.150000e+00 1.850000e+00 1.850000e+00 3.252000e-01 4.205948e-03 4.205948e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.600000e-01 1.746425e-03 2.118962e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.710000e-02 1.360147e-03 1.360147e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.324000e-02 5.565968e-04 5.565968e-04
+5.150000e+01 1.150000e+01 1.150000e+01 6.240000e-03 2.118962e-04 2.118962e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.132000e-03 6.741662e-05 7.022820e-05
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d01-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d01-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t1
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 2.880000e+00 1.341641e-01 1.341641e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.880000e+00 8.316850e-02 7.186793e-02
+3.250000e+00 7.500000e-01 7.500000e-01 9.880000e-01 4.100000e-02 2.941088e-02
+5.150000e+00 1.150000e+00 1.150000e+00 5.210000e-01 2.236068e-02 1.552417e-02
+8.150000e+00 1.850000e+00 1.850000e+00 2.698000e-01 9.580188e-03 5.961543e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.411000e-01 4.301163e-03 4.016217e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.500000e-02 2.213594e-03 2.213594e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.482000e-02 1.043552e-03 8.285530e-04
+5.150000e+01 1.150000e+01 1.150000e+01 7.340000e-03 4.085340e-04 3.992493e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.310000e-03 1.208305e-04 1.486607e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d02-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d02-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t2
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.914000e+00 5.028916e-02 3.534119e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.454000e+00 3.764306e-02 2.549510e-02
+3.250000e+00 7.500000e-01 7.500000e-01 9.840000e-01 2.404163e-02 1.931321e-02
+5.150000e+00 1.150000e+00 1.150000e+00 6.190000e-01 1.077033e-02 7.211103e-03
+8.150000e+00 1.850000e+00 1.850000e+00 3.362000e-01 5.147815e-03 4.060788e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.655000e-01 2.607681e-03 2.692582e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.860000e-02 1.303840e-03 1.220656e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.209000e-02 6.105735e-04 5.768882e-04
+5.150000e+01 1.150000e+01 1.150000e+01 5.620000e-03 2.729469e-04 2.729469e-04
+8.150000e+01 1.850000e+01 1.850000e+01 9.800000e-04 6.403124e-05 6.403124e-05
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d02-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d02-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t2
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 2.950000e+00 3.383785e-01 1.421267e-01
+2.050000e+00 4.500000e-01 4.500000e-01 2.060000e+00 9.433981e-02 8.602325e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.045000e+00 6.621933e-02 3.106445e-02
+5.150000e+00 1.150000e+00 1.150000e+00 5.700000e-01 2.912044e-02 1.788854e-02
+8.150000e+00 1.850000e+00 1.850000e+00 2.860000e-01 1.868154e-02 8.602325e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.427000e-01 4.887740e-03 6.132699e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.590000e-02 3.087070e-03 2.996665e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.360000e-02 1.431782e-03 1.081665e-03
+5.150000e+01 1.150000e+01 1.150000e+01 7.400000e-03 5.556978e-04 5.131277e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.180000e-03 1.581139e-04 1.749286e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d03-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d03-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t3
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.849000e+00 3.984972e-02 3.324154e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.426000e+00 2.247221e-02 2.340940e-02
+3.250000e+00 7.500000e-01 7.500000e-01 9.720000e-01 1.208305e-02 1.392839e-02
+5.150000e+00 1.150000e+00 1.150000e+00 6.091000e-01 6.637017e-03 7.782031e-03
+8.150000e+00 1.850000e+00 1.850000e+00 3.332000e-01 4.118252e-03 4.742362e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.624000e-01 1.780449e-03 2.195450e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.600000e-02 1.431782e-03 1.431782e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.263000e-02 5.635601e-04 5.724509e-04
+5.150000e+01 1.150000e+01 1.150000e+01 5.990000e-03 2.282542e-04 2.282542e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.046000e-03 6.435060e-05 6.603787e-05
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d03-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d03-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t3
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 3.000000e+00 2.236068e-01 1.414214e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.860000e+00 1.264911e-01 8.944272e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.067000e+00 3.220248e-02 3.769615e-02
+5.150000e+00 1.150000e+00 1.150000e+00 5.160000e-01 2.184033e-02 1.708801e-02
+8.150000e+00 1.850000e+00 1.850000e+00 2.732000e-01 9.527329e-03 1.674873e-02
+1.300000e+01 3.000000e+00 3.000000e+00 1.479000e-01 4.924429e-03 1.226418e-02
+2.050000e+01 4.500000e+00 4.500000e+00 6.490000e-02 2.416609e-03 2.416609e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.460000e-02 1.029563e-03 8.602325e-04
+5.150000e+01 1.150000e+01 1.150000e+01 6.980000e-03 4.049691e-04 5.099020e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.300000e-03 1.612452e-04 1.700000e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d04-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d04-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t4
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.634000e+00 4.332436e-02 3.769615e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.260000e+00 3.162278e-02 3.162278e-02
+3.250000e+00 7.500000e-01 7.500000e-01 8.660000e-01 1.897367e-02 1.802776e-02
+5.150000e+00 1.150000e+00 1.150000e+00 5.480000e-01 1.077033e-02 9.848858e-03
+8.150000e+00 1.850000e+00 1.850000e+00 3.050000e-01 5.053712e-03 5.053712e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.519000e-01 2.385372e-03 2.641969e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.720000e-02 1.931321e-03 1.746425e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.490000e-02 6.888396e-04 6.977105e-04
+5.150000e+01 1.150000e+01 1.150000e+01 6.970000e-03 2.126029e-04 2.865310e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.320000e-03 1.300000e-04 1.300000e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d04-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d04-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t4
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 2.580000e+00 1.341641e-01 3.324154e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.820000e+00 7.810250e-02 5.830952e-02
+3.250000e+00 7.500000e-01 7.500000e-01 8.440000e-01 4.308132e-02 2.640076e-02
+5.150000e+00 1.150000e+00 1.150000e+00 4.880000e-01 2.308679e-02 1.565248e-02
+8.150000e+00 1.850000e+00 1.850000e+00 2.530000e-01 5.656854e-03 6.403124e-03
+1.300000e+01 3.000000e+00 3.000000e+00 1.291000e-01 5.188449e-03 4.410215e-03
+2.050000e+01 4.500000e+00 4.500000e+00 6.440000e-02 2.000000e-03 1.843909e-03
+3.250000e+01 7.500000e+00 7.500000e+00 2.540000e-02 1.000000e-03 9.219544e-04
+5.150000e+01 1.150000e+01 1.150000e+01 7.450000e-03 3.753665e-04 3.440930e-04
+8.150000e+01 1.850000e+01 1.850000e+01 1.390000e-03 1.664332e-04 1.835756e-04
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d05-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d05-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t5
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.952000e+02 4.079216e+00 3.492850e+00
+2.050000e-02 4.500000e-03 4.500000e-03 1.436000e+02 2.376973e+00 2.280351e+00
+3.250000e-02 7.500000e-03 7.500000e-03 9.360000e+01 1.552417e+00 1.360147e+00
+5.150000e-02 1.150000e-02 1.150000e-02 5.616000e+01 7.624303e-01 7.433034e-01
+8.150000e-02 1.850000e-02 1.850000e-02 2.976000e+01 3.640055e-01 3.640055e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.371000e+01 1.565248e-01 2.024846e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.350000e+00 1.341231e-01 1.244548e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.669000e+00 4.743416e-02 5.028916e-02
+5.150000e-01 1.150000e-01 1.150000e-01 3.680000e-01 1.581139e-02 1.772005e-02
+8.150000e-01 1.850000e-01 1.850000e-01 4.060000e-02 3.807887e-03 3.716181e-03
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d05-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d05-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t5
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 2.980000e+02 1.300000e+01 8.602325e+00
+2.050000e-02 4.500000e-03 4.500000e-03 1.681000e+02 9.708244e+00 1.078703e+01
+3.250000e-02 7.500000e-03 7.500000e-03 8.950000e+01 3.201562e+00 2.435159e+00
+5.150000e-02 1.150000e-02 1.150000e-02 4.690000e+01 1.746425e+00 1.264911e+00
+8.150000e-02 1.850000e-02 1.850000e-02 2.459000e+01 9.095603e-01 7.273239e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.247000e+01 3.921734e-01 3.921734e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.380000e+00 1.838478e-01 2.500000e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.880000e+00 1.008811e-01 8.115417e-02
+5.150000e-01 1.150000e-01 1.150000e-01 4.580000e-01 3.046309e-02 2.863564e-02
+8.150000e-01 1.850000e-01 1.850000e-01 4.490000e-02 6.576473e-03 1.008811e-02
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d06-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d06-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t6
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 2.071000e+02 5.440588e+00 3.848376e+00
+2.050000e-02 4.500000e-03 4.500000e-03 1.506000e+02 3.383785e+00 2.459675e+00
+3.250000e-02 7.500000e-03 7.500000e-03 9.820000e+01 2.308679e+00 1.838478e+00
+5.150000e-02 1.150000e-02 1.150000e-02 5.830000e+01 9.848858e-01 7.211103e-01
+8.150000e-02 1.850000e-02 1.850000e-02 3.049000e+01 4.664762e-01 3.764306e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.411000e+01 2.061553e-01 2.220360e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.250000e+00 1.252996e-01 1.252996e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.492000e+00 4.500000e-02 4.420407e-02
+5.150000e-01 1.150000e-01 1.150000e-01 3.100000e-01 2.236068e-02 2.236068e-02
+8.150000e-01 1.850000e-01 1.850000e-01 3.230000e-02 4.632494e-03 3.905125e-03
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d06-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d06-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t6
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 3.300000e+02 2.236068e+01 1.000000e+01
+2.050000e-02 4.500000e-03 4.500000e-03 1.780000e+02 1.649242e+01 1.264911e+01
+3.250000e-02 7.500000e-03 7.500000e-03 9.510000e+01 4.459821e+00 2.267157e+00
+5.150000e-02 1.150000e-02 1.150000e-02 5.080000e+01 2.624881e+00 1.360147e+00
+8.150000e-02 1.850000e-02 1.850000e-02 2.520000e+01 1.392839e+00 1.208305e+00
+1.300000e-01 3.000000e-02 3.000000e-02 1.241000e+01 4.161730e-01 6.741662e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.200000e+00 2.863564e-01 3.324154e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.780000e+00 1.081665e-01 9.219544e-02
+5.150000e-01 1.150000e-01 1.150000e-01 4.330000e-01 4.701064e-02 5.869412e-02
+8.150000e-01 1.850000e-01 1.850000e-01 3.800000e-02 7.071068e-03 1.208305e-02
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d07-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d07-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t7
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 2.015000e+02 3.733631e+00 3.640055e+00
+2.050000e-02 4.500000e-03 4.500000e-03 1.487000e+02 2.012461e+00 2.284732e+00
+3.250000e-02 7.500000e-03 7.500000e-03 9.640000e+01 1.252996e+00 1.431782e+00
+5.150000e-02 1.150000e-02 1.150000e-02 5.763000e+01 6.212890e-01 7.602631e-01
+8.150000e-02 1.850000e-02 1.850000e-02 3.030000e+01 3.982462e-01 4.701064e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.363000e+01 1.640122e-01 2.236068e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.160000e+00 1.300000e-01 1.300000e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.589000e+00 4.219005e-02 4.565085e-02
+5.150000e-01 1.150000e-01 1.150000e-01 3.350000e-01 1.788854e-02 1.612452e-02
+8.150000e-01 1.850000e-01 1.850000e-01 3.200000e-02 2.900000e-03 2.900000e-03
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d07-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d07-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t7
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 2.970000e+02 2.340940e+01 1.280625e+01
+2.050000e-02 4.500000e-03 4.500000e-03 1.727000e+02 1.018332e+01 1.375391e+01
+3.250000e-02 7.500000e-03 7.500000e-03 9.370000e+01 3.417601e+00 3.231099e+00
+5.150000e-02 1.150000e-02 1.150000e-02 4.600000e+01 1.615549e+00 1.708801e+00
+8.150000e-02 1.850000e-02 1.850000e-02 2.530000e+01 1.068925e+00 7.032780e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.293000e+01 5.442426e-01 4.701064e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.200000e+00 2.236068e-01 3.162278e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.840000e+00 1.029563e-01 1.300000e-01
+5.150000e-01 1.150000e-01 1.150000e-01 4.110000e-01 3.080584e-02 4.024922e-02
+8.150000e-01 1.850000e-01 1.850000e-01 3.700000e-02 8.944272e-03 8.944272e-03
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d08-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d08-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t8
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.766000e+02 4.554119e+00 4.178516e+00
+2.050000e-02 4.500000e-03 4.500000e-03 1.310000e+02 3.162278e+00 3.162278e+00
+3.250000e-02 7.500000e-03 7.500000e-03 8.620000e+01 1.897367e+00 1.708801e+00
+5.150000e-02 1.150000e-02 1.150000e-02 5.250000e+01 9.848858e-01 9.848858e-01
+8.150000e-02 1.850000e-02 1.850000e-02 2.836000e+01 4.830114e-01 4.390900e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.345000e+01 2.163331e-01 2.594224e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.670000e+00 1.802776e-01 1.523155e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.899000e+00 8.005623e-02 8.381527e-02
+5.150000e-01 1.150000e-01 1.150000e-01 4.460000e-01 2.282542e-02 2.823119e-02
+8.150000e-01 1.850000e-01 1.850000e-01 5.200000e-02 8.944272e-03 8.944272e-03
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d08-x01-y02
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d08-x01-y02
+Title=doi:10.17182/hepdata.77789.v1/t8
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 2.730000e+02 1.118034e+01 2.507987e+01
+2.050000e-02 4.500000e-03 4.500000e-03 1.570000e+02 7.211103e+00 6.403124e+00
+3.250000e-02 7.500000e-03 7.500000e-03 7.990000e+01 4.617359e+00 2.692582e+00
+5.150000e-02 1.150000e-02 1.150000e-02 4.480000e+01 1.476482e+00 1.303840e+00
+8.150000e-02 1.850000e-02 1.850000e-02 2.320000e+01 7.211103e-01 8.062258e-01
+1.300000e-01 3.000000e-02 3.000000e-02 1.180000e+01 4.565085e-01 3.801316e-01
+2.050000e-01 4.500000e-02 4.500000e-02 5.700000e+00 1.920937e-01 2.418677e-01
+3.250000e-01 7.500000e-02 7.500000e-02 1.950000e+00 1.431782e-01 1.081665e-01
+5.150000e-01 1.150000e-01 1.150000e-01 5.300000e-01 4.161730e-02 4.664762e-02
+8.150000e-01 1.850000e-01 1.850000e-01 5.500000e-02 1.081665e-02 1.523155e-02
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d09-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d09-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t9
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.600000e+00 5.000000e-02 8.062258e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.362000e+00 5.200000e-02 4.651881e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.050000e+00 3.736308e-02 2.879236e-02
+5.150000e+00 1.150000e+00 1.150000e+00 8.810000e-01 3.373426e-02 2.404163e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.300000e-01 2.529822e-02 1.969772e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.820000e-01 2.376973e-02 2.376973e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.690000e-01 3.195309e-02 3.008322e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.068000e+00 4.870318e-02 3.848376e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.176000e+00 5.247857e-02 4.743416e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.150000e+00 9.433981e-02 1.208305e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d13-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d13-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t13
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.540000e+00 1.431782e-01 1.000000e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.410000e+00 5.656854e-02 6.403124e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.062000e+00 5.692100e-02 3.498571e-02
+5.150000e+00 1.150000e+00 1.150000e+00 9.210000e-01 3.956008e-02 2.692582e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.510000e-01 4.933559e-02 2.343075e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.620000e-01 3.190611e-02 3.801316e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.600000e-01 4.517743e-02 4.606517e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.067000e+00 6.400781e-02 4.827007e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.320000e+00 1.000000e-01 9.219544e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.200000e+00 1.555635e-01 1.702939e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d17-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d17-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t17
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.640000e+00 1.029563e-01 8.602325e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.306000e+00 8.415462e-02 4.940648e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.097000e+00 3.312099e-02 3.757659e-02
+5.150000e+00 1.150000e+00 1.150000e+00 8.470000e-01 3.478505e-02 3.101612e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.200000e-01 2.370654e-02 5.119570e-02
+1.300000e+01 3.000000e+00 3.000000e+00 9.110000e-01 2.607681e-02 7.040597e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.840000e-01 3.847077e-02 3.847077e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.089000e+00 5.147815e-02 4.301163e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.160000e+00 6.403124e-02 7.211103e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.240000e+00 1.421267e-01 1.500000e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d21-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d21-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t21
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.580000e+00 9.433981e-02 2.061553e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.450000e+00 7.211103e-02 5.656854e-02
+3.250000e+00 7.500000e-01 7.500000e-01 9.750000e-01 4.792703e-02 3.220248e-02
+5.150000e+00 1.150000e+00 1.150000e+00 8.920000e-01 3.900000e-02 2.580698e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.310000e-01 1.984943e-02 2.121320e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.500000e-01 3.244996e-02 2.617250e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.580000e-01 3.420526e-02 2.900000e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.020000e+00 4.177320e-02 3.623534e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.070000e+00 4.472136e-02 4.472136e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.050000e+00 9.433981e-02 1.000000e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d25-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d25-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t25
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.525000e+00 4.327817e-02 5.385165e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.170000e+00 6.281720e-02 4.648656e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.560000e-01 3.132092e-02 2.469818e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.350000e-01 2.720294e-02 2.247221e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.260000e-01 2.912044e-02 1.969772e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.090000e-01 2.692582e-02 2.600000e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.006000e+00 3.401470e-02 4.049691e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.127000e+00 6.262587e-02 4.965884e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.250000e+00 8.062258e-02 6.403124e-02
+8.150000e-01 1.850000e-01 1.850000e-01 1.110000e+00 1.581139e-01 2.193171e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d29-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d29-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t29
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.580000e+00 7.810250e-02 7.810250e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.184000e+00 9.492102e-02 5.770615e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.690000e-01 4.716991e-02 3.106445e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.720000e-01 3.624914e-02 2.500000e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.280000e-01 4.114608e-02 2.545584e-02
+1.300000e-01 3.000000e-02 3.000000e-02 8.790000e-01 3.061046e-02 4.976947e-02
+2.050000e-01 4.500000e-02 4.500000e-02 9.890000e-01 5.813777e-02 6.174140e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.190000e+00 7.211103e-02 6.403124e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.410000e+00 1.835756e-01 2.102380e-01
+8.150000e-01 1.850000e-01 1.850000e-01 1.170000e+00 2.549510e-01 3.807887e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d33-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d33-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t33
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.470000e+00 8.944272e-02 6.403124e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.162000e+00 6.862215e-02 5.830952e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.720000e-01 3.492850e-02 3.310589e-02
+5.150000e-02 1.150000e-02 1.150000e-02 7.990000e-01 2.640076e-02 3.008322e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.350000e-01 3.640055e-02 2.641969e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.480000e-01 4.031129e-02 3.400000e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.015000e+00 4.134005e-02 5.280152e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.156000e+00 6.551336e-02 7.335530e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.230000e+00 8.485281e-02 1.081665e-01
+8.150000e-01 1.850000e-01 1.850000e-01 1.170000e+00 2.580698e-01 2.267157e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d37-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d37-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t37
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.550000e+00 7.211103e-02 1.166190e-01
+2.050000e-02 4.500000e-03 4.500000e-03 1.202000e+00 6.842514e-02 4.827007e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.280000e-01 4.716991e-02 2.780288e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.530000e-01 2.830194e-02 2.343075e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.180000e-01 2.884441e-02 2.408319e-02
+1.300000e-01 3.000000e-02 3.000000e-02 8.780000e-01 3.328663e-02 2.617250e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.005000e+00 3.061046e-02 3.764306e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.025000e+00 8.600581e-02 5.800862e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.190000e+00 7.810250e-02 9.219544e-02
+8.150000e-01 1.850000e-01 1.850000e-01 1.070000e+00 2.267157e-01 2.745906e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d41-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d41-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t41
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.600000e+00 5.000000e-02 8.062258e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.362000e+00 5.200000e-02 4.651881e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.050000e+00 3.736308e-02 2.879236e-02
+5.150000e+00 1.150000e+00 1.150000e+00 8.810000e-01 3.373426e-02 2.404163e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.300000e-01 2.529822e-02 1.969772e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.820000e-01 2.376973e-02 2.376973e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.690000e-01 3.195309e-02 3.008322e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.068000e+00 4.870318e-02 3.848376e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.176000e+00 5.247857e-02 4.743416e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.150000e+00 9.433981e-02 1.208305e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d45-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d45-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t45
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.550000e+00 5.000000e-02 8.944272e-02
+2.050000e+00 4.500000e-01 4.500000e-01 1.351000e+00 5.423099e-02 4.965884e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.030000e+00 3.929377e-02 3.257299e-02
+5.150000e+00 1.150000e+00 1.150000e+00 8.660000e-01 3.395585e-02 2.529822e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.260000e-01 2.816026e-02 2.061553e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.800000e-01 2.236068e-02 2.236068e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.720000e-01 3.605551e-02 3.231099e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.074000e+00 5.314132e-02 4.295346e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.184000e+00 6.003332e-02 4.841487e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.150000e+00 1.081665e-01 1.523155e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d49-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d49-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t49
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 1.870000e+00 1.442221e-01 1.442221e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.500000e+00 7.071068e-02 7.810250e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.157000e+00 6.146544e-02 4.188078e-02
+5.150000e+00 1.150000e+00 1.150000e+00 9.530000e-01 4.623851e-02 3.023243e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.470000e-01 3.312099e-02 2.968164e-02
+1.300000e+01 3.000000e+00 3.000000e+00 8.890000e-01 3.466987e-02 2.758623e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.580000e-01 4.356604e-02 2.745906e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.038000e+00 4.666905e-02 3.478505e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.120000e+00 5.830952e-02 5.830952e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.300000e+00 1.414214e-01 1.414214e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d53-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d53-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t53
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e+00 3.000000e-01 3.000000e-01 2.120000e+00 2.126029e-01 1.565248e-01
+2.050000e+00 4.500000e-01 4.500000e-01 1.480000e+00 8.602325e-02 9.219544e-02
+3.250000e+00 7.500000e-01 7.500000e-01 1.240000e+00 7.211103e-02 5.000000e-02
+5.150000e+00 1.150000e+00 1.150000e+00 1.004000e+00 4.909175e-02 3.244996e-02
+8.150000e+00 1.850000e+00 1.850000e+00 8.530000e-01 2.657066e-02 2.915476e-02
+1.300000e+01 3.000000e+00 3.000000e+00 9.000000e-01 4.545327e-02 3.178050e-02
+2.050000e+01 4.500000e+00 4.500000e+00 9.260000e-01 3.420526e-02 4.080441e-02
+3.250000e+01 7.500000e+00 7.500000e+00 1.000000e+00 4.472136e-02 4.123106e-02
+5.150000e+01 1.150000e+01 1.150000e+01 1.090000e+00 6.324555e-02 8.485281e-02
+8.150000e+01 1.850000e+01 1.850000e+01 1.100000e+00 1.414214e-01 1.414214e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d57-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d57-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t57
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.525000e+00 4.327817e-02 5.385165e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.170000e+00 6.281720e-02 4.648656e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.560000e-01 3.132092e-02 2.469818e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.350000e-01 2.720294e-02 2.247221e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.260000e-01 2.912044e-02 1.969772e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.090000e-01 2.692582e-02 2.600000e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.006000e+00 3.401470e-02 4.049691e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.127000e+00 6.262587e-02 4.965884e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.250000e+00 8.062258e-02 6.403124e-02
+8.150000e-01 1.850000e-01 1.850000e-01 1.110000e+00 1.581139e-01 2.193171e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d61-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d61-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t61
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.534000e+00 4.750789e-02 6.313478e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.172000e+00 6.500000e-02 5.059644e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.600000e-01 3.162278e-02 2.236068e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.350000e-01 3.008322e-02 2.340940e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.190000e-01 3.132092e-02 2.102380e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.040000e-01 2.823119e-02 2.915476e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.003000e+00 3.676955e-02 4.143670e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.130000e+00 6.673080e-02 5.008992e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.260000e+00 7.211103e-02 7.211103e-02
+8.150000e-01 1.850000e-01 1.850000e-01 1.110000e+00 1.581139e-01 2.193171e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d65-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d65-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t65
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.590000e+00 7.810250e-02 8.602325e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.225000e+00 6.082763e-02 4.720169e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.850000e-01 5.220153e-02 3.244996e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.740000e-01 3.801316e-02 3.623534e-02
+8.150000e-02 1.850000e-02 1.850000e-02 8.740000e-01 4.428318e-02 2.831960e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.120000e-01 4.477723e-02 3.405877e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.045000e+00 4.313931e-02 3.289377e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.110000e+00 7.071068e-02 5.830952e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.210000e+00 1.204159e-01 1.131371e-01
+8.150000e-01 1.850000e-01 1.850000e-01 1.310000e+00 2.745906e-01 4.188078e-01
+END YODA_SCATTER2D
+
+
+BEGIN YODA_SCATTER2D /REF/ATLAS_2017_I1511869/d69-x01-y01
+IsRef=1
+Path=/REF/ATLAS_2017_I1511869/d69-x01-y01
+Title=doi:10.17182/hepdata.77789.v1/t69
+Type=Scatter2D
+# xval xerr- xerr+ yval yerr- yerr+
+1.300000e-02 3.000000e-03 3.000000e-03 1.440000e+00 1.000000e-01 7.211103e-02
+2.050000e-02 4.500000e-03 4.500000e-03 1.149000e+00 5.742822e-02 3.807887e-02
+3.250000e-02 7.500000e-03 7.500000e-03 9.190000e-01 3.220248e-02 2.863564e-02
+5.150000e-02 1.150000e-02 1.150000e-02 8.390000e-01 3.162278e-02 3.969887e-02
+8.150000e-02 1.850000e-02 1.850000e-02 9.050000e-01 3.744329e-02 3.920459e-02
+1.300000e-01 3.000000e-02 3.000000e-02 9.700000e-01 4.472136e-02 4.123106e-02
+2.050000e-01 4.500000e-02 4.500000e-02 1.050000e+00 5.830952e-02 7.071068e-02
+3.250000e-01 7.500000e-02 7.500000e-02 1.090000e+00 7.071068e-02 8.602325e-02
+5.150000e-01 1.150000e-01 1.150000e-01 1.140000e+00 1.984943e-01 1.476482e-01
+8.150000e-01 1.850000e-01 1.850000e-01 1.070000e+00 3.220248e-01 4.318565e-01
+END YODA_SCATTER2D
+
+
Index: trunk/code/ATLAS_2012_I1126965.plot
===================================================================
--- trunk/code/ATLAS_2012_I1126965.plot (revision 465)
+++ trunk/code/ATLAS_2012_I1126965.plot (revision 466)
@@ -1,154 +1,166 @@
-# BEGIN PLOT /ATLAS_2012_I1126965/*
+# BEGIN PLOT /ATLAS_2012_I1126965/d0*
LogY=0
FullRange=1
YMax=1.
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d02-x01-y01
Title=R=0.2, 00-10/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
+LogY=0
+FullRange=1
+YMax=1.
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d02-x01-y02
Title=R=0.3, 00-10/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
+LogY=0
+FullRange=1
+YMax=1.
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d02-x01-y03
Title=R=0.4, 00-10/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
+LogY=0
+FullRange=1
+YMax=1.
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d02-x01-y04
Title=R=0.5, 00-10/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
+LogY=0
+FullRange=1
+YMax=1.
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/jetpt0*
#DrawOnly=
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d03-x01-y01
Title=R=0.2, 10-20/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d03-x01-y02
Title=R=0.3, 10-20/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d03-x01-y03
Title=R=0.4, 10-20/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d03-x01-y04
Title=R=0.5, 10-20/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d04-x01-y01
Title=R=0.2, 20-30/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d04-x01-y02
Title=R=0.3, 20-30/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d04-x01-y03
Title=R=0.4, 20-30/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d04-x01-y04
Title=R=0.5, 20-30/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d05-x01-y01
Title=R=0.2, 30-40/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d05-x01-y02
Title=R=0.3, 30-40/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d05-x01-y03
Title=R=0.4, 30-40/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d05-x01-y04
Title=R=0.5, 30-40/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d06-x01-y01
Title=R=0.2, 40-50/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d06-x01-y02
Title=R=0.3, 40-50/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d06-x01-y03
Title=R=0.4, 40-50/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d06-x01-y04
Title=R=0.5, 40-50/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d07-x01-y01
Title=R=0.2, 50-60/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d07-x01-y02
Title=R=0.3, 50-60/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d07-x01-y03
Title=R=0.4, 50-60/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
# BEGIN PLOT /ATLAS_2012_I1126965/d07-x01-y04
Title=R=0.5, 50-60/60-80
XLabel=$p_\perp\ [\mathrm{GeV}]$
YLabel=$R_{CP}$
# END PLOT
Index: trunk/code/ATLAS_2013_I1240088.plot
===================================================================
--- trunk/code/ATLAS_2013_I1240088.plot (revision 465)
+++ trunk/code/ATLAS_2013_I1240088.plot (revision 466)
@@ -1,295 +1,296 @@
# BEGIN PLOT /ATLAS_2013_I1240088/*
YMin=0.5
YMax=0.8
NormalizeToIntegral=1
+LogY=0
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x01-y01
Title=$5-10$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x02-y01
Title=$5-10$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x01-y02
Title=$5-10$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x02-y02
Title=$5-10$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x01-y03
Title=$5-10$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x02-y03
Title=$5-10$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x01-y04
Title=$5-10$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d01-x02-y04
Title=$5-10$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x01-y01
Title=$10-20$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x02-y01
Title=$10-20$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x01-y02
Title=$10-20$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x02-y02
Title=$10-20$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x01-y03
Title=$10-20$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x02-y03
Title=$10-20$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x01-y04
Title=$10-20$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d02-x02-y04
Title=$10-20$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x01-y01
Title=$20-30$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
PolyMarker=*
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x02-y01
Title=$20-30$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x01-y02
Title=$20-30$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x02-y02
Title=$20-30$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x01-y03
Title=$20-30$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x02-y03
Title=$20-30$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x01-y04
Title=$20-30$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d03-x02-y04
Title=$20-30$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x01-y01
Title=$30-40$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x02-y01
Title=$30-40$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x01-y02
Title=$30-40$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x02-y02
Title=$30-40$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x01-y03
Title=$30-40$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x02-y03
Title=$30-40$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x01-y04
Title=$30-40$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d04-x02-y04
Title=$30-40$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x01-y01
Title=$40-50$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x02-y01
Title=$40-50$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x01-y02
Title=$40-50$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x02-y02
Title=$40-50$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x01-y03
Title=$40-50$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x02-y03
Title=$40-50$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x01-y04
Title=$40-50$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d05-x02-y04
Title=$40-50$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x01-y01
Title=$50-60$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x02-y01
Title=$50-60$, $45 < p_\perp < 60\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x01-y02
Title=$50-60$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x02-y02
Title=$50-60$, $60 < p_\perp < 80\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x01-y03
Title=$50-60$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x02-y03
Title=$50-60$, $80 < p_\perp < 110\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x01-y04
Title=$50-60$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{meas}\ [\text{GeV}^{-1}]$
# END PLOT
# BEGIN PLOT /ATLAS_2013_I1240088/d06-x02-y04
Title=$50-60$, $110 < p_\perp < 160\,\text{GeV}$
XLabel=$\Delta \phi$
YLabel=$1/N_\text{jet}\ \left.\frac{\text{d}^2 N_\text{jet}}{\text{d}p_\perp\,\text{d}\Delta\phi}\right|_\text{corr}\ [\text{GeV}^{-1}]$
# END PLOT
File Metadata
Details
Attached
Mime Type
text/x-diff
Expires
Tue, Nov 19, 8:07 PM (1 d, 5 h)
Storage Engine
blob
Storage Format
Raw Data
Storage Handle
3805973
Default Alt Text
(88 KB)
Attached To
rJEWELSVN jewelsvn
Event Timeline
Log In to Comment