diff --git a/analyses/pluginHERA/H1_2007_I746380.cc b/analyses/pluginHERA/H1_2007_I746380.cc --- a/analyses/pluginHERA/H1_2007_I746380.cc +++ b/analyses/pluginHERA/H1_2007_I746380.cc @@ -1,615 +1,534 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/Beam.hh" #include "Rivet/Projections/FinalState.hh" #include "Rivet/Projections/DISKinematics.hh" #include "Rivet/Projections/DISFinalState.hh" #include "Rivet/Projections/FastJets.hh" namespace Rivet { // Projection to find the largest gaps and the masses of the two - // systems separated by the gap. Based on the HZTools gap-finding - // method (hzhadgap.F). Note that gaps are found in the HCM frame. - // Author Christine O. Rasmussen. + // systems separated by the gap. Based on the HZTools gap-finding + // method (hzhadgap.F). Note that gaps are found in the HCM frame. + // Author Christine O. Rasmussen. class RapidityGap : public Projection { - + public: /// Type of DIS boost to apply enum Frame { HCM, LAB, XCM }; - + RapidityGap() { setName("RapidityGap"); addProjection(DISKinematics(), "DISKIN"); addProjection(DISFinalState(DISFinalState::HCM), "DISFS"); } DEFAULT_RIVET_PROJ_CLONE(RapidityGap); - const double M2X() const {return _M2X;} - const double M2Y() const {return _M2Y;} + const double M2X() const {return _M2X;} + const double M2Y() const {return _M2Y;} const double t() const {return _t;} const double gap() const {return _gap;} const double gapUpp() const {return _gapUpp;} const double gapLow() const {return _gapLow;} const double EpPzX(Frame f) const { if (f == LAB) return _ePpzX_LAB; else if (f == XCM) return _ePpzX_XCM; - return _ePpzX_HCM; + else return _ePpzX_HCM; } const double EmPzX(Frame f) const { if (f == LAB) return _eMpzX_LAB; else if (f == XCM) return _eMpzX_XCM; - return _eMpzX_HCM; + else return _eMpzX_HCM; } const FourMomentum pX(Frame f) const { if (f == LAB) return _momX_LAB; else if (f == XCM) return _momX_XCM; - return _momX_HCM; + else return _momX_HCM; } const FourMomentum pY(Frame f) const { if (f == LAB) return _momY_LAB; else if (f == XCM) return _momY_XCM; - return _momY_HCM; + else return _momY_HCM; } const Particles& systemX(Frame f) const { if (f == LAB) return _pX_LAB; else if (f == XCM) return _pX_XCM; - return _pX_HCM; + else return _pX_HCM; } const Particles& systemY(Frame f) const { if (f == LAB) return _pY_LAB; else if (f == XCM) return _pY_XCM; - return _pY_HCM; + else return _pY_HCM; } protected: - + virtual int compare(const Projection& p) const { const RapidityGap& other = pcast(p); return mkNamedPCmp(other, "DISKIN") || mkNamedPCmp(other, "DISFS"); } - + virtual void project(const Event& e){ const DISKinematics& dk = apply(e, "DISKIN"); - if ( dk.failed() ) { - fail(); - return; - } const Particles& p = apply(e, "DISFS").particles(cmpMomByEta); findgap(p, dk); } void clearAll(){ - _M2X = _M2Y = _t = 0.; - _gap = 0.; + _M2X = _M2Y = _t = _gap = 0.; _gapUpp = _gapLow = -8.; _ePpzX_HCM = _eMpzX_HCM =_ePpzX_LAB = _eMpzX_LAB = _ePpzX_XCM = _eMpzX_XCM = 0.; + _momX_HCM.setPE(0., 0., 0., 0.); + _momY_HCM.setPE(0., 0., 0., 0.); + _momX_XCM.setPE(0., 0., 0., 0.); + _momY_XCM.setPE(0., 0., 0., 0.); + _momX_LAB.setPE(0., 0., 0., 0.); + _momY_LAB.setPE(0., 0., 0., 0.); + _pX_HCM.clear(); + _pY_HCM.clear(); + _pX_XCM.clear(); + _pY_XCM.clear(); + _pX_LAB.clear(); + _pY_LAB.clear(); } void findgap(const Particles& particles, const DISKinematics& diskin){ clearAll(); - - // Begin by finding largest gap and gapedges between all final + + // Begin by finding largest gap and gapedges between all final // state particles in HCM frame. int nP = particles.size(); int dir = diskin.orientation(); for (int i = 0; i < nP-1; ++i){ - double tmpGap = dir * particles[i+1].eta() - - dir * particles[i].eta(); + double tmpGap = abs(particles[i+1].eta() - particles[i].eta()); if (tmpGap > _gap) { _gap = tmpGap; - _gapLow = dir * particles[i].eta(); - _gapUpp = dir * particles[i+1].eta(); + _gapLow = (dir > 0) ? particles[i].eta() : dir * particles[i+1].eta(); + _gapUpp = (dir > 0) ? particles[i+1].eta() : dir * particles[i].eta(); } } // Define the two systems X and Y. - Particles pX, pY; + Particles tmp_pX, tmp_pY; foreach (const Particle& ip, particles) { - if (dir * ip.eta() > _gapLow) pX.push_back(ip); - else pY.push_back(ip); + if (dir * ip.eta() > _gapLow) tmp_pX.push_back(ip); + else tmp_pY.push_back(ip); } - // Find variables related to HCM frame. - // Note that HCM has photon along +z, as opposed to - // H1 where proton is along +z. This results in a sign change + Particles pX, pY; + pX = (dir < 0) ? tmp_pY : tmp_pX; + pY = (dir < 0) ? tmp_pX : tmp_pY; + + // Find variables related to HCM frame. + // Note that HCM has photon along +z, as opposed to + // H1 where proton is along +z. This results in a sign change // as compared to H1 papers! + // X - side FourMomentum momX; foreach (const Particle& jp, pX) { momX += jp.momentum(); _ePpzX_HCM += jp.E() - jp.pz(); // Sign + => - - _eMpzX_HCM += jp.E() + jp.pz(); // Sign - => + + _eMpzX_HCM += jp.E() + jp.pz(); // Sign - => + } _momX_HCM = momX; _pX_HCM = pX; _M2X = _momX_HCM.mass2(); + // Y - side FourMomentum momY; foreach (const Particle& kp, pY) momY += kp.momentum(); _momY_HCM = momY; _pY_HCM = pY; _M2Y = _momY_HCM.mass2(); // Find variables related to LAB frame const LorentzTransform hcmboost = diskin.boostHCM(); const LorentzTransform hcminverse = hcmboost.inverse(); _momX_LAB = hcminverse.transform(_momX_HCM); _momY_LAB = hcminverse.transform(_momY_HCM); - + // Find momenta in XCM frame. Note that it is HCM frame that is - // boosted, resulting in a sign change later! + // boosted, resulting in a sign change later! const bool doXCM = (momX.betaVec().mod2() < 1.); if (doXCM) { - const LorentzTransform xcmboost = + const LorentzTransform xcmboost = LorentzTransform::mkFrameTransformFromBeta(momX.betaVec()); _momX_XCM = xcmboost.transform(momX); _momY_XCM = xcmboost.transform(momY); - } else { - _momX_XCM = momX; - _momY_XCM = momY; - } - - double pInPlusZ = (diskin.beamHadron().pz() > 0.) ? 1. : -1.; + } + foreach (const Particle& jp, pX) { - // Boost from HCM to LAB. Here check if proton is along +z - // and adjust sign wrt. this. + // Boost from HCM to LAB. FourMomentum lab = hcminverse.transform(jp.momentum()); - _ePpzX_LAB += lab.E() + pInPlusZ * lab.pz(); - _eMpzX_LAB += lab.E() - pInPlusZ * lab.pz(); + _ePpzX_LAB += lab.E() + dir * lab.pz(); + _eMpzX_LAB += lab.E() - dir * lab.pz(); Particle plab = jp; plab.setMomentum(lab); _pX_LAB.push_back(plab); // Set XCM. Note that since HCM frame is boosted to XCM frame, - // we have a sign change + // we have a sign change if (doXCM) { - const LorentzTransform xcmboost = + const LorentzTransform xcmboost = LorentzTransform::mkFrameTransformFromBeta(_momX_HCM.betaVec()); FourMomentum xcm = xcmboost.transform(jp.momentum()); _ePpzX_XCM += xcm.E() - xcm.pz(); // Sign + => - _eMpzX_XCM += xcm.E() + xcm.pz(); // Sign - => + Particle pxcm = jp; pxcm.setMomentum(xcm); _pX_XCM.push_back(pxcm); } - } + } foreach (const Particle& jp, pY) { // Boost from HCM to LAB FourMomentum lab = hcminverse.transform(jp.momentum()); Particle plab = jp; plab.setMomentum(lab); _pY_LAB.push_back(plab); - // Boost from HCM to XCM + // Boost from HCM to XCM if (doXCM) { - const LorentzTransform xcmboost = + const LorentzTransform xcmboost = LorentzTransform::mkFrameTransformFromBeta(_momX_HCM.betaVec()); FourMomentum xcm = xcmboost.transform(jp.momentum()); Particle pxcm = jp; pxcm.setMomentum(xcm); _pY_XCM.push_back(pxcm); } - } - if (!doXCM) { - _ePpzX_XCM = _ePpzX_HCM; - _eMpzX_XCM = _eMpzX_HCM; - _pX_XCM = _pX_HCM; - _pY_XCM = _pY_HCM; } // Find t: Currently can only handle gap on proton side. // @TODO: Expand to also handle gap on photon side // Boost p from LAB to HCM frame to find t. const FourMomentum proton = hcmboost.transform(diskin.beamHadron().momentum()); FourMomentum pPom = proton - _momY_HCM; _t = pPom * pPom; - + } private: double _M2X, _M2Y, _t; double _gap, _gapUpp, _gapLow; double _ePpzX_LAB, _eMpzX_LAB, _ePpzX_HCM, _eMpzX_HCM, _ePpzX_XCM, _eMpzX_XCM; FourMomentum _momX_HCM, _momY_HCM,_momX_LAB, _momY_LAB, _momX_XCM, _momY_XCM; Particles _pX_HCM, _pY_HCM, _pX_LAB, _pY_LAB, _pX_XCM, _pY_XCM; }; - // Projection to pick out the scattered beam proton with diffraction. - // Author Ilkka Helenius - class DiffHadron : public Projection { - - public: - - /// @name Constructors. - //@{ - - DiffHadron(){ - setName("DiffHadron"); - addProjection(Beam(), "Beam"); - addProjection(PromptFinalState(), "PromptFS"); - } - - /// Clone on the heap. - DEFAULT_RIVET_PROJ_CLONE(DiffHadron); - - //@} - - protected: - - void project(const Event& e) { - - // Find incoming hadron beam - const ParticlePair& inc = applyProjection(e, "Beam").beams(); - bool firstIsHadron = PID::isHadron(inc.first.pid()); - bool secondIsHadron = PID::isHadron(inc.second.pid()); - if (firstIsHadron && !secondIsHadron) { - _incoming = inc.first; - } else if (!firstIsHadron && secondIsHadron) { - _incoming = inc.second; - } else { - throw Error("DiffHadron could not find the correct beam"); - } - - const Particles fshadrons = applyProjection(e, "PromptFS").particles(isHadron, cmpMomByE); - const Particles sfhadrons = filter_select(fshadrons, Cuts::pid == _incoming.pid()); - if (!sfhadrons.empty()) { - _outgoing = sfhadrons.front(); - } else if (!fshadrons.empty()) { - _outgoing = fshadrons.front(); - } else { - throw Error("Could not find the scattered hadron"); - } - - } - - int compare(const Projection& p) const { - const DiffHadron& other = pcast(p); - return mkNamedPCmp(other, "Beam") || mkNamedPCmp(other, "PromptFS"); - } - - - public: - - /// The incoming hadron - const Particle& in() const { return _incoming; } - - /// The outgoing hadron - const Particle& out() const { return _outgoing; } - - /// Sign of the incoming lepton pz component - int pzSign() const { return sign(_incoming.pz()); } - - - private: - - /// The incoming hadron - Particle _incoming; - - /// The outgoing hadron - Particle _outgoing; - - // /// The charge sign of the DIS current - // double _charge; - - }; - // Projection to boost system X (photon+Pomeron) particles into its rest frame. // Author Ilkka Helenius class BoostedXSystem : public FinalState { public: BoostedXSystem(const FinalState& fs) { setName("BoostedXSystem"); declare(fs,"FS"); addProjection(RapidityGap(), "RAPGAP"); } // Return the boost to XCM frame. const LorentzTransform& boost() const { return _boost; } DEFAULT_RIVET_PROJ_CLONE(BoostedXSystem); protected: // Apply the projection on the supplied event. void project(const Event& e){ const RapidityGap& rg = apply(e, "RAPGAP"); - if ( rg.failed() ) vetoEvent; // Total momentum of the system X. const FourMomentum pX = rg.pX(RapidityGap::HCM); // Reset the boost. Is there a separate method for this? _boost = combine(_boost, _boost.inverse()); // Define boost only when numerically safe, otherwise negligible. if (pX.betaVec().mod2() < 1.) _boost = LorentzTransform::mkFrameTransformFromBeta(pX.betaVec()); // Boost the particles from system X. _theParticles.clear(); _theParticles.reserve(rg.systemX(RapidityGap::HCM).size()); for (const Particle& p : rg.systemX(RapidityGap::HCM)) { Particle temp = p; temp.setMomentum(_boost.transform(temp.momentum())); _theParticles.push_back(temp); } } // Compare projections. int compare(const Projection& p) const { const BoostedXSystem& other = pcast(p); return mkNamedPCmp(other, "RAPGAP") || mkNamedPCmp(other, "FS"); } - private: - + private: + LorentzTransform _boost; }; /// @brief H1 diffractive dijets /// /// Diffractive dijets H1 with 920 GeV p and 27.5 GeV e /// Note tagged protons! /// /// @author Christine O. Rasmussen class H1_2007_I746380 : public Analysis { public: /// Constructor DEFAULT_RIVET_ANALYSIS_CTOR(H1_2007_I746380); /// @name Analysis methods //@{ // Book projections and histograms void init() { declare(DISKinematics(), "Kinematics"); const DISFinalState& disfs = declare(DISFinalState(DISFinalState::HCM), "DISFS"); const BoostedXSystem& disfsXcm = declare( BoostedXSystem(disfs), "BoostedXFS"); - declare(FastJets(disfsXcm, fastjet::JetAlgorithm::kt_algorithm, fastjet::RecombinationScheme::pt_scheme, 1.0, + declare(FastJets(disfsXcm, fastjet::JetAlgorithm::kt_algorithm, fastjet::RecombinationScheme::pt_scheme, 1.0, JetAlg::ALL_MUONS, JetAlg::NO_INVISIBLES, nullptr), "DISFSJets"); - declare(DiffHadron(), "Hadron"); declare(RapidityGap(), "RapidityGap"); // Book histograms from REF data _h_DIS_dsigdzPom = bookHisto1D(1, 1, 1); _h_DIS_dsigdlogXpom = bookHisto1D(2, 1, 1); _h_DIS_dsigdW = bookHisto1D(3, 1, 1); _h_DIS_dsigdQ2 = bookHisto1D(4, 1, 1); _h_DIS_dsigdEtJet1 = bookHisto1D(5, 1, 1); _h_DIS_dsigdAvgEta = bookHisto1D(6, 1, 1); _h_DIS_dsigdDeltaEta = bookHisto1D(7, 1, 1); _h_PHO_dsigdzPom = bookHisto1D(8, 1, 1); _h_PHO_dsigdxGam = bookHisto1D(9, 1, 1); _h_PHO_dsigdlogXpom = bookHisto1D(10, 1, 1); _h_PHO_dsigdW = bookHisto1D(11, 1, 1); _h_PHO_dsigdEtJet1 = bookHisto1D(12, 1, 1); _h_PHO_dsigdAvgEta = bookHisto1D(13, 1, 1); _h_PHO_dsigdDeltaEta = bookHisto1D(14, 1, 1); _h_PHO_dsigdMjets = bookHisto1D(15, 1, 1); - + isDIS = false; nVeto0 = 0; nVeto1 = 0; nVeto2 = 0; nVeto3 = 0; nVeto4 = 0; nVeto5 = 0; nPHO = 0; nDIS = 0; } // Do the analysis void analyze(const Event& event) { // Event weight - const double weight = event.weight(); + const double weight = event.weight(); isDIS = false; - + // Projections - special handling of events where no proton found: const RapidityGap& rg = apply(event, "RapidityGap"); - if ( rg.failed() ) vetoEvent; const DISKinematics& kin = apply(event, "Kinematics"); - if ( kin.failed() ) vetoEvent; const BoostedXSystem& disfsXcm = apply( event, "BoostedXFS"); - + // Determine kinematics: H1 has +z = proton direction int dir = kin.orientation(); double W2 = kin.W2(); double W = sqrt(W2); double y = kin.y(); double Q2 = kin.Q2(); // Separate into DIS and PHO regimes else veto if (!inRange(W, 165.*GeV, 242.*GeV)) vetoEvent; if (Q2 < 0.01*GeV2) { isDIS = false; ++nPHO; } else if (inRange(Q2, 4.0*GeV2, 80.*GeV2)) { isDIS = true; ++nDIS; } else { vetoEvent; } ++nVeto0; - // Find diffractive variables as defined in paper. + // Find diffractive variables as defined in paper. const double M2Y = rg.M2Y(); const double M2X = rg.M2X(); const double abst = abs(rg.t()); const double xPom = (isDIS) ? (Q2 + M2X) / (Q2 + W2) : rg.EpPzX(RapidityGap::LAB) / (2. * kin.beamHadron().E()); - + // Veto if outside allowed region if (sqrt(M2Y) > 1.6*GeV) vetoEvent; ++nVeto1; if (abst > 1.0*GeV2) vetoEvent; ++nVeto2; if (xPom > 0.03) vetoEvent; ++nVeto3; - // Jet selection. Note jets are found in photon-proton (XCM) - // frame, but eta cut is applied in lab frame! + // Jet selection. Note jets are found in photon-proton (XCM) + // frame, but eta cut is applied in lab frame! Cut jetcuts = Cuts::Et > 4.* GeV; Jets jets = apply(event, "DISFSJets").jets(jetcuts, cmpMomByEt); // Veto if not dijets and if Et_j1 < 5.0 if (jets.size() < 2) vetoEvent; if (jets[0].Et() < 5.*GeV) vetoEvent; ++nVeto4; // Find Et_jet1 and deltaEta* in XCM frame double EtJet1 = jets[0].Et() * GeV; - double etaXCMJet1 = dir * jets[0].eta(); - double etaXCMJet2 = dir * jets[1].eta(); + double etaXCMJet1 = jets[0].eta(); + double etaXCMJet2 = jets[1].eta(); double deltaEtaJets = abs(etaXCMJet1 - etaXCMJet2); // Transform from XCM to HCM const LorentzTransform xcmboost = disfsXcm.boost(); for (int i = 0; i < 2; ++i) jets[i].transformBy(xcmboost.inverse()); // Find mass of jets and EpPz, EmPz of jets FourMomentum momJets = jets[0].momentum() + jets[1].momentum(); double M2jets = momJets.mass2(); double EpPzJets = 0.; double EmPzJets = 0.; // DIS variables are found in XCM frame, so boost back again - if (isDIS){ + if (isDIS){ for (int i = 0; i < 2; ++i) jets[i].transformBy(xcmboost); } // Note sign change wrt. H1 because photon is in +z direction + // Jets in HCM so no need to consider orientation. for (int i = 0; i < 2; ++i){ EpPzJets += jets[i].E() - jets[i].pz(); // Sign: + => - EmPzJets += jets[i].E() + jets[i].pz(); // Sign: - => + } - + // Transform the jets from HCM to LAB frame where eta cut is // applied for photoproduction. const LorentzTransform hcmboost = kin.boostHCM(); for (int i = 0; i < 2; ++i) jets[i].transformBy(hcmboost.inverse()); double etaLabJet1 = dir * jets[0].eta(); double etaLabJet2 = dir * jets[1].eta(); double etaMin = (isDIS) ? -3. : -1.; double etaMax = (isDIS) ? 0. : 2.; double eta1 = (isDIS) ? etaXCMJet1 : etaLabJet1; double eta2 = (isDIS) ? etaXCMJet2 : etaLabJet2; if (!inRange(eta1, etaMin, etaMax)) vetoEvent; if (!inRange(eta2, etaMin, etaMax)) vetoEvent; ++nVeto5; - - // Pseudorapidity distributions are examined in lab frame: + + // Pseudorapidity distributions are examined in lab frame: double avgEtaJets = 0.5 * (etaLabJet1 + etaLabJet2); + // Derive xPom and xGam values from the jet kinematics. double zPomJets, xGamJets; if (isDIS) { zPomJets = (Q2 + M2jets) / (Q2 + M2X); xGamJets = EmPzJets / rg.EmPzX(RapidityGap::XCM); } else { // Boost E_p, E_e to HCM frame - const LorentzTransform hcminverse = hcmboost.inverse(); - FourMomentum lep = hcminverse.transform(kin.beamLepton().momentum()); - FourMomentum had = hcminverse.transform(kin.beamHadron().momentum()); + FourMomentum lep = hcmboost.transform(kin.beamLepton().momentum()); + FourMomentum had = hcmboost.transform(kin.beamHadron().momentum()); zPomJets = EpPzJets / (2. * xPom * had.E()); xGamJets = EmPzJets / (2. * y * lep.E()); } // Now fill histograms if (isDIS){ _h_DIS_dsigdzPom ->fill(zPomJets, weight); _h_DIS_dsigdlogXpom ->fill(log10(xPom), weight); _h_DIS_dsigdW ->fill(W, weight); _h_DIS_dsigdQ2 ->fill(Q2, weight); _h_DIS_dsigdEtJet1 ->fill(EtJet1, weight); _h_DIS_dsigdAvgEta ->fill(avgEtaJets, weight); _h_DIS_dsigdDeltaEta ->fill(deltaEtaJets, weight); } else { _h_PHO_dsigdzPom ->fill(zPomJets, weight); _h_PHO_dsigdxGam ->fill(xGamJets, weight); _h_PHO_dsigdlogXpom ->fill(log10(xPom), weight); _h_PHO_dsigdW ->fill(W, weight); _h_PHO_dsigdEtJet1 ->fill(EtJet1, weight); _h_PHO_dsigdAvgEta ->fill(avgEtaJets, weight); _h_PHO_dsigdDeltaEta ->fill(deltaEtaJets, weight); _h_PHO_dsigdMjets ->fill(sqrt(M2jets), weight); - } - + } + } // Finalize void finalize() { // Normalise to cross section const double norm = crossSection()/picobarn/sumOfWeights(); - - scale( _h_DIS_dsigdzPom , norm); - scale( _h_DIS_dsigdlogXpom , norm); - scale( _h_DIS_dsigdW , norm); - scale( _h_DIS_dsigdQ2 , norm); - scale( _h_DIS_dsigdEtJet1 , norm); - scale( _h_DIS_dsigdAvgEta , norm); - scale( _h_DIS_dsigdDeltaEta, norm); - - scale( _h_PHO_dsigdzPom , norm); + + scale( _h_DIS_dsigdzPom , norm); + scale( _h_DIS_dsigdlogXpom , norm); + scale( _h_DIS_dsigdW , norm); + scale( _h_DIS_dsigdQ2 , norm); + scale( _h_DIS_dsigdEtJet1 , norm); + scale( _h_DIS_dsigdAvgEta , norm); + scale( _h_DIS_dsigdDeltaEta, norm); + + scale( _h_PHO_dsigdzPom , norm); scale( _h_PHO_dsigdxGam , norm); - scale( _h_PHO_dsigdlogXpom , norm); - scale( _h_PHO_dsigdW , norm); - scale( _h_PHO_dsigdEtJet1 , norm); - scale( _h_PHO_dsigdAvgEta , norm); - scale( _h_PHO_dsigdDeltaEta, norm); - scale( _h_PHO_dsigdMjets , norm); - + scale( _h_PHO_dsigdlogXpom , norm); + scale( _h_PHO_dsigdW , norm); + scale( _h_PHO_dsigdEtJet1 , norm); + scale( _h_PHO_dsigdAvgEta , norm); + scale( _h_PHO_dsigdDeltaEta, norm); + scale( _h_PHO_dsigdMjets , norm); + const double dPHO = nPHO; MSG_INFO("H1_2007_I746380"); MSG_INFO("Cross section = " << crossSection()/picobarn << " pb"); MSG_INFO("Number of events = " << numEvents() << ", sumW = " << sumOfWeights()); MSG_INFO("Number of PHO = " << nPHO << ", number of DIS = " << nDIS); MSG_INFO("Events passing electron veto = " << nVeto0 << " (" << nVeto0/dPHO * 100. << "%)" ); MSG_INFO("Events passing MY = " << nVeto1 << " (" << nVeto1/dPHO * 100. << "%)" ); MSG_INFO("Events passing t veto = " << nVeto2 << " (" << nVeto2/dPHO * 100. << "%)" ); MSG_INFO("Events passing xPom = " << nVeto3 << " (" << nVeto3/dPHO * 100. << "%)" ); MSG_INFO("Events passing jet Et veto = " << nVeto4 << " (" << nVeto4/dPHO * 100. << "%)" ); MSG_INFO("Events passing jet eta veto = " << nVeto5 << " (" << nVeto5/dPHO * 100. << "%)" ); } //@} private: /// @name Histograms //@{ // Book histograms from REF data Histo1DPtr _h_DIS_dsigdzPom ; Histo1DPtr _h_DIS_dsigdlogXpom ; Histo1DPtr _h_DIS_dsigdW ; Histo1DPtr _h_DIS_dsigdQ2 ; Histo1DPtr _h_DIS_dsigdEtJet1 ; Histo1DPtr _h_DIS_dsigdAvgEta ; Histo1DPtr _h_DIS_dsigdDeltaEta; - + Histo1DPtr _h_PHO_dsigdzPom ; Histo1DPtr _h_PHO_dsigdxGam ; Histo1DPtr _h_PHO_dsigdlogXpom ; Histo1DPtr _h_PHO_dsigdW ; Histo1DPtr _h_PHO_dsigdEtJet1 ; Histo1DPtr _h_PHO_dsigdAvgEta ; Histo1DPtr _h_PHO_dsigdDeltaEta; Histo1DPtr _h_PHO_dsigdMjets ; //@} bool isDIS; int nVeto0, nVeto1, nVeto2, nVeto3, nVeto4, nVeto5; int nPHO, nDIS; }; DECLARE_RIVET_PLUGIN(H1_2007_I746380); } diff --git a/analyses/pluginHERA/H1_2007_I746380.info b/analyses/pluginHERA/H1_2007_I746380.info --- a/analyses/pluginHERA/H1_2007_I746380.info +++ b/analyses/pluginHERA/H1_2007_I746380.info @@ -1,43 +1,46 @@ Name: H1_2007_I746380 Year: 2007 Summary: Tests of QCD Factorisation in the diffractive production of dijets in deep-inelastic scattering and photoproduction at HERA Experiment: H1 Collider: HERA InspireID: 746380 Status: UNVALIDATED Authors: - Christine O. Rasmussen - - Ilkka Helenius + - Ilkka Helenius References: - Eur. Phys. J. C51 (2007) 549 - arXiv:hep-ex/0703022 -RunInfo: +RunInfo: 820 GeV protons colliding with 27.5 GeV positrons; Diffractive photoproduction of dijets; Jet $E_T > 4$ GeV; NumEvents: 1000000 Beams: [p+, e+] Energies: [[820, 27.5]] PtCuts: [0] Description: - H1 diffractive jets from proton--positron - collisions at beam energies of 820~GeV on 27.5~GeV. -BibKey: Andreev:2015cwa + H1 diffractive jets from proton--positron collisions at beam energies of + 820~GeV and 27.5~GeV. Measurements are presented of differential dijet cross + sections in diffractive photoproduction (Q2 < 0.01 GeV2) and deep-inelastic + scattering processes (DIS, 4 < Q2 < 80 GeV2). The event topology is given by + ep → eXY , in which the system X, containing at least two jets, is separated + from a leading low-mass proton remnant system Y by a large rapidity gap. +BibKey: Aktas:2007hn BibTeX: '@article{Aktas:2007hn, author = "Aktas, A. and others", title = "{Tests of QCD factorisation in the diffractive production of dijets in deep-inelastic scattering and photoproduction at HERA}", collaboration = "H1", journal = "Eur. Phys. J.", volume = "C51", year = "2007", pages = "549-568", doi = "10.1140/epjc/s10052-007-0325-4", eprint = "hep-ex/0703022", archivePrefix = "arXiv", primaryClass = "hep-ex", reportNumber = "DESY-07-018", SLACcitation = "%%CITATION = HEP-EX/0703022;%%" }' - diff --git a/analyses/pluginHERA/H1_2015_I1343110.cc b/analyses/pluginHERA/H1_2015_I1343110.cc new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/H1_2015_I1343110.cc @@ -0,0 +1,586 @@ +// -*- C++ -*- +#include "Rivet/Analysis.hh" +#include "Rivet/Projections/Beam.hh" +#include "Rivet/Projections/FinalState.hh" +#include "Rivet/Projections/DISKinematics.hh" +#include "Rivet/Projections/DISFinalState.hh" +#include "Rivet/Projections/DISDiffHadron.hh" +#include "Rivet/Projections/FastJets.hh" + +namespace Rivet { + + // Projection to find the largest gaps and the masses of the two + // systems separated by the gap. Based on the HZTools gap-finding + // method (hzhadgap.F). Note that gaps are found in the HCM frame. + // Author Christine O. Rasmussen. + class RapidityGap : public Projection { + + public: + + /// Type of DIS boost to apply + enum Frame { HCM, LAB, XCM }; + + RapidityGap() { + setName("RapidityGap"); + addProjection(DISKinematics(), "DISKIN"); + addProjection(DISFinalState(DISFinalState::HCM), "DISFS"); + } + + DEFAULT_RIVET_PROJ_CLONE(RapidityGap); + + const double M2X() const {return _M2X;} + const double M2Y() const {return _M2Y;} + const double t() const {return _t;} + const double gap() const {return _gap;} + const double gapUpp() const {return _gapUpp;} + const double gapLow() const {return _gapLow;} + const double EpPzX(Frame f) const { + if (f == LAB) return _ePpzX_LAB; + else if (f == XCM) return _ePpzX_XCM; + else return _ePpzX_HCM; + } + const double EmPzX(Frame f) const { + if (f == LAB) return _eMpzX_LAB; + else if (f == XCM) return _eMpzX_XCM; + else return _eMpzX_HCM; + } + const FourMomentum pX(Frame f) const { + if (f == LAB) return _momX_LAB; + else if (f == XCM) return _momX_XCM; + else return _momX_HCM; + } + const FourMomentum pY(Frame f) const { + if (f == LAB) return _momY_LAB; + else if (f == XCM) return _momY_XCM; + else return _momY_HCM; + } + const Particles& systemX(Frame f) const { + if (f == LAB) return _pX_LAB; + else if (f == XCM) return _pX_XCM; + else return _pX_HCM; + } + const Particles& systemY(Frame f) const { + if (f == LAB) return _pY_LAB; + else if (f == XCM) return _pY_XCM; + else return _pY_HCM; + } + + protected: + + virtual int compare(const Projection& p) const { + const RapidityGap& other = pcast(p); + return mkNamedPCmp(other, "DISKIN") || mkNamedPCmp(other, "DISFS"); + } + + virtual void project(const Event& e){ + const DISKinematics& dk = apply(e, "DISKIN"); + const Particles& p = apply(e, "DISFS").particles(cmpMomByEta); + findgap(p, dk); + } + + void clearAll(){ + _M2X = _M2Y = _t = _gap = 0.; + _gapUpp = _gapLow = -8.; + _ePpzX_HCM = _eMpzX_HCM =_ePpzX_LAB = _eMpzX_LAB = _ePpzX_XCM = _eMpzX_XCM = 0.; + _momX_HCM.setPE(0., 0., 0., 0.); + _momY_HCM.setPE(0., 0., 0., 0.); + _momX_XCM.setPE(0., 0., 0., 0.); + _momY_XCM.setPE(0., 0., 0., 0.); + _momX_LAB.setPE(0., 0., 0., 0.); + _momY_LAB.setPE(0., 0., 0., 0.); + _pX_HCM.clear(); + _pY_HCM.clear(); + _pX_XCM.clear(); + _pY_XCM.clear(); + _pX_LAB.clear(); + _pY_LAB.clear(); + } + + void findgap(const Particles& particles, const DISKinematics& diskin){ + + clearAll(); + + // Begin by finding largest gap and gapedges between all final + // state particles in HCM frame. + int nP = particles.size(); + int dir = diskin.orientation(); + for (int i = 0; i < nP-1; ++i){ + double tmpGap = abs(particles[i+1].eta() - particles[i].eta()); + if (tmpGap > _gap) { + _gap = tmpGap; + _gapLow = (dir > 0) ? particles[i].eta() : dir * particles[i+1].eta(); + _gapUpp = (dir > 0) ? particles[i+1].eta() : dir * particles[i].eta(); + } + } + + // Define the two systems X and Y. + Particles tmp_pX, tmp_pY; + foreach (const Particle& ip, particles) { + if (dir * ip.eta() > _gapLow) tmp_pX.push_back(ip); + else tmp_pY.push_back(ip); + } + + Particles pX, pY; + pX = (dir < 0) ? tmp_pY : tmp_pX; + pY = (dir < 0) ? tmp_pX : tmp_pY; + + // Find variables related to HCM frame. + // Note that HCM has photon along +z, as opposed to + // H1 where proton is along +z. This results in a sign change + // as compared to H1 papers! + + // X - side + FourMomentum momX; + foreach (const Particle& jp, pX) { + momX += jp.momentum(); + _ePpzX_HCM += jp.E() - jp.pz(); // Sign + => - + _eMpzX_HCM += jp.E() + jp.pz(); // Sign - => + + } + _momX_HCM = momX; + _pX_HCM = pX; + _M2X = _momX_HCM.mass2(); + + // Y - side + FourMomentum momY; + foreach (const Particle& kp, pY) momY += kp.momentum(); + _momY_HCM = momY; + _pY_HCM = pY; + _M2Y = _momY_HCM.mass2(); + + // Find variables related to LAB frame + const LorentzTransform hcmboost = diskin.boostHCM(); + const LorentzTransform hcminverse = hcmboost.inverse(); + _momX_LAB = hcminverse.transform(_momX_HCM); + _momY_LAB = hcminverse.transform(_momY_HCM); + + // Find momenta in XCM frame. Note that it is HCM frame that is + // boosted, resulting in a sign change later! + const bool doXCM = (momX.betaVec().mod2() < 1.); + if (doXCM) { + const LorentzTransform xcmboost = + LorentzTransform::mkFrameTransformFromBeta(momX.betaVec()); + _momX_XCM = xcmboost.transform(momX); + _momY_XCM = xcmboost.transform(momY); + } + + foreach (const Particle& jp, pX) { + // Boost from HCM to LAB. + FourMomentum lab = hcminverse.transform(jp.momentum()); + _ePpzX_LAB += lab.E() + dir * lab.pz(); + _eMpzX_LAB += lab.E() - dir * lab.pz(); + Particle plab = jp; + plab.setMomentum(lab); + _pX_LAB.push_back(plab); + // Set XCM. Note that since HCM frame is boosted to XCM frame, + // we have a sign change + if (doXCM) { + const LorentzTransform xcmboost = + LorentzTransform::mkFrameTransformFromBeta(_momX_HCM.betaVec()); + FourMomentum xcm = xcmboost.transform(jp.momentum()); + _ePpzX_XCM += xcm.E() - xcm.pz(); // Sign + => - + _eMpzX_XCM += xcm.E() + xcm.pz(); // Sign - => + + Particle pxcm = jp; + pxcm.setMomentum(xcm); + _pX_XCM.push_back(pxcm); + } + } + + foreach (const Particle& jp, pY) { + // Boost from HCM to LAB + FourMomentum lab = hcminverse.transform(jp.momentum()); + Particle plab = jp; + plab.setMomentum(lab); + _pY_LAB.push_back(plab); + // Boost from HCM to XCM + if (doXCM) { + const LorentzTransform xcmboost = + LorentzTransform::mkFrameTransformFromBeta(_momX_HCM.betaVec()); + FourMomentum xcm = xcmboost.transform(jp.momentum()); + Particle pxcm = jp; + pxcm.setMomentum(xcm); + _pY_XCM.push_back(pxcm); + } + } + + // Find t: Currently can only handle gap on proton side. + // @TODO: Expand to also handle gap on photon side + // Boost p from LAB to HCM frame to find t. + const FourMomentum proton = hcmboost.transform(diskin.beamHadron().momentum()); + FourMomentum pPom = proton - _momY_HCM; + _t = pPom * pPom; + + } + + private: + + double _M2X, _M2Y, _t; + double _gap, _gapUpp, _gapLow; + double _ePpzX_LAB, _eMpzX_LAB, _ePpzX_HCM, _eMpzX_HCM, _ePpzX_XCM, _eMpzX_XCM; + FourMomentum _momX_HCM, _momY_HCM,_momX_LAB, _momY_LAB, _momX_XCM, _momY_XCM; + Particles _pX_HCM, _pY_HCM, _pX_LAB, _pY_LAB, _pX_XCM, _pY_XCM; + + }; + + // Projection to boost system X (photon+Pomeron) particles into its rest frame. + // Author Ilkka Helenius + class BoostedXSystem : public FinalState { + public: + + BoostedXSystem(const FinalState& fs) { + setName("BoostedXSystem"); + declare(fs,"FS"); + addProjection(RapidityGap(), "RAPGAP"); + } + + // Return the boost to XCM frame. + const LorentzTransform& boost() const { return _boost; } + + DEFAULT_RIVET_PROJ_CLONE(BoostedXSystem); + + protected: + + // Apply the projection on the supplied event. + void project(const Event& e){ + + const RapidityGap& rg = apply(e, "RAPGAP"); + + // Total momentum of the system X. + const FourMomentum pX = rg.pX(RapidityGap::HCM); + + // Reset the boost. Is there a separate method for this? + _boost = combine(_boost, _boost.inverse()); + + // Define boost only when numerically safe, otherwise negligible. + if (pX.betaVec().mod2() < 1.) + _boost = LorentzTransform::mkFrameTransformFromBeta(pX.betaVec()); + + // Boost the particles from system X. + _theParticles.clear(); + _theParticles.reserve(rg.systemX(RapidityGap::HCM).size()); + for (const Particle& p : rg.systemX(RapidityGap::HCM)) { + Particle temp = p; + temp.setMomentum(_boost.transform(temp.momentum())); + _theParticles.push_back(temp); + } + + } + + // Compare projections. + int compare(const Projection& p) const { + const BoostedXSystem& other = pcast(p); + return mkNamedPCmp(other, "RAPGAP") || mkNamedPCmp(other, "FS"); + } + + private: + + LorentzTransform _boost; + + }; + + /// @brief H1 diffractive dijets + /// + /// Diffractive dijets H1 with 920 GeV p and 27.5 GeV e + /// Tagged protons & jets found in gamma*p rest frame. + /// + /// @author Christine O. Rasmussen + class H1_2015_I1343110 : public Analysis { + public: + + /// Constructor + DEFAULT_RIVET_ANALYSIS_CTOR(H1_2015_I1343110); + + /// @name Analysis methods + //@{ + + // Book projections and histograms + void init() { + + declare(DISKinematics(), "Kinematics"); + const DISFinalState& disfs = declare(DISFinalState(DISFinalState::HCM), "DISFS"); + const BoostedXSystem& disfsXcm = declare( BoostedXSystem(disfs), "BoostedXFS"); + declare(FastJets(disfsXcm, fastjet::JetAlgorithm::kt_algorithm, fastjet::RecombinationScheme::pt_scheme, 1.0, + JetAlg::ALL_MUONS, JetAlg::NO_INVISIBLES, nullptr), "DISFSJets"); + declare(DISDiffHadron(), "Hadron"); + declare(RapidityGap(), "RapidityGap"); + + // Book histograms from REF data + _h_PHO_sig_sqrts = bookHisto1D(1, 1, 1); + _h_DIS_sig_sqrts = bookHisto1D(2, 1, 1); + _h_PHODIS_sqrts = bookScatter2D(3, 1, 1); + + _h_DIS_dsigdz = bookHisto1D(4, 1, 1); + _h_DIS_dsigdxPom = bookHisto1D(5, 1, 1); + _h_DIS_dsigdy = bookHisto1D(6, 1, 1); + _h_DIS_dsigdQ2 = bookHisto1D(7, 1, 1); + _h_DIS_dsigdEtj1 = bookHisto1D(8, 1, 1); + _h_DIS_dsigdMX = bookHisto1D(9, 1, 1); + _h_DIS_dsigdDeltaEta = bookHisto1D(10, 1, 1); + _h_DIS_dsigdAvgEta = bookHisto1D(11, 1, 1); + + _h_PHO_dsigdz = bookHisto1D(12, 1, 1); + _h_PHO_dsigdxPom = bookHisto1D(13, 1, 1); + _h_PHO_dsigdy = bookHisto1D(14, 1, 1); + _h_PHO_dsigdxGam = bookHisto1D(15, 1, 1); + _h_PHO_dsigdEtj1 = bookHisto1D(16, 1, 1); + _h_PHO_dsigdMX = bookHisto1D(17, 1, 1); + _h_PHO_dsigdDeltaEta = bookHisto1D(18, 1, 1); + _h_PHO_dsigdAvgEta = bookHisto1D(19, 1, 1); + + _h_PHODIS_deltaEta = bookScatter2D(20, 1, 1); + _h_PHODIS_y = bookScatter2D(21, 1, 1); + _h_PHODIS_z = bookScatter2D(22, 1, 1); + _h_PHODIS_Etj1 = bookScatter2D(23, 1, 1); + + isPHO = false; + nVeto1 = 0; + nVeto2 = 0; + nVeto3 = 0; + nVeto4 = 0; + nVeto5 = 0; + nVeto6 = 0; + nPHO = 0; + nDIS = 0; + } + + // Do the analysis + void analyze(const Event& event) { + + // Event weight + const double weight = event.weight(); + isPHO = false; + + // Projections - special handling of events where no proton found: + const RapidityGap& rg = apply(event, "RapidityGap"); + const DISKinematics& kin = apply(event, "Kinematics"); + const BoostedXSystem& disfsXcm = apply( event, "BoostedXFS"); + Particle hadronOut; + Particle hadronIn; + try { + const DISDiffHadron& diffhadr = apply(event, "Hadron"); + hadronOut = diffhadr.out(); + hadronIn = diffhadr.in(); + } catch (const Error& e){ + vetoEvent; + } + + // Determine kinematics: H1 has +z = proton direction + int dir = kin.orientation(); + double y = kin.y(); + double Q2 = kin.Q2(); + + // Separate into DIS and PHO regimes else veto + if (Q2 < 2.*GeV2 && inRange(y, 0.2, 0.70)) { + isPHO = true; + ++nPHO; + } else if (inRange(Q2, 4.0*GeV2, 80.*GeV2) && inRange(y, 0.2, 0.7)) { + isPHO = false; + ++nDIS; + } else vetoEvent; + ++nVeto1; + + // Find diffractive variables as defined in paper. + // Note tagged protons in VFPS => smaller allowed xPom range + // xPom = 1 - E'/E, M2X from hadrons, t = (P-P')^2 + const double M2X = rg.M2X(); + const double abst = abs(rg.t()); + const double xPom = 1. - hadronOut.energy() / hadronIn.energy(); + + //cout << "\nhadout=" << hadronOut.energy() << ", hadin=" << hadronIn.energy() << endl; + //cout << "xPomH1=" << (Q2+M2X) / (y * sqr(sqrtS())) << endl; + //cout << "|t|=" << abst << ", xPom=" << xPom << endl; + // Veto if outside allowed region + if (abst > 0.6 * GeV2) vetoEvent; + ++nVeto2; + if (!inRange(xPom, 0.010, 0.024)) vetoEvent; + ++nVeto3; + + // Jet selection. Note jets are found in XCM frame, but + // eta cut is applied in lab frame! + Cut jetcuts = Cuts::Et > 4.* GeV; + Jets jets = apply(event, "DISFSJets").jets(jetcuts, cmpMomByEt); + // Veto if not dijets and if Et_j1 < 5.5 + if (jets.size() < 2) vetoEvent; + if (jets[0].Et() < 5.5 * GeV) vetoEvent; + ++nVeto4; + // Find Et_jet1 in XCM frame + double EtJet1 = jets[0].Et() * GeV; + + //cout << "gamma*p frame:" << endl; + //cout << "Et1=" << jets[0].Et() << ", E1=" << jets[0].E() << ", pz1=" << jets[0].pz() << ", m1=" << jets[0].mass() << endl; + //cout << "Et2=" << jets[1].Et() << ", E2=" << jets[1].E() << ", pz2=" << jets[1].pz() << ", m2=" << jets[1].mass() << endl; + + // Transform from XCM to HCM + const LorentzTransform xcmboost = disfsXcm.boost(); + for (int i = 0; i < 2; ++i) jets[i].transformBy(xcmboost.inverse()); + + // Find mass of jets and EpPz, EmPz of jets in HCM frame. + FourMomentum momJets = jets[0].momentum() + jets[1].momentum(); + double M2jets = momJets.mass2(); + double EpPzJets = 0.; + double EmPzJets = 0.; + // Note sign change wrt. H1 because photon is in +z direction + for (int i = 0; i < 2; ++i){ + EpPzJets += jets[i].E() - jets[i].pz(); // Sign: + => - + EmPzJets += jets[i].E() + jets[i].pz(); // Sign: - => + + } + + // Transform the jets from HCM to LAB frame where eta cut is + // applied for photoproduction. + const LorentzTransform hcmboost = kin.boostHCM(); + for (int i = 0; i < 2; ++i) jets[i].transformBy(hcmboost.inverse()); + double etaLabJet1 = dir * jets[0].eta(); + double etaLabJet2 = dir * jets[1].eta(); + if (!inRange(etaLabJet1, -1., 2.5)) vetoEvent; + if (!inRange(etaLabJet2, -1., 2.5)) vetoEvent; + ++nVeto5; + + // Pseudorapidity distributions are examined in lab frame: + double deltaEtaJets = abs(dir * jets[0].eta() - dir * jets[1].eta()); + double avgEtaJets = 0.5 * (dir * jets[0].eta() + dir * jets[1].eta()); + + // Evaluate observables + double zPomJets, xGamJets = 0.; + if (isPHO){ + zPomJets = EpPzJets / rg.EpPzX(RapidityGap::HCM); + xGamJets = EmPzJets / rg.EmPzX(RapidityGap::HCM); + //cout << "xGamJets=" << xGamJets << endl; + } else { + zPomJets = (Q2 + M2jets) / (Q2 + M2X); + } + + //cout << "lab frame:" << endl; + //cout << "Et1=" << jets[0].Et() << ", E1=" << jets[0].E() << ", pz1=" << jets[0].pz() << ", m1=" << jets[0].mass() << endl; + //cout << "Et2=" << jets[1].Et() << ", E2=" << jets[1].E() << ", pz2=" << jets[1].pz() << ", m2=" << jets[1].mass() << endl; + //cout << "EpPzJets=" << EpPzJets << ", EmPzJets=" << EmPzJets << endl; + //cout << "Et*exp(eta)=" << jets[0].Et()*exp(etaLabJet1) + jets[1].Et()*exp(etaLabJet2) << endl; + //cout << "Et*exp(-eta)=" << jets[0].Et()*exp(-etaLabJet1) + jets[1].Et()*exp(-etaLabJet2) << endl; + //cout << "EpPz=" << rg.EpPzX(RapidityGap::HCM) << ", EmPz=" << rg.EmPzX(RapidityGap::HCM) << endl; + //cout << "2 xPom Ep=" << 2. * xPom * kin.beamHadron().E() << ", 2 y Ee=" << 2. * y * kin.beamLepton().E() << endl; + //cout << "xGam=" << xGamJets << ", zPom=" << zPomJets << endl; + //cout << "M12=" << M2jets << ", deltaEta=" << deltaEtaJets << ", avgEta=" << avgEtaJets << endl; + + // Veto events with zPom > 0.8 + if (zPomJets > 0.8) vetoEvent; + ++nVeto6; + + // Now fill histograms + if (isPHO){ + _h_PHO_sig_sqrts ->fill(sqrtS()/GeV, weight); + _h_PHO_dsigdz ->fill(zPomJets, weight); + _h_PHO_dsigdxPom ->fill(xPom, weight); + _h_PHO_dsigdy ->fill(y, weight); + _h_PHO_dsigdxGam ->fill(xGamJets, weight); + _h_PHO_dsigdEtj1 ->fill(EtJet1, weight); + _h_PHO_dsigdMX ->fill(sqrt(M2X)*GeV, weight); + _h_PHO_dsigdDeltaEta ->fill(deltaEtaJets, weight); + _h_PHO_dsigdAvgEta ->fill(avgEtaJets, weight); + } else { + _h_DIS_sig_sqrts ->fill(sqrtS()/GeV, weight); + _h_DIS_dsigdz ->fill(zPomJets, weight); + _h_DIS_dsigdxPom ->fill(xPom, weight); + _h_DIS_dsigdy ->fill(y, weight); + _h_DIS_dsigdQ2 ->fill(Q2, weight); + _h_DIS_dsigdEtj1 ->fill(EtJet1, weight); + _h_DIS_dsigdMX ->fill(sqrt(M2X)*GeV, weight); + _h_DIS_dsigdDeltaEta ->fill(deltaEtaJets, weight); + _h_DIS_dsigdAvgEta ->fill(avgEtaJets, weight); + } + + } + + // Finalize + void finalize() { + // Normalise to cross section + // Remember to manually scale the cross section afterwards with + // the number of rejected events. + const double norm = crossSection()/picobarn/sumOfWeights(); + + scale(_h_PHO_sig_sqrts, norm); + scale(_h_PHO_dsigdz, norm); + scale(_h_PHO_dsigdxPom, norm); + scale(_h_PHO_dsigdy, norm); + scale(_h_PHO_dsigdxGam, norm); + scale(_h_PHO_dsigdEtj1, norm); + scale(_h_PHO_dsigdMX, norm); + scale(_h_PHO_dsigdDeltaEta, norm); + scale(_h_PHO_dsigdAvgEta, norm); + + scale(_h_DIS_sig_sqrts, norm); + scale(_h_DIS_dsigdz, norm); + scale(_h_DIS_dsigdxPom, norm); + scale(_h_DIS_dsigdy, norm); + scale(_h_DIS_dsigdQ2, norm); + scale(_h_DIS_dsigdEtj1, norm); + scale(_h_DIS_dsigdMX, norm); + scale(_h_DIS_dsigdDeltaEta, norm); + scale(_h_DIS_dsigdAvgEta, norm); + + if (_h_DIS_sig_sqrts->numEntries() != 0) + divide(_h_PHO_sig_sqrts, _h_DIS_sig_sqrts, _h_PHODIS_sqrts); + if (_h_DIS_dsigdDeltaEta->numEntries() != 0) + divide(_h_PHO_dsigdDeltaEta, _h_DIS_dsigdDeltaEta, _h_PHODIS_deltaEta); + if (_h_DIS_dsigdy->numEntries() != 0) + divide(_h_PHO_dsigdy, _h_DIS_dsigdy, _h_PHODIS_y); + if (_h_DIS_dsigdz->numEntries() != 0) + divide(_h_PHO_dsigdz, _h_DIS_dsigdz, _h_PHODIS_z); + if (_h_DIS_dsigdEtj1->numEntries() != 0) + divide(_h_PHO_dsigdEtj1, _h_DIS_dsigdEtj1, _h_PHODIS_Etj1); + + const double dPHO = nPHO; + MSG_INFO("H1_2015_I1343110"); + MSG_INFO("Cross section = " << crossSection()/picobarn << " pb"); + MSG_INFO("Number of events = " << numEvents() << ", sumW = " << sumOfWeights()); + MSG_INFO("Number of PHO = " << nPHO << ", number of DIS = " << nDIS); + MSG_INFO("Events passing electron veto = " << nVeto1 << " (" << nVeto1/dPHO * 100. << "%)" ); + MSG_INFO("Events passing t veto = " << nVeto2 << " (" << nVeto2/dPHO * 100. << "%)" ); + MSG_INFO("Events passing xPom = " << nVeto3 << " (" << nVeto3/dPHO * 100. << "%)" ); + MSG_INFO("Events passing jet Et veto = " << nVeto4 << " (" << nVeto4/dPHO * 100. << "%)" ); + MSG_INFO("Events passing jet eta veto = " << nVeto5 << " (" << nVeto5/dPHO * 100. << "%)" ); + MSG_INFO("Events passing zPom veto = " << nVeto6 << " (" << nVeto6/dPHO * 100. << "%)" ); + + } + + //@} + + + private: + + /// @name Histograms + //@{ + // Book histograms from REF data + Histo1DPtr _h_PHO_sig_sqrts; + Histo1DPtr _h_DIS_sig_sqrts; + Scatter2DPtr _h_PHODIS_sqrts; + + Histo1DPtr _h_DIS_dsigdz; + Histo1DPtr _h_DIS_dsigdxPom; + Histo1DPtr _h_DIS_dsigdy; + Histo1DPtr _h_DIS_dsigdQ2; + Histo1DPtr _h_DIS_dsigdEtj1; + Histo1DPtr _h_DIS_dsigdMX; + Histo1DPtr _h_DIS_dsigdDeltaEta; + Histo1DPtr _h_DIS_dsigdAvgEta; + + Histo1DPtr _h_PHO_dsigdz; + Histo1DPtr _h_PHO_dsigdxPom; + Histo1DPtr _h_PHO_dsigdy; + Histo1DPtr _h_PHO_dsigdxGam; + Histo1DPtr _h_PHO_dsigdEtj1; + Histo1DPtr _h_PHO_dsigdMX; + Histo1DPtr _h_PHO_dsigdDeltaEta; + Histo1DPtr _h_PHO_dsigdAvgEta; + + Scatter2DPtr _h_PHODIS_deltaEta; + Scatter2DPtr _h_PHODIS_y; + Scatter2DPtr _h_PHODIS_z; + Scatter2DPtr _h_PHODIS_Etj1; + //@} + + bool isPHO; + int nVeto1, nVeto2, nVeto3, nVeto4, nVeto5, nVeto6; + int nPHO, nDIS; + }; + + DECLARE_RIVET_PLUGIN(H1_2015_I1343110); + +} diff --git a/analyses/pluginHERA/H1_2015_I1343110.info b/analyses/pluginHERA/H1_2015_I1343110.info new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/H1_2015_I1343110.info @@ -0,0 +1,49 @@ +Name: H1_2015_I1343110 +Year: 2015 +Summary: Diffractive dijets in DIS and photoproduction +Experiment: H1 +Collider: HERA +InspireID: 1343110 +Status: UNVALIDATED +Authors: + - Christine O. Rasmussen + - Ilkka Helenius +References: +- JHEP 05 (2015) 056 +- arXiv:1502.01683[hep-ex] +RunInfo: + 920 GeV protons colliding with 27.5 GeV positrons; + Diffractive photoproduction of dijets; + Tagged protons.; + Jet $pT > 5$ GeV; + Note that CM energy is WRONG in HepData table.; + Has been changed by hand in YODA refdata file to correct value. +NumEvents: 1000000 +Beams: [p+, e+] +Energies: [[920, 27.5]] +PtCuts: [0] +Description: + H1 diffractive jets from proton--positron collisions at beam energies of + 920~GeV and 27.5~GeV. The cross section of the diffractive process + e+p -> e+X+p is measured at a centre-of-mass energy of 318 GeV, where the + system X contains at least two jets and the leading final state proton p is + detected in the H1 Very Forward Proton Spectrometer. The measurement is + performed in photoproduction with photon virtualities Q^2 < 2 GeV^2 and in + deep-inelastic scattering with 4 GeV^2 < Q2 < 80 GeV^2. +BibKey: Andreev:2015cwa +BibTeX: '@Article{Andreev:2015cwa, + author = "Andreev, V. and others", + title = "{Diffractive Dijet Production with a Leading Proton in + $ep$ Collisions at HERA}", + collaboration = "H1", + journal = "JHEP", + volume = "05", + year = "2015", + pages = "056", + doi = "10.1007/JHEP05(2015)056", + eprint = "1502.01683", + archivePrefix = "arXiv", + primaryClass = "hep-ex", + reportNumber = "DESY-14-242", + SLACcitation = "%%CITATION = ARXIV:1502.01683;%%" +}' diff --git a/analyses/pluginHERA/H1_2015_I1343110.plot b/analyses/pluginHERA/H1_2015_I1343110.plot new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/H1_2015_I1343110.plot @@ -0,0 +1,262 @@ +# BEGIN PLOT /H1_2015_I1343110/d01-x01-y01 +Title= Photoproduction +YLabel=$\sigma_{\gamma\mathm{p}}$ +XLabel=$\sqrt{s}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d02-x01-y01 +Title= DIS +YLabel=$\sigma_{\mathm{DIS}}$ +XLabel=$\sqrt{s}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d03-x01-y01 +Title= Photoproduction/DIS +YLabel=$\sigma_{\gamma\mathrm{p}}/\sigma_{\mathrm{DIS}}$ +XLabel=$\sqrt{s}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d04-x01-y01 +Title= DIS +XLabel=$z_{\mathbb{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} z_{\mathbb{P}}$ +LogY=0 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d05-x01-y01 +Title= DIS +XLabel=$x_{\mathbb{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} x_{\mathbb{P}}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d06-x01-y01 +Title=DIS +XLabel=$y$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} y$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d07-x01-y01 +Title=DIS +XLabel=$Q^2$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} Q^2$ +LogY=1 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d08-x01-y01 +Title=DIS +XLabel=$E_{\mathrm{T}}^{\mathrm{jet1}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} E_{\mathrm{T}}^{\mathrm{jet1}}$ +LogY=1 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d09-x01-y01 +Title=DIS +XLabel=$M_X$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} M_X$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d10-x01-y01 +Title=DIS +XLabel=$|\Delta\eta|$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} |\Delta\eta|$ +LogY=0 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d11-x01-y01 +Title=DIS +XLabel=$<\eta>$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} <\eta>$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d12-x01-y01 +Title= Photoproduction +XLabel=$z_{\mathbb{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} z_{\mathbb{P}}$ +LogY=0 +LegendXPos=0.05 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d13-x01-y01 +Title= Photoproduction +XLabel=$x_{\mathbb{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} x_{\mathbb{P}}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d14-x01-y01 +Title=Photoproduction +XLabel=$y$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} y$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d15-x01-y01 +Title=Photoproduction +XLabel=$x_{\gamma}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} x_{\gamma}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d16-x01-y01 +Title=Photoproduction +XLabel=$E_{\mathrm{T}}^{\mathrm{jet1}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} E_{\mathrm{T}}^{\mathrm{jet1}}$ +LogY=1 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d17-x01-y01 +Title=Photoproduction +XLabel=$M_X$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} M_X$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d18-x01-y01 +Title=Photoproduction +XLabel=$|\Delta\eta|$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} |\Delta\eta|$ +LogY=0 +LegendXPos=0.6 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d19-x01-y01 +Title=Photoproduction +XLabel=$<\eta>$ +YLabel=$\mathrm{d}\sigma / \mathrm{d} <\eta>$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d20-x01-y01 +Title= Photoproduction/DIS +YLabel=$\sigma_{\gamma\mathrm{p}}/\sigma_{\mathrm{DIS}}$ +XLabel=$|\Delta\eta|$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d21-x01-y01 +Title= Photoproduction/DIS +YLabel=$\sigma_{\gamma\mathrm{p}}/\sigma_{\mathrm{DIS}}$ +XLabel=$y$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d22-x01-y01 +Title= Photoproduction/DIS +YLabel=$\sigma_{\gamma\mathrm{p}}/\sigma_{\mathrm{DIS}}$ +XLabel=$z_{\mathbb{P}}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /H1_2015_I1343110/d23-x01-y01 +Title= Photoproduction/DIS +YLabel=$\sigma_{\gamma\mathrm{p}}/\sigma_{\mathrm{DIS}}$ +XLabel=$E_T^{\mathrm{jet1}}$ +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# ... add more histograms as you need them ... +# BEGIN PLOT /H1_2015_I1343110/d01-x01-y01 +#Title=[Uncomment and insert title for histogram d01-x01-y01 here] +#XLabel=[Uncomment and insert x-axis label for histogram d01-x01-y01 here] +#YLabel=[Uncomment and insert y-axis label for histogram d01-x01-y01 here] +# + any additional plot settings you might like, see make-plots documentation +# END PLOT + +# ... add more histograms as you need them ... diff --git a/analyses/pluginHERA/H1_2015_I1343110.yoda b/analyses/pluginHERA/H1_2015_I1343110.yoda new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/H1_2015_I1343110.yoda @@ -0,0 +1,623 @@ +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d01-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d01-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t1 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 2.370000e+02 3.401470e+01 3.401470e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d01-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d01-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t1 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 9.060000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d02-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d02-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t2 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 3.050000e+01 3.224903e+00 3.224903e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d02-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d02-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t2 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 9.990000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d02-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d02-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t2 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 1.022000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d03-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d03-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t3 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.181000e+02 5.000000e-01 5.000000e-01 7.780000e+00 1.288255e+00 1.288255e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d04-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d04-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t4 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 3.210000e+01 8.567574e+00 8.567574e+00 +3.000000e-01 1.000000e-01 1.000000e-01 5.980000e+01 9.755285e+00 9.755285e+00 +5.000000e-01 1.000000e-01 1.000000e-01 4.800000e+01 8.586769e+00 8.586769e+00 +7.000000e-01 1.000000e-01 1.000000e-01 1.390000e+01 5.891633e+00 5.891633e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d04-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d04-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t4 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 9.160000e-01 0.000000e+00 0.000000e+00 +3.000000e-01 1.000000e-01 1.000000e-01 1.012000e+00 0.000000e+00 0.000000e+00 +5.000000e-01 1.000000e-01 1.000000e-01 1.017000e+00 0.000000e+00 0.000000e+00 +7.000000e-01 1.000000e-01 1.000000e-01 1.028000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d04-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d04-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t4 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 1.084000e+00 0.000000e+00 0.000000e+00 +3.000000e-01 1.000000e-01 1.000000e-01 1.054000e+00 0.000000e+00 0.000000e+00 +5.000000e-01 1.000000e-01 1.000000e-01 9.960000e-01 0.000000e+00 0.000000e+00 +7.000000e-01 1.000000e-01 1.000000e-01 9.100000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d05-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d05-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t5 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.200000e-02 2.000000e-03 2.000000e-03 2.250000e+03 5.550253e+02 5.550253e+02 +1.650000e-02 2.500000e-03 2.500000e-03 2.210000e+03 4.257908e+02 4.257908e+02 +2.150000e-02 2.500000e-03 2.500000e-03 2.290000e+03 3.968049e+02 3.968049e+02 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d05-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d05-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t5 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.200000e-02 2.000000e-03 2.000000e-03 9.980000e-01 0.000000e+00 0.000000e+00 +1.650000e-02 2.500000e-03 2.500000e-03 1.003000e+00 0.000000e+00 0.000000e+00 +2.150000e-02 2.500000e-03 2.500000e-03 9.970000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d05-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d05-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t5 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.200000e-02 2.000000e-03 2.000000e-03 1.058000e+00 0.000000e+00 0.000000e+00 +1.650000e-02 2.500000e-03 2.500000e-03 1.014000e+00 0.000000e+00 0.000000e+00 +2.150000e-02 2.500000e-03 2.500000e-03 1.006000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d06-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d06-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t6 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 7.600000e+01 1.568714e+01 1.568714e+01 +3.800000e-01 6.000000e-02 6.000000e-02 6.970000e+01 1.277052e+01 1.277052e+01 +5.000000e-01 6.000000e-02 6.000000e-02 6.540000e+01 1.189094e+01 1.189094e+01 +6.300000e-01 7.000000e-02 7.000000e-02 3.860000e+01 9.184205e+00 9.184205e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d06-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d06-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t6 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 1.060000e+00 0.000000e+00 0.000000e+00 +3.800000e-01 6.000000e-02 6.000000e-02 9.750000e-01 0.000000e+00 0.000000e+00 +5.000000e-01 6.000000e-02 6.000000e-02 9.920000e-01 0.000000e+00 0.000000e+00 +6.300000e-01 7.000000e-02 7.000000e-02 9.480000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d06-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d06-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t6 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 9.920000e-01 0.000000e+00 0.000000e+00 +3.800000e-01 6.000000e-02 6.000000e-02 1.002000e+00 0.000000e+00 0.000000e+00 +5.000000e-01 6.000000e-02 6.000000e-02 1.056000e+00 0.000000e+00 0.000000e+00 +6.300000e-01 7.000000e-02 7.000000e-02 1.084000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d07-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d07-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t7 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +4.500000e+00 5.000000e-01 5.000000e-01 4.830000e+00 1.351132e+00 1.351132e+00 +6.000000e+00 1.000000e+00 1.000000e+00 2.550000e+00 6.687518e-01 6.687518e-01 +9.000000e+00 2.000000e+00 2.000000e+00 1.660000e+00 3.343242e-01 3.343242e-01 +2.050000e+01 9.500000e+00 9.500000e+00 5.200000e-01 8.538457e-02 8.538457e-02 +5.500000e+01 2.500000e+01 2.500000e+01 1.040000e-01 2.724165e-02 2.724165e-02 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d07-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d07-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t7 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +4.500000e+00 5.000000e-01 5.000000e-01 9.820000e-01 0.000000e+00 0.000000e+00 +6.000000e+00 1.000000e+00 1.000000e+00 1.002000e+00 0.000000e+00 0.000000e+00 +9.000000e+00 2.000000e+00 2.000000e+00 9.740000e-01 0.000000e+00 0.000000e+00 +2.050000e+01 9.500000e+00 9.500000e+00 1.019000e+00 0.000000e+00 0.000000e+00 +5.500000e+01 2.500000e+01 2.500000e+01 1.036000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d07-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d07-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t7 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +4.500000e+00 5.000000e-01 5.000000e-01 1.020000e+00 0.000000e+00 0.000000e+00 +6.000000e+00 1.000000e+00 1.000000e+00 1.020000e+00 0.000000e+00 0.000000e+00 +9.000000e+00 2.000000e+00 2.000000e+00 1.028000e+00 0.000000e+00 0.000000e+00 +2.050000e+01 9.500000e+00 9.500000e+00 1.034000e+00 0.000000e+00 0.000000e+00 +5.500000e+01 2.500000e+01 2.500000e+01 1.013000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d08-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d08-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t8 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 1.124000e+01 1.630769e+00 1.630769e+00 +7.750000e+00 7.500000e-01 7.500000e-01 5.660000e+00 1.170567e+00 1.170567e+00 +9.250000e+00 7.500000e-01 7.500000e-01 2.550000e+00 1.191710e+00 1.191710e+00 +1.225000e+01 2.250000e+00 2.250000e+00 4.850000e-01 2.309761e-01 2.309761e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d08-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d08-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t8 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 9.990000e-01 0.000000e+00 0.000000e+00 +7.750000e+00 7.500000e-01 7.500000e-01 9.860000e-01 0.000000e+00 0.000000e+00 +9.250000e+00 7.500000e-01 7.500000e-01 1.050000e+00 0.000000e+00 0.000000e+00 +1.225000e+01 2.250000e+00 2.250000e+00 9.610000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d08-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d08-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t8 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 1.006000e+00 0.000000e+00 0.000000e+00 +7.750000e+00 7.500000e-01 7.500000e-01 1.034000e+00 0.000000e+00 0.000000e+00 +9.250000e+00 7.500000e-01 7.500000e-01 1.112000e+00 0.000000e+00 0.000000e+00 +1.225000e+01 2.250000e+00 2.250000e+00 9.760000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d09-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d09-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t9 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e+01 5.000000e+00 5.000000e+00 2.000000e-01 2.698611e-01 2.698611e-01 +2.400000e+01 4.000000e+00 4.000000e+00 2.060000e+00 2.932227e-01 2.932227e-01 +3.200000e+01 4.000000e+00 4.000000e+00 1.430000e+00 2.477864e-01 2.477864e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d09-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d09-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t9 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e+01 5.000000e+00 5.000000e+00 1.024000e+00 0.000000e+00 0.000000e+00 +2.400000e+01 4.000000e+00 4.000000e+00 1.026000e+00 0.000000e+00 0.000000e+00 +3.200000e+01 4.000000e+00 4.000000e+00 9.520000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d09-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d09-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t9 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e+01 5.000000e+00 5.000000e+00 9.770000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 4.000000e+00 4.000000e+00 1.021000e+00 0.000000e+00 0.000000e+00 +3.200000e+01 4.000000e+00 4.000000e+00 1.046000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d10-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d10-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t10 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 2.480000e+01 4.022266e+00 4.022266e+00 +7.500000e-01 2.500000e-01 2.500000e-01 1.600000e+01 3.472590e+00 3.472590e+00 +1.250000e+00 2.500000e-01 2.500000e-01 1.310000e+01 3.128268e+00 3.128268e+00 +1.750000e+00 2.500000e-01 2.500000e-01 7.800000e+00 2.672305e+00 2.672305e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d10-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d10-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t10 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 1.015000e+00 0.000000e+00 0.000000e+00 +7.500000e-01 2.500000e-01 2.500000e-01 1.002000e+00 0.000000e+00 0.000000e+00 +1.250000e+00 2.500000e-01 2.500000e-01 9.680000e-01 0.000000e+00 0.000000e+00 +1.750000e+00 2.500000e-01 2.500000e-01 9.660000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d10-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d10-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t10 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 1.004000e+00 0.000000e+00 0.000000e+00 +7.500000e-01 2.500000e-01 2.500000e-01 1.046000e+00 0.000000e+00 0.000000e+00 +1.250000e+00 2.500000e-01 2.500000e-01 1.030000e+00 0.000000e+00 0.000000e+00 +1.750000e+00 2.500000e-01 2.500000e-01 1.030000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d11-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d11-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t11 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-7.250000e-01 2.750000e-01 2.750000e-01 1.030000e+01 2.455681e+00 2.455681e+00 +-2.500000e-01 2.000000e-01 2.000000e-01 3.010000e+01 4.685556e+00 4.685556e+00 +1.000000e-01 1.500000e-01 1.500000e-01 3.000000e+01 5.646539e+00 5.646539e+00 +4.500000e-01 2.000000e-01 2.000000e-01 9.200000e+00 3.509749e+00 3.509749e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d11-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d11-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t11 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-7.250000e-01 2.750000e-01 2.750000e-01 1.011000e+00 0.000000e+00 0.000000e+00 +-2.500000e-01 2.000000e-01 2.000000e-01 1.021000e+00 0.000000e+00 0.000000e+00 +1.000000e-01 1.500000e-01 1.500000e-01 9.940000e-01 0.000000e+00 0.000000e+00 +4.500000e-01 2.000000e-01 2.000000e-01 9.210000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d11-x01-y03 +IsRef=1 +Path=/REF/H1_2015_I1343110/d11-x01-y03 +Title=doi:10.17182/hepdata.73234.v1/t11 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-7.250000e-01 2.750000e-01 2.750000e-01 9.050000e-01 0.000000e+00 0.000000e+00 +-2.500000e-01 2.000000e-01 2.000000e-01 1.011000e+00 0.000000e+00 0.000000e+00 +1.000000e-01 1.500000e-01 1.500000e-01 1.056000e+00 0.000000e+00 0.000000e+00 +4.500000e-01 2.000000e-01 2.000000e-01 1.171000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d12-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d12-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t12 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 7.300000e+01 4.375642e+01 4.375642e+01 +3.000000e-01 1.000000e-01 1.000000e-01 3.660000e+02 8.649533e+01 8.649533e+01 +5.000000e-01 1.000000e-01 1.000000e-01 4.130000e+02 8.893416e+01 8.893416e+01 +7.000000e-01 1.000000e-01 1.000000e-01 2.980000e+02 7.628451e+01 7.628451e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d12-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d12-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t12 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 7.540000e-01 0.000000e+00 0.000000e+00 +3.000000e-01 1.000000e-01 1.000000e-01 8.330000e-01 0.000000e+00 0.000000e+00 +5.000000e-01 1.000000e-01 1.000000e-01 9.280000e-01 0.000000e+00 0.000000e+00 +7.000000e-01 1.000000e-01 1.000000e-01 1.017000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d13-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d13-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t13 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.200000e-02 2.000000e-03 2.000000e-03 1.780000e+04 3.348104e+03 3.348104e+03 +1.650000e-02 2.500000e-03 2.500000e-03 1.530000e+04 2.736691e+03 2.736691e+03 +2.150000e-02 2.500000e-03 2.500000e-03 1.790000e+04 5.193129e+03 5.193129e+03 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d13-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d13-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t13 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.200000e-02 2.000000e-03 2.000000e-03 9.330000e-01 0.000000e+00 0.000000e+00 +1.650000e-02 2.500000e-03 2.500000e-03 9.160000e-01 0.000000e+00 0.000000e+00 +2.150000e-02 2.500000e-03 2.500000e-03 8.820000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d14-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d14-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t14 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 6.200000e+02 1.560837e+02 1.560837e+02 +3.800000e-01 6.000000e-02 6.000000e-02 5.410000e+02 1.190016e+02 1.190016e+02 +5.000000e-01 6.000000e-02 6.000000e-02 4.080000e+02 1.087739e+02 1.087739e+02 +6.300000e-01 7.000000e-02 7.000000e-02 3.420000e+02 7.948024e+01 7.948024e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d14-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d14-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t14 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 8.580000e-01 0.000000e+00 0.000000e+00 +3.800000e-01 6.000000e-02 6.000000e-02 9.140000e-01 0.000000e+00 0.000000e+00 +5.000000e-01 6.000000e-02 6.000000e-02 9.570000e-01 0.000000e+00 0.000000e+00 +6.300000e-01 7.000000e-02 7.000000e-02 9.130000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d15-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d15-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t15 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e-01 1.500000e-01 1.500000e-01 6.500000e+01 4.965804e+01 4.965804e+01 +4.500000e-01 1.500000e-01 1.500000e-01 1.800000e+02 5.183781e+01 5.183781e+01 +7.000000e-01 1.000000e-01 1.000000e-01 3.970000e+02 9.235094e+01 9.235094e+01 +9.000000e-01 1.000000e-01 1.000000e-01 3.670000e+02 6.187624e+01 6.187624e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d15-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d15-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t15 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e-01 1.500000e-01 1.500000e-01 6.540000e-01 0.000000e+00 0.000000e+00 +4.500000e-01 1.500000e-01 1.500000e-01 8.840000e-01 0.000000e+00 0.000000e+00 +7.000000e-01 1.000000e-01 1.000000e-01 1.536000e+00 0.000000e+00 0.000000e+00 +9.000000e-01 1.000000e-01 1.000000e-01 6.830000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d16-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d16-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t16 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 9.100000e+01 1.930444e+01 1.930444e+01 +7.750000e+00 7.500000e-01 7.500000e-01 4.560000e+01 1.244220e+01 1.244220e+01 +9.250000e+00 7.500000e-01 7.500000e-01 1.120000e+01 6.276089e+00 6.276089e+00 +1.225000e+01 2.250000e+00 2.250000e+00 1.150000e+00 1.058962e+00 1.058962e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d16-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d16-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t16 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 8.770000e-01 0.000000e+00 0.000000e+00 +7.750000e+00 7.500000e-01 7.500000e-01 9.910000e-01 0.000000e+00 0.000000e+00 +9.250000e+00 7.500000e-01 7.500000e-01 9.560000e-01 0.000000e+00 0.000000e+00 +1.225000e+01 2.250000e+00 2.250000e+00 8.400000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d17-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d17-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t17 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e+01 5.000000e+00 5.000000e+00 2.470000e+00 1.097286e+00 1.097286e+00 +2.400000e+01 4.000000e+00 4.000000e+00 1.320000e+01 2.564268e+00 2.564268e+00 +3.200000e+01 4.000000e+00 4.000000e+00 1.240000e+01 2.753247e+00 2.753247e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d17-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d17-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t17 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.500000e+01 5.000000e+00 5.000000e+00 8.990000e-01 0.000000e+00 0.000000e+00 +2.400000e+01 4.000000e+00 4.000000e+00 9.250000e-01 0.000000e+00 0.000000e+00 +3.200000e+01 4.000000e+00 4.000000e+00 9.330000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d18-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d18-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t18 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 1.710000e+02 2.558437e+01 2.558437e+01 +7.500000e-01 2.500000e-01 2.500000e-01 1.470000e+02 2.712220e+01 2.712220e+01 +1.250000e+00 2.500000e-01 2.500000e-01 9.300000e+01 2.178683e+01 2.178683e+01 +1.750000e+00 2.500000e-01 2.500000e-01 4.100000e+01 1.595638e+01 1.595638e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d18-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d18-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t18 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 8.720000e-01 0.000000e+00 0.000000e+00 +7.500000e-01 2.500000e-01 2.500000e-01 9.050000e-01 0.000000e+00 0.000000e+00 +1.250000e+00 2.500000e-01 2.500000e-01 9.360000e-01 0.000000e+00 0.000000e+00 +1.750000e+00 2.500000e-01 2.500000e-01 9.780000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d19-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d19-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t19 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-7.250000e-01 2.750000e-01 2.750000e-01 4.840000e+01 9.001489e+00 9.001489e+00 +-2.500000e-01 2.000000e-01 2.000000e-01 1.750000e+02 2.853359e+01 2.853359e+01 +1.000000e-01 1.500000e-01 1.500000e-01 2.640000e+02 4.349595e+01 4.349595e+01 +4.500000e-01 2.000000e-01 2.000000e-01 1.340000e+02 3.725224e+01 3.725224e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d19-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d19-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t19 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-7.250000e-01 2.750000e-01 2.750000e-01 7.950000e-01 0.000000e+00 0.000000e+00 +-2.500000e-01 2.000000e-01 2.000000e-01 8.810000e-01 0.000000e+00 0.000000e+00 +1.000000e-01 1.500000e-01 1.500000e-01 9.710000e-01 0.000000e+00 0.000000e+00 +4.500000e-01 2.000000e-01 2.000000e-01 9.760000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d20-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d20-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t20 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 6.900000e+00 1.449082e+00 1.449082e+00 +7.500000e-01 2.500000e-01 2.500000e-01 9.200000e+00 2.595542e+00 2.595542e+00 +1.250000e+00 2.500000e-01 2.500000e-01 7.100000e+00 2.376592e+00 2.376592e+00 +1.750000e+00 2.500000e-01 2.500000e-01 5.200000e+00 2.653784e+00 2.653784e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d20-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d20-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t20 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-01 2.500000e-01 2.500000e-01 8.670000e-01 0.000000e+00 0.000000e+00 +7.500000e-01 2.500000e-01 2.500000e-01 8.650000e-01 0.000000e+00 0.000000e+00 +1.250000e+00 2.500000e-01 2.500000e-01 9.080000e-01 0.000000e+00 0.000000e+00 +1.750000e+00 2.500000e-01 2.500000e-01 9.510000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d21-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d21-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t21 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 8.000000e+00 2.556923e+00 2.556923e+00 +3.800000e-01 6.000000e-02 6.000000e-02 7.700000e+00 2.167314e+00 2.167314e+00 +5.000000e-01 6.000000e-02 6.000000e-02 6.200000e+00 2.002379e+00 2.002379e+00 +6.300000e-01 7.000000e-02 7.000000e-02 8.900000e+00 2.814554e+00 2.814554e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d21-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d21-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t21 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.600000e-01 6.000000e-02 6.000000e-02 8.640000e-01 0.000000e+00 0.000000e+00 +3.800000e-01 6.000000e-02 6.000000e-02 9.120000e-01 0.000000e+00 0.000000e+00 +5.000000e-01 6.000000e-02 6.000000e-02 9.070000e-01 0.000000e+00 0.000000e+00 +6.300000e-01 7.000000e-02 7.000000e-02 8.410000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d22-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d22-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t22 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 2.290000e+00 1.567528e+00 1.567528e+00 +3.000000e-01 1.000000e-01 1.000000e-01 6.100000e+00 1.704696e+00 1.704696e+00 +5.000000e-01 1.000000e-01 1.000000e-01 8.500000e+00 2.239520e+00 2.239520e+00 +7.000000e-01 1.000000e-01 1.000000e-01 2.140000e+01 1.040553e+01 1.040553e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d22-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d22-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t22 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.000000e-01 1.000000e-01 1.000000e-01 6.970000e-01 0.000000e+00 0.000000e+00 +3.000000e-01 1.000000e-01 1.000000e-01 7.900000e-01 0.000000e+00 0.000000e+00 +5.000000e-01 1.000000e-01 1.000000e-01 9.320000e-01 0.000000e+00 0.000000e+00 +7.000000e-01 1.000000e-01 1.000000e-01 1.116000e+00 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d23-x01-y01 +IsRef=1 +Path=/REF/H1_2015_I1343110/d23-x01-y01 +Title=doi:10.17182/hepdata.73234.v1/t23 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 8.000000e+00 2.129518e+00 2.129518e+00 +7.750000e+00 7.500000e-01 7.500000e-01 8.050000e+00 2.363097e+00 2.363097e+00 +9.250000e+00 7.500000e-01 7.500000e-01 4.400000e+00 2.982749e+00 2.982749e+00 +1.225000e+01 2.250000e+00 2.250000e+00 2.400000e+00 2.417634e+00 2.417634e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/H1_2015_I1343110/d23-x01-y02 +IsRef=1 +Path=/REF/H1_2015_I1343110/d23-x01-y02 +Title=doi:10.17182/hepdata.73234.v1/t23 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +6.250000e+00 7.500000e-01 7.500000e-01 8.720000e-01 0.000000e+00 0.000000e+00 +7.750000e+00 7.500000e-01 7.500000e-01 9.570000e-01 0.000000e+00 0.000000e+00 +9.250000e+00 7.500000e-01 7.500000e-01 8.580000e-01 0.000000e+00 0.000000e+00 +1.225000e+01 2.250000e+00 2.250000e+00 8.590000e-01 0.000000e+00 0.000000e+00 +END YODA_SCATTER2D + diff --git a/analyses/pluginHERA/ZEUS_2008_I763404.cc b/analyses/pluginHERA/ZEUS_2008_I763404.cc new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/ZEUS_2008_I763404.cc @@ -0,0 +1,182 @@ +// -*- C++ -*- +#include "Rivet/Analysis.hh" +#include "Rivet/Projections/Beam.hh" +#include "Rivet/Projections/DISKinematics.hh" +#include "Rivet/Projections/DISDiffHadron.hh" +#include "Rivet/Projections/FastJets.hh" + +namespace Rivet { + + + /// @brief ZEUS dijet photoproduction study used in the ZEUS jets PDF fit + /// + /// This class is a reproduction of the HZTool routine for the ZEUS + /// dijet photoproduction paper which was used in the ZEUS jets PDF fit. + /// + /// @author Ilkka Helenius + class ZEUS_2008_I763404 : public Analysis { + public: + + /// Constructor + DEFAULT_RIVET_ANALYSIS_CTOR(ZEUS_2008_I763404); + + /// @name Analysis methods + //@{ + + // Book projections and histograms + void init() { + + /// @todo Acceptance + FinalState fs; + // Final state particles with central tracking detector. + declare(FastJets(fs, FastJets::KT, 1.0), "Jets"); + + // Projections + declare(DISKinematics(), "Kinematics"); + declare(DISDiffHadron(), "Hadron"); + + _h_dsigma_all[0] = bookHisto1D(1, 1, 1); + _h_dsigma_all[1] = bookHisto1D(2, 1, 1); + _h_dsigma_all[2] = bookHisto1D(3, 1, 1); + _h_dsigma_all[3] = bookHisto1D(4, 1, 1); + _h_dsigma_all[4] = bookHisto1D(5, 1, 1); + _h_dsigma_all[5] = bookHisto1D(6, 1, 1); + _h_xgamma = bookHisto1D(7, 1, 1); + _h_dsigma_xgamma[0][0] = bookHisto1D(8, 1, 1); + _h_dsigma_xgamma[0][1] = bookHisto1D(9, 1, 1); + _h_dsigma_xgamma[0][2] = bookHisto1D(10, 1, 1); + _h_dsigma_xgamma[0][3] = bookHisto1D(11, 1, 1); + _h_dsigma_xgamma[1][0] = bookHisto1D(12, 1, 1); + _h_dsigma_xgamma[1][1] = bookHisto1D(13, 1, 1); + _h_dsigma_xgamma[1][2] = bookHisto1D(14, 1, 1); + _h_dsigma_xgamma[1][3] = bookHisto1D(15, 1, 1); + + nVeto0 = 0; + nVeto1 = 0; + nVeto2 = 0; + nVeto3 = 0; + nVeto4 = 0; + } + + // Do the analysis + void analyze(const Event& event) { + + // Derive the DIS kinematics. + const DISKinematics& kin = apply(event, "Kinematics"); + + // Derive the diffractive kinematics (should be used for diffractive only). + Particle hadronOut; + Particle hadronIn; + try { + const DISDiffHadron & diffhadr = apply(event, "Hadron"); + hadronOut = diffhadr.out(); + hadronIn = diffhadr.in(); + } catch (const Error& e){ + vetoEvent; + } + + // Determine event orientation, since coord system is for +z = proton direction + const int orientation = kin.orientation(); + + // Calculate the photon 4-momentum from the incoming and outgoing lepton. + const FourMomentum qleptonIn = kin.beamLepton().momentum(); + const FourMomentum qleptonOut = kin.scatteredLepton().momentum(); + const FourMomentum qphoton = qleptonIn - qleptonOut; + + // Calculate the Pomeron 4-momentum from the incoming and outgoing hadron + const FourMomentum pHadOut = hadronOut.momentum(); + const FourMomentum pHadIn = hadronIn.momentum(); + const FourMomentum pPomeron = pHadIn - pHadOut; + + // Q2 and inelasticity cuts + if (kin.Q2() > 1*GeV2) vetoEvent; + ++nVeto0; + if (!inRange(kin.y(), 0.2, 0.85)) vetoEvent; + ++nVeto1; + + // Jet selection and veto. + const Jets jets = apply(event, "Jets") \ + .jets(Cuts::Et > 6.5*GeV && Cuts::etaIn(-1.5*orientation, 1.5*orientation), cmpMomByEt); + MSG_DEBUG("Jet multiplicity = " << jets.size()); + if (jets.size() < 2) vetoEvent; + ++nVeto2; + const Jet& j1 = jets[0]; + const Jet& j2 = jets[1]; + if (j1.Et() < 7.5*GeV) vetoEvent; + ++nVeto3; + + // Veto on x_Pomeron. + const double xPom = ( pPomeron * qphoton ) / (pHadIn * qphoton); + if (xPom > 0.025) vetoEvent; + ++nVeto4; + + // Computation of event-level variables. + const double eta1 = orientation*j1.eta(), eta2 = orientation*j2.eta(); + const double xyobs = (j1.Et() * exp(-eta1) + j2.Et() * exp(-eta2)) / (2*kin.y()*kin.beamLepton().E()); + const size_t i_xyobs = (xyobs < 0.75) ? 1 : 0; + const double zPobs = (j1.Et() * exp(eta1) + j2.Et() * exp(eta2)) / (2*xPom*kin.beamHadron().E()); + const double M_X = sqrt( (pPomeron + qphoton).mass2() ); + + // Fill histograms + const double weight = event.weight(); + + _h_dsigma_all[0]->fill(kin.y(), weight); + _h_dsigma_all[1]->fill(M_X, weight); + _h_dsigma_all[2]->fill(xPom, weight); + _h_dsigma_all[3]->fill(zPobs, weight); + _h_dsigma_all[4]->fill(j1.Et(), weight); + _h_dsigma_all[5]->fill(eta1, weight); + + _h_xgamma->fill(xyobs, weight); + + _h_dsigma_xgamma[i_xyobs][0]->fill(kin.y(), weight); + _h_dsigma_xgamma[i_xyobs][1]->fill(M_X, weight); + _h_dsigma_xgamma[i_xyobs][2]->fill(xPom, weight); + _h_dsigma_xgamma[i_xyobs][3]->fill(zPobs, weight); + + } + + // Finalize + void finalize() { + const double norm = crossSection()/picobarn/sumOfWeights(); + scale(_h_xgamma, norm); + for (auto& h : _h_dsigma_all) scale(h, norm); + for (auto& h : _h_dsigma_xgamma[0]) scale(h, norm); + for (auto& h : _h_dsigma_xgamma[1]) scale(h, norm); + + // Cross section in nb for these observables. + scale(_h_dsigma_all[2], 1e-3); + scale(_h_dsigma_xgamma[0][2], 1e-3); + scale(_h_dsigma_xgamma[1][2], 1e-3); + + double dPHO = nVeto1; + + MSG_INFO("ZEUS_2008_I763403"); + MSG_INFO("Cross section = " << crossSection()/picobarn); + MSG_INFO("Number of events = " << numEvents() << ", sumW = " << sumOfWeights()); + MSG_INFO("Events passing electron veto1= " << nVeto0 << " (" << nVeto0/dPHO * 100. << "%)" ); + MSG_INFO("Events passing electron veto2= " << nVeto1 << " (" << nVeto1/dPHO * 100. << "%)" ); + MSG_INFO("Events passing jet size veto = " << nVeto2 << " (" << nVeto2/dPHO * 100. << "%)" ); + MSG_INFO("Events passing jet Et veto = " << nVeto3 << " (" << nVeto3/dPHO * 100. << "%)" ); + MSG_INFO("Events passing xPom veto = " << nVeto4 << " (" << nVeto4/dPHO * 100. << "%)" ); + + } + + //@} + + + private: + + /// @name Histograms + //@{ + Histo1DPtr _h_dsigma_all[6]; + Histo1DPtr _h_xgamma; + Histo1DPtr _h_dsigma_xgamma[2][4]; + //@} + + int nVeto0, nVeto1, nVeto2, nVeto3, nVeto4; + }; + + DECLARE_RIVET_PLUGIN(ZEUS_2008_I763404); + +} diff --git a/analyses/pluginHERA/ZEUS_2008_I763404.info b/analyses/pluginHERA/ZEUS_2008_I763404.info new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/ZEUS_2008_I763404.info @@ -0,0 +1,50 @@ +Name: ZEUS_2008_I763404 +Year: 2008 +Summary: Diffractive photoproduction of dijets +Experiment: ZEUS +Collider: HERA Run II +SpiresID: 7416806 +InspireID: 763404 +Status: UNVALIDATED +Authors: + - Ilkka Helenius + - Christine O. Rasmussen +References: + - Eur.Phys.J.C55:177,2008 + - DESY 07/161 + - arXiv:0710.1498 [hep-ex] +RunInfo: + 920 GeV protons colliding with 27.5 GeV positrons; + Diffractive photoproduction of dijets; + Leading jet $pT > 7.5$ GeV, second jet $pT > 6.5$ GeV; + Jet pseudorapidity $-1.5 < \eta^{jet} < 1.5$ +NumEvents: 1000000 +Beams: [p+, e+] +Energies: [[920, 27.5]] +PtCuts: [0] +Description: + ZEUS analysis for diffractive photoproduction of dijets in proton-positron + collisions with beam energies of 920~GeV on 27.5~GeV at the ep collider HERA + using an integrated luminosity of 77.2 pb−1. The measurements were made in the + kinematic range Q2 < 1 GeV^2, 0.20 < y < 0.85 and xIP < 0.025, where Q2 is the + photon virtuality, y is the inelasticity and xIP is the fraction of the proton + momentum taken by the diffractive exchange. The two jets with the highest + transverse energy, Ejet, were required to satisfy E_jet > 7.5 and 6.5 GeV, + respectively, and to lie in the pseudorapidity range −1.5 < η_{jet} < 1.5. +BibKey: Chekanov:2007rh +BibTeX: '@article{Chekanov:2007rh, + author = "Chekanov, Sergei and others", + title = "{Diffractive photoproduction of dijets in ep collisions + at HERA}", + collaboration = "ZEUS", + journal = "Eur. Phys. J.", + volume = "C55", + year = "2008", + pages = "177-191", + doi = "10.1140/epjc/s10052-008-0598-2", + eprint = "0710.1498", + archivePrefix = "arXiv", + primaryClass = "hep-ex", + reportNumber = "DESY-07-161", + SLACcitation = "%%CITATION = ARXIV:0710.1498;%%" +}' diff --git a/analyses/pluginHERA/ZEUS_2008_I763404.plot b/analyses/pluginHERA/ZEUS_2008_I763404.plot new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/ZEUS_2008_I763404.plot @@ -0,0 +1,203 @@ +# BEGIN PLOT /ZEUS_2008_I763404/d01-x01-y01 +Title= +XLabel=$y$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}y$ [pb] +LogY=0 +LegendXPos=0.1 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +#YMax=400 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d02-x01-y01 +Title= +XLabel=$M_X$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}M_X$ [pb] +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +YMax=12 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d03-x01-y01 +Title= +XLabel=$x_{\mathrm{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}x_{\mathrm{P}}$ [pb] +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d04-x01-y01 +Title= +XLabel=$z_{\mathrm{P}}^{\mathrm{obs}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}z_{\mathrm{P}}^{\mathrm{obs}}$ [pb] +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +YMax=500 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d05-x01-y01 +Title= +XLabel=$E_{\mathrm{T}}^{\mathrm{jet1}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}E_{\mathrm{T}}^{\mathrm{jet1}}$ [pb/GeV] +LogY=1 +LegendXPos=0.1 +LegendYPos=0.35 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +#YMax=100 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d06-x01-y01 +Title= +XLabel=$\eta^{\mathrm{jet1}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}\eta^{\mathrm{jet1}}$ [pb] +LogY=0 +LegendXPos=0.3 +LegendYPos=0.35 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +#YMax=150 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d07-x01-y01 +Title= +XLabel=$x_{\gamma}^{\mathrm{obs}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}x_{\gamma}^{\mathrm{obs}}$ [pb] +LogY=0 +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.3 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d08-x01-y01 +Title= +XLabel=$y$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}y$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} > 0.75$ +LegendXPos=0.1 +LegendYPos=0.35 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d09-x01-y01 +Title= +XLabel=$M_X$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}M_X$ [pb/GeV] +LogY=0 +CustomLegend=$x_{\gamma} > 0.75$ +LegendXPos=0.6 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d10-x01-y01 +Title= +XLabel=$x_{\mathrm{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}x_{\mathrm{P}}$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} > 0.75$ +LegendXPos=0.6 +LegendYPos=0.35 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d11-x01-y01 +Title= +XLabel=$z_{\mathrm{P}}^{\mathrm{obs}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}z_{\mathrm{P}}^{\mathrm{obs}}$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} > 0.75$ +LegendXPos=0.6 +LegendYPos=0.35 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d12-x01-y01 +Title= +XLabel=$y$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}y$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} < 0.75$ +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d13-x01-y01 +Title= +XLabel=$M_X$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}M_X$ [pb/GeV] +LogY=0 +CustomLegend=$x_{\gamma} < 0.75$ +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d14-x01-y01 +Title= +XLabel=$x_{\mathrm{P}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}x_{\mathrm{P}}$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} < 0.75$ +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT + +# BEGIN PLOT /ZEUS_2008_I763404/d15-x01-y01 +Title= +XLabel=$z_{\mathrm{P}}^{\mathrm{obs}}$ +YLabel=$\mathrm{d}\sigma / \mathrm{d}z_{\mathrm{P}}^{\mathrm{obs}}$ [pb] +LogY=0 +CustomLegend=$x_{\gamma} < 0.75$ +LegendXPos=0.1 +LegendYPos=0.95 +#RatioPlotYMin=0.0 +#RatioPlotYMax=2.2 +RatioPlotYMin=0.1 +RatioPlotYMax=2.2 +# END PLOT diff --git a/analyses/pluginHERA/ZEUS_2008_I763404.yoda b/analyses/pluginHERA/ZEUS_2008_I763404.yoda new file mode 100644 --- /dev/null +++ b/analyses/pluginHERA/ZEUS_2008_I763404.yoda @@ -0,0 +1,194 @@ +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d01-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d01-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t1 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.650000e-01 6.500000e-02 6.500000e-02 1.379000e+02 9.246621e+00 1.658704e+01 +3.950000e-01 6.500000e-02 6.500000e-02 1.984000e+02 9.027735e+00 2.330901e+01 +5.250000e-01 6.500000e-02 6.500000e-02 2.183000e+02 1.780140e+01 2.633439e+01 +6.550000e-01 6.500000e-02 6.500000e-02 1.965000e+02 1.175457e+01 2.392175e+01 +7.850000e-01 6.500000e-02 6.500000e-02 2.036000e+02 1.388092e+01 2.467651e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d02-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d02-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t2 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.750000e+01 2.500000e+00 2.500000e+00 2.110000e+00 1.109054e-01 2.027313e-01 +2.250000e+01 2.500000e+00 2.500000e+00 6.350000e+00 3.141656e-01 3.925557e-01 +2.750000e+01 2.500000e+00 2.500000e+00 6.390000e+00 3.449638e-01 8.668333e-01 +3.250000e+01 2.500000e+00 2.500000e+00 5.410000e+00 4.188078e-01 6.952697e-01 +3.750000e+01 2.500000e+00 2.500000e+00 3.140000e+00 2.694439e-01 7.116179e-01 +4.250000e+01 2.500000e+00 2.500000e+00 1.210000e+00 1.392839e-01 3.241913e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d03-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d03-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t3 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-03 2.500000e-03 2.500000e-03 4.000000e-01 7.280110e-02 7.280110e-02 +7.500000e-03 2.500000e-03 2.500000e-03 3.940000e+00 2.714774e-01 2.675818e-01 +1.250000e-02 2.500000e-03 2.500000e-03 6.280000e+00 2.808914e-01 6.628725e-01 +1.750000e-02 2.500000e-03 2.500000e-03 7.000000e+00 4.528797e-01 9.811218e-01 +2.250000e-02 2.500000e-03 2.500000e-03 7.210000e+00 5.714018e-01 1.305910e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d04-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d04-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t4 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.000000e-01 1.000000e-01 1.000000e-01 8.640000e+01 1.090688e+01 1.663641e+01 +5.000000e-01 1.000000e-01 1.000000e-01 1.457000e+02 1.305603e+01 1.889418e+01 +7.000000e-01 1.000000e-01 1.000000e-01 1.929000e+02 1.423025e+01 1.561602e+01 +9.000000e-01 1.000000e-01 1.000000e-01 1.902000e+02 6.687301e+00 1.611583e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d05-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d05-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t5 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +8.500000e+00 1.000000e+00 1.000000e+00 4.400000e+01 2.049390e+00 4.001250e+00 +1.050000e+01 1.000000e+00 1.000000e+00 1.370000e+01 9.486833e-01 3.385262e+00 +1.250000e+01 1.000000e+00 1.000000e+00 3.500000e+00 4.123106e-01 5.385165e-01 +1.450000e+01 1.000000e+00 1.000000e+00 8.000000e-01 1.414214e-01 1.732051e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d06-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d06-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t6 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +-1.250000e+00 2.500000e-01 2.500000e-01 1.420000e+01 1.473092e+00 2.014944e+00 +-7.500000e-01 2.500000e-01 2.500000e-01 5.560000e+01 3.551056e+00 4.805206e+00 +-2.500000e-01 2.500000e-01 2.500000e-01 7.290000e+01 5.536244e+00 7.147727e+00 +2.500000e-01 2.500000e-01 2.500000e-01 6.360000e+01 3.852272e+00 7.948585e+00 +7.500000e-01 2.500000e-01 2.500000e-01 3.490000e+01 1.539480e+00 5.566866e+00 +1.250000e+00 2.500000e-01 2.500000e-01 8.000000e+00 7.348469e-01 1.542725e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d07-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d07-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t7 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.125000e-01 6.250000e-02 6.250000e-02 2.850000e+01 3.996248e+00 2.823119e+00 +4.375000e-01 6.250000e-02 6.250000e-02 5.270000e+01 5.537147e+00 5.930430e+00 +5.625000e-01 6.250000e-02 6.250000e-02 7.810000e+01 7.181922e+00 5.247857e+00 +6.875000e-01 6.250000e-02 6.250000e-02 1.143000e+02 1.132696e+01 1.006479e+01 +8.750000e-01 1.250000e-01 1.250000e-01 3.565000e+02 2.108578e+01 3.779074e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d08-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d08-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t8 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.650000e-01 6.500000e-02 6.500000e-02 1.232000e+02 9.237965e+00 1.324009e+01 +3.950000e-01 6.500000e-02 6.500000e-02 1.526000e+02 8.705171e+00 1.747942e+01 +5.250000e-01 6.500000e-02 6.500000e-02 1.518000e+02 1.257100e+01 1.839701e+01 +6.550000e-01 6.500000e-02 6.500000e-02 1.252000e+02 7.505331e+00 1.633922e+01 +7.850000e-01 6.500000e-02 6.500000e-02 1.353000e+02 1.221515e+01 1.640762e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d09-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d09-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t9 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.750000e+01 2.500000e+00 2.500000e+00 2.080000e+00 1.109054e-01 1.974842e-01 +2.250000e+01 2.500000e+00 2.500000e+00 5.270000e+00 2.211334e-01 4.049691e-01 +2.750000e+01 2.500000e+00 2.500000e+00 4.880000e+00 4.207137e-01 5.408327e-01 +3.250000e+01 2.500000e+00 2.500000e+00 3.260000e+00 3.189044e-01 4.495553e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.700000e+00 2.032240e-01 4.216634e-01 +4.250000e+01 2.500000e+00 2.500000e+00 5.800000e-01 1.212436e-01 1.835756e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d10-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d10-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t10 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.500000e-03 2.500000e-03 2.500000e-03 4.000000e-01 7.874008e-02 6.782330e-02 +7.500000e-03 2.500000e-03 2.500000e-03 3.330000e+00 1.984943e-01 2.576820e-01 +1.250000e-02 2.500000e-03 2.500000e-03 4.840000e+00 2.370654e-01 4.593474e-01 +1.750000e-02 2.500000e-03 2.500000e-03 4.860000e+00 3.762978e-01 6.743886e-01 +2.250000e-02 2.500000e-03 2.500000e-03 4.430000e+00 4.863127e-01 7.812810e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d11-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d11-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t11 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.000000e-01 1.000000e-01 1.000000e-01 7.200000e+01 9.929250e+00 1.263566e+01 +5.000000e-01 1.000000e-01 1.000000e-01 1.053000e+02 9.970456e+00 1.453203e+01 +7.000000e-01 1.000000e-01 1.000000e-01 1.206000e+02 6.862215e+00 1.298807e+01 +9.000000e-01 1.000000e-01 1.000000e-01 1.440000e+02 6.873136e+00 9.332202e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d12-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d12-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t12 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +2.650000e-01 6.500000e-02 6.500000e-02 1.470000e+01 1.805547e+00 2.998333e+00 +3.950000e-01 6.500000e-02 6.500000e-02 4.490000e+01 4.179713e+00 6.217717e+00 +5.250000e-01 6.500000e-02 6.500000e-02 6.650000e+01 9.729851e+00 1.300269e+01 +6.550000e-01 6.500000e-02 6.500000e-02 7.100000e+01 7.570997e+00 2.297129e+01 +7.850000e-01 6.500000e-02 6.500000e-02 6.950000e+01 6.351378e+00 1.940876e+01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d13-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d13-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t13 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +1.750000e+01 2.500000e+00 2.500000e+00 3.000000e-02 1.732051e-02 1.732051e-02 +2.250000e+01 2.500000e+00 2.500000e+00 1.090000e+00 1.987461e-01 8.124038e-02 +2.750000e+01 2.500000e+00 2.500000e+00 1.550000e+00 1.067708e-01 2.853069e-01 +3.250000e+01 2.500000e+00 2.500000e+00 2.140000e+00 2.489980e-01 6.024948e-01 +3.750000e+01 2.500000e+00 2.500000e+00 1.450000e+00 2.051828e-01 5.128353e-01 +4.250000e+01 2.500000e+00 2.500000e+00 6.400000e-01 9.380832e-02 2.758623e-01 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d14-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d14-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t14 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +7.500000e-03 2.500000e-03 2.500000e-03 6.000000e-01 1.109054e-01 5.196152e-02 +1.250000e-02 2.500000e-03 2.500000e-03 1.440000e+00 1.445683e-01 2.515949e-01 +1.750000e-02 2.500000e-03 2.500000e-03 2.190000e+00 2.156386e-01 4.724405e-01 +2.250000e-02 2.500000e-03 2.500000e-03 2.760000e+00 3.238827e-01 1.008464e+00 +END YODA_SCATTER2D + +BEGIN YODA_SCATTER2D /REF/ZEUS_2008_I763404/d15-x01-y01 +IsRef=1 +Path=/REF/ZEUS_2008_I763404/d15-x01-y01 +Title=doi:10.17182/hepdata.63789.v1/t15 +Type=Scatter2D +# xval xerr- xerr+ yval yerr- yerr+ +3.000000e-01 1.000000e-01 1.000000e-01 1.440000e+01 2.509980e+00 8.872993e+00 +5.000000e-01 1.000000e-01 1.000000e-01 4.040000e+01 4.733920e+00 2.258982e+01 +7.000000e-01 1.000000e-01 1.000000e-01 7.230000e+01 8.439194e+00 2.127299e+01 +9.000000e-01 1.000000e-01 1.000000e-01 4.620000e+01 1.175670e+01 2.126029e+00 +END YODA_SCATTER2D +