diff --git a/analyses/pluginATLAS/ATLAS_2014_I1306615.cc b/analyses/pluginATLAS/ATLAS_2014_I1306615.cc --- a/analyses/pluginATLAS/ATLAS_2014_I1306615.cc +++ b/analyses/pluginATLAS/ATLAS_2014_I1306615.cc @@ -1,484 +1,484 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/DressedLeptons.hh" #include "Rivet/Projections/VetoedFinalState.hh" #include "Rivet/Projections/FastJets.hh" namespace Rivet { /// @brief ATLAS H->yy differential cross-sections measurement /// /// @author Michaela Queitsch-Maitland // // arXiv: http://arxiv.org/abs/ARXIV:1407.4222 // HepData: http://hepdata.cedar.ac.uk/view/ins1306615 class ATLAS_2014_I1306615 : public Analysis { public: // Constructor ATLAS_2014_I1306615() : Analysis("ATLAS_2014_I1306615") { } // Book histograms and initialise projections before the run void init() { // Final state // All particles within |eta| < 5.0 const FinalState FS(Cuts::abseta<5.0); declare(FS,"FS"); // Project photons with pT > 25 GeV and |eta| < 2.37 IdentifiedFinalState ph_FS(Cuts::abseta<2.37 && Cuts::pT>25.0*GeV); ph_FS.acceptIdPair(PID::PHOTON); declare(ph_FS, "PH_FS"); // Project photons for dressing IdentifiedFinalState ph_dressing_FS(FS); ph_dressing_FS.acceptIdPair(PID::PHOTON); // Project bare electrons IdentifiedFinalState el_bare_FS(FS); el_bare_FS.acceptIdPair(PID::ELECTRON); declare(el_bare_FS,"el_bare_FS"); // Project dressed electrons with pT > 15 GeV and |eta| < 2.47 DressedLeptons el_dressed_FS(ph_dressing_FS, el_bare_FS, 0.1, Cuts::abseta < 2.47 && Cuts::pT > 15*GeV); declare(el_dressed_FS,"EL_DRESSED_FS"); // Project bare muons IdentifiedFinalState mu_bare_FS(FS); mu_bare_FS.acceptIdPair(PID::MUON); // Project dressed muons with pT > 15 GeV and |eta| < 2.47 //DressedLeptons mu_dressed_FS(ph_dressing_FS, mu_bare_FS, 0.1, true, -2.47, 2.47, 15.0*GeV, false); DressedLeptons mu_dressed_FS(ph_dressing_FS, mu_bare_FS, 0.1, Cuts::abseta < 2.47 && Cuts::pT > 15*GeV); declare(mu_dressed_FS,"MU_DRESSED_FS"); // Final state excluding muons and neutrinos (for jet building and photon isolation) VetoedFinalState veto_mu_nu_FS(FS); veto_mu_nu_FS.vetoNeutrinos(); veto_mu_nu_FS.addVetoPairId(PID::MUON); declare(veto_mu_nu_FS, "VETO_MU_NU_FS"); // Build the anti-kT R=0.4 jets, using FinalState particles (vetoing muons and neutrinos) FastJets jets(veto_mu_nu_FS, FastJets::ANTIKT, 0.4); declare(jets, "JETS"); // Book histograms // 1D distributions book(_h_pT_yy ,1,1,1); book(_h_y_yy ,2,1,1); book(_h_Njets30 ,3,1,1); book(_h_Njets50 ,4,1,1); book(_h_pT_j1 ,5,1,1); book(_h_y_j1 ,6,1,1); book(_h_HT ,7,1,1); book(_h_pT_j2 ,8,1,1); book(_h_Dy_jj ,9,1,1); book(_h_Dphi_yy_jj ,10,1,1); book(_h_cosTS_CS ,11,1,1); book(_h_cosTS_CS_5bin ,12,1,1); book(_h_Dphi_jj ,13,1,1); book(_h_pTt_yy ,14,1,1); book(_h_Dy_yy ,15,1,1); book(_h_tau_jet ,16,1,1); book(_h_sum_tau_jet ,17,1,1); book(_h_y_j2 ,18,1,1); book(_h_pT_j3 ,19,1,1); book(_h_m_jj ,20,1,1); book(_h_pT_yy_jj ,21,1,1); // 2D distributions of cosTS_CS x pT_yy - book(_h_cosTS_pTyy_low ,22,1,1); - book(_h_cosTS_pTyy_high ,22,1,2); - book(_h_cosTS_pTyy_rest ,22,1,3); + book(_h_cosTS_pTyy_low, 22,1,1); + book(_h_cosTS_pTyy_high, 22,1,2); + book(_h_cosTS_pTyy_rest, 22,1,3); // 2D distributions of Njets x pT_yy - book(_h_pTyy_Njets0 ,23,1,1); - book(_h_pTyy_Njets1 ,23,1,2); - book(_h_pTyy_Njets2 ,23,1,3); + book(_h_pTyy_Njets0, 23,1,1); + book(_h_pTyy_Njets1, 23,1,2); + book(_h_pTyy_Njets2, 23,1,3); - book(_h_pTj1_excl ,24,1,1); + book(_h_pTj1_excl, 24,1,1); // Fiducial regions - book(_h_fidXSecs ,29,1,1); + book(_h_fidXSecs, 30,1,1); } // Perform the per-event analysis void analyze(const Event& event) { // Get final state particles const Particles& FS_ptcls = apply(event, "FS").particles(); const Particles& ptcls_veto_mu_nu = apply(event, "VETO_MU_NU_FS").particles(); const Particles& photons = apply(event, "PH_FS").particlesByPt(); const vector& el_dressed = apply(event, "EL_DRESSED_FS").dressedLeptons(); const vector& mu_dressed = apply(event, "MU_DRESSED_FS").dressedLeptons(); // For isolation calculation float dR_iso = 0.4; float ETcut_iso = 14.0; FourMomentum ET_iso; // Fiducial selection: pT > 25 GeV, |eta| < 2.37 and isolation (in cone deltaR = 0.4) is < 14 GeV vector fid_photons; for (const Particle& ph : photons) { // Veto photons from hadron or tau decay if ( fromHadronDecay(ph) ) continue; // Calculate isolation ET_iso = - ph.momentum(); // Loop over fs truth particles (excluding muons and neutrinos) for (const Particle& p : ptcls_veto_mu_nu) { // Check if the truth particle is in a cone of 0.4 if ( deltaR(ph.momentum(), p.momentum()) < dR_iso ) ET_iso += p.momentum(); } // Check isolation if ( ET_iso.Et() > ETcut_iso ) continue; // Fill vector of photons passing fiducial selection fid_photons.push_back(&ph); } if(fid_photons.size() < 2) vetoEvent; const FourMomentum& y1 = fid_photons[0]->momentum(); const FourMomentum& y2 = fid_photons[1]->momentum(); double m_yy = (y1 + y2).mass(); // Relative pT cuts if ( y1.pT() < 0.35 * m_yy || y2.pT() < 0.25 * m_yy ) vetoEvent; // Mass window cut if ( m_yy < 105 || m_yy > 160 ) vetoEvent; // -------------------------------------------- // // Passed diphoton baseline fiducial selection! // // -------------------------------------------- // // Electron selection vector good_el; for(const DressedLepton& els : el_dressed) { const Particle& el = els.constituentLepton(); if ( el.momentum().pT() < 15 ) continue; if ( fabs(el.momentum().eta()) > 2.47 ) continue; if ( deltaR(el.momentum(), y1) < 0.4 ) continue; if ( deltaR(el.momentum(), y2) < 0.4 ) continue; if ( fromHadronDecay(el) ) continue; // Veto electrons from hadron or tau decay good_el.push_back(&el); } // Muon selection vector good_mu; for(const DressedLepton& mus : mu_dressed) { const Particle& mu = mus.constituentLepton(); if ( mu.momentum().pT() < 15 ) continue; if ( fabs(mu.momentum().eta()) > 2.47 ) continue; if ( deltaR(mu.momentum(), y1) < 0.4 ) continue; if ( deltaR(mu.momentum(), y2) < 0.4 ) continue; if ( fromHadronDecay(mu) ) continue; // Veto muons from hadron or tau decay good_mu.push_back(&mu); } // Find prompt, invisible particles for missing ET calculation // Based on VisibleFinalState projection FourMomentum invisible(0,0,0,0); for (const Particle& p : FS_ptcls) { // Veto non-prompt particles (from hadron or tau decay) if ( fromHadronDecay(p) ) continue; // Charged particles are visible if ( PID::charge3( p.pid() ) != 0 ) continue; // Neutral hadrons are visible if ( PID::isHadron( p.pid() ) ) continue; // Photons are visible if ( p.pid() == PID::PHOTON ) continue; // Gluons are visible (for parton level analyses) if ( p.pid() == PID::GLUON ) continue; // Everything else is invisible invisible += p.momentum(); } double MET = invisible.Et(); // Jet selection // Get jets with pT > 25 GeV and |rapidity| < 4.4 //const Jets& jets = apply(event, "JETS").jetsByPt(25.0*GeV, DBL_MAX, -4.4, 4.4, RAPIDITY); const Jets& jets = apply(event, "JETS").jetsByPt(Cuts::pT>25.0*GeV && Cuts::absrap <4.4); vector jets_25; vector jets_30; vector jets_50; for (const Jet& jet : jets) { bool passOverlap = true; // Overlap with leading photons if ( deltaR(y1, jet.momentum()) < 0.4 ) passOverlap = false; if ( deltaR(y2, jet.momentum()) < 0.4 ) passOverlap = false; // Overlap with good electrons for (const Particle* el : good_el) if ( deltaR(el->momentum(), jet.momentum()) < 0.2 ) passOverlap = false; if ( ! passOverlap ) continue; if ( fabs(jet.momentum().eta()) < 2.4 || ( fabs(jet.momentum().eta()) > 2.4 && jet.momentum().pT() > 30 ) ) jets_25.push_back(&jet); if ( jet.momentum().pT() > 30 ) jets_30.push_back(&jet); if ( jet.momentum().pT() > 50 ) jets_50.push_back(&jet); } // Fiducial regions _h_fidXSecs->fill(1); if ( jets_30.size() >= 1 ) _h_fidXSecs->fill(2); if ( jets_30.size() >= 2 ) _h_fidXSecs->fill(3); if ( jets_30.size() >= 3 ) _h_fidXSecs->fill(4); if ( jets_30.size() >= 2 && passVBFCuts(y1 + y2, jets_30.at(0)->momentum(), jets_30.at(1)->momentum()) ) _h_fidXSecs->fill(5); if ( (good_el.size() + good_mu.size()) > 0 ) _h_fidXSecs->fill(6); if ( MET > 80 ) _h_fidXSecs->fill(7); // Fill histograms // Inclusive variables _pT_yy = (y1 + y2).pT(); _y_yy = fabs( (y1 + y2).rapidity() ); _cosTS_CS = cosTS_CS(y1, y2); _pTt_yy = pTt(y1, y2); _Dy_yy = fabs( deltaRap(y1, y2) ); _Njets30 = jets_30.size() > 3 ? 3 : jets_30.size(); _Njets50 = jets_50.size() > 3 ? 3 : jets_50.size(); _h_Njets30->fill(_Njets30); _h_Njets50->fill(_Njets50); _pT_j1 = jets_30.size() > 0 ? jets_30.at(0)->momentum().pT() : 0.; _pT_j2 = jets_30.size() > 1 ? jets_30.at(1)->momentum().pT() : 0.; _pT_j3 = jets_30.size() > 2 ? jets_30.at(2)->momentum().pT() : 0.; _HT = 0.0; for (const Jet* jet : jets_30) _HT += jet->momentum().pT(); _tau_jet = tau_jet_max(y1 + y2, jets_25); _sum_tau_jet = sum_tau_jet(y1 + y2, jets_25); _h_pT_yy ->fill(_pT_yy); _h_y_yy ->fill(_y_yy); _h_pT_j1 ->fill(_pT_j1); _h_cosTS_CS ->fill(_cosTS_CS); _h_cosTS_CS_5bin->fill(_cosTS_CS); _h_HT ->fill(_HT); _h_pTt_yy ->fill(_pTt_yy); _h_Dy_yy ->fill(_Dy_yy); _h_tau_jet ->fill(_tau_jet); _h_sum_tau_jet ->fill(_sum_tau_jet); // >=1 jet variables if ( jets_30.size() >= 1 ) { FourMomentum j1 = jets_30[0]->momentum(); _y_j1 = fabs( j1.rapidity() ); _h_pT_j2->fill(_pT_j2); _h_y_j1 ->fill(_y_j1); } // >=2 jet variables if ( jets_30.size() >= 2 ) { FourMomentum j1 = jets_30[0]->momentum(); FourMomentum j2 = jets_30[1]->momentum(); _Dy_jj = fabs( deltaRap(j1, j2) ); _Dphi_jj = fabs( deltaPhi(j1, j2) ); _Dphi_yy_jj = fabs( deltaPhi(y1 + y2, j1 + j2) ); _m_jj = (j1 + j2).mass(); _pT_yy_jj = (y1 + y2 + j1 + j2).pT(); _y_j2 = fabs( j2.rapidity() ); _h_Dy_jj ->fill(_Dy_jj); _h_Dphi_jj ->fill(_Dphi_jj); _h_Dphi_yy_jj ->fill(_Dphi_yy_jj); _h_m_jj ->fill(_m_jj); _h_pT_yy_jj ->fill(_pT_yy_jj); _h_pT_j3 ->fill(_pT_j3); _h_y_j2 ->fill(_y_j2); } // 2D distributions of cosTS_CS x pT_yy if ( _pT_yy < 80 ) _h_cosTS_pTyy_low->fill(_cosTS_CS); else if ( _pT_yy > 80 && _pT_yy < 200 ) _h_cosTS_pTyy_high->fill(_cosTS_CS); else if ( _pT_yy > 200 ) _h_cosTS_pTyy_rest->fill(_cosTS_CS); // 2D distributions of pT_yy x Njets if ( _Njets30 == 0 ) _h_pTyy_Njets0->fill(_pT_yy); else if ( _Njets30 == 1 ) _h_pTyy_Njets1->fill(_pT_yy); else if ( _Njets30 >= 2 ) _h_pTyy_Njets2->fill(_pT_yy); if ( _Njets30 == 1 ) _h_pTj1_excl->fill(_pT_j1); } // Normalise histograms after the run void finalize() { const double xs = crossSectionPerEvent()/femtobarn; scale(_h_pT_yy, xs); scale(_h_y_yy, xs); scale(_h_pT_j1, xs); scale(_h_y_j1, xs); scale(_h_HT, xs); scale(_h_pT_j2, xs); scale(_h_Dy_jj, xs); scale(_h_Dphi_yy_jj, xs); scale(_h_cosTS_CS, xs); scale(_h_cosTS_CS_5bin, xs); scale(_h_Dphi_jj, xs); scale(_h_pTt_yy, xs); scale(_h_Dy_yy, xs); scale(_h_tau_jet, xs); scale(_h_sum_tau_jet, xs); scale(_h_y_j2, xs); scale(_h_pT_j3, xs); scale(_h_m_jj, xs); scale(_h_pT_yy_jj, xs); scale(_h_cosTS_pTyy_low, xs); scale(_h_cosTS_pTyy_high, xs); scale(_h_cosTS_pTyy_rest, xs); scale(_h_pTyy_Njets0, xs); scale(_h_pTyy_Njets1, xs); scale(_h_pTyy_Njets2, xs); scale(_h_pTj1_excl, xs); scale(_h_Njets30, xs); scale(_h_Njets50, xs); scale(_h_fidXSecs, xs); } // Trace event record to see if particle came from a hadron (or a tau from a hadron decay) // Based on fromDecay() function bool fromHadronDecay(const Particle& p ) { const GenParticle * gp = p.genParticle(); if (!gp) return false; /// TODO: something weird to make this necessary const GenVertex* prodVtx = p.genParticle()->production_vertex(); if (prodVtx == NULL) return false; for (const GenParticle* ancestor : particles(prodVtx, HepMC::ancestors)) { const PdgId pid = ancestor->pdg_id(); if (ancestor->status() == 2 && PID::isHadron(pid)) return true; if (ancestor->status() == 2 && (abs(pid) == PID::TAU && fromHadronDecay(ancestor))) return true; } return false; } // VBF-enhanced dijet topology selection cuts bool passVBFCuts(const FourMomentum &H, const FourMomentum &j1, const FourMomentum &j2) { return ( fabs(deltaRap(j1, j2)) > 2.8 && (j1 + j2).mass() > 400 && fabs(deltaPhi(H, j1 + j2)) > 2.6 ); } // Cosine of the decay angle in the Collins-Soper frame double cosTS_CS(const FourMomentum &y1, const FourMomentum &y2) { return fabs( ( (y1.E() + y1.pz())* (y2.E() - y2.pz()) - (y1.E() - y1.pz()) * (y2.E() + y2.pz()) ) / ((y1 + y2).mass() * sqrt(pow((y1 + y2).mass(), 2) + pow((y1 + y2).pt(), 2)) ) ); } // Diphoton pT along thrust axis double pTt(const FourMomentum &y1, const FourMomentum &y2) { return fabs(y1.px() * y2.py() - y2.px() * y1.py()) / (y1 - y2).pT()*2; } // Tau of jet (see paper for description) // tau_jet = mT/(2*cosh(y*)), where mT = pT (+) m, and y* = rapidty in Higgs rest frame double tau_jet( const FourMomentum &H, const FourMomentum &jet ) { return sqrt( pow(jet.pT(),2) + pow(jet.mass(),2) ) / (2.0 * cosh( jet.rapidity() - H.rapidity() ) ); } // Maximal (leading) tau_jet (see paper for description) double tau_jet_max( const FourMomentum &H, const vector jets, double tau_jet_cut = 8. ) { double max_tj = 0; for (size_t i=0; i < jets.size(); ++i) { FourMomentum jet = jets[i]->momentum(); if ( tau_jet(H, jet) > tau_jet_cut ) max_tj = max( tau_jet(H, jet), max_tj ); } return max_tj; } // Scalar sum of tau for all jets (see paper for description) double sum_tau_jet( const FourMomentum &H, const vector jets, double tau_jet_cut = 8. ) { double sum_tj = 0; for (size_t i=0; i < jets.size(); ++i) { FourMomentum jet = jets[i]->momentum(); if ( tau_jet(H, jet) > tau_jet_cut ) sum_tj += tau_jet(H, jet); } return sum_tj; } private: Histo1DPtr _h_pT_yy; Histo1DPtr _h_y_yy; Histo1DPtr _h_Njets30; Histo1DPtr _h_Njets50; Histo1DPtr _h_pT_j1; Histo1DPtr _h_y_j1; Histo1DPtr _h_HT; Histo1DPtr _h_pT_j2; Histo1DPtr _h_Dy_jj; Histo1DPtr _h_Dphi_yy_jj; Histo1DPtr _h_cosTS_CS; Histo1DPtr _h_cosTS_CS_5bin; Histo1DPtr _h_Dphi_jj; Histo1DPtr _h_pTt_yy; Histo1DPtr _h_Dy_yy; Histo1DPtr _h_tau_jet; Histo1DPtr _h_sum_tau_jet; Histo1DPtr _h_y_j2; Histo1DPtr _h_pT_j3; Histo1DPtr _h_m_jj; Histo1DPtr _h_pT_yy_jj; Histo1DPtr _h_cosTS_pTyy_low; Histo1DPtr _h_cosTS_pTyy_high; Histo1DPtr _h_cosTS_pTyy_rest; Histo1DPtr _h_pTyy_Njets0; Histo1DPtr _h_pTyy_Njets1; Histo1DPtr _h_pTyy_Njets2; Histo1DPtr _h_pTj1_excl; Histo1DPtr _h_fidXSecs; int _Njets30; int _Njets50; double _pT_yy; double _y_yy; double _cosTS_CS; double _pT_j1; double _m_jj; double _y_j1; double _HT; double _pT_j2; double _y_j2; double _Dphi_yy_jj; double _pT_yy_jj; double _Dphi_jj; double _Dy_jj; double _pT_j3; double _pTt_yy; double _Dy_yy; double _tau_jet; double _sum_tau_jet; }; // The hook for the plugin system DECLARE_RIVET_PLUGIN(ATLAS_2014_I1306615); } diff --git a/analyses/pluginATLAS/ATLAS_2014_I1306615.plot b/analyses/pluginATLAS/ATLAS_2014_I1306615.plot --- a/analyses/pluginATLAS/ATLAS_2014_I1306615.plot +++ b/analyses/pluginATLAS/ATLAS_2014_I1306615.plot @@ -1,208 +1,210 @@ # BEGIN PLOT /ATLAS_2014_I1306615/.* RatioPlotYMin=0.0 RatioPlotYMax=2.49999 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d01-x01-y01 Title=Diphoton transverse momentum XLabel=$p_T^{\gamma\gamma}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d02-x01-y01 Title=Diphoton rapidity XLabel=$|y_{\gamma\gamma}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |y_{\gamma\gamma}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d03-x01-y01 Title=Number of jets, $p_{T}^{jet} > 30$ GeV XLabel=$N_{jets}$ YLabel=$\sigma_{\mathrm{fid}}$ [fb] LogY=0 +XCustomMajorTicks=1.0 $0$ 2.0 $1$ 3.0 $2$ 4.0 $\geq 3$ # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d04-x01-y01 Title=Number of jets, $p_{T}^{jet} > 50$ GeV XLabel=$N_{jets}$ YLabel=$\sigma_{\mathrm{fid}}$ [fb] +XCustomMajorTicks=1.0 $0$ 2.0 $1$ 3.0 $2$ 4.0 $\geq 3$ LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d05-x01-y01 Title=Leading jet $p_{T}$, $N_{jets} \ge 0$ XLabel=$p_{T}^{j1}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d06-x01-y01 Title=Leading jet rapidity, $N_{jets} \ge 1$, $p_T^{jet} > 30$ GeV XLabel=$|y_{j1}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |y|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d07-x01-y01 Title=Scalar sum of jet transverse momenta, $N_{jets} \ge 0$ XLabel=$H_T$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} H_T$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d08-x01-y01 Title=Subleading jet $p_{T}$, $N_{jets} \ge 1$ XLabel=$p_{T}^{j2}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d09-x01-y01 Title=Dijet rapidity separation, $N_{jets} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$|\Delta y_{jj}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\Delta y_{jj}|$ [fb] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d10-x01-y01 Title=$\Delta \phi$ between dijet and diphoton systems, $N_{jets} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$|\Delta \phi_{\gamma\gamma - jj}|$ [rad] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\Delta \phi_{\gamma\gamma - jj}|$ [fb/rad] LogY=1 #LogX=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d11-x01-y01 Title=Photon decay angle in the Collins-Soper frame XLabel=$|\cos \theta^{*}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\cos \theta^{*}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d12-x01-y01 Title=Photon decay angle in the Collins-Soper frame XLabel=$|\cos \theta^{*}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\cos \theta^{*}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d13-x01-y01 Title=Azimuthal angle between the leading jets, $N_{jets} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$|\Delta \phi_{jj}|$ [rad] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\Delta \phi_{jj}|$ [fb/rad] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d14-x01-y01 Title=Diphoton momentum perpendicular to the diphoton thrust axis XLabel=$p_{Tt}^{\gamma\gamma}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_{Tt}^{\gamma\gamma}$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d15-x01-y01 Title=Rapidity separation between the two photons XLabel=$|\Delta y_{\gamma\gamma}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\Delta y_{\gamma\gamma}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d16-x01-y01 Title=Beam-thrust-like variable for leading jet, $N_{jet} \ge 0$,$p_T^{jet} > 25$ GeV XLabel=$\tau_{1}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} \tau_1$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d17-x01-y01 Title=Sum of beam-thrust-like variables for jets, $N_{jet} \ge 0$,$p_T^{jet} > 25$ GeV XLabel=$\sum \tau_{i}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} \sum \tau_{i}$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d18-x01-y01 Title=Subleading jet rapidity, $N_{jet} \ge 2$,$p_T^{jet} > 30$ GeV XLabel=$|y_{j2}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |y_{j2}| $ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d19-x01-y01 Title=Third-leading jet transverse momentum, $N_{jet} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$|p_T^{j3}|$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{j3}| $ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d20-x01-y01 Title=Dijet invariant mass, $N_{jet} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$m_{jj}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} m_{jj}$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d21-x01-y01 Title=$p_T$ of diphoton-dijet system, $N_{jet} \ge 2$, $p_T^{jet} > 30$ GeV XLabel=$p_T^{\gamma\gamma jj}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{\gamma\gamma jj}$ [fb/GeV] LogY=1 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d22-x01-y01 Title=Photon decay angle in the Collins-Soper frame,$p_T^{\gamma\gamma}< 80$ GeV XLabel=$|\cos \theta^{*}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\cos \theta^{*}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d22-x01-y02 Title=Photon decay angle in the Collins-Soper frame, $80 < p_T^{\gamma\gamma}< 200$ GeV XLabel=$|\cos \theta^{*}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\cos \theta^{*}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d22-x01-y03 Title=Photon decay angle in the Collins-Soper frame, $p_T^{\gamma\gamma} > 200$ GeV XLabel=$|\cos \theta^{*}|$ YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} |\cos \theta^{*}|$ [fb] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d23-x01-y01 Title=Diphoton transverse momentum, $N_{jet} = 0$ XLabel=$p_T^{\gamma\gamma}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{\gamma\gamma}$ [fb/GeV] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d23-x01-y02 Title=Diphoton transverse momentum, $N_{jet} = 1$ XLabel=$p_T^{\gamma\gamma}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{\gamma\gamma}$ [fb/GeV] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d23-x01-y03 Title=Diphoton transverse momentum, $N_{jet} \ge 2$ XLabel=$p_T^{\gamma\gamma}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{\gamma\gamma}$ [fb/GeV] LogY=0 # END PLOT # BEGIN PLOT /ATLAS_2014_I1306615/d24-x01-y01 Title=Leading jet transverse momentum, $N_{jet} = 1$ XLabel=$p_T^{j1}$ [GeV] YLabel=$\mathrm{d}\sigma_{\mathrm{fid}} / \mathrm{d} p_T^{j1}$ [fb/GeV] LogY=0 # END PLOT -# BEGIN PLOT /ATLAS_2014_I1306615/d29-x01-y01 +# BEGIN PLOT /ATLAS_2014_I1306615/d30-x01-y01 Title=Baseline, $N_{jets} \ge 1, 2, 3$, VBF, $N_{lep} \ge 1$, $E_T^{miss} \ge 80$ GeV regions XLabel=region ID YLabel=$\sigma_{\mathrm{fid}}$ [fb] LogY=1 # END PLOT diff --git a/analyses/pluginATLAS/ATLAS_2014_I1306615.yoda b/analyses/pluginATLAS/ATLAS_2014_I1306615.yoda --- a/analyses/pluginATLAS/ATLAS_2014_I1306615.yoda +++ b/analyses/pluginATLAS/ATLAS_2014_I1306615.yoda @@ -1,391 +1,1647 @@ BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d01-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d01-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t1 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+01 1.000000e+01 1.000000e+01 7.300000e-02 3.130910e-01 3.130958e-01 2.500000e+01 5.000000e+00 5.000000e+00 1.315000e+00 4.095375e-01 4.107664e-01 3.500000e+01 5.000000e+00 5.000000e+00 6.820000e-01 3.263633e-01 3.270138e-01 4.500000e+01 5.000000e+00 5.000000e+00 7.880000e-01 2.770740e-01 2.782409e-01 5.500000e+01 5.000000e+00 5.000000e+00 3.790000e-01 2.286395e-01 2.290589e-01 7.000000e+01 1.000000e+01 1.000000e+01 2.530000e-01 1.244910e-01 1.248119e-01 9.000000e+01 1.000000e+01 1.000000e+01 1.797000e-01 8.660947e-02 8.682742e-02 1.500000e+02 5.000000e+01 5.000000e+01 1.930000e-02 1.562050e-02 1.563170e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d02-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d02-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t2 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e-01 1.500000e-01 1.500000e-01 2.370000e+01 1.109414e+01 1.109279e+01 4.500000e-01 1.500000e-01 1.500000e-01 2.540000e+01 1.141534e+01 1.141184e+01 7.500000e-01 1.500000e-01 1.500000e-01 1.340000e+01 1.243423e+01 1.243423e+01 1.050000e+00 1.500000e-01 1.500000e-01 3.050000e+01 1.477972e+01 1.477972e+01 1.400000e+00 2.000000e-01 2.000000e-01 2.860000e+01 1.292710e+01 1.292710e+01 2.000000e+00 4.000000e-01 4.000000e-01 7.860000e+00 5.588291e+00 5.588291e+00 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d03-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d03-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t3 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -0.000000e+00 5.000000e-01 5.000000e-01 2.188000e+01 8.231725e+00 8.267418e+00 -1.000000e+00 5.000000e-01 5.000000e-01 1.233000e+01 4.718506e+00 4.765658e+00 -2.000000e+00 5.000000e-01 5.000000e-01 5.190000e+00 2.497579e+00 2.498019e+00 -3.000000e+00 5.000000e-01 5.000000e-01 3.990000e+00 1.484015e+00 1.512052e+00 +1.000000e+00 5.000000e-01 5.000000e-01 2.188000e+01 8.231725e+00 8.267418e+00 +2.000000e+00 5.000000e-01 5.000000e-01 1.233000e+01 4.718506e+00 4.765658e+00 +3.000000e+00 5.000000e-01 5.000000e-01 5.190000e+00 2.497579e+00 2.498019e+00 +4.000000e+00 5.000000e-01 5.000000e-01 3.990000e+00 1.484015e+00 1.512052e+00 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d04-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d04-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t4 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ -0.000000e+00 5.000000e-01 5.000000e-01 3.067000e+01 8.896556e+00 8.960011e+00 -1.000000e+00 5.000000e-01 5.000000e-01 7.780000e+00 4.720551e+00 4.727420e+00 -2.000000e+00 5.000000e-01 5.000000e-01 3.770000e+00 1.785609e+00 1.786449e+00 -3.000000e+00 5.000000e-01 5.000000e-01 1.652000e+00 7.503632e-01 7.505291e-01 +1.000000e+00 5.000000e-01 5.000000e-01 3.067000e+01 8.896556e+00 8.960011e+00 +2.000000e+00 5.000000e-01 5.000000e-01 7.780000e+00 4.720551e+00 4.727420e+00 +3.000000e+00 5.000000e-01 5.000000e-01 3.770000e+00 1.785609e+00 1.786449e+00 +4.000000e+00 5.000000e-01 5.000000e-01 1.652000e+00 7.503632e-01 7.505291e-01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d05-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d05-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t5 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e+01 1.500000e+01 1.500000e+01 7.280000e-01 2.725106e-01 2.737499e-01 4.000000e+01 1.000000e+01 1.000000e+01 3.930000e-01 1.852944e-01 1.872752e-01 6.000000e+01 1.000000e+01 1.000000e+01 1.150000e-01 1.294952e-01 1.295839e-01 8.500000e+01 1.500000e+01 1.500000e+01 1.383000e-01 7.338835e-02 7.332435e-02 1.200000e+02 2.000000e+01 2.000000e+01 7.060000e-02 3.621105e-02 3.624583e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d06-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d06-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t6 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e-01 5.000000e-01 5.000000e-01 1.104000e+01 3.731340e+00 3.762340e+00 1.500000e+00 5.000000e-01 5.000000e-01 5.930000e+00 3.090971e+00 3.102322e+00 2.500000e+00 5.000000e-01 5.000000e-01 3.030000e+00 2.090981e+00 2.095280e+00 3.700000e+00 7.000000e-01 7.000000e-01 8.340000e-01 8.343596e-01 8.368518e-01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d07-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d07-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t7 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e+01 1.500000e+01 1.500000e+01 7.230000e-01 2.727031e-01 2.738960e-01 4.000000e+01 1.000000e+01 1.000000e+01 3.530000e-01 1.745766e-01 1.764370e-01 6.000000e+01 1.000000e+01 1.000000e+01 1.320000e-01 1.145469e-01 1.147432e-01 1.100000e+02 4.000000e+01 4.000000e+01 4.160000e-02 3.550606e-02 3.551000e-02 2.000000e+02 5.000000e+01 5.000000e+01 4.960000e-02 1.583003e-02 1.584298e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d08-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d08-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t8 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e+01 1.500000e+01 1.500000e+01 3.850000e-01 1.556792e-01 1.569745e-01 4.000000e+01 1.000000e+01 1.000000e+01 1.990000e-01 1.117318e-01 1.118079e-01 6.000000e+01 1.000000e+01 1.000000e+01 1.081000e-01 6.347803e-02 6.341932e-02 1.050000e+02 3.500000e+01 3.500000e+01 4.360000e-02 1.642315e-02 1.652786e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d09-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d09-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t9 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+00 1.000000e+00 1.000000e+00 2.830000e+00 1.171580e+00 1.177455e+00 3.000000e+00 1.000000e+00 1.000000e+00 1.313000e+00 7.480394e-01 7.474015e-01 4.750000e+00 7.500000e-01 7.500000e-01 6.710000e-01 4.025966e-01 4.024562e-01 7.150000e+00 1.650000e+00 1.650000e+00 7.030000e-02 7.447852e-02 7.458780e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d10-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d10-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t10 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.300000e+00 1.300000e+00 1.300000e+00 1.093000e+00 5.677667e-01 5.903778e-01 2.750000e+00 1.500000e-01 1.500000e-01 6.600000e+00 4.473153e+00 4.467773e+00 3.000000e+00 1.000000e-01 1.000000e-01 8.000000e+00 8.263801e+00 8.260617e+00 3.120000e+00 2.000000e-02 2.000000e-02 4.540000e+01 2.528003e+01 2.538169e+01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d11-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d11-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t11 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e-02 5.000000e-02 5.000000e-02 3.300000e+01 2.910172e+01 2.914979e+01 1.500000e-01 5.000000e-02 5.000000e-02 4.400000e+01 2.987658e+01 2.999833e+01 2.500000e-01 5.000000e-02 5.000000e-02 9.190000e+01 3.153696e+01 3.196029e+01 3.500000e-01 5.000000e-02 5.000000e-02 4.470000e+01 3.118124e+01 3.128690e+01 4.500000e-01 5.000000e-02 5.000000e-02 8.400000e+00 3.261855e+01 3.261901e+01 5.500000e-01 5.000000e-02 5.000000e-02 6.950000e+01 3.601014e+01 3.599750e+01 6.500000e-01 5.000000e-02 5.000000e-02 2.610000e+01 3.953998e+01 3.953694e+01 7.500000e-01 5.000000e-02 5.000000e-02 9.100000e+01 4.020075e+01 4.017835e+01 8.500000e-01 5.000000e-02 5.000000e-02 1.950000e+01 1.473058e+01 1.472888e+01 9.500000e-01 5.000000e-02 5.000000e-02 1.700000e+01 1.200542e+01 1.200042e+01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d12-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d12-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t12 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e-01 1.000000e-01 1.000000e-01 3.850000e+01 2.942975e+01 2.951118e+01 3.000000e-01 1.000000e-01 1.000000e-01 6.830000e+01 3.132890e+01 3.156058e+01 5.000000e-01 1.000000e-01 1.000000e-01 3.890000e+01 3.421082e+01 3.420614e+01 7.000000e-01 1.000000e-01 1.000000e-01 5.850000e+01 3.981583e+01 3.980678e+01 9.000000e-01 1.000000e-01 1.000000e-01 1.820000e+01 1.332029e+01 1.331578e+01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d13-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d13-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t13 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.250000e-01 5.250000e-01 5.250000e-01 1.930000e+00 1.074895e+00 1.075407e+00 1.570000e+00 5.200000e-01 5.200000e-01 1.250000e+00 1.284484e+00 1.285107e+00 2.355000e+00 2.650000e-01 2.650000e-01 2.160000e+00 2.590811e+00 2.592277e+00 2.880000e+00 2.600000e-01 2.600000e-01 9.580000e+00 3.430248e+00 3.498657e+00 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d14-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d14-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t14 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e+00 5.000000e+00 5.000000e+00 4.400000e-01 6.470464e-01 6.472078e-01 1.500000e+01 5.000000e+00 5.000000e+00 1.597000e+00 4.741930e-01 4.763266e-01 2.500000e+01 5.000000e+00 5.000000e+00 6.520000e-01 3.381568e-01 3.388348e-01 3.500000e+01 5.000000e+00 5.000000e+00 5.690000e-01 2.663907e-01 2.668782e-01 5.000000e+01 1.000000e+01 1.000000e+01 8.700000e-02 1.334316e-01 1.334616e-01 7.000000e+01 1.000000e+01 1.000000e+01 3.504000e-01 1.007083e-01 1.010034e-01 1.150000e+02 3.500000e+01 3.500000e+01 3.400000e-03 1.753112e-02 1.753140e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d15-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d15-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t15 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e-01 1.500000e-01 1.500000e-01 2.090000e+01 1.183512e+01 1.188444e+01 4.500000e-01 1.500000e-01 1.500000e-01 3.080000e+01 1.229675e+01 1.242618e+01 7.500000e-01 1.500000e-01 1.500000e-01 1.640000e+01 1.186971e+01 1.190336e+01 1.050000e+00 1.500000e-01 1.500000e-01 1.930000e+01 1.222047e+01 1.221720e+01 1.350000e+00 1.500000e-01 1.500000e-01 1.180000e+01 1.230528e+01 1.230528e+01 1.750000e+00 2.500000e-01 2.500000e-01 2.209000e+01 1.005372e+01 1.004492e+01 2.275000e+00 2.750000e-01 2.750000e-01 7.200000e+00 4.830248e+00 4.833560e+00 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d16-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d16-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t16 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 4.000000e+00 4.000000e+00 4.000000e+00 3.430000e+00 1.068878e+00 1.048523e+00 1.200000e+01 4.000000e+00 4.000000e+00 5.290000e-01 3.936369e-01 3.953568e-01 2.300000e+01 7.000000e+00 7.000000e+00 4.560000e-01 2.301825e-01 2.309459e-01 4.250000e+01 1.250000e+01 1.250000e+01 5.080000e-02 7.885563e-02 7.886526e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d17-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d17-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t17 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 4.000000e+00 4.000000e+00 4.000000e+00 3.440000e+00 1.078332e+00 1.058159e+00 1.200000e+01 4.000000e+00 4.000000e+00 4.050000e-01 3.745077e-01 3.757632e-01 2.300000e+01 7.000000e+00 7.000000e+00 3.570000e-01 2.135743e-01 2.143548e-01 4.250000e+01 1.250000e+01 1.250000e+01 1.187000e-01 8.971148e-02 8.969877e-02 1.025000e+02 4.750000e+01 4.750000e+01 4.170000e-02 1.637529e-02 1.646026e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d18-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d18-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t18 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e-01 5.000000e-01 5.000000e-01 3.700000e+00 1.894281e+00 1.894307e+00 1.500000e+00 5.000000e-01 5.000000e-01 2.480000e+00 1.598624e+00 1.603216e+00 2.500000e+00 5.000000e-01 5.000000e-01 1.860000e+00 1.182497e+00 1.181482e+00 3.700000e+00 7.000000e-01 7.000000e-01 9.880000e-01 5.247876e-01 5.263611e-01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d19-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d19-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t19 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e+01 1.500000e+01 1.500000e+01 1.704000e-01 8.364724e-02 8.367903e-02 4.000000e+01 1.000000e+01 1.000000e+01 8.830000e-02 5.519556e-02 5.558975e-02 1.000000e+02 5.000000e+01 5.000000e+01 1.350000e-02 7.014285e-03 7.015219e-03 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d20-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d20-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t20 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+02 1.000000e+02 1.000000e+02 1.550000e-02 1.113373e-02 1.114675e-02 3.000000e+02 1.000000e+02 1.000000e+02 2.160000e-02 7.562248e-03 7.548192e-03 5.250000e+02 1.250000e+02 1.250000e+02 6.300000e-03 3.024913e-03 3.033974e-03 8.250000e+02 1.750000e+02 1.750000e+02 1.400000e-03 1.107700e-03 1.108918e-03 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d21-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d21-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t21 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.500000e+01 1.500000e+01 1.500000e+01 1.325000e-01 7.893377e-02 7.926153e-02 4.250000e+01 1.250000e+01 1.250000e+01 6.340000e-02 5.775664e-02 5.763896e-02 6.750000e+01 1.250000e+01 1.250000e+01 1.050000e-01 4.352976e-02 4.371693e-02 1.100000e+02 3.000000e+01 3.000000e+01 8.000000e-03 8.980913e-03 9.003921e-03 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d22-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d22-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t22 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.250000e-01 1.250000e-01 1.250000e-01 3.070000e+01 1.806599e+01 1.814332e+01 3.750000e-01 1.250000e-01 1.250000e-01 4.110000e+01 1.994091e+01 2.000925e+01 6.250000e-01 1.250000e-01 1.250000e-01 6.120000e+01 2.425387e+01 2.423510e+01 8.750000e-01 1.250000e-01 1.250000e-01 2.070000e+01 1.220492e+01 1.220860e+01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d22-x01-y02 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d22-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t22 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.250000e-01 1.250000e-01 1.250000e-01 4.640000e+00 5.437683e+00 5.444741e+00 3.750000e-01 1.250000e-01 1.250000e-01 7.280000e+00 4.380925e+00 4.396453e+00 6.250000e-01 1.250000e-01 1.250000e-01 2.300000e-01 3.667860e+00 3.667860e+00 8.750000e-01 1.250000e-01 1.250000e-01 7.930000e+00 5.119590e+00 5.121308e+00 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d22-x01-y03 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d22-x01-y03 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t22 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 5.000000e-01 5.000000e-01 5.000000e-01 4.650000e-01 3.932862e-01 3.934730e-01 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d23-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d23-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t23 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.500000e+01 2.500000e+01 2.500000e+01 4.010000e-01 1.617096e-01 1.623022e-01 1.250000e+02 7.500000e+01 7.500000e+01 1.280000e-02 8.195859e-03 8.242184e-03 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d23-x01-y02 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d23-x01-y02 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t23 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.500000e+01 2.500000e+01 2.500000e+01 1.036000e-01 6.265740e-02 6.316653e-02 7.500000e+01 2.500000e+01 2.500000e+01 9.820000e-02 6.280565e-02 6.290119e-02 1.500000e+02 5.000000e+01 5.000000e+01 7.300000e-03 1.120491e-02 1.120580e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d23-x01-y03 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d23-x01-y03 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t23 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.500000e+01 2.500000e+01 2.500000e+01 4.570000e-02 3.248661e-02 3.300030e-02 7.500000e+01 2.500000e+01 2.500000e+01 8.790000e-02 3.598903e-02 3.620483e-02 1.500000e+02 5.000000e+01 5.000000e+01 1.080000e-02 1.079861e-02 1.080185e-02 END YODA_SCATTER2D_V2 - BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d24-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d24-x01-y01 -Title: ~ +Title: doi:10.17182/hepdata.65179.v2/t24 Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 4.000000e+01 1.000000e+01 1.000000e+01 3.580000e-01 1.741695e-01 1.761846e-01 9.500000e+01 4.500000e+01 4.500000e+01 3.070000e-02 3.233589e-02 3.235058e-02 END YODA_SCATTER2D_V2 - -BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d29-x01-y01 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y01 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 6.260000e+01 9.000000e-01 9.000000e-01 +2.000000e+00 5.000000e-01 5.000000e-01 6.110000e+01 7.000000e-01 7.000000e-01 +3.000000e+00 5.000000e-01 5.000000e-01 6.190000e+01 6.000000e-01 6.000000e-01 +4.000000e+00 5.000000e-01 5.000000e-01 6.380000e+01 6.000000e-01 6.000000e-01 +5.000000e+00 5.000000e-01 5.000000e-01 5.500000e+01 5.000000e-01 5.000000e-01 +6.000000e+00 5.000000e-01 5.000000e-01 6.120000e+01 6.000000e-01 6.000000e-01 +7.000000e+00 5.000000e-01 5.000000e-01 6.360000e+01 1.000000e+00 1.000000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 6.290000e+01 9.000000e-01 9.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 6.150000e+01 6.000000e-01 6.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 6.110000e+01 5.000000e-01 5.000000e-01 +1.100000e+01 5.000000e-01 5.000000e-01 6.080000e+01 7.000000e-01 7.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 6.100000e+01 6.000000e-01 6.000000e-01 +1.300000e+01 5.000000e-01 5.000000e-01 6.210000e+01 6.000000e-01 6.000000e-01 +1.400000e+01 5.000000e-01 5.000000e-01 5.440000e+01 5.000000e-01 5.000000e-01 +1.500000e+01 5.000000e-01 5.000000e-01 6.030000e+01 6.000000e-01 6.000000e-01 +1.600000e+01 5.000000e-01 5.000000e-01 5.750000e+01 6.000000e-01 6.000000e-01 +1.700000e+01 5.000000e-01 5.000000e-01 5.950000e+01 1.000000e+00 1.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 6.300000e+01 1.000000e+00 1.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 6.360000e+01 1.000000e+00 1.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 6.360000e+01 1.000000e+00 1.000000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 7.390000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.210000e+01 1.100000e+00 1.100000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y02 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 6.220000e+01 6.000000e-01 6.000000e-01 +7.000000e+00 5.000000e-01 5.000000e-01 6.080000e+01 7.000000e-01 7.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 6.070000e+01 6.000000e-01 6.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 6.150000e+01 7.000000e-01 7.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 6.160000e+01 6.000000e-01 6.000000e-01 +1.100000e+01 5.000000e-01 5.000000e-01 6.010000e+01 6.000000e-01 6.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 6.270000e+01 6.000000e-01 6.000000e-01 +1.300000e+01 5.000000e-01 5.000000e-01 6.200000e+01 6.000000e-01 6.000000e-01 +1.400000e+01 5.000000e-01 5.000000e-01 7.960000e+01 8.000000e-01 8.000000e-01 +1.500000e+01 5.000000e-01 5.000000e-01 6.230000e+01 6.000000e-01 6.000000e-01 +1.600000e+01 5.000000e-01 5.000000e-01 6.570000e+01 7.000000e-01 7.000000e-01 +1.700000e+01 5.000000e-01 5.000000e-01 6.150000e+01 7.000000e-01 7.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 6.130000e+01 7.000000e-01 7.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 6.070000e+01 8.000000e-01 8.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 6.090000e+01 8.000000e-01 8.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 7.400000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.490000e+01 1.000000e+00 1.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y03 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 6.890000e+01 6.000000e-01 6.000000e-01 +7.000000e+00 5.000000e-01 5.000000e-01 6.120000e+01 6.000000e-01 6.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 6.430000e+01 6.000000e-01 6.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 6.020000e+01 7.000000e-01 7.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 6.310000e+01 6.000000e-01 6.000000e-01 +1.100000e+01 5.000000e-01 5.000000e-01 6.290000e+01 6.000000e-01 6.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 6.420000e+01 6.000000e-01 6.000000e-01 +1.300000e+01 5.000000e-01 5.000000e-01 6.010000e+01 6.000000e-01 6.000000e-01 +1.400000e+01 5.000000e-01 5.000000e-01 6.670000e+01 7.000000e-01 7.000000e-01 +1.500000e+01 5.000000e-01 5.000000e-01 6.330000e+01 6.000000e-01 6.000000e-01 +1.600000e+01 5.000000e-01 5.000000e-01 6.150000e+01 6.000000e-01 6.000000e-01 +1.700000e+01 5.000000e-01 5.000000e-01 5.970000e+01 6.000000e-01 6.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 5.980000e+01 6.000000e-01 6.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 5.980000e+01 7.000000e-01 7.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 6.010000e+01 7.000000e-01 7.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 7.420000e+01 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.410000e+01 9.000000e-01 9.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y04 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y04 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.000000e+00 5.000000e-01 5.000000e-01 6.380000e+01 6.000000e-01 6.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 6.780000e+01 6.000000e-01 6.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 6.010000e+01 7.000000e-01 7.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 6.340000e+01 6.000000e-01 6.000000e-01 +1.100000e+01 5.000000e-01 5.000000e-01 6.750000e+01 6.000000e-01 6.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 6.260000e+01 6.000000e-01 6.000000e-01 +1.300000e+01 5.000000e-01 5.000000e-01 6.090000e+01 5.000000e-01 5.000000e-01 +1.400000e+01 5.000000e-01 5.000000e-01 4.250000e+01 4.000000e-01 4.000000e-01 +1.500000e+01 5.000000e-01 5.000000e-01 6.740000e+01 6.000000e-01 6.000000e-01 +1.600000e+01 5.000000e-01 5.000000e-01 6.080000e+01 5.000000e-01 5.000000e-01 +1.700000e+01 5.000000e-01 5.000000e-01 6.180000e+01 6.000000e-01 6.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 6.050000e+01 5.000000e-01 5.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 5.960000e+01 6.000000e-01 6.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 5.930000e+01 6.000000e-01 6.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 7.390000e+01 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.280000e+01 8.000000e-01 8.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y05 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.800000e+01 5.000000e-01 5.000000e-01 6.730000e+01 6.000000e-01 6.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 6.050000e+01 5.000000e-01 5.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 6.380000e+01 6.000000e-01 6.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 6.990000e+01 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.170000e+01 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y06 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y06 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.100000e+01 5.000000e-01 5.000000e-01 3.880000e+01 5.000000e-01 5.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 6.010000e+01 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y07 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.200000e+01 5.000000e-01 5.000000e-01 6.020000e+01 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d25-x01-y08 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d25-x01-y08 +Title: doi:10.17182/hepdata.65179.v2/t25 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.200000e+01 5.000000e-01 5.000000e-01 5.990000e+01 5.000000e-01 5.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y01 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 9.810000e+01 5.000000e-01 5.000000e-01 +2.000000e+00 5.000000e-01 5.000000e-01 9.750000e+01 6.000000e-01 6.000000e-01 +3.000000e+00 5.000000e-01 5.000000e-01 9.640000e+01 1.000000e+00 1.000000e+00 +4.000000e+00 5.000000e-01 5.000000e-01 9.510000e+01 1.900000e+00 1.900000e+00 +5.000000e+00 5.000000e-01 5.000000e-01 9.700000e+01 3.000000e+00 3.000000e+00 +6.000000e+00 5.000000e-01 5.000000e-01 9.670000e+01 1.100000e+00 1.100000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 9.850000e+01 6.000000e-01 6.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 9.840000e+01 6.000000e-01 6.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 9.710000e+01 7.000000e-01 7.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 9.590000e+01 1.500000e+00 1.500000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.790000e+01 7.000000e-01 7.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 9.650000e+01 1.200000e+00 1.200000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.600000e+01 1.200000e+00 1.200000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.610000e+01 1.600000e+00 1.600000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.740000e+01 1.500000e+00 1.500000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.390000e+01 3.200000e+00 3.200000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.810000e+01 6.000000e-01 6.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 9.840000e+01 6.000000e-01 6.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 9.850000e+01 6.000000e-01 6.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 9.850000e+01 6.000000e-01 6.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 9.800000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.780000e+01 6.000000e-01 6.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.820000e+01 5.000000e-01 5.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 9.950000e+01 5.000000e-01 5.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 9.780000e+01 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y02 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 9.530000e+01 2.100000e+00 2.100000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 9.790000e+01 7.000000e-01 7.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 9.730000e+01 7.000000e-01 7.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 9.740000e+01 8.000000e-01 8.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 9.610000e+01 1.600000e+00 1.600000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.670000e+01 1.200000e+00 1.200000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.580000e+01 1.800000e+00 1.800000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.640000e+01 1.700000e+00 1.700000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.630000e+01 1.600000e+00 1.600000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.610000e+01 1.800000e+00 1.800000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.590000e+01 2.000000e+00 2.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.790000e+01 9.000000e-01 9.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 9.810000e+01 1.000000e+00 1.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.810000e+01 8.000000e-01 8.000000e-01 +2.000000e+01 5.000000e-01 5.000000e-01 9.820000e+01 9.000000e-01 9.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 9.810000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.780000e+01 7.000000e-01 7.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.820000e+01 6.000000e-01 6.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 9.840000e+01 9.000000e-01 9.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 9.780000e+01 8.000000e-01 8.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y03 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 9.380000e+01 3.800000e+00 3.800000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 9.670000e+01 1.100000e+00 1.100000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 9.570000e+01 1.700000e+00 1.700000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.770000e+01 1.200000e+00 1.200000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.650000e+01 2.100000e+00 2.100000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.600000e+01 2.000000e+00 2.000000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.570000e+01 3.200000e+00 3.200000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.710000e+01 3.600000e+00 3.600000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.650000e+01 2.200000e+00 2.200000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.460000e+01 3.000000e+00 3.000000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.670000e+01 1.400000e+00 1.400000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.730000e+01 8.000000e-01 8.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 9.750000e+01 9.000000e-01 9.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 9.760000e+01 1.000000e+00 1.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.790000e+01 1.100000e+00 1.100000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 9.800000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.800000e+01 7.000000e-01 7.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.840000e+01 9.000000e-01 9.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 9.760000e+01 1.100000e+00 1.100000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.790000e+01 8.000000e-01 8.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y04 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y04 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.000000e+00 5.000000e-01 5.000000e-01 9.490000e+01 1.900000e+00 1.900000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 9.460000e+01 3.700000e+00 3.700000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.790000e+01 1.800000e+00 1.800000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.710000e+01 3.200000e+00 3.200000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.510000e+01 2.600000e+00 2.600000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.560000e+01 4.800000e+00 4.800000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.770000e+01 7.800000e+00 7.800000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.550000e+01 2.400000e+00 2.400000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.240000e+01 3.800000e+00 3.800000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.690000e+01 2.200000e+00 2.200000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.690000e+01 1.300000e+00 1.300000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 9.700000e+01 1.200000e+00 1.200000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.730000e+01 1.200000e+00 1.200000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.730000e+01 9.000000e-01 9.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 9.820000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.820000e+01 7.000000e-01 7.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.830000e+01 1.000000e+00 1.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 9.710000e+01 1.100000e+00 1.100000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.800000e+01 8.000000e-01 8.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y05 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.800000e+01 5.000000e-01 5.000000e-01 9.580000e+01 1.400000e+00 1.400000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.680000e+01 1.400000e+00 1.400000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.640000e+01 1.400000e+00 1.400000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 9.820000e+01 7.000000e-01 7.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.850000e+01 8.000000e-01 8.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.830000e+01 9.000000e-01 9.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 9.670000e+01 1.200000e+00 1.200000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.820000e+01 8.000000e-01 8.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y06 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y06 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.100000e+01 5.000000e-01 5.000000e-01 9.800000e+01 9.000000e-01 9.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 9.890000e+01 9.000000e-01 9.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.800000e+01 1.100000e+00 1.100000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 9.650000e+01 1.000000e+00 1.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.840000e+01 9.000000e-01 9.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y07 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.200000e+01 5.000000e-01 5.000000e-01 9.920000e+01 2.300000e+00 2.300000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 9.740000e+01 1.000000e+00 1.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 9.660000e+01 1.300000e+00 1.300000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.870000e+01 9.000000e-01 9.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y08 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y08 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.400000e+01 5.000000e-01 5.000000e-01 9.740000e+01 1.000000e+00 1.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 9.890000e+01 1.100000e+00 1.100000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y09 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y09 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 9.790000e+01 2.000000e+00 2.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d26-x01-y10 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d26-x01-y10 +Title: doi:10.17182/hepdata.65179.v2/t26 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 9.790000e+01 2.300000e+00 2.300000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y01 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 9.990000e+01 6.000000e-01 6.000000e-01 +2.000000e+00 5.000000e-01 5.000000e-01 9.920000e+01 2.200000e+00 2.200000e+00 +3.000000e+00 5.000000e-01 5.000000e-01 9.800000e+01 4.400000e+00 4.400000e+00 +4.000000e+00 5.000000e-01 5.000000e-01 9.620000e+01 5.700000e+00 5.700000e+00 +5.000000e+00 5.000000e-01 5.000000e-01 9.880000e+01 5.800000e+00 5.800000e+00 +6.000000e+00 5.000000e-01 5.000000e-01 9.880000e+01 4.000000e+00 4.000000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 1.009000e+02 2.100000e+00 2.100000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 1.006000e+02 1.200000e+00 1.200000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.970000e+01 2.100000e+00 2.100000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.770000e+01 3.900000e+00 3.900000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.970000e+01 2.700000e+00 2.700000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.710000e+01 4.100000e+00 4.100000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.750000e+01 3.600000e+00 3.600000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.660000e+01 4.600000e+00 4.600000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.700000e+01 6.300000e+00 6.300000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 1.016000e+02 5.400000e+00 5.400000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 1.005000e+02 1.700000e+00 1.700000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 1.005000e+02 1.700000e+00 1.700000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 1.009000e+02 2.100000e+00 2.100000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 1.009000e+02 2.100000e+00 2.100000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 1.000000e+02 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.001000e+02 6.000000e-01 6.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 9.920000e+01 1.300000e+00 1.300000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 9.950000e+01 9.000000e-01 9.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 1.002000e+02 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y02 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 9.690000e+01 6.800000e+00 6.800000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 9.970000e+01 2.700000e+00 2.700000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 9.940000e+01 2.400000e+00 2.400000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.940000e+01 2.000000e+00 2.000000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.820000e+01 4.200000e+00 4.200000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.830000e+01 4.900000e+00 4.900000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.900000e+01 4.400000e+00 4.400000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.900000e+01 5.200000e+00 5.200000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.860000e+01 4.100000e+00 4.100000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.950000e+01 3.000000e+00 3.000000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.830000e+01 4.200000e+00 4.200000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.900000e+01 2.600000e+00 2.600000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 9.940000e+01 2.300000e+00 2.300000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.950000e+01 2.200000e+00 2.200000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.950000e+01 2.600000e+00 2.600000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 1.001000e+02 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.000000e+02 7.000000e-01 7.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 1.010000e+02 1.100000e+00 1.100000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 1.010000e+02 1.000000e+00 1.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 1.001000e+02 6.000000e-01 6.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y03 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 9.550000e+01 3.200000e+00 3.200000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 9.880000e+01 4.000000e+00 4.000000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 9.840000e+01 4.000000e+00 4.000000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.920000e+01 2.200000e+00 2.200000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.860000e+01 5.000000e+00 5.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.800000e+01 4.500000e+00 4.500000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.920000e+01 4.900000e+00 4.900000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.870000e+01 5.800000e+00 5.800000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 9.810000e+01 4.300000e+00 4.300000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.880000e+01 4.400000e+00 4.400000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.860000e+01 4.700000e+00 4.700000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 1.004000e+02 2.300000e+00 2.300000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 1.006000e+02 2.300000e+00 2.300000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.920000e+01 2.300000e+00 2.300000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.940000e+01 3.100000e+00 3.100000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 9.990000e+01 4.000000e-01 4.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.000000e+02 6.000000e-01 6.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 1.004000e+02 7.000000e-01 7.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 1.004000e+02 9.000000e-01 9.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 1.002000e+02 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y04 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y04 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.000000e+00 5.000000e-01 5.000000e-01 9.630000e+01 5.700000e+00 5.700000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 9.530000e+01 3.200000e+00 3.200000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.820000e+01 3.400000e+00 3.400000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 9.810000e+01 6.100000e+00 6.100000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 9.780000e+01 3.500000e+00 3.500000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 9.900000e+01 5.700000e+00 5.700000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 9.880000e+01 6.900000e+00 6.900000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 1.002000e+02 5.400000e+00 5.400000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 9.790000e+01 5.200000e+00 5.200000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 9.520000e+01 4.000000e+00 4.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 1.002000e+02 2.000000e+00 2.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 9.950000e+01 2.600000e+00 2.600000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.910000e+01 2.300000e+00 2.300000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.900000e+01 2.500000e+00 2.500000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 1.001000e+02 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.002000e+02 8.000000e-01 8.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 1.001000e+02 7.000000e-01 7.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 1.002000e+02 7.000000e-01 7.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 9.990000e+01 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y05 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.800000e+01 5.000000e-01 5.000000e-01 9.910000e+01 2.500000e+00 2.500000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 9.900000e+01 2.300000e+00 2.300000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 9.850000e+01 3.500000e+00 3.500000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 1.000000e+02 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.002000e+02 6.000000e-01 6.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 1.002000e+02 7.000000e-01 7.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 1.002000e+02 1.000000e+00 1.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 1.002000e+02 6.000000e-01 6.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y06 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y06 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.100000e+01 5.000000e-01 5.000000e-01 1.003000e+02 6.000000e-01 6.000000e-01 +2.200000e+01 5.000000e-01 5.000000e-01 1.002000e+02 5.000000e-01 5.000000e-01 +2.300000e+01 5.000000e-01 5.000000e-01 1.000000e+02 7.000000e-01 7.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 9.980000e+01 7.000000e-01 7.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 1.000000e+02 5.000000e-01 5.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y07 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.200000e+01 5.000000e-01 5.000000e-01 1.005000e+02 1.500000e+00 1.500000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 9.990000e+01 7.000000e-01 7.000000e-01 +2.400000e+01 5.000000e-01 5.000000e-01 1.000000e+02 8.000000e-01 8.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 1.002000e+02 7.000000e-01 7.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y08 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y08 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.400000e+01 5.000000e-01 5.000000e-01 1.000000e+02 6.000000e-01 6.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 1.000000e+02 6.000000e-01 6.000000e-01 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y09 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y09 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 1.000000e+02 1.000000e+00 1.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d27-x01-y10 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d27-x01-y10 +Title: doi:10.17182/hepdata.65179.v2/t27 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 1.002000e+02 1.100000e+00 1.100000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y01 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e+00 5.000000e-01 5.000000e-01 3.700000e+00 2.000000e-01 2.000000e-01 +2.000000e+00 5.000000e-01 5.000000e-01 3.200000e+00 2.000000e-01 2.000000e-01 +3.000000e+00 5.000000e-01 5.000000e-01 1.800000e+00 1.000000e-01 1.000000e-01 +4.000000e+00 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +5.000000e+00 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +6.000000e+00 5.000000e-01 5.000000e-01 1.400000e+00 1.000000e-01 1.000000e-01 +7.000000e+00 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 1.300000e+00 1.000000e-01 1.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e-01 1.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 1.300000e+00 1.000000e-01 1.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 1.200000e+00 1.000000e-01 1.000000e-01 +1.600000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 1.200000e+00 1.000000e-01 1.000000e-01 +1.800000e+01 5.000000e-01 5.000000e-01 1.200000e+00 1.000000e-01 1.000000e-01 +1.900000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y02 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y02 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 1.300000e+00 1.000000e-01 1.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 1.500000e+00 1.000000e-01 1.000000e-01 +9.000000e+00 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e-01 1.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e-01 1.000000e-01 +1.200000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y03 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y03 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +6.000000e+00 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 1.400000e+00 1.000000e-01 1.000000e-01 +8.000000e+00 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 1.000000e-01 0.000000e+00 0.000000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 9.000000e-01 0.000000e+00 0.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y04 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y04 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +7.000000e+00 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +1.000000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 1.000000e-01 0.000000e+00 0.000000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 7.000000e-01 0.000000e+00 0.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 8.000000e-01 0.000000e+00 0.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 1.300000e+00 1.000000e-01 1.000000e-01 +2.100000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y05 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y05 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +1.800000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y06 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y06 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.100000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 6.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 4.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y07 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y07 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.200000e+01 5.000000e-01 5.000000e-01 1.000000e-01 0.000000e+00 0.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 9.000000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y08 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y08 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.400000e+01 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e-01 1.000000e-01 +2.500000e+01 5.000000e-01 5.000000e-01 3.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y09 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y09 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d28-x01-y10 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d28-x01-y10 +Title: doi:10.17182/hepdata.65179.v2/t28 +Type: Scatter2D +--- +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e+01 5.000000e-01 5.000000e-01 2.000000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D_V2 +BEGIN YODA_SCATTER3D_V2 /REF/ATLAS_2014_I1306615/d29-x01-y01 IsRef: 1 Path: /REF/ATLAS_2014_I1306615/d29-x01-y01 +Title: doi:10.17182/hepdata.65179.v2/t29 +Type: Scatter3D +--- +# xval xerr- xerr+ yval yerr- yerr+ zval zerr- zerr+ +1.000000e+00 5.000000e-01 5.000000e-01 1.000000e+00 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.000000e+00 5.000000e-01 5.000000e-01 2.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.000000e+00 5.000000e-01 5.000000e-01 3.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.000000e+00 5.000000e-01 5.000000e-01 4.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.000000e+00 5.000000e-01 5.000000e-01 5.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +6.000000e+00 5.000000e-01 5.000000e-01 6.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.000000e+00 5.000000e-01 5.000000e-01 7.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +8.000000e+00 5.000000e-01 5.000000e-01 8.000000e+00 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +9.000000e+00 5.000000e-01 5.000000e-01 9.000000e+00 5.000000e-01 5.000000e-01 7.480000e+01 5.000000e-01 5.000000e-01 +1.000000e+01 5.000000e-01 5.000000e-01 1.000000e+01 5.000000e-01 5.000000e-01 7.700000e+00 1.000000e+00 1.000000e+00 +1.100000e+01 5.000000e-01 5.000000e-01 1.100000e+01 5.000000e-01 5.000000e-01 4.700000e+00 1.100000e+00 1.100000e+00 +1.200000e+01 5.000000e-01 5.000000e-01 1.200000e+01 5.000000e-01 5.000000e-01 2.800000e+00 1.000000e+00 1.000000e+00 +1.300000e+01 5.000000e-01 5.000000e-01 1.300000e+01 5.000000e-01 5.000000e-01 5.100000e+00 1.000000e+00 1.000000e+00 +1.400000e+01 5.000000e-01 5.000000e-01 1.400000e+01 5.000000e-01 5.000000e-01 2.000000e+00 1.100000e+00 1.100000e+00 +1.500000e+01 5.000000e-01 5.000000e-01 1.500000e+01 5.000000e-01 5.000000e-01 8.000000e-01 1.100000e+00 1.100000e+00 +1.600000e+01 5.000000e-01 5.000000e-01 1.600000e+01 5.000000e-01 5.000000e-01 3.000000e-01 1.000000e+00 1.000000e+00 +1.700000e+01 5.000000e-01 5.000000e-01 1.700000e+01 5.000000e-01 5.000000e-01 -8.000000e-01 1.000000e+00 1.000000e+00 +1.800000e+01 5.000000e-01 5.000000e-01 1.800000e+01 5.000000e-01 5.000000e-01 -1.000000e-01 1.000000e+00 1.000000e+00 +1.900000e+01 5.000000e-01 5.000000e-01 1.900000e+01 5.000000e-01 5.000000e-01 3.700000e+00 1.100000e+00 1.100000e+00 +2.000000e+01 5.000000e-01 5.000000e-01 2.000000e+01 5.000000e-01 5.000000e-01 6.800000e+00 1.100000e+00 1.100000e+00 +2.100000e+01 5.000000e-01 5.000000e-01 2.100000e+01 5.000000e-01 5.000000e-01 9.800000e+00 1.100000e+00 1.100000e+00 +2.200000e+01 5.000000e-01 5.000000e-01 2.200000e+01 5.000000e-01 5.000000e-01 3.500000e+00 1.000000e+00 1.000000e+00 +2.300000e+01 5.000000e-01 5.000000e-01 2.300000e+01 5.000000e-01 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e+00 +2.400000e+01 5.000000e-01 5.000000e-01 2.400000e+01 5.000000e-01 5.000000e-01 2.700000e+00 1.000000e+00 1.000000e+00 +2.500000e+01 5.000000e-01 5.000000e-01 2.500000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.600000e+01 5.000000e-01 5.000000e-01 2.600000e+01 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.700000e+01 5.000000e-01 5.000000e-01 2.700000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.800000e+01 5.000000e-01 5.000000e-01 2.800000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.900000e+01 5.000000e-01 5.000000e-01 2.900000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.000000e+01 5.000000e-01 5.000000e-01 3.000000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.100000e+01 5.000000e-01 5.000000e-01 3.100000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.200000e+01 5.000000e-01 5.000000e-01 3.200000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.300000e+01 5.000000e-01 5.000000e-01 3.300000e+01 5.000000e-01 5.000000e-01 4.010000e+01 1.000000e+00 1.000000e+00 +3.400000e+01 5.000000e-01 5.000000e-01 3.400000e+01 5.000000e-01 5.000000e-01 1.430000e+01 1.100000e+00 1.100000e+00 +3.500000e+01 5.000000e-01 5.000000e-01 3.500000e+01 5.000000e-01 5.000000e-01 7.300000e+00 1.100000e+00 1.100000e+00 +3.600000e+01 5.000000e-01 5.000000e-01 3.600000e+01 5.000000e-01 5.000000e-01 2.000000e+00 1.100000e+00 1.100000e+00 +3.700000e+01 5.000000e-01 5.000000e-01 3.700000e+01 5.000000e-01 5.000000e-01 5.300000e+00 1.100000e+00 1.100000e+00 +3.800000e+01 5.000000e-01 5.000000e-01 3.800000e+01 5.000000e-01 5.000000e-01 4.900000e+00 1.100000e+00 1.100000e+00 +3.900000e+01 5.000000e-01 5.000000e-01 3.900000e+01 5.000000e-01 5.000000e-01 1.700000e+00 1.100000e+00 1.100000e+00 +4.000000e+01 5.000000e-01 5.000000e-01 4.000000e+01 5.000000e-01 5.000000e-01 1.000000e-01 1.100000e+00 1.100000e+00 +4.100000e+01 5.000000e-01 5.000000e-01 4.100000e+01 5.000000e-01 5.000000e-01 1.100000e+00 1.000000e+00 1.000000e+00 +4.200000e+01 5.000000e-01 5.000000e-01 4.200000e+01 5.000000e-01 5.000000e-01 1.200000e+00 1.100000e+00 1.100000e+00 +4.300000e+01 5.000000e-01 5.000000e-01 4.300000e+01 5.000000e-01 5.000000e-01 4.700000e+00 1.100000e+00 1.100000e+00 +4.400000e+01 5.000000e-01 5.000000e-01 4.400000e+01 5.000000e-01 5.000000e-01 6.900000e+00 1.200000e+00 1.200000e+00 +4.500000e+01 5.000000e-01 5.000000e-01 4.500000e+01 5.000000e-01 5.000000e-01 1.850000e+01 1.200000e+00 1.200000e+00 +4.600000e+01 5.000000e-01 5.000000e-01 4.600000e+01 5.000000e-01 5.000000e-01 3.900000e+00 1.100000e+00 1.100000e+00 +4.700000e+01 5.000000e-01 5.000000e-01 4.700000e+01 5.000000e-01 5.000000e-01 2.400000e+00 1.100000e+00 1.100000e+00 +4.800000e+01 5.000000e-01 5.000000e-01 4.800000e+01 5.000000e-01 5.000000e-01 2.400000e+00 1.100000e+00 1.100000e+00 +4.900000e+01 5.000000e-01 5.000000e-01 4.900000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.000000e+01 5.000000e-01 5.000000e-01 5.000000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.100000e+01 5.000000e-01 5.000000e-01 5.100000e+01 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +5.200000e+01 5.000000e-01 5.000000e-01 5.200000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.300000e+01 5.000000e-01 5.000000e-01 5.300000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.400000e+01 5.000000e-01 5.000000e-01 5.400000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.500000e+01 5.000000e-01 5.000000e-01 5.500000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.600000e+01 5.000000e-01 5.000000e-01 5.600000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.700000e+01 5.000000e-01 5.000000e-01 5.700000e+01 5.000000e-01 5.000000e-01 2.300000e+01 1.100000e+00 1.100000e+00 +5.800000e+01 5.000000e-01 5.000000e-01 5.800000e+01 5.000000e-01 5.000000e-01 2.300000e+01 1.200000e+00 1.200000e+00 +5.900000e+01 5.000000e-01 5.000000e-01 5.900000e+01 5.000000e-01 5.000000e-01 9.000000e+00 1.200000e+00 1.200000e+00 +6.000000e+01 5.000000e-01 5.000000e-01 6.000000e+01 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +6.100000e+01 5.000000e-01 5.000000e-01 6.100000e+01 5.000000e-01 5.000000e-01 1.000000e+01 1.200000e+00 1.200000e+00 +6.200000e+01 5.000000e-01 5.000000e-01 6.200000e+01 5.000000e-01 5.000000e-01 4.500000e+00 1.200000e+00 1.200000e+00 +6.300000e+01 5.000000e-01 5.000000e-01 6.300000e+01 5.000000e-01 5.000000e-01 8.000000e-01 1.100000e+00 1.100000e+00 +6.400000e+01 5.000000e-01 5.000000e-01 6.400000e+01 5.000000e-01 5.000000e-01 -7.000000e-01 1.100000e+00 1.100000e+00 +6.500000e+01 5.000000e-01 5.000000e-01 6.500000e+01 5.000000e-01 5.000000e-01 2.100000e+00 1.100000e+00 1.100000e+00 +6.600000e+01 5.000000e-01 5.000000e-01 6.600000e+01 5.000000e-01 5.000000e-01 2.800000e+00 1.100000e+00 1.100000e+00 +6.700000e+01 5.000000e-01 5.000000e-01 6.700000e+01 5.000000e-01 5.000000e-01 5.700000e+00 1.300000e+00 1.300000e+00 +6.800000e+01 5.000000e-01 5.000000e-01 6.800000e+01 5.000000e-01 5.000000e-01 8.900000e+00 1.300000e+00 1.300000e+00 +6.900000e+01 5.000000e-01 5.000000e-01 6.900000e+01 5.000000e-01 5.000000e-01 2.590000e+01 1.200000e+00 1.200000e+00 +7.000000e+01 5.000000e-01 5.000000e-01 7.000000e+01 5.000000e-01 5.000000e-01 9.600000e+00 1.200000e+00 1.200000e+00 +7.100000e+01 5.000000e-01 5.000000e-01 7.100000e+01 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +7.200000e+01 5.000000e-01 5.000000e-01 7.200000e+01 5.000000e-01 5.000000e-01 2.300000e+00 1.100000e+00 1.100000e+00 +7.300000e+01 5.000000e-01 5.000000e-01 7.300000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.400000e+01 5.000000e-01 5.000000e-01 7.400000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.500000e+01 5.000000e-01 5.000000e-01 7.500000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.600000e+01 5.000000e-01 5.000000e-01 7.600000e+01 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +7.700000e+01 5.000000e-01 5.000000e-01 7.700000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.800000e+01 5.000000e-01 5.000000e-01 7.800000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +7.900000e+01 5.000000e-01 5.000000e-01 7.900000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +8.000000e+01 5.000000e-01 5.000000e-01 8.000000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +8.100000e+01 5.000000e-01 5.000000e-01 8.100000e+01 5.000000e-01 5.000000e-01 1.250000e+01 1.100000e+00 1.100000e+00 +8.200000e+01 5.000000e-01 5.000000e-01 8.200000e+01 5.000000e-01 5.000000e-01 2.940000e+01 1.200000e+00 1.200000e+00 +8.300000e+01 5.000000e-01 5.000000e-01 8.300000e+01 5.000000e-01 5.000000e-01 9.700000e+00 1.300000e+00 1.300000e+00 +8.400000e+01 5.000000e-01 5.000000e-01 8.400000e+01 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +8.500000e+01 5.000000e-01 5.000000e-01 8.500000e+01 5.000000e-01 5.000000e-01 7.800000e+00 1.200000e+00 1.200000e+00 +8.600000e+01 5.000000e-01 5.000000e-01 8.600000e+01 5.000000e-01 5.000000e-01 6.000000e+00 1.300000e+00 1.300000e+00 +8.700000e+01 5.000000e-01 5.000000e-01 8.700000e+01 5.000000e-01 5.000000e-01 4.300000e+00 1.300000e+00 1.300000e+00 +8.800000e+01 5.000000e-01 5.000000e-01 8.800000e+01 5.000000e-01 5.000000e-01 4.000000e+00 1.400000e+00 1.400000e+00 +8.900000e+01 5.000000e-01 5.000000e-01 8.900000e+01 5.000000e-01 5.000000e-01 3.500000e+00 1.200000e+00 1.200000e+00 +9.000000e+01 5.000000e-01 5.000000e-01 9.000000e+01 5.000000e-01 5.000000e-01 5.400000e+00 1.300000e+00 1.300000e+00 +9.100000e+01 5.000000e-01 5.000000e-01 9.100000e+01 5.000000e-01 5.000000e-01 4.200000e+00 1.300000e+00 1.300000e+00 +9.200000e+01 5.000000e-01 5.000000e-01 9.200000e+01 5.000000e-01 5.000000e-01 8.900000e+00 1.300000e+00 1.300000e+00 +9.300000e+01 5.000000e-01 5.000000e-01 9.300000e+01 5.000000e-01 5.000000e-01 2.690000e+01 1.200000e+00 1.200000e+00 +9.400000e+01 5.000000e-01 5.000000e-01 9.400000e+01 5.000000e-01 5.000000e-01 1.620000e+01 1.300000e+00 1.300000e+00 +9.500000e+01 5.000000e-01 5.000000e-01 9.500000e+01 5.000000e-01 5.000000e-01 7.800000e+00 1.200000e+00 1.200000e+00 +9.600000e+01 5.000000e-01 5.000000e-01 9.600000e+01 5.000000e-01 5.000000e-01 4.300000e+00 1.200000e+00 1.200000e+00 +9.700000e+01 5.000000e-01 5.000000e-01 9.700000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +9.800000e+01 5.000000e-01 5.000000e-01 9.800000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +9.900000e+01 5.000000e-01 5.000000e-01 9.900000e+01 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.000000e+02 5.000000e-01 5.000000e-01 1.000000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.010000e+02 5.000000e-01 5.000000e-01 1.010000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +1.020000e+02 5.000000e-01 5.000000e-01 1.020000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.030000e+02 5.000000e-01 5.000000e-01 1.030000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.040000e+02 5.000000e-01 5.000000e-01 1.040000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.050000e+02 5.000000e-01 5.000000e-01 1.050000e+02 5.000000e-01 5.000000e-01 4.100000e+00 1.100000e+00 1.100000e+00 +1.060000e+02 5.000000e-01 5.000000e-01 1.060000e+02 5.000000e-01 5.000000e-01 2.860000e+01 1.200000e+00 1.200000e+00 +1.070000e+02 5.000000e-01 5.000000e-01 1.070000e+02 5.000000e-01 5.000000e-01 1.270000e+01 1.300000e+00 1.300000e+00 +1.080000e+02 5.000000e-01 5.000000e-01 1.080000e+02 5.000000e-01 5.000000e-01 7.900000e+00 1.400000e+00 1.400000e+00 +1.090000e+02 5.000000e-01 5.000000e-01 1.090000e+02 5.000000e-01 5.000000e-01 1.290000e+01 1.300000e+00 1.300000e+00 +1.100000e+02 5.000000e-01 5.000000e-01 1.100000e+02 5.000000e-01 5.000000e-01 4.500000e+00 1.300000e+00 1.300000e+00 +1.110000e+02 5.000000e-01 5.000000e-01 1.110000e+02 5.000000e-01 5.000000e-01 6.900000e+00 1.300000e+00 1.300000e+00 +1.120000e+02 5.000000e-01 5.000000e-01 1.120000e+02 5.000000e-01 5.000000e-01 1.500000e+00 1.400000e+00 1.400000e+00 +1.130000e+02 5.000000e-01 5.000000e-01 1.130000e+02 5.000000e-01 5.000000e-01 2.800000e+00 1.200000e+00 1.200000e+00 +1.140000e+02 5.000000e-01 5.000000e-01 1.140000e+02 5.000000e-01 5.000000e-01 7.400000e+00 1.400000e+00 1.400000e+00 +1.150000e+02 5.000000e-01 5.000000e-01 1.150000e+02 5.000000e-01 5.000000e-01 1.100000e+01 1.400000e+00 1.400000e+00 +1.160000e+02 5.000000e-01 5.000000e-01 1.160000e+02 5.000000e-01 5.000000e-01 8.400000e+00 1.400000e+00 1.400000e+00 +1.170000e+02 5.000000e-01 5.000000e-01 1.170000e+02 5.000000e-01 5.000000e-01 2.050000e+01 1.300000e+00 1.300000e+00 +1.180000e+02 5.000000e-01 5.000000e-01 1.180000e+02 5.000000e-01 5.000000e-01 2.430000e+01 1.400000e+00 1.400000e+00 +1.190000e+02 5.000000e-01 5.000000e-01 1.190000e+02 5.000000e-01 5.000000e-01 1.000000e+01 1.300000e+00 1.300000e+00 +1.200000e+02 5.000000e-01 5.000000e-01 1.200000e+02 5.000000e-01 5.000000e-01 5.100000e+00 1.300000e+00 1.300000e+00 +1.210000e+02 5.000000e-01 5.000000e-01 1.210000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.220000e+02 5.000000e-01 5.000000e-01 1.220000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.230000e+02 5.000000e-01 5.000000e-01 1.230000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.240000e+02 5.000000e-01 5.000000e-01 1.240000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.250000e+02 5.000000e-01 5.000000e-01 1.250000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.260000e+02 5.000000e-01 5.000000e-01 1.260000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +1.270000e+02 5.000000e-01 5.000000e-01 1.270000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.280000e+02 5.000000e-01 5.000000e-01 1.280000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.290000e+02 5.000000e-01 5.000000e-01 1.290000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.000000e+00 1.000000e+00 +1.300000e+02 5.000000e-01 5.000000e-01 1.300000e+02 5.000000e-01 5.000000e-01 3.000000e+01 1.200000e+00 1.200000e+00 +1.310000e+02 5.000000e-01 5.000000e-01 1.310000e+02 5.000000e-01 5.000000e-01 2.250000e+01 1.400000e+00 1.400000e+00 +1.320000e+02 5.000000e-01 5.000000e-01 1.320000e+02 5.000000e-01 5.000000e-01 1.040000e+01 1.400000e+00 1.400000e+00 +1.330000e+02 5.000000e-01 5.000000e-01 1.330000e+02 5.000000e-01 5.000000e-01 2.110000e+01 1.400000e+00 1.400000e+00 +1.340000e+02 5.000000e-01 5.000000e-01 1.340000e+02 5.000000e-01 5.000000e-01 1.120000e+01 1.400000e+00 1.400000e+00 +1.350000e+02 5.000000e-01 5.000000e-01 1.350000e+02 5.000000e-01 5.000000e-01 5.600000e+00 1.500000e+00 1.500000e+00 +1.360000e+02 5.000000e-01 5.000000e-01 1.360000e+02 5.000000e-01 5.000000e-01 2.300000e+00 1.400000e+00 1.400000e+00 +1.370000e+02 5.000000e-01 5.000000e-01 1.370000e+02 5.000000e-01 5.000000e-01 1.090000e+01 1.500000e+00 1.500000e+00 +1.380000e+02 5.000000e-01 5.000000e-01 1.380000e+02 5.000000e-01 5.000000e-01 1.780000e+01 1.500000e+00 1.500000e+00 +1.390000e+02 5.000000e-01 5.000000e-01 1.390000e+02 5.000000e-01 5.000000e-01 1.140000e+01 1.400000e+00 1.400000e+00 +1.400000e+02 5.000000e-01 5.000000e-01 1.400000e+02 5.000000e-01 5.000000e-01 1.020000e+01 1.300000e+00 1.300000e+00 +1.410000e+02 5.000000e-01 5.000000e-01 1.410000e+02 5.000000e-01 5.000000e-01 1.620000e+01 1.200000e+00 1.200000e+00 +1.420000e+02 5.000000e-01 5.000000e-01 1.420000e+02 5.000000e-01 5.000000e-01 2.780000e+01 1.400000e+00 1.400000e+00 +1.430000e+02 5.000000e-01 5.000000e-01 1.430000e+02 5.000000e-01 5.000000e-01 2.640000e+01 1.500000e+00 1.500000e+00 +1.440000e+02 5.000000e-01 5.000000e-01 1.440000e+02 5.000000e-01 5.000000e-01 1.060000e+01 1.400000e+00 1.400000e+00 +1.450000e+02 5.000000e-01 5.000000e-01 1.450000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.460000e+02 5.000000e-01 5.000000e-01 1.460000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.470000e+02 5.000000e-01 5.000000e-01 1.470000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.480000e+02 5.000000e-01 5.000000e-01 1.480000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.490000e+02 5.000000e-01 5.000000e-01 1.490000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.500000e+02 5.000000e-01 5.000000e-01 1.500000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.510000e+02 5.000000e-01 5.000000e-01 1.510000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +1.520000e+02 5.000000e-01 5.000000e-01 1.520000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.530000e+02 5.000000e-01 5.000000e-01 1.530000e+02 5.000000e-01 5.000000e-01 -1.300000e+00 1.000000e+00 1.000000e+00 +1.540000e+02 5.000000e-01 5.000000e-01 1.540000e+02 5.000000e-01 5.000000e-01 1.940000e+01 1.200000e+00 1.200000e+00 +1.550000e+02 5.000000e-01 5.000000e-01 1.550000e+02 5.000000e-01 5.000000e-01 2.160000e+01 1.500000e+00 1.500000e+00 +1.560000e+02 5.000000e-01 5.000000e-01 1.560000e+02 5.000000e-01 5.000000e-01 1.050000e+01 1.600000e+00 1.600000e+00 +1.570000e+02 5.000000e-01 5.000000e-01 1.570000e+02 5.000000e-01 5.000000e-01 1.700000e+01 1.500000e+00 1.500000e+00 +1.580000e+02 5.000000e-01 5.000000e-01 1.580000e+02 5.000000e-01 5.000000e-01 1.370000e+01 1.600000e+00 1.600000e+00 +1.590000e+02 5.000000e-01 5.000000e-01 1.590000e+02 5.000000e-01 5.000000e-01 8.300000e+00 1.700000e+00 1.700000e+00 +1.600000e+02 5.000000e-01 5.000000e-01 1.600000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.500000e+00 1.500000e+00 +1.610000e+02 5.000000e-01 5.000000e-01 1.610000e+02 5.000000e-01 5.000000e-01 1.570000e+01 1.800000e+00 1.800000e+00 +1.620000e+02 5.000000e-01 5.000000e-01 1.620000e+02 5.000000e-01 5.000000e-01 1.440000e+01 1.700000e+00 1.700000e+00 +1.630000e+02 5.000000e-01 5.000000e-01 1.630000e+02 5.000000e-01 5.000000e-01 9.900000e+00 1.600000e+00 1.600000e+00 +1.640000e+02 5.000000e-01 5.000000e-01 1.640000e+02 5.000000e-01 5.000000e-01 8.900000e+00 1.400000e+00 1.400000e+00 +1.650000e+02 5.000000e-01 5.000000e-01 1.650000e+02 5.000000e-01 5.000000e-01 7.000000e+00 1.100000e+00 1.100000e+00 +1.660000e+02 5.000000e-01 5.000000e-01 1.660000e+02 5.000000e-01 5.000000e-01 1.540000e+01 1.500000e+00 1.500000e+00 +1.670000e+02 5.000000e-01 5.000000e-01 1.670000e+02 5.000000e-01 5.000000e-01 2.610000e+01 1.700000e+00 1.700000e+00 +1.680000e+02 5.000000e-01 5.000000e-01 1.680000e+02 5.000000e-01 5.000000e-01 1.730000e+01 1.800000e+00 1.800000e+00 +1.690000e+02 5.000000e-01 5.000000e-01 1.690000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.700000e+02 5.000000e-01 5.000000e-01 1.700000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.710000e+02 5.000000e-01 5.000000e-01 1.710000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.720000e+02 5.000000e-01 5.000000e-01 1.720000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.730000e+02 5.000000e-01 5.000000e-01 1.730000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.740000e+02 5.000000e-01 5.000000e-01 1.740000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.750000e+02 5.000000e-01 5.000000e-01 1.750000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +1.760000e+02 5.000000e-01 5.000000e-01 1.760000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +1.770000e+02 5.000000e-01 5.000000e-01 1.770000e+02 5.000000e-01 5.000000e-01 3.000000e-01 1.000000e+00 1.000000e+00 +1.780000e+02 5.000000e-01 5.000000e-01 1.780000e+02 5.000000e-01 5.000000e-01 1.530000e+01 1.200000e+00 1.200000e+00 +1.790000e+02 5.000000e-01 5.000000e-01 1.790000e+02 5.000000e-01 5.000000e-01 2.050000e+01 1.500000e+00 1.500000e+00 +1.800000e+02 5.000000e-01 5.000000e-01 1.800000e+02 5.000000e-01 5.000000e-01 2.090000e+01 1.900000e+00 1.900000e+00 +1.810000e+02 5.000000e-01 5.000000e-01 1.810000e+02 5.000000e-01 5.000000e-01 2.260000e+01 1.600000e+00 1.600000e+00 +1.820000e+02 5.000000e-01 5.000000e-01 1.820000e+02 5.000000e-01 5.000000e-01 1.430000e+01 1.800000e+00 1.800000e+00 +1.830000e+02 5.000000e-01 5.000000e-01 1.830000e+02 5.000000e-01 5.000000e-01 8.800000e+00 1.900000e+00 1.900000e+00 +1.840000e+02 5.000000e-01 5.000000e-01 1.840000e+02 5.000000e-01 5.000000e-01 6.400000e+00 2.100000e+00 2.100000e+00 +1.850000e+02 5.000000e-01 5.000000e-01 1.850000e+02 5.000000e-01 5.000000e-01 2.390000e+01 2.100000e+00 2.100000e+00 +1.860000e+02 5.000000e-01 5.000000e-01 1.860000e+02 5.000000e-01 5.000000e-01 1.790000e+01 1.800000e+00 1.800000e+00 +1.870000e+02 5.000000e-01 5.000000e-01 1.870000e+02 5.000000e-01 5.000000e-01 1.140000e+01 1.600000e+00 1.600000e+00 +1.880000e+02 5.000000e-01 5.000000e-01 1.880000e+02 5.000000e-01 5.000000e-01 6.200000e+00 1.400000e+00 1.400000e+00 +1.890000e+02 5.000000e-01 5.000000e-01 1.890000e+02 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e+00 1.000000e+00 +1.900000e+02 5.000000e-01 5.000000e-01 1.900000e+02 5.000000e-01 5.000000e-01 5.400000e+00 1.300000e+00 1.300000e+00 +1.910000e+02 5.000000e-01 5.000000e-01 1.910000e+02 5.000000e-01 5.000000e-01 1.980000e+01 1.600000e+00 1.600000e+00 +1.920000e+02 5.000000e-01 5.000000e-01 1.920000e+02 5.000000e-01 5.000000e-01 3.290000e+01 2.000000e+00 2.000000e+00 +1.930000e+02 5.000000e-01 5.000000e-01 1.930000e+02 5.000000e-01 5.000000e-01 7.480000e+01 5.000000e-01 5.000000e-01 +1.940000e+02 5.000000e-01 5.000000e-01 1.940000e+02 5.000000e-01 5.000000e-01 4.010000e+01 1.000000e+00 1.000000e+00 +1.950000e+02 5.000000e-01 5.000000e-01 1.950000e+02 5.000000e-01 5.000000e-01 2.300000e+01 1.100000e+00 1.100000e+00 +1.960000e+02 5.000000e-01 5.000000e-01 1.960000e+02 5.000000e-01 5.000000e-01 1.250000e+01 1.100000e+00 1.100000e+00 +1.970000e+02 5.000000e-01 5.000000e-01 1.970000e+02 5.000000e-01 5.000000e-01 4.100000e+00 1.100000e+00 1.100000e+00 +1.980000e+02 5.000000e-01 5.000000e-01 1.980000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.000000e+00 1.000000e+00 +1.990000e+02 5.000000e-01 5.000000e-01 1.990000e+02 5.000000e-01 5.000000e-01 -1.300000e+00 1.000000e+00 1.000000e+00 +2.000000e+02 5.000000e-01 5.000000e-01 2.000000e+02 5.000000e-01 5.000000e-01 3.000000e-01 1.000000e+00 1.000000e+00 +2.010000e+02 5.000000e-01 5.000000e-01 2.010000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.020000e+02 5.000000e-01 5.000000e-01 2.020000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.030000e+02 5.000000e-01 5.000000e-01 2.030000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.040000e+02 5.000000e-01 5.000000e-01 2.040000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.050000e+02 5.000000e-01 5.000000e-01 2.050000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.060000e+02 5.000000e-01 5.000000e-01 2.060000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.070000e+02 5.000000e-01 5.000000e-01 2.070000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.080000e+02 5.000000e-01 5.000000e-01 2.080000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.090000e+02 5.000000e-01 5.000000e-01 2.090000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.100000e+02 5.000000e-01 5.000000e-01 2.100000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.110000e+02 5.000000e-01 5.000000e-01 2.110000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.120000e+02 5.000000e-01 5.000000e-01 2.120000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.130000e+02 5.000000e-01 5.000000e-01 2.130000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.140000e+02 5.000000e-01 5.000000e-01 2.140000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.150000e+02 5.000000e-01 5.000000e-01 2.150000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.160000e+02 5.000000e-01 5.000000e-01 2.160000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.170000e+02 5.000000e-01 5.000000e-01 2.170000e+02 5.000000e-01 5.000000e-01 7.700000e+00 1.000000e+00 1.000000e+00 +2.180000e+02 5.000000e-01 5.000000e-01 2.180000e+02 5.000000e-01 5.000000e-01 1.430000e+01 1.100000e+00 1.100000e+00 +2.190000e+02 5.000000e-01 5.000000e-01 2.190000e+02 5.000000e-01 5.000000e-01 2.300000e+01 1.200000e+00 1.200000e+00 +2.200000e+02 5.000000e-01 5.000000e-01 2.200000e+02 5.000000e-01 5.000000e-01 2.940000e+01 1.200000e+00 1.200000e+00 +2.210000e+02 5.000000e-01 5.000000e-01 2.210000e+02 5.000000e-01 5.000000e-01 2.860000e+01 1.200000e+00 1.200000e+00 +2.220000e+02 5.000000e-01 5.000000e-01 2.220000e+02 5.000000e-01 5.000000e-01 3.000000e+01 1.200000e+00 1.200000e+00 +2.230000e+02 5.000000e-01 5.000000e-01 2.230000e+02 5.000000e-01 5.000000e-01 1.940000e+01 1.200000e+00 1.200000e+00 +2.240000e+02 5.000000e-01 5.000000e-01 2.240000e+02 5.000000e-01 5.000000e-01 1.530000e+01 1.200000e+00 1.200000e+00 +2.250000e+02 5.000000e-01 5.000000e-01 2.250000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.260000e+02 5.000000e-01 5.000000e-01 2.260000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.270000e+02 5.000000e-01 5.000000e-01 2.270000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.280000e+02 5.000000e-01 5.000000e-01 2.280000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.290000e+02 5.000000e-01 5.000000e-01 2.290000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.300000e+02 5.000000e-01 5.000000e-01 2.300000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.310000e+02 5.000000e-01 5.000000e-01 2.310000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.320000e+02 5.000000e-01 5.000000e-01 2.320000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.330000e+02 5.000000e-01 5.000000e-01 2.330000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.340000e+02 5.000000e-01 5.000000e-01 2.340000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.350000e+02 5.000000e-01 5.000000e-01 2.350000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.360000e+02 5.000000e-01 5.000000e-01 2.360000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.370000e+02 5.000000e-01 5.000000e-01 2.370000e+02 5.000000e-01 5.000000e-01 6.990000e+01 7.000000e-01 7.000000e-01 +2.380000e+02 5.000000e-01 5.000000e-01 2.380000e+02 5.000000e-01 5.000000e-01 3.890000e+01 1.100000e+00 1.100000e+00 +2.390000e+02 5.000000e-01 5.000000e-01 2.390000e+02 5.000000e-01 5.000000e-01 2.340000e+01 1.200000e+00 1.200000e+00 +2.400000e+02 5.000000e-01 5.000000e-01 2.400000e+02 5.000000e-01 5.000000e-01 1.240000e+01 1.200000e+00 1.200000e+00 +2.410000e+02 5.000000e-01 5.000000e-01 2.410000e+02 5.000000e-01 5.000000e-01 4.700000e+00 1.100000e+00 1.100000e+00 +2.420000e+02 5.000000e-01 5.000000e-01 2.420000e+02 5.000000e-01 5.000000e-01 7.300000e+00 1.100000e+00 1.100000e+00 +2.430000e+02 5.000000e-01 5.000000e-01 2.430000e+02 5.000000e-01 5.000000e-01 9.000000e+00 1.200000e+00 1.200000e+00 +2.440000e+02 5.000000e-01 5.000000e-01 2.440000e+02 5.000000e-01 5.000000e-01 9.700000e+00 1.300000e+00 1.300000e+00 +2.450000e+02 5.000000e-01 5.000000e-01 2.450000e+02 5.000000e-01 5.000000e-01 1.270000e+01 1.300000e+00 1.300000e+00 +2.460000e+02 5.000000e-01 5.000000e-01 2.460000e+02 5.000000e-01 5.000000e-01 2.250000e+01 1.400000e+00 1.400000e+00 +2.470000e+02 5.000000e-01 5.000000e-01 2.470000e+02 5.000000e-01 5.000000e-01 2.160000e+01 1.500000e+00 1.500000e+00 +2.480000e+02 5.000000e-01 5.000000e-01 2.480000e+02 5.000000e-01 5.000000e-01 2.050000e+01 1.500000e+00 1.500000e+00 +2.490000e+02 5.000000e-01 5.000000e-01 2.490000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.500000e+02 5.000000e-01 5.000000e-01 2.500000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.510000e+02 5.000000e-01 5.000000e-01 2.510000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.520000e+02 5.000000e-01 5.000000e-01 2.520000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.530000e+02 5.000000e-01 5.000000e-01 2.530000e+02 5.000000e-01 5.000000e-01 7.310000e+01 1.000000e+00 1.000000e+00 +2.540000e+02 5.000000e-01 5.000000e-01 2.540000e+02 5.000000e-01 5.000000e-01 3.570000e+01 1.600000e+00 1.600000e+00 +2.550000e+02 5.000000e-01 5.000000e-01 2.550000e+02 5.000000e-01 5.000000e-01 2.030000e+01 1.700000e+00 1.700000e+00 +2.560000e+02 5.000000e-01 5.000000e-01 2.560000e+02 5.000000e-01 5.000000e-01 1.340000e+01 1.700000e+00 1.700000e+00 +2.570000e+02 5.000000e-01 5.000000e-01 2.570000e+02 5.000000e-01 5.000000e-01 3.510000e+01 1.600000e+00 1.600000e+00 +2.580000e+02 5.000000e-01 5.000000e-01 2.580000e+02 5.000000e-01 5.000000e-01 4.330000e+01 1.500000e+00 1.500000e+00 +2.590000e+02 5.000000e-01 5.000000e-01 2.590000e+02 5.000000e-01 5.000000e-01 3.840000e+01 1.500000e+00 1.500000e+00 +2.600000e+02 5.000000e-01 5.000000e-01 2.600000e+02 5.000000e-01 5.000000e-01 5.070000e+01 1.400000e+00 1.400000e+00 +2.610000e+02 5.000000e-01 5.000000e-01 2.610000e+02 5.000000e-01 5.000000e-01 1.850000e+01 1.200000e+00 1.200000e+00 +2.620000e+02 5.000000e-01 5.000000e-01 2.620000e+02 5.000000e-01 5.000000e-01 2.640000e+01 1.400000e+00 1.400000e+00 +2.630000e+02 5.000000e-01 5.000000e-01 2.630000e+02 5.000000e-01 5.000000e-01 2.960000e+01 1.400000e+00 1.400000e+00 +2.640000e+02 5.000000e-01 5.000000e-01 2.640000e+02 5.000000e-01 5.000000e-01 2.120000e+01 1.500000e+00 1.500000e+00 +2.650000e+02 5.000000e-01 5.000000e-01 2.650000e+02 5.000000e-01 5.000000e-01 2.800000e+00 1.000000e+00 1.000000e+00 +2.660000e+02 5.000000e-01 5.000000e-01 2.660000e+02 5.000000e-01 5.000000e-01 2.000000e+00 1.100000e+00 1.100000e+00 +2.670000e+02 5.000000e-01 5.000000e-01 2.670000e+02 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +2.680000e+02 5.000000e-01 5.000000e-01 2.680000e+02 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +2.690000e+02 5.000000e-01 5.000000e-01 2.690000e+02 5.000000e-01 5.000000e-01 7.900000e+00 1.400000e+00 1.400000e+00 +2.700000e+02 5.000000e-01 5.000000e-01 2.700000e+02 5.000000e-01 5.000000e-01 1.040000e+01 1.400000e+00 1.400000e+00 +2.710000e+02 5.000000e-01 5.000000e-01 2.710000e+02 5.000000e-01 5.000000e-01 1.050000e+01 1.600000e+00 1.600000e+00 +2.720000e+02 5.000000e-01 5.000000e-01 2.720000e+02 5.000000e-01 5.000000e-01 2.090000e+01 1.900000e+00 1.900000e+00 +2.730000e+02 5.000000e-01 5.000000e-01 2.730000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.740000e+02 5.000000e-01 5.000000e-01 2.740000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.750000e+02 5.000000e-01 5.000000e-01 2.750000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.760000e+02 5.000000e-01 5.000000e-01 2.760000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +2.770000e+02 5.000000e-01 5.000000e-01 2.770000e+02 5.000000e-01 5.000000e-01 3.390000e+01 1.600000e+00 1.600000e+00 +2.780000e+02 5.000000e-01 5.000000e-01 2.780000e+02 5.000000e-01 5.000000e-01 3.830000e+01 2.000000e+00 2.000000e+00 +2.790000e+02 5.000000e-01 5.000000e-01 2.790000e+02 5.000000e-01 5.000000e-01 1.690000e+01 2.200000e+00 2.200000e+00 +2.800000e+02 5.000000e-01 5.000000e-01 2.800000e+02 5.000000e-01 5.000000e-01 6.800000e+00 2.200000e+00 2.200000e+00 +2.810000e+02 5.000000e-01 5.000000e-01 2.810000e+02 5.000000e-01 5.000000e-01 2.090000e+01 1.900000e+00 1.900000e+00 +2.820000e+02 5.000000e-01 5.000000e-01 2.820000e+02 5.000000e-01 5.000000e-01 2.280000e+01 1.900000e+00 1.900000e+00 +2.830000e+02 5.000000e-01 5.000000e-01 2.830000e+02 5.000000e-01 5.000000e-01 2.500000e+01 2.000000e+00 2.000000e+00 +2.840000e+02 5.000000e-01 5.000000e-01 2.840000e+02 5.000000e-01 5.000000e-01 3.350000e+01 1.800000e+00 1.800000e+00 +2.850000e+02 5.000000e-01 5.000000e-01 2.850000e+02 5.000000e-01 5.000000e-01 3.800000e+00 1.100000e+00 1.100000e+00 +2.860000e+02 5.000000e-01 5.000000e-01 2.860000e+02 5.000000e-01 5.000000e-01 1.210000e+01 1.400000e+00 1.400000e+00 +2.870000e+02 5.000000e-01 5.000000e-01 2.870000e+02 5.000000e-01 5.000000e-01 2.040000e+01 1.600000e+00 1.600000e+00 +2.880000e+02 5.000000e-01 5.000000e-01 2.880000e+02 5.000000e-01 5.000000e-01 2.420000e+01 1.900000e+00 1.900000e+00 +2.890000e+02 5.000000e-01 5.000000e-01 2.890000e+02 5.000000e-01 5.000000e-01 5.100000e+00 1.000000e+00 1.000000e+00 +2.900000e+02 5.000000e-01 5.000000e-01 2.900000e+02 5.000000e-01 5.000000e-01 5.300000e+00 1.100000e+00 1.100000e+00 +2.910000e+02 5.000000e-01 5.000000e-01 2.910000e+02 5.000000e-01 5.000000e-01 1.000000e+01 1.200000e+00 1.200000e+00 +2.920000e+02 5.000000e-01 5.000000e-01 2.920000e+02 5.000000e-01 5.000000e-01 7.800000e+00 1.200000e+00 1.200000e+00 +2.930000e+02 5.000000e-01 5.000000e-01 2.930000e+02 5.000000e-01 5.000000e-01 1.290000e+01 1.300000e+00 1.300000e+00 +2.940000e+02 5.000000e-01 5.000000e-01 2.940000e+02 5.000000e-01 5.000000e-01 2.110000e+01 1.400000e+00 1.400000e+00 +2.950000e+02 5.000000e-01 5.000000e-01 2.950000e+02 5.000000e-01 5.000000e-01 1.700000e+01 1.500000e+00 1.500000e+00 +2.960000e+02 5.000000e-01 5.000000e-01 2.960000e+02 5.000000e-01 5.000000e-01 2.260000e+01 1.600000e+00 1.600000e+00 +2.970000e+02 5.000000e-01 5.000000e-01 2.970000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.980000e+02 5.000000e-01 5.000000e-01 2.980000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +2.990000e+02 5.000000e-01 5.000000e-01 2.990000e+02 5.000000e-01 5.000000e-01 7.310000e+01 1.000000e+00 1.000000e+00 +3.000000e+02 5.000000e-01 5.000000e-01 3.000000e+02 5.000000e-01 5.000000e-01 3.390000e+01 1.600000e+00 1.600000e+00 +3.010000e+02 5.000000e-01 5.000000e-01 3.010000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +3.020000e+02 5.000000e-01 5.000000e-01 3.020000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.030000e+02 5.000000e-01 5.000000e-01 3.030000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.040000e+02 5.000000e-01 5.000000e-01 3.040000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.050000e+02 5.000000e-01 5.000000e-01 3.050000e+02 5.000000e-01 5.000000e-01 4.250000e+01 1.600000e+00 1.600000e+00 +3.060000e+02 5.000000e-01 5.000000e-01 3.060000e+02 5.000000e-01 5.000000e-01 4.190000e+01 1.600000e+00 1.600000e+00 +3.070000e+02 5.000000e-01 5.000000e-01 3.070000e+02 5.000000e-01 5.000000e-01 3.930000e+01 1.600000e+00 1.600000e+00 +3.080000e+02 5.000000e-01 5.000000e-01 3.080000e+02 5.000000e-01 5.000000e-01 3.820000e+01 1.500000e+00 1.500000e+00 +3.090000e+02 5.000000e-01 5.000000e-01 3.090000e+02 5.000000e-01 5.000000e-01 1.770000e+01 1.200000e+00 1.200000e+00 +3.100000e+02 5.000000e-01 5.000000e-01 3.100000e+02 5.000000e-01 5.000000e-01 3.020000e+01 1.400000e+00 1.400000e+00 +3.110000e+02 5.000000e-01 5.000000e-01 3.110000e+02 5.000000e-01 5.000000e-01 3.020000e+01 1.500000e+00 1.500000e+00 +3.120000e+02 5.000000e-01 5.000000e-01 3.120000e+02 5.000000e-01 5.000000e-01 1.770000e+01 1.500000e+00 1.500000e+00 +3.130000e+02 5.000000e-01 5.000000e-01 3.130000e+02 5.000000e-01 5.000000e-01 2.000000e+00 1.100000e+00 1.100000e+00 +3.140000e+02 5.000000e-01 5.000000e-01 3.140000e+02 5.000000e-01 5.000000e-01 4.900000e+00 1.100000e+00 1.100000e+00 +3.150000e+02 5.000000e-01 5.000000e-01 3.150000e+02 5.000000e-01 5.000000e-01 4.500000e+00 1.200000e+00 1.200000e+00 +3.160000e+02 5.000000e-01 5.000000e-01 3.160000e+02 5.000000e-01 5.000000e-01 6.000000e+00 1.300000e+00 1.300000e+00 +3.170000e+02 5.000000e-01 5.000000e-01 3.170000e+02 5.000000e-01 5.000000e-01 4.500000e+00 1.300000e+00 1.300000e+00 +3.180000e+02 5.000000e-01 5.000000e-01 3.180000e+02 5.000000e-01 5.000000e-01 1.120000e+01 1.400000e+00 1.400000e+00 +3.190000e+02 5.000000e-01 5.000000e-01 3.190000e+02 5.000000e-01 5.000000e-01 1.370000e+01 1.600000e+00 1.600000e+00 +3.200000e+02 5.000000e-01 5.000000e-01 3.200000e+02 5.000000e-01 5.000000e-01 1.430000e+01 1.800000e+00 1.800000e+00 +3.210000e+02 5.000000e-01 5.000000e-01 3.210000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.220000e+02 5.000000e-01 5.000000e-01 3.220000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.230000e+02 5.000000e-01 5.000000e-01 3.230000e+02 5.000000e-01 5.000000e-01 3.570000e+01 1.600000e+00 1.600000e+00 +3.240000e+02 5.000000e-01 5.000000e-01 3.240000e+02 5.000000e-01 5.000000e-01 3.830000e+01 2.000000e+00 2.000000e+00 +3.250000e+02 5.000000e-01 5.000000e-01 3.250000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.260000e+02 5.000000e-01 5.000000e-01 3.260000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +3.270000e+02 5.000000e-01 5.000000e-01 3.270000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.280000e+02 5.000000e-01 5.000000e-01 3.280000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.290000e+02 5.000000e-01 5.000000e-01 3.290000e+02 5.000000e-01 5.000000e-01 7.700000e+00 1.700000e+00 1.700000e+00 +3.300000e+02 5.000000e-01 5.000000e-01 3.300000e+02 5.000000e-01 5.000000e-01 2.150000e+01 1.900000e+00 1.900000e+00 +3.310000e+02 5.000000e-01 5.000000e-01 3.310000e+02 5.000000e-01 5.000000e-01 2.080000e+01 2.000000e+00 2.000000e+00 +3.320000e+02 5.000000e-01 5.000000e-01 3.320000e+02 5.000000e-01 5.000000e-01 4.440000e+01 1.800000e+00 1.800000e+00 +3.330000e+02 5.000000e-01 5.000000e-01 3.330000e+02 5.000000e-01 5.000000e-01 6.400000e+00 1.200000e+00 1.200000e+00 +3.340000e+02 5.000000e-01 5.000000e-01 3.340000e+02 5.000000e-01 5.000000e-01 6.300000e+00 1.400000e+00 1.400000e+00 +3.350000e+02 5.000000e-01 5.000000e-01 3.350000e+02 5.000000e-01 5.000000e-01 1.940000e+01 1.600000e+00 1.600000e+00 +3.360000e+02 5.000000e-01 5.000000e-01 3.360000e+02 5.000000e-01 5.000000e-01 2.330000e+01 2.000000e+00 2.000000e+00 +3.370000e+02 5.000000e-01 5.000000e-01 3.370000e+02 5.000000e-01 5.000000e-01 8.000000e-01 1.100000e+00 1.100000e+00 +3.380000e+02 5.000000e-01 5.000000e-01 3.380000e+02 5.000000e-01 5.000000e-01 1.700000e+00 1.100000e+00 1.100000e+00 +3.390000e+02 5.000000e-01 5.000000e-01 3.390000e+02 5.000000e-01 5.000000e-01 8.000000e-01 1.100000e+00 1.100000e+00 +3.400000e+02 5.000000e-01 5.000000e-01 3.400000e+02 5.000000e-01 5.000000e-01 4.300000e+00 1.300000e+00 1.300000e+00 +3.410000e+02 5.000000e-01 5.000000e-01 3.410000e+02 5.000000e-01 5.000000e-01 6.900000e+00 1.300000e+00 1.300000e+00 +3.420000e+02 5.000000e-01 5.000000e-01 3.420000e+02 5.000000e-01 5.000000e-01 5.600000e+00 1.500000e+00 1.500000e+00 +3.430000e+02 5.000000e-01 5.000000e-01 3.430000e+02 5.000000e-01 5.000000e-01 8.300000e+00 1.700000e+00 1.700000e+00 +3.440000e+02 5.000000e-01 5.000000e-01 3.440000e+02 5.000000e-01 5.000000e-01 8.800000e+00 1.900000e+00 1.900000e+00 +3.450000e+02 5.000000e-01 5.000000e-01 3.450000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.460000e+02 5.000000e-01 5.000000e-01 3.460000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.470000e+02 5.000000e-01 5.000000e-01 3.470000e+02 5.000000e-01 5.000000e-01 2.030000e+01 1.700000e+00 1.700000e+00 +3.480000e+02 5.000000e-01 5.000000e-01 3.480000e+02 5.000000e-01 5.000000e-01 1.690000e+01 2.200000e+00 2.200000e+00 +3.490000e+02 5.000000e-01 5.000000e-01 3.490000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.500000e+02 5.000000e-01 5.000000e-01 3.500000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.510000e+02 5.000000e-01 5.000000e-01 3.510000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +3.520000e+02 5.000000e-01 5.000000e-01 3.520000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.530000e+02 5.000000e-01 5.000000e-01 3.530000e+02 5.000000e-01 5.000000e-01 8.000000e+00 1.900000e+00 1.900000e+00 +3.540000e+02 5.000000e-01 5.000000e-01 3.540000e+02 5.000000e-01 5.000000e-01 1.230000e+01 2.000000e+00 2.000000e+00 +3.550000e+02 5.000000e-01 5.000000e-01 3.550000e+02 5.000000e-01 5.000000e-01 1.030000e+01 2.100000e+00 2.100000e+00 +3.560000e+02 5.000000e-01 5.000000e-01 3.560000e+02 5.000000e-01 5.000000e-01 2.020000e+01 2.100000e+00 2.100000e+00 +3.570000e+02 5.000000e-01 5.000000e-01 3.570000e+02 5.000000e-01 5.000000e-01 9.000000e-01 1.100000e+00 1.100000e+00 +3.580000e+02 5.000000e-01 5.000000e-01 3.580000e+02 5.000000e-01 5.000000e-01 3.900000e+00 1.300000e+00 1.300000e+00 +3.590000e+02 5.000000e-01 5.000000e-01 3.590000e+02 5.000000e-01 5.000000e-01 5.800000e+00 1.600000e+00 1.600000e+00 +3.600000e+02 5.000000e-01 5.000000e-01 3.600000e+02 5.000000e-01 5.000000e-01 1.390000e+01 1.900000e+00 1.900000e+00 +3.610000e+02 5.000000e-01 5.000000e-01 3.610000e+02 5.000000e-01 5.000000e-01 3.000000e-01 1.000000e+00 1.000000e+00 +3.620000e+02 5.000000e-01 5.000000e-01 3.620000e+02 5.000000e-01 5.000000e-01 1.000000e-01 1.100000e+00 1.100000e+00 +3.630000e+02 5.000000e-01 5.000000e-01 3.630000e+02 5.000000e-01 5.000000e-01 -7.000000e-01 1.100000e+00 1.100000e+00 +3.640000e+02 5.000000e-01 5.000000e-01 3.640000e+02 5.000000e-01 5.000000e-01 4.000000e+00 1.400000e+00 1.400000e+00 +3.650000e+02 5.000000e-01 5.000000e-01 3.650000e+02 5.000000e-01 5.000000e-01 1.500000e+00 1.400000e+00 1.400000e+00 +3.660000e+02 5.000000e-01 5.000000e-01 3.660000e+02 5.000000e-01 5.000000e-01 2.300000e+00 1.400000e+00 1.400000e+00 +3.670000e+02 5.000000e-01 5.000000e-01 3.670000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.500000e+00 1.500000e+00 +3.680000e+02 5.000000e-01 5.000000e-01 3.680000e+02 5.000000e-01 5.000000e-01 6.400000e+00 2.100000e+00 2.100000e+00 +3.690000e+02 5.000000e-01 5.000000e-01 3.690000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.700000e+02 5.000000e-01 5.000000e-01 3.700000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.710000e+02 5.000000e-01 5.000000e-01 3.710000e+02 5.000000e-01 5.000000e-01 1.340000e+01 1.700000e+00 1.700000e+00 +3.720000e+02 5.000000e-01 5.000000e-01 3.720000e+02 5.000000e-01 5.000000e-01 6.800000e+00 2.200000e+00 2.200000e+00 +3.730000e+02 5.000000e-01 5.000000e-01 3.730000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.740000e+02 5.000000e-01 5.000000e-01 3.740000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.750000e+02 5.000000e-01 5.000000e-01 3.750000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.760000e+02 5.000000e-01 5.000000e-01 3.760000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +3.770000e+02 5.000000e-01 5.000000e-01 3.770000e+02 5.000000e-01 5.000000e-01 7.300000e+00 2.000000e+00 2.000000e+00 +3.780000e+02 5.000000e-01 5.000000e-01 3.780000e+02 5.000000e-01 5.000000e-01 7.400000e+00 2.000000e+00 2.000000e+00 +3.790000e+02 5.000000e-01 5.000000e-01 3.790000e+02 5.000000e-01 5.000000e-01 4.800000e+00 2.100000e+00 2.100000e+00 +3.800000e+02 5.000000e-01 5.000000e-01 3.800000e+02 5.000000e-01 5.000000e-01 1.030000e+01 2.100000e+00 2.100000e+00 +3.810000e+02 5.000000e-01 5.000000e-01 3.810000e+02 5.000000e-01 5.000000e-01 1.000000e+00 1.100000e+00 1.100000e+00 +3.820000e+02 5.000000e-01 5.000000e-01 3.820000e+02 5.000000e-01 5.000000e-01 1.600000e+00 1.200000e+00 1.200000e+00 +3.830000e+02 5.000000e-01 5.000000e-01 3.830000e+02 5.000000e-01 5.000000e-01 3.500000e+00 1.600000e+00 1.600000e+00 +3.840000e+02 5.000000e-01 5.000000e-01 3.840000e+02 5.000000e-01 5.000000e-01 4.500000e+00 1.900000e+00 1.900000e+00 +3.850000e+02 5.000000e-01 5.000000e-01 3.850000e+02 5.000000e-01 5.000000e-01 -8.000000e-01 1.000000e+00 1.000000e+00 +3.860000e+02 5.000000e-01 5.000000e-01 3.860000e+02 5.000000e-01 5.000000e-01 1.100000e+00 1.000000e+00 1.000000e+00 +3.870000e+02 5.000000e-01 5.000000e-01 3.870000e+02 5.000000e-01 5.000000e-01 2.100000e+00 1.100000e+00 1.100000e+00 +3.880000e+02 5.000000e-01 5.000000e-01 3.880000e+02 5.000000e-01 5.000000e-01 3.500000e+00 1.200000e+00 1.200000e+00 +3.890000e+02 5.000000e-01 5.000000e-01 3.890000e+02 5.000000e-01 5.000000e-01 2.800000e+00 1.200000e+00 1.200000e+00 +3.900000e+02 5.000000e-01 5.000000e-01 3.900000e+02 5.000000e-01 5.000000e-01 1.090000e+01 1.500000e+00 1.500000e+00 +3.910000e+02 5.000000e-01 5.000000e-01 3.910000e+02 5.000000e-01 5.000000e-01 1.570000e+01 1.800000e+00 1.800000e+00 +3.920000e+02 5.000000e-01 5.000000e-01 3.920000e+02 5.000000e-01 5.000000e-01 2.390000e+01 2.100000e+00 2.100000e+00 +3.930000e+02 5.000000e-01 5.000000e-01 3.930000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.940000e+02 5.000000e-01 5.000000e-01 3.940000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +3.950000e+02 5.000000e-01 5.000000e-01 3.950000e+02 5.000000e-01 5.000000e-01 3.510000e+01 1.600000e+00 1.600000e+00 +3.960000e+02 5.000000e-01 5.000000e-01 3.960000e+02 5.000000e-01 5.000000e-01 2.090000e+01 1.900000e+00 1.900000e+00 +3.970000e+02 5.000000e-01 5.000000e-01 3.970000e+02 5.000000e-01 5.000000e-01 4.250000e+01 1.600000e+00 1.600000e+00 +3.980000e+02 5.000000e-01 5.000000e-01 3.980000e+02 5.000000e-01 5.000000e-01 7.700000e+00 1.700000e+00 1.700000e+00 +3.990000e+02 5.000000e-01 5.000000e-01 3.990000e+02 5.000000e-01 5.000000e-01 8.000000e+00 1.900000e+00 1.900000e+00 +4.000000e+02 5.000000e-01 5.000000e-01 4.000000e+02 5.000000e-01 5.000000e-01 7.300000e+00 2.000000e+00 2.000000e+00 +4.010000e+02 5.000000e-01 5.000000e-01 4.010000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +4.020000e+02 5.000000e-01 5.000000e-01 4.020000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.030000e+02 5.000000e-01 5.000000e-01 4.030000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.040000e+02 5.000000e-01 5.000000e-01 4.040000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.050000e+02 5.000000e-01 5.000000e-01 4.050000e+02 5.000000e-01 5.000000e-01 9.900000e+00 1.300000e+00 1.300000e+00 +4.060000e+02 5.000000e-01 5.000000e-01 4.060000e+02 5.000000e-01 5.000000e-01 1.620000e+01 1.500000e+00 1.500000e+00 +4.070000e+02 5.000000e-01 5.000000e-01 4.070000e+02 5.000000e-01 5.000000e-01 1.220000e+01 1.500000e+00 1.500000e+00 +4.080000e+02 5.000000e-01 5.000000e-01 4.080000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.500000e+00 1.500000e+00 +4.090000e+02 5.000000e-01 5.000000e-01 4.090000e+02 5.000000e-01 5.000000e-01 -1.000000e-01 1.000000e+00 1.000000e+00 +4.100000e+02 5.000000e-01 5.000000e-01 4.100000e+02 5.000000e-01 5.000000e-01 1.200000e+00 1.100000e+00 1.100000e+00 +4.110000e+02 5.000000e-01 5.000000e-01 4.110000e+02 5.000000e-01 5.000000e-01 2.800000e+00 1.100000e+00 1.100000e+00 +4.120000e+02 5.000000e-01 5.000000e-01 4.120000e+02 5.000000e-01 5.000000e-01 5.400000e+00 1.300000e+00 1.300000e+00 +4.130000e+02 5.000000e-01 5.000000e-01 4.130000e+02 5.000000e-01 5.000000e-01 7.400000e+00 1.400000e+00 1.400000e+00 +4.140000e+02 5.000000e-01 5.000000e-01 4.140000e+02 5.000000e-01 5.000000e-01 1.780000e+01 1.500000e+00 1.500000e+00 +4.150000e+02 5.000000e-01 5.000000e-01 4.150000e+02 5.000000e-01 5.000000e-01 1.440000e+01 1.700000e+00 1.700000e+00 +4.160000e+02 5.000000e-01 5.000000e-01 4.160000e+02 5.000000e-01 5.000000e-01 1.790000e+01 1.800000e+00 1.800000e+00 +4.170000e+02 5.000000e-01 5.000000e-01 4.170000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.180000e+02 5.000000e-01 5.000000e-01 4.180000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.190000e+02 5.000000e-01 5.000000e-01 4.190000e+02 5.000000e-01 5.000000e-01 4.330000e+01 1.500000e+00 1.500000e+00 +4.200000e+02 5.000000e-01 5.000000e-01 4.200000e+02 5.000000e-01 5.000000e-01 2.280000e+01 1.900000e+00 1.900000e+00 +4.210000e+02 5.000000e-01 5.000000e-01 4.210000e+02 5.000000e-01 5.000000e-01 4.190000e+01 1.600000e+00 1.600000e+00 +4.220000e+02 5.000000e-01 5.000000e-01 4.220000e+02 5.000000e-01 5.000000e-01 2.150000e+01 1.900000e+00 1.900000e+00 +4.230000e+02 5.000000e-01 5.000000e-01 4.230000e+02 5.000000e-01 5.000000e-01 1.230000e+01 2.000000e+00 2.000000e+00 +4.240000e+02 5.000000e-01 5.000000e-01 4.240000e+02 5.000000e-01 5.000000e-01 7.400000e+00 2.000000e+00 2.000000e+00 +4.250000e+02 5.000000e-01 5.000000e-01 4.250000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.260000e+02 5.000000e-01 5.000000e-01 4.260000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +4.270000e+02 5.000000e-01 5.000000e-01 4.270000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.280000e+02 5.000000e-01 5.000000e-01 4.280000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.290000e+02 5.000000e-01 5.000000e-01 4.290000e+02 5.000000e-01 5.000000e-01 9.100000e+00 1.300000e+00 1.300000e+00 +4.300000e+02 5.000000e-01 5.000000e-01 4.300000e+02 5.000000e-01 5.000000e-01 1.560000e+01 1.500000e+00 1.500000e+00 +4.310000e+02 5.000000e-01 5.000000e-01 4.310000e+02 5.000000e-01 5.000000e-01 1.780000e+01 1.600000e+00 1.600000e+00 +4.320000e+02 5.000000e-01 5.000000e-01 4.320000e+02 5.000000e-01 5.000000e-01 1.420000e+01 1.700000e+00 1.700000e+00 +4.330000e+02 5.000000e-01 5.000000e-01 4.330000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.100000e+00 1.100000e+00 +4.340000e+02 5.000000e-01 5.000000e-01 4.340000e+02 5.000000e-01 5.000000e-01 4.700000e+00 1.100000e+00 1.100000e+00 +4.350000e+02 5.000000e-01 5.000000e-01 4.350000e+02 5.000000e-01 5.000000e-01 5.700000e+00 1.300000e+00 1.300000e+00 +4.360000e+02 5.000000e-01 5.000000e-01 4.360000e+02 5.000000e-01 5.000000e-01 4.200000e+00 1.300000e+00 1.300000e+00 +4.370000e+02 5.000000e-01 5.000000e-01 4.370000e+02 5.000000e-01 5.000000e-01 1.100000e+01 1.400000e+00 1.400000e+00 +4.380000e+02 5.000000e-01 5.000000e-01 4.380000e+02 5.000000e-01 5.000000e-01 1.140000e+01 1.400000e+00 1.400000e+00 +4.390000e+02 5.000000e-01 5.000000e-01 4.390000e+02 5.000000e-01 5.000000e-01 9.900000e+00 1.600000e+00 1.600000e+00 +4.400000e+02 5.000000e-01 5.000000e-01 4.400000e+02 5.000000e-01 5.000000e-01 1.140000e+01 1.600000e+00 1.600000e+00 +4.410000e+02 5.000000e-01 5.000000e-01 4.410000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.420000e+02 5.000000e-01 5.000000e-01 4.420000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.430000e+02 5.000000e-01 5.000000e-01 4.430000e+02 5.000000e-01 5.000000e-01 3.840000e+01 1.500000e+00 1.500000e+00 +4.440000e+02 5.000000e-01 5.000000e-01 4.440000e+02 5.000000e-01 5.000000e-01 2.500000e+01 2.000000e+00 2.000000e+00 +4.450000e+02 5.000000e-01 5.000000e-01 4.450000e+02 5.000000e-01 5.000000e-01 3.930000e+01 1.600000e+00 1.600000e+00 +4.460000e+02 5.000000e-01 5.000000e-01 4.460000e+02 5.000000e-01 5.000000e-01 2.080000e+01 2.000000e+00 2.000000e+00 +4.470000e+02 5.000000e-01 5.000000e-01 4.470000e+02 5.000000e-01 5.000000e-01 1.030000e+01 2.100000e+00 2.100000e+00 +4.480000e+02 5.000000e-01 5.000000e-01 4.480000e+02 5.000000e-01 5.000000e-01 4.800000e+00 2.100000e+00 2.100000e+00 +4.490000e+02 5.000000e-01 5.000000e-01 4.490000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.500000e+02 5.000000e-01 5.000000e-01 4.500000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.510000e+02 5.000000e-01 5.000000e-01 4.510000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +4.520000e+02 5.000000e-01 5.000000e-01 4.520000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.530000e+02 5.000000e-01 5.000000e-01 4.530000e+02 5.000000e-01 5.000000e-01 1.040000e+01 1.200000e+00 1.200000e+00 +4.540000e+02 5.000000e-01 5.000000e-01 4.540000e+02 5.000000e-01 5.000000e-01 1.160000e+01 1.400000e+00 1.400000e+00 +4.550000e+02 5.000000e-01 5.000000e-01 4.550000e+02 5.000000e-01 5.000000e-01 1.360000e+01 1.600000e+00 1.600000e+00 +4.560000e+02 5.000000e-01 5.000000e-01 4.560000e+02 5.000000e-01 5.000000e-01 1.880000e+01 1.900000e+00 1.900000e+00 +4.570000e+02 5.000000e-01 5.000000e-01 4.570000e+02 5.000000e-01 5.000000e-01 6.800000e+00 1.100000e+00 1.100000e+00 +4.580000e+02 5.000000e-01 5.000000e-01 4.580000e+02 5.000000e-01 5.000000e-01 6.900000e+00 1.200000e+00 1.200000e+00 +4.590000e+02 5.000000e-01 5.000000e-01 4.590000e+02 5.000000e-01 5.000000e-01 8.900000e+00 1.300000e+00 1.300000e+00 +4.600000e+02 5.000000e-01 5.000000e-01 4.600000e+02 5.000000e-01 5.000000e-01 8.900000e+00 1.300000e+00 1.300000e+00 +4.610000e+02 5.000000e-01 5.000000e-01 4.610000e+02 5.000000e-01 5.000000e-01 8.400000e+00 1.400000e+00 1.400000e+00 +4.620000e+02 5.000000e-01 5.000000e-01 4.620000e+02 5.000000e-01 5.000000e-01 1.020000e+01 1.300000e+00 1.300000e+00 +4.630000e+02 5.000000e-01 5.000000e-01 4.630000e+02 5.000000e-01 5.000000e-01 8.900000e+00 1.400000e+00 1.400000e+00 +4.640000e+02 5.000000e-01 5.000000e-01 4.640000e+02 5.000000e-01 5.000000e-01 6.200000e+00 1.400000e+00 1.400000e+00 +4.650000e+02 5.000000e-01 5.000000e-01 4.650000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.660000e+02 5.000000e-01 5.000000e-01 4.660000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.670000e+02 5.000000e-01 5.000000e-01 4.670000e+02 5.000000e-01 5.000000e-01 5.070000e+01 1.400000e+00 1.400000e+00 +4.680000e+02 5.000000e-01 5.000000e-01 4.680000e+02 5.000000e-01 5.000000e-01 3.350000e+01 1.800000e+00 1.800000e+00 +4.690000e+02 5.000000e-01 5.000000e-01 4.690000e+02 5.000000e-01 5.000000e-01 3.820000e+01 1.500000e+00 1.500000e+00 +4.700000e+02 5.000000e-01 5.000000e-01 4.700000e+02 5.000000e-01 5.000000e-01 4.440000e+01 1.800000e+00 1.800000e+00 +4.710000e+02 5.000000e-01 5.000000e-01 4.710000e+02 5.000000e-01 5.000000e-01 2.020000e+01 2.100000e+00 2.100000e+00 +4.720000e+02 5.000000e-01 5.000000e-01 4.720000e+02 5.000000e-01 5.000000e-01 1.030000e+01 2.100000e+00 2.100000e+00 +4.730000e+02 5.000000e-01 5.000000e-01 4.730000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.740000e+02 5.000000e-01 5.000000e-01 4.740000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.750000e+02 5.000000e-01 5.000000e-01 4.750000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.760000e+02 5.000000e-01 5.000000e-01 4.760000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +4.770000e+02 5.000000e-01 5.000000e-01 4.770000e+02 5.000000e-01 5.000000e-01 7.100000e+00 1.200000e+00 1.200000e+00 +4.780000e+02 5.000000e-01 5.000000e-01 4.780000e+02 5.000000e-01 5.000000e-01 1.420000e+01 1.400000e+00 1.400000e+00 +4.790000e+02 5.000000e-01 5.000000e-01 4.790000e+02 5.000000e-01 5.000000e-01 2.550000e+01 1.600000e+00 1.600000e+00 +4.800000e+02 5.000000e-01 5.000000e-01 4.800000e+02 5.000000e-01 5.000000e-01 2.300000e+01 1.800000e+00 1.800000e+00 +4.810000e+02 5.000000e-01 5.000000e-01 4.810000e+02 5.000000e-01 5.000000e-01 9.800000e+00 1.100000e+00 1.100000e+00 +4.820000e+02 5.000000e-01 5.000000e-01 4.820000e+02 5.000000e-01 5.000000e-01 1.850000e+01 1.200000e+00 1.200000e+00 +4.830000e+02 5.000000e-01 5.000000e-01 4.830000e+02 5.000000e-01 5.000000e-01 2.590000e+01 1.200000e+00 1.200000e+00 +4.840000e+02 5.000000e-01 5.000000e-01 4.840000e+02 5.000000e-01 5.000000e-01 2.690000e+01 1.200000e+00 1.200000e+00 +4.850000e+02 5.000000e-01 5.000000e-01 4.850000e+02 5.000000e-01 5.000000e-01 2.050000e+01 1.300000e+00 1.300000e+00 +4.860000e+02 5.000000e-01 5.000000e-01 4.860000e+02 5.000000e-01 5.000000e-01 1.620000e+01 1.200000e+00 1.200000e+00 +4.870000e+02 5.000000e-01 5.000000e-01 4.870000e+02 5.000000e-01 5.000000e-01 7.000000e+00 1.100000e+00 1.100000e+00 +4.880000e+02 5.000000e-01 5.000000e-01 4.880000e+02 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e+00 1.000000e+00 +4.890000e+02 5.000000e-01 5.000000e-01 4.890000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +4.900000e+02 5.000000e-01 5.000000e-01 4.900000e+02 5.000000e-01 5.000000e-01 6.990000e+01 7.000000e-01 7.000000e-01 +4.910000e+02 5.000000e-01 5.000000e-01 4.910000e+02 5.000000e-01 5.000000e-01 1.850000e+01 1.200000e+00 1.200000e+00 +4.920000e+02 5.000000e-01 5.000000e-01 4.920000e+02 5.000000e-01 5.000000e-01 3.800000e+00 1.100000e+00 1.100000e+00 +4.930000e+02 5.000000e-01 5.000000e-01 4.930000e+02 5.000000e-01 5.000000e-01 1.770000e+01 1.200000e+00 1.200000e+00 +4.940000e+02 5.000000e-01 5.000000e-01 4.940000e+02 5.000000e-01 5.000000e-01 6.400000e+00 1.200000e+00 1.200000e+00 +4.950000e+02 5.000000e-01 5.000000e-01 4.950000e+02 5.000000e-01 5.000000e-01 9.000000e-01 1.100000e+00 1.100000e+00 +4.960000e+02 5.000000e-01 5.000000e-01 4.960000e+02 5.000000e-01 5.000000e-01 1.000000e+00 1.100000e+00 1.100000e+00 +4.970000e+02 5.000000e-01 5.000000e-01 4.970000e+02 5.000000e-01 5.000000e-01 9.900000e+00 1.300000e+00 1.300000e+00 +4.980000e+02 5.000000e-01 5.000000e-01 4.980000e+02 5.000000e-01 5.000000e-01 9.100000e+00 1.300000e+00 1.300000e+00 +4.990000e+02 5.000000e-01 5.000000e-01 4.990000e+02 5.000000e-01 5.000000e-01 1.040000e+01 1.200000e+00 1.200000e+00 +5.000000e+02 5.000000e-01 5.000000e-01 5.000000e+02 5.000000e-01 5.000000e-01 7.100000e+00 1.200000e+00 1.200000e+00 +5.010000e+02 5.000000e-01 5.000000e-01 5.010000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +5.020000e+02 5.000000e-01 5.000000e-01 5.020000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.030000e+02 5.000000e-01 5.000000e-01 5.030000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.040000e+02 5.000000e-01 5.000000e-01 5.040000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.050000e+02 5.000000e-01 5.000000e-01 5.050000e+02 5.000000e-01 5.000000e-01 3.500000e+00 1.000000e+00 1.000000e+00 +5.060000e+02 5.000000e-01 5.000000e-01 5.060000e+02 5.000000e-01 5.000000e-01 3.900000e+00 1.100000e+00 1.100000e+00 +5.070000e+02 5.000000e-01 5.000000e-01 5.070000e+02 5.000000e-01 5.000000e-01 9.600000e+00 1.200000e+00 1.200000e+00 +5.080000e+02 5.000000e-01 5.000000e-01 5.080000e+02 5.000000e-01 5.000000e-01 1.620000e+01 1.300000e+00 1.300000e+00 +5.090000e+02 5.000000e-01 5.000000e-01 5.090000e+02 5.000000e-01 5.000000e-01 2.430000e+01 1.400000e+00 1.400000e+00 +5.100000e+02 5.000000e-01 5.000000e-01 5.100000e+02 5.000000e-01 5.000000e-01 2.780000e+01 1.400000e+00 1.400000e+00 +5.110000e+02 5.000000e-01 5.000000e-01 5.110000e+02 5.000000e-01 5.000000e-01 1.540000e+01 1.500000e+00 1.500000e+00 +5.120000e+02 5.000000e-01 5.000000e-01 5.120000e+02 5.000000e-01 5.000000e-01 5.400000e+00 1.300000e+00 1.300000e+00 +5.130000e+02 5.000000e-01 5.000000e-01 5.130000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.140000e+02 5.000000e-01 5.000000e-01 5.140000e+02 5.000000e-01 5.000000e-01 3.890000e+01 1.100000e+00 1.100000e+00 +5.150000e+02 5.000000e-01 5.000000e-01 5.150000e+02 5.000000e-01 5.000000e-01 2.640000e+01 1.400000e+00 1.400000e+00 +5.160000e+02 5.000000e-01 5.000000e-01 5.160000e+02 5.000000e-01 5.000000e-01 1.210000e+01 1.400000e+00 1.400000e+00 +5.170000e+02 5.000000e-01 5.000000e-01 5.170000e+02 5.000000e-01 5.000000e-01 3.020000e+01 1.400000e+00 1.400000e+00 +5.180000e+02 5.000000e-01 5.000000e-01 5.180000e+02 5.000000e-01 5.000000e-01 6.300000e+00 1.400000e+00 1.400000e+00 +5.190000e+02 5.000000e-01 5.000000e-01 5.190000e+02 5.000000e-01 5.000000e-01 3.900000e+00 1.300000e+00 1.300000e+00 +5.200000e+02 5.000000e-01 5.000000e-01 5.200000e+02 5.000000e-01 5.000000e-01 1.600000e+00 1.200000e+00 1.200000e+00 +5.210000e+02 5.000000e-01 5.000000e-01 5.210000e+02 5.000000e-01 5.000000e-01 1.620000e+01 1.500000e+00 1.500000e+00 +5.220000e+02 5.000000e-01 5.000000e-01 5.220000e+02 5.000000e-01 5.000000e-01 1.560000e+01 1.500000e+00 1.500000e+00 +5.230000e+02 5.000000e-01 5.000000e-01 5.230000e+02 5.000000e-01 5.000000e-01 1.160000e+01 1.400000e+00 1.400000e+00 +5.240000e+02 5.000000e-01 5.000000e-01 5.240000e+02 5.000000e-01 5.000000e-01 1.420000e+01 1.400000e+00 1.400000e+00 +5.250000e+02 5.000000e-01 5.000000e-01 5.250000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.260000e+02 5.000000e-01 5.000000e-01 5.260000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +5.270000e+02 5.000000e-01 5.000000e-01 5.270000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.280000e+02 5.000000e-01 5.000000e-01 5.280000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.290000e+02 5.000000e-01 5.000000e-01 5.290000e+02 5.000000e-01 5.000000e-01 5.000000e-01 1.000000e+00 1.000000e+00 +5.300000e+02 5.000000e-01 5.000000e-01 5.300000e+02 5.000000e-01 5.000000e-01 2.400000e+00 1.100000e+00 1.100000e+00 +5.310000e+02 5.000000e-01 5.000000e-01 5.310000e+02 5.000000e-01 5.000000e-01 5.200000e+00 1.200000e+00 1.200000e+00 +5.320000e+02 5.000000e-01 5.000000e-01 5.320000e+02 5.000000e-01 5.000000e-01 7.800000e+00 1.200000e+00 1.200000e+00 +5.330000e+02 5.000000e-01 5.000000e-01 5.330000e+02 5.000000e-01 5.000000e-01 1.000000e+01 1.300000e+00 1.300000e+00 +5.340000e+02 5.000000e-01 5.000000e-01 5.340000e+02 5.000000e-01 5.000000e-01 2.640000e+01 1.500000e+00 1.500000e+00 +5.350000e+02 5.000000e-01 5.000000e-01 5.350000e+02 5.000000e-01 5.000000e-01 2.610000e+01 1.700000e+00 1.700000e+00 +5.360000e+02 5.000000e-01 5.000000e-01 5.360000e+02 5.000000e-01 5.000000e-01 1.980000e+01 1.600000e+00 1.600000e+00 +5.370000e+02 5.000000e-01 5.000000e-01 5.370000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.380000e+02 5.000000e-01 5.000000e-01 5.380000e+02 5.000000e-01 5.000000e-01 2.340000e+01 1.200000e+00 1.200000e+00 +5.390000e+02 5.000000e-01 5.000000e-01 5.390000e+02 5.000000e-01 5.000000e-01 2.960000e+01 1.400000e+00 1.400000e+00 +5.400000e+02 5.000000e-01 5.000000e-01 5.400000e+02 5.000000e-01 5.000000e-01 2.040000e+01 1.600000e+00 1.600000e+00 +5.410000e+02 5.000000e-01 5.000000e-01 5.410000e+02 5.000000e-01 5.000000e-01 3.020000e+01 1.500000e+00 1.500000e+00 +5.420000e+02 5.000000e-01 5.000000e-01 5.420000e+02 5.000000e-01 5.000000e-01 1.940000e+01 1.600000e+00 1.600000e+00 +5.430000e+02 5.000000e-01 5.000000e-01 5.430000e+02 5.000000e-01 5.000000e-01 5.800000e+00 1.600000e+00 1.600000e+00 +5.440000e+02 5.000000e-01 5.000000e-01 5.440000e+02 5.000000e-01 5.000000e-01 3.500000e+00 1.600000e+00 1.600000e+00 +5.450000e+02 5.000000e-01 5.000000e-01 5.450000e+02 5.000000e-01 5.000000e-01 1.220000e+01 1.500000e+00 1.500000e+00 +5.460000e+02 5.000000e-01 5.000000e-01 5.460000e+02 5.000000e-01 5.000000e-01 1.780000e+01 1.600000e+00 1.600000e+00 +5.470000e+02 5.000000e-01 5.000000e-01 5.470000e+02 5.000000e-01 5.000000e-01 1.360000e+01 1.600000e+00 1.600000e+00 +5.480000e+02 5.000000e-01 5.000000e-01 5.480000e+02 5.000000e-01 5.000000e-01 2.550000e+01 1.600000e+00 1.600000e+00 +5.490000e+02 5.000000e-01 5.000000e-01 5.490000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.500000e+02 5.000000e-01 5.000000e-01 5.500000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.510000e+02 5.000000e-01 5.000000e-01 5.510000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +5.520000e+02 5.000000e-01 5.000000e-01 5.520000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.530000e+02 5.000000e-01 5.000000e-01 5.530000e+02 5.000000e-01 5.000000e-01 2.700000e+00 1.000000e+00 1.000000e+00 +5.540000e+02 5.000000e-01 5.000000e-01 5.540000e+02 5.000000e-01 5.000000e-01 2.400000e+00 1.100000e+00 1.100000e+00 +5.550000e+02 5.000000e-01 5.000000e-01 5.550000e+02 5.000000e-01 5.000000e-01 2.300000e+00 1.100000e+00 1.100000e+00 +5.560000e+02 5.000000e-01 5.000000e-01 5.560000e+02 5.000000e-01 5.000000e-01 4.300000e+00 1.200000e+00 1.200000e+00 +5.570000e+02 5.000000e-01 5.000000e-01 5.570000e+02 5.000000e-01 5.000000e-01 5.100000e+00 1.300000e+00 1.300000e+00 +5.580000e+02 5.000000e-01 5.000000e-01 5.580000e+02 5.000000e-01 5.000000e-01 1.060000e+01 1.400000e+00 1.400000e+00 +5.590000e+02 5.000000e-01 5.000000e-01 5.590000e+02 5.000000e-01 5.000000e-01 1.730000e+01 1.800000e+00 1.800000e+00 +5.600000e+02 5.000000e-01 5.000000e-01 5.600000e+02 5.000000e-01 5.000000e-01 3.290000e+01 2.000000e+00 2.000000e+00 +5.610000e+02 5.000000e-01 5.000000e-01 5.610000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.620000e+02 5.000000e-01 5.000000e-01 5.620000e+02 5.000000e-01 5.000000e-01 1.240000e+01 1.200000e+00 1.200000e+00 +5.630000e+02 5.000000e-01 5.000000e-01 5.630000e+02 5.000000e-01 5.000000e-01 2.120000e+01 1.500000e+00 1.500000e+00 +5.640000e+02 5.000000e-01 5.000000e-01 5.640000e+02 5.000000e-01 5.000000e-01 2.420000e+01 1.900000e+00 1.900000e+00 +5.650000e+02 5.000000e-01 5.000000e-01 5.650000e+02 5.000000e-01 5.000000e-01 1.770000e+01 1.500000e+00 1.500000e+00 +5.660000e+02 5.000000e-01 5.000000e-01 5.660000e+02 5.000000e-01 5.000000e-01 2.330000e+01 2.000000e+00 2.000000e+00 +5.670000e+02 5.000000e-01 5.000000e-01 5.670000e+02 5.000000e-01 5.000000e-01 1.390000e+01 1.900000e+00 1.900000e+00 +5.680000e+02 5.000000e-01 5.000000e-01 5.680000e+02 5.000000e-01 5.000000e-01 4.500000e+00 1.900000e+00 1.900000e+00 +5.690000e+02 5.000000e-01 5.000000e-01 5.690000e+02 5.000000e-01 5.000000e-01 3.700000e+00 1.500000e+00 1.500000e+00 +5.700000e+02 5.000000e-01 5.000000e-01 5.700000e+02 5.000000e-01 5.000000e-01 1.420000e+01 1.700000e+00 1.700000e+00 +5.710000e+02 5.000000e-01 5.000000e-01 5.710000e+02 5.000000e-01 5.000000e-01 1.880000e+01 1.900000e+00 1.900000e+00 +5.720000e+02 5.000000e-01 5.000000e-01 5.720000e+02 5.000000e-01 5.000000e-01 2.300000e+01 1.800000e+00 1.800000e+00 +5.730000e+02 5.000000e-01 5.000000e-01 5.730000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.740000e+02 5.000000e-01 5.000000e-01 5.740000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.750000e+02 5.000000e-01 5.000000e-01 5.750000e+02 5.000000e-01 5.000000e-01 0.000000e+00 0.000000e+00 0.000000e+00 +5.760000e+02 5.000000e-01 5.000000e-01 5.760000e+02 5.000000e-01 5.000000e-01 1.000000e+02 0.000000e+00 0.000000e+00 +END YODA_SCATTER3D_V2 +BEGIN YODA_SCATTER2D_V2 /REF/ATLAS_2014_I1306615/d30-x01-y01 +IsRef: 1 +Path: /REF/ATLAS_2014_I1306615/d30-x01-y01 Title: ~ Type: Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e+00 5.000000e-01 5.000000e-01 4.320000e+01 9.910096e+00 1.000200e+01 2.000000e+00 5.000000e-01 5.000000e-01 2.150000e+01 5.769749e+00 5.848932e+00 3.000000e+00 5.000000e-01 5.000000e-01 9.200000e+00 3.061046e+00 3.101612e+00 4.000000e+00 5.000000e-01 5.000000e-01 4.000000e+00 1.479865e+00 1.479865e+00 5.000000e+00 5.000000e-01 5.000000e-01 1.680000e+00 6.335614e-01 6.296825e-01 6.000000e+00 5.000000e-01 5.000000e-01 8.000000e-01 1.000000e-10 0.000000e+00 7.000000e+00 5.000000e-01 5.000000e-01 7.400000e-01 1.000000e-10 0.000000e+00 END YODA_SCATTER2D_V2