diff --git a/analyses/pluginATLAS/ATLAS_2013_I1230812.cc b/analyses/pluginATLAS/ATLAS_2013_I1230812.cc --- a/analyses/pluginATLAS/ATLAS_2013_I1230812.cc +++ b/analyses/pluginATLAS/ATLAS_2013_I1230812.cc @@ -1,292 +1,292 @@ // -*- C++ -*- #include "Rivet/Analysis.hh" #include "Rivet/Projections/ZFinder.hh" #include "Rivet/Projections/FastJets.hh" #include "Rivet/Projections/VetoedFinalState.hh" #include "Rivet/Projections/PromptFinalState.hh" namespace Rivet { /// Z + jets in pp at 7 TeV (combined channel / base class) /// @note This base class contains a "mode" variable for combined, e, and mu channel derived classes class ATLAS_2013_I1230812 : public Analysis { public: /// @name Constructors etc. //@{ /// Constructor DEFAULT_RIVET_ANALYSIS_CTOR(ATLAS_2013_I1230812); //@} /// Book histograms and initialise projections before the run void init() { // Get options from the new option system _mode = 0; - if ( getOption("ZMODE") == "EL" ) _mode = 1; - if ( getOption("ZMODE") == "MU" ) _mode = 2; + if ( getOption("LMODE") == "EL" ) _mode = 1; + if ( getOption("LMODE") == "MU" ) _mode = 2; // Determine the e/mu decay channels used (NB Prompt leptons only). /// @todo Note that Zs are accepted with any rapidity: the cuts are on the e/mu: is this correct? Cut pt20 = Cuts::pT >= 20*GeV; - Cut eta_e = _mode? Cuts::abseta < 1.37 || Cuts::absetaIn(1.52, 2.47) : Cuts::abseta < 2.5; - Cut eta_m = _mode? Cuts::abseta < 2.4 : Cuts::abseta < 2.5; + Cut eta_e = _mode? Cuts::abseta < 1.37 || Cuts::absetaIn(1.52, 2.47) : Cuts::abseta < 2.5; + Cut eta_m = _mode? Cuts::abseta < 2.4 : Cuts::abseta < 2.5; ZFinder zfinder_el(FinalState(eta_e), pt20, PID::ELECTRON, 66*GeV, 116*GeV); ZFinder zfinder_mu(FinalState(eta_m), pt20, PID::MUON, 66*GeV, 116*GeV); declare(zfinder_el, "zfinder_el"); declare(zfinder_mu, "zfinder_mu"); // Define veto FS in order to prevent Z-decay products entering the jet algorithm VetoedFinalState had_fs; had_fs.addVetoOnThisFinalState(getProjection("zfinder_el")); had_fs.addVetoOnThisFinalState(getProjection("zfinder_mu")); FastJets jets(had_fs, FastJets::ANTIKT, 0.4); jets.useInvisibles(true); declare(jets, "jets"); _h_njet_incl = bookHisto1D( 1, 1, _mode + 1); _h_njet_incl_ratio = bookScatter2D(2, 1, _mode + 1, true); _h_njet_excl = bookHisto1D( 3, 1, _mode + 1); _h_njet_excl_ratio = bookScatter2D(4, 1, _mode + 1, true); _h_njet_excl_pt150 = bookHisto1D( 5, 1, _mode + 1); _h_njet_excl_pt150_ratio = bookScatter2D(6, 1, _mode + 1, true); _h_njet_excl_vbf = bookHisto1D ( 7, 1, _mode + 1); _h_njet_excl_vbf_ratio = bookScatter2D(8, 1, _mode + 1, true); _h_ptlead = bookHisto1D( 9, 1, _mode + 1); _h_ptseclead = bookHisto1D( 10, 1, _mode + 1); _h_ptthirdlead = bookHisto1D( 11, 1, _mode + 1); _h_ptfourthlead = bookHisto1D( 12, 1, _mode + 1); _h_ptlead_excl = bookHisto1D( 13, 1, _mode + 1); _h_pt_ratio = bookHisto1D( 14, 1, _mode + 1); _h_pt_z = bookHisto1D( 15, 1, _mode + 1); _h_pt_z_excl = bookHisto1D( 16, 1, _mode + 1); _h_ylead = bookHisto1D( 17, 1, _mode + 1); _h_yseclead = bookHisto1D( 18, 1, _mode + 1); _h_ythirdlead = bookHisto1D( 19, 1, _mode + 1); _h_yfourthlead = bookHisto1D( 20, 1, _mode + 1); _h_deltay = bookHisto1D( 21, 1, _mode + 1); _h_mass = bookHisto1D( 22, 1, _mode + 1); _h_deltaphi = bookHisto1D( 23, 1, _mode + 1); _h_deltaR = bookHisto1D( 24, 1, _mode + 1); _h_ptthirdlead_vbf = bookHisto1D( 25, 1, _mode + 1); _h_ythirdlead_vbf = bookHisto1D( 26, 1, _mode + 1); _h_ht = bookHisto1D( 27, 1, _mode + 1); _h_st = bookHisto1D( 28, 1, _mode + 1); } /// Perform the per-event analysis void analyze(const Event& event) { FourMomentum z, lp, lm; const ZFinder& zfinder_el = apply(event, "zfinder_el"); const ZFinder& zfinder_mu = apply(event, "zfinder_mu"); if (_mode == 0 && (zfinder_el.constituents().size() + zfinder_mu.constituents().size()) != 2) vetoEvent; if (_mode == 1 && !(zfinder_el.constituents().size() == 2 && zfinder_mu.constituents().empty())) vetoEvent; if (_mode == 2 && !(zfinder_el.constituents().empty() && zfinder_mu.constituents().size() == 2)) vetoEvent; if (zfinder_el.constituents().size() == 2) { z = zfinder_el.boson().momentum(); lp = zfinder_el.constituents()[0].momentum(); lm = zfinder_el.constituents()[1].momentum(); } else if (zfinder_mu.constituents().size() == 2) { z = zfinder_mu.boson().momentum(); lp = zfinder_mu.constituents()[0].momentum(); lm = zfinder_mu.constituents()[1].momentum(); } else vetoEvent; if (deltaR(lp, lm) < 0.2) vetoEvent; Jets jets = apply(event, "jets").jetsByPt(Cuts::pT > 30*GeV && Cuts::absrap < 4.4); ifilter_discard(jets, deltaRLess(lp, 0.5)); ifilter_discard(jets, deltaRLess(lm, 0.5)); const double weight = event.weight(); // Fill jet multiplicities for (size_t ijet = 0; ijet <= jets.size(); ++ijet) { _h_njet_incl->fill(ijet, weight); } _h_njet_excl->fill(jets.size(), weight); // Require at least one jet if (jets.size() >= 1) { // Leading jet histos const double ptlead = jets[0].pT()/GeV; const double yabslead = fabs(jets[0].rapidity()); const double ptz = z.pT()/GeV; _h_ptlead->fill(ptlead, weight); _h_ylead ->fill(yabslead, weight); _h_pt_z ->fill(ptz, weight); // Fill jet multiplicities if (ptlead > 150) _h_njet_excl_pt150->fill(jets.size(), weight); // Loop over selected jets, fill inclusive distributions double st = 0; double ht = lp.pT()/GeV + lm.pT()/GeV; for (size_t ijet = 0; ijet < jets.size(); ++ijet) { ht += jets[ijet].pT()/GeV; st += jets[ijet].pT()/GeV; } _h_ht->fill(ht, weight); _h_st->fill(st, weight); // Require exactly one jet if (jets.size() == 1) { _h_ptlead_excl->fill(ptlead, weight); _h_pt_z_excl ->fill(ptz, weight); } } // Require at least two jets if (jets.size() >= 2) { // Second jet histos const double ptlead = jets[0].pT()/GeV; const double pt2ndlead = jets[1].pT()/GeV; const double ptratio = pt2ndlead/ptlead; const double yabs2ndlead = fabs(jets[1].rapidity()); _h_ptseclead->fill(pt2ndlead, weight); _h_yseclead->fill( yabs2ndlead, weight); _h_pt_ratio->fill( ptratio, weight); // Dijet histos const double deltaphi = fabs(deltaPhi(jets[1], jets[0])); const double deltarap = fabs(jets[0].rapidity() - jets[1].rapidity()) ; const double deltar = fabs(deltaR(jets[0], jets[1], RAPIDITY)); const double mass = (jets[0].momentum() + jets[1].momentum()).mass()/GeV; _h_mass->fill( mass, weight); _h_deltay->fill( deltarap, weight); _h_deltaphi->fill(deltaphi, weight); _h_deltaR->fill( deltar, weight); if (mass > 350 && deltarap > 3) _h_njet_excl_vbf->fill(jets.size(), weight); } // Require at least three jets if (jets.size() >= 3) { // Third jet histos const double pt3rdlead = jets[2].pT()/GeV; const double yabs3rdlead = fabs(jets[2].rapidity()); _h_ptthirdlead->fill(pt3rdlead, weight); _h_ythirdlead->fill( yabs3rdlead, weight); //Histos after VBF preselection const double deltarap = fabs(jets[0].rapidity() - jets[1].rapidity()) ; const double mass = (jets[0].momentum() + jets[1].momentum()).mass(); if (mass > 350 && deltarap > 3) { _h_ptthirdlead_vbf->fill(pt3rdlead, weight); _h_ythirdlead_vbf->fill( yabs3rdlead, weight); } } // Require at least four jets if (jets.size() >= 4) { // Fourth jet histos const double pt4thlead = jets[3].pT()/GeV; const double yabs4thlead = fabs(jets[3].rapidity()); _h_ptfourthlead->fill(pt4thlead, weight); _h_yfourthlead->fill( yabs4thlead, weight); } } /// @name Ratio calculator util functions //@{ /// Calculate the efficiency error, being careful about div-by-zero double err_incl(const HistoBin1D &M, const HistoBin1D &N, bool hasWeights) { double r = safediv(M.sumW(), N.sumW()); if (hasWeights) { // use F. James's approximation for weighted events return sqrt( safediv((1 - 2 * r) * M.sumW2() + r * r * N.sumW2(), N.sumW() * N.sumW()) ); } return sqrt( safediv(r * (1 - r), N.sumW()) ); } /// Calculate the ratio error, being careful about div-by-zero double err_excl(const HistoBin1D &A, const HistoBin1D &B) { double r = safediv(A.sumW(), B.sumW()); double dAsquared = safediv(A.sumW2(), A.sumW() * A.sumW()); // squared relative error of A double dBsquared = safediv(B.sumW2(), B.sumW() * B.sumW()); // squared relative error of B return r * sqrt(dAsquared + dBsquared); } //@} void finalize() { bool hasWeights = _h_njet_incl->effNumEntries() != _h_njet_incl->numEntries(); for (size_t i = 0; i < 6; ++i) { _h_njet_incl_ratio->point(i).setY(safediv(_h_njet_incl->bin(i + 1).sumW(), _h_njet_incl->bin(i).sumW()), err_incl(_h_njet_incl->bin(i + 1), _h_njet_incl->bin(i), hasWeights)); _h_njet_excl_ratio->point(i).setY(safediv(_h_njet_excl->bin(i + 1).sumW(), _h_njet_excl->bin(i).sumW()), err_excl(_h_njet_excl->bin(i + 1), _h_njet_excl->bin(i))); if (i >= 1) { _h_njet_excl_pt150_ratio->point(i - 1).setY(safediv(_h_njet_excl_pt150->bin(i).sumW(), _h_njet_excl_pt150->bin(i - 1).sumW()), err_excl(_h_njet_excl_pt150->bin(i), _h_njet_excl_pt150->bin(i - 1))); if (i >= 2) { _h_njet_excl_vbf_ratio->point(i - 2).setY(safediv(_h_njet_excl_vbf->bin(i).sumW(), _h_njet_excl_vbf->bin(i - 1).sumW()), err_excl(_h_njet_excl_vbf->bin(i), _h_njet_excl_vbf->bin(i - 1))); } } } double sf = _mode? 1.0 : 0.5; const double xs = sf * crossSectionPerEvent()/picobarn; scale({_h_njet_incl, _h_njet_excl, _h_njet_excl_pt150, _h_njet_excl_vbf}, xs); scale({_h_ptlead, _h_ptseclead, _h_ptthirdlead, _h_ptfourthlead, _h_ptlead_excl}, xs); scale({_h_pt_ratio, _h_pt_z, _h_pt_z_excl}, xs); scale({_h_ylead, _h_yseclead, _h_ythirdlead, _h_yfourthlead}, xs); scale({_h_deltay, _h_mass, _h_deltaphi, _h_deltaR}, xs); scale({_h_ptthirdlead_vbf, _h_ythirdlead_vbf}, xs); scale({_h_ht, _h_st}, xs); } //@} protected: size_t _mode; private: Scatter2DPtr _h_njet_incl_ratio; Scatter2DPtr _h_njet_excl_ratio; Scatter2DPtr _h_njet_excl_pt150_ratio; Scatter2DPtr _h_njet_excl_vbf_ratio; Histo1DPtr _h_njet_incl; Histo1DPtr _h_njet_excl; Histo1DPtr _h_njet_excl_pt150; Histo1DPtr _h_njet_excl_vbf; Histo1DPtr _h_ptlead; Histo1DPtr _h_ptseclead; Histo1DPtr _h_ptthirdlead; Histo1DPtr _h_ptfourthlead; Histo1DPtr _h_ptlead_excl; Histo1DPtr _h_pt_ratio; Histo1DPtr _h_pt_z; Histo1DPtr _h_pt_z_excl; Histo1DPtr _h_ylead; Histo1DPtr _h_yseclead; Histo1DPtr _h_ythirdlead; Histo1DPtr _h_yfourthlead; Histo1DPtr _h_deltay; Histo1DPtr _h_mass; Histo1DPtr _h_deltaphi; Histo1DPtr _h_deltaR; Histo1DPtr _h_ptthirdlead_vbf; Histo1DPtr _h_ythirdlead_vbf; Histo1DPtr _h_ht; Histo1DPtr _h_st; }; DECLARE_RIVET_PLUGIN(ATLAS_2013_I1230812); } diff --git a/analyses/pluginATLAS/ATLAS_2013_I1230812.info b/analyses/pluginATLAS/ATLAS_2013_I1230812.info --- a/analyses/pluginATLAS/ATLAS_2013_I1230812.info +++ b/analyses/pluginATLAS/ATLAS_2013_I1230812.info @@ -1,54 +1,52 @@ Name: ATLAS_2013_I1230812 Year: 2013 Summary: $Z$ + jets in $pp$ at 7 TeV Experiment: ATLAS Collider: LHC InspireID: 1230812 Status: VALIDATED Authors: - Katharina Bierwagen - Frank Siegert References: - arXiv:1304.7098 [hep-ex] - J. High Energy Phys. 07 (2013) 032 RunInfo: Z+jets, electronic Z-decays (data are a weighted combination of electron/muon). NumEvents: 1000000 Beams: [p+, p+] Energies: [7000] NeedCrossSection: True Options: - - ZMODE=EL,MU + - LMODE=EL,MU Description: 'Measurements of the production of jets of particles in association with a $Z$ boson in $pp$ collisions at $\sqrt{s}$ = 7 TeV are presented, using data corresponding to an integrated luminosity of 4.6/fb collected by the ATLAS experiment at the Large Hadron Collider. Inclusive and differential jet cross sections in $Z$ events, with Z decaying into electron or muon pairs, are measured for jets with transverse momentum $p_T > 30$ GeV and rapidity $|y| < 4.4$. - This Rivet module implements the event selection for the weighted combination - of both decay channels and uses the data from that combination (as in the - paper plots). In the default mode this is how it will run, assuming mixed - electronic and muonic events. - For convenience, if ZMODE is set to EL (MU), it only requires events from the - the electronic (muonic) final state and ignores muonic (electronic). This allows - it to be used with pure electronic or pure muonic samples.' + of both decay channels to produce the average cross section for a single lepton flavour, + and uses the data from that combination (as in the paper plots). In the default mode this is how it will run, + assuming mixed electronic and muonic events. + If LMODE is set to EL (MU), the plots for the individual decay channels (with a slightly + different fiducial phase space) are made.' BibKey: Aad:2013ysa BibTeX: '@article{Aad:2013ysa, author = "Aad, Georges and others", title = "{Measurement of the production cross section of jets in association with a Z boson in pp collisions at $\sqrt{s}$ = 7 TeV with the ATLAS detector}", collaboration = "ATLAS Collaboration", journal = "JHEP", volume = "1307", pages = "032", doi = "10.1007/JHEP07(2013)032", year = "2013", eprint = "1304.7098", archivePrefix = "arXiv", primaryClass = "hep-ex", reportNumber = "CERN-PH-EP-2013-023", SLACcitation = "%%CITATION = ARXIV:1304.7098;%%", }' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620.cc b/analyses/pluginATLAS/ATLAS_2016_I1502620.cc new file mode 100644 --- /dev/null +++ b/analyses/pluginATLAS/ATLAS_2016_I1502620.cc @@ -0,0 +1,216 @@ +// -*- C++ -*- +#include "Rivet/Analysis.hh" +#include "Rivet/Projections/FinalState.hh" +#include "Rivet/Projections/WFinder.hh" +#include "Rivet/Projections/ZFinder.hh" + +namespace Rivet { + + /// @brief inclusive W/Z cross sections at 7 TeV + class ATLAS_2016_I1502620 : public Analysis { + public: + + /// Constructor + DEFAULT_RIVET_ANALYSIS_CTOR(ATLAS_2016_I1502620); + //@} + + + /// @name Analysis methods + //@{ + + /// Book histograms and initialise projections before the run + void init() { + + // Get options from the new option system + _mode = 0; + if ( getOption("LMODE") == "EL" ) _mode = 1; + if ( getOption("LMODE") == "MU" ) _mode = 2; + + + ///Initialise and register projections here + const FinalState fs; + + Cut Wcuts = Cuts::pT >= 25*GeV; // minimum lepton pT + Cut Zcuts = Cuts::pT >= 20.0*GeV; + + WFinder wfinder_edressed(fs, Wcuts, PID::ELECTRON, 40*GeV, 13*TeV, 25*GeV, 0.1, + WFinder::CLUSTERNODECAY, WFinder::NOTRACK, WFinder::TRANSMASS); + declare(wfinder_edressed, "WFinder_edressed"); + + ZFinder zfindere(fs, Zcuts, PID::ELECTRON, 46.0*GeV, 150*GeV, 0.1, ZFinder::CLUSTERNODECAY, ZFinder::NOTRACK); + declare(zfindere, "ZFindere"); + + WFinder wfinder_mdressed(fs, Wcuts, PID::MUON, 40*GeV, 13*TeV, 25*GeV, 0.1, + WFinder::CLUSTERNODECAY, WFinder::NOTRACK, WFinder::TRANSMASS); + declare(wfinder_mdressed, "WFinder_mdressed"); + + ZFinder zfinderm(fs, Zcuts, PID::MUON, 46.0*GeV, 150*GeV, 0.1, ZFinder::CLUSTERNODECAY, ZFinder::NOTRACK); + declare(zfinderm, "ZFinderm"); + + + /// Book histograms here + _h_Wp_eta = bookHisto1D( 9, 1, 1); + _h_Wm_eta = bookHisto1D( 10, 1, 1); + _h_W_asym = bookScatter2D(35, 1, 1); + + _h_Zcenlow_y_dressed = bookHisto1D(11, 1, 1); + _h_Zcenpeak_y_dressed = bookHisto1D(12, 1, 1); + _h_Zcenhigh_y_dressed = bookHisto1D(13, 1, 1); + _h_Zfwdpeak_y_dressed = bookHisto1D(14, 1, 1); + _h_Zfwdhigh_y_dressed = bookHisto1D(15, 1, 1); + + } + + /// Perform the per-event analysis + void analyze(const Event& event) { + + // W stuff + const WFinder& wfindere = apply(event, "WFinder_edressed"); + const WFinder& wfinderm = apply(event, "WFinder_mdressed"); + + if (wfindere.bosons().size()+wfinderm.bosons().size() == 1) { + + const double weight = event.weight(); + + Particle lep; + if (_mode !=2 && wfindere.bosons().size() == 1 ) { + lep = wfindere.constituentLeptons()[0]; + } + else if (_mode !=1 && wfinderm.bosons().size() == 1 ) { + lep = wfinderm.constituentLeptons()[0]; + } + if (lep.charge3() > 0) _h_Wp_eta->fill(lep.abseta(), weight); + else _h_Wm_eta->fill(lep.abseta(), weight); + + } + + // now the Z stuff. + const ZFinder& zfindere = apply(event, "ZFindere"); + const ZFinder& zfinderm = apply(event, "ZFinderm"); + + + // must be one and only one candidate. + if (zfindere.bosons().size()+zfinderm.bosons().size() == 1) { + + const double weight = event.weight(); + + Particle Zboson; + ParticleVector leptons; + + // candidate is e+e- + if (_mode != 2 && zfindere.bosons().size() == 1 ) { + + Zboson = zfindere.boson(); + leptons = zfindere.constituents(); + } + + // candidate is mu+mu- + else if (_mode !=1 && zfinderm.bosons().size() == 1 ) { + + Zboson = zfinderm.boson(); + leptons = zfinderm.constituents(); + + } + const double zrap = Zboson.absrap(); + const double zmass = Zboson.mass(); + const double eta1 = leptons[0].abseta(); + const double eta2 = leptons[1].abseta(); + + // separation into central/forward and three mass bins + if (eta1 < 2.5 && eta2 < 2.5) { + if (zmass < 66.0*GeV) _h_Zcenlow_y_dressed->fill(zrap, weight); + else if (zmass < 116.0*GeV) _h_Zcenpeak_y_dressed->fill(zrap, weight); + else _h_Zcenhigh_y_dressed->fill(zrap, weight); + } + else if ((eta1 < 2.5 && 2.5 < eta2 && eta2 < 4.9) || (eta2 < 2.5 && 2.5 < eta1 && eta1 < 4.9)) { + if (zmass < 66.0*GeV) vetoEvent; + if (zmass < 116.0*GeV) _h_Zfwdpeak_y_dressed->fill(zrap, weight); + else _h_Zfwdhigh_y_dressed->fill(zrap, weight); + } + } + + } + + /// Normalise histograms etc., after the run + void finalize() { + + // Construct asymmetry: (dsig+/deta - dsig-/deta) / (dsig+/deta + dsig-/deta) + //divide(*_h_Wp_eta - *_h_Wm_eta, *_h_Wp_eta + *_h_Wm_eta, _h_W_asym); + for (size_t i = 0; i < _h_Wp_eta->numBins(); ++i) { + YODA::HistoBin1D& bp = _h_Wp_eta->bin(i); + YODA::HistoBin1D& bm = _h_Wm_eta->bin(i); + const double sum = bp.height() + bm.height(); + //const double xerr = 0.5 * bp.xWidth(); + double val = 0., yerr = 0.; + + if (sum) { + const double pos2 = bp.height() * bp.height(); + const double min2 = bm.height() * bm.height(); + const double errp2 = bp.heightErr() * bp.heightErr(); + const double errm2 = bm.heightErr() * bm.heightErr(); + val = (bp.height() - bm.height()) / sum; + yerr = 2. * sqrt(errm2 * pos2 + errp2 * min2) / (sum * sum); + } + + _h_W_asym->addPoint(bp.midpoint(), val, 0.5*bp.xWidth(), yerr); + } + + // Print summary info + const double xs_pb(crossSection() / picobarn); + const double sumw(sumOfWeights()); + MSG_DEBUG( "Cross-section/pb : " << xs_pb ); + MSG_DEBUG( "Sum of weights : " << sumw ); + MSG_DEBUG( "nEvents : " << numEvents() ); + + /// Normalise, scale and otherwise manipulate histograms here + double lfac = 1.0; + // If we have been running on both electrons and muons, need to divide by two to + // get the xsec for one flavour + if (_mode == 0) lfac = 0.5; + const double sf = lfac * 0.5 * xs_pb / sumw; // 0.5 accounts for rapidity bin width + + + scale(_h_Wp_eta, sf); + scale(_h_Wm_eta, sf); + + scale(_h_Zcenlow_y_dressed, sf); + scale(_h_Zcenpeak_y_dressed, sf); + scale(_h_Zcenhigh_y_dressed, sf); + scale(_h_Zfwdpeak_y_dressed, sf); + scale(_h_Zfwdhigh_y_dressed, sf); + + } + + //@} + + + protected: + size_t _mode; + + private: + + /// @name Histograms + //@{ + Histo1DPtr _h_Wp_eta, _h_Wm_eta; + Scatter2DPtr _h_W_asym; + + Histo1DPtr _h_Zcenlow_y_dressed; + Histo1DPtr _h_Zcenpeak_y_dressed; + Histo1DPtr _h_Zcenhigh_y_dressed; + Histo1DPtr _h_Zfwdpeak_y_dressed; + Histo1DPtr _h_Zfwdhigh_y_dressed; + //@} + + }; + + // The hook for the plugin system + DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620); + + +} + +// END END END + + + + diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620.info b/analyses/pluginATLAS/ATLAS_2016_I1502620.info new file mode 100644 --- /dev/null +++ b/analyses/pluginATLAS/ATLAS_2016_I1502620.info @@ -0,0 +1,58 @@ +Name: ATLAS_2016_I1502620 +Year: 2016 +Summary: W and Z inclusive cross sections at 7 TeV +Experiment: ATLAS +Collider: LHC +InspireID: 1502620 +Status: VALIDATED +Authors: + - Jan Kretzschmar + - Christian Gutschow +References: + - Eur. Phys. J. C77 (2017) no.6, 367 + - doi:10.1140/epjc/s10052-017-4911-9 + - arXiv:1612.03016 [hep-ex] +Keywords: + - zboson +RunInfo: + p + p -> Z + X ( Z -> e e ) +Luminosity_fb: 4.9 +Beams: [p+, p+] +Energies: [7000] +PtCuts: [20] +NeedCrossSection: True +Options: + - LMODE=EL,MU +Description: + 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, + $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected + in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential + $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential + $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, + for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential + electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of + parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data + from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution + functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined + more accurately than in previous determinations based on collider data only, and is established to be close to unity in + the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. + N.B.: Use :LMODE to specify the decay channel directly.' +BibKey: Aaboud:2016btc +BibTeX: '@article{Aaboud:2016btc, + author = "Aaboud, Morad and others", + title = "{Precision measurement and interpretation of inclusive + $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections + with the ATLAS detector}", + collaboration = "ATLAS", + journal = "Eur. Phys. J.", + volume = "C77", + year = "2017", + number = "6", + pages = "367", + doi = "10.1140/epjc/s10052-017-4911-9", + eprint = "1612.03016", + archivePrefix = "arXiv", + primaryClass = "hep-ex", + reportNumber = "CERN-EP-2016-272", + SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" +}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620.plot new file mode 100644 --- /dev/null +++ b/analyses/pluginATLAS/ATLAS_2016_I1502620.plot @@ -0,0 +1,61 @@ +# BEGIN PLOT /ATLAS_2016_I1502620/d..-x..-y.. +LeftMargin=1.5 +LogX=0 +LogY=0 +GofType=chi2 +GofLegend=0 +LegendYPos=0.25 +LegendXPos=0.05 +RatioPlotYMin=0.85 +RatioPlotYMax=1.15 +YLabel=$\text{d}\sigma / \text{d}y_{\ell\ell}$ [pb] +XLabel=$|y_{\ell\ell}|$ +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620_Z/d11 +Title=central $Z/\gamma^*\rightarrow \ell\ell$, $46 < m_{\ell\ell} < 66$ GeV +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620_Z/d12 +Title=central $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620_Z/d13 +Title=central $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620_Z/d14 +Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV +LegendYPos=0.95 +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620_Z/d15 +Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV +LegendYPos=0.95 +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620/d35 +RatioPlotYMin=0.9 +RatioPlotYMax=1.1 +XLabel=$|\eta_\ell|$ +YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] +Title=$W$ charge asymmetry, dressed level +YLabel=$A_\ell$ +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620/d09 +RatioPlotYMin=0.9 +RatioPlotYMax=1.1 +XLabel=$|\eta_\ell|$ +YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] +Title=$W^+\rightarrow \ell^+\nu$, dressed level +# END PLOT + +# BEGIN PLOT /ATLAS_2016_I1502620/d10 +RatioPlotYMin=0.9 +RatioPlotYMax=1.1 +XLabel=$|\eta_\ell|$ +YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] +Title=$W^-\rightarrow \ell^-\bar{\nu}$, dressed level +# END PLOT + diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620.yoda b/analyses/pluginATLAS/ATLAS_2016_I1502620.yoda --- a/analyses/pluginATLAS/ATLAS_2016_I1502620.yoda +++ b/analyses/pluginATLAS/ATLAS_2016_I1502620.yoda @@ -1,141 +1,141 @@ BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d09-x01-y01 IsRef=1 Path=/REF/ATLAS_2016_I1502620/d09-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t9 Type=Scatter2D # xval xerr- xerr+ yval yerr- yerr+ 1.050000e-01 1.050000e-01 1.050000e-01 5.701953e+02 1.072725e+01 1.072725e+01 3.150000e-01 1.050000e-01 1.050000e-01 5.699476e+02 1.068511e+01 1.068511e+01 5.250000e-01 1.050000e-01 1.050000e-01 5.746817e+02 1.075530e+01 1.075530e+01 7.350000e-01 1.050000e-01 1.050000e-01 5.790665e+02 1.085205e+01 1.085205e+01 9.450000e-01 1.050000e-01 1.050000e-01 5.791768e+02 1.086570e+01 1.086570e+01 1.210000e+00 1.600000e-01 1.600000e-01 5.917613e+02 1.110779e+01 1.110779e+01 1.445000e+00 7.500000e-02 7.500000e-02 5.894995e+02 1.124106e+01 1.124106e+01 1.630000e+00 1.100000e-01 1.100000e-01 5.967085e+02 1.127684e+01 1.127684e+01 1.845000e+00 1.050000e-01 1.050000e-01 5.995861e+02 1.134217e+01 1.134217e+01 2.065000e+00 1.150000e-01 1.150000e-01 5.862495e+02 1.104983e+01 1.104983e+01 2.340000e+00 1.600000e-01 1.600000e-01 5.518143e+02 1.055452e+01 1.055452e+01 END YODA_SCATTER2D BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d10-x01-y01 IsRef=1 Path=/REF/ATLAS_2016_I1502620/d10-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t10 Type=Scatter2D # xval xerr- xerr+ yval yerr- yerr+ 1.050000e-01 1.050000e-01 1.050000e-01 4.315399e+02 8.124420e+00 8.124420e+00 3.150000e-01 1.050000e-01 1.050000e-01 4.279112e+02 8.017371e+00 8.017371e+00 5.250000e-01 1.050000e-01 1.050000e-01 4.244605e+02 7.951245e+00 7.951245e+00 7.350000e-01 1.050000e-01 1.050000e-01 4.187228e+02 7.857387e+00 7.857387e+00 9.450000e-01 1.050000e-01 1.050000e-01 4.090900e+02 7.680221e+00 7.680221e+00 1.210000e+00 1.600000e-01 1.600000e-01 4.007008e+02 7.585003e+00 7.585003e+00 1.445000e+00 7.500000e-02 7.500000e-02 3.836354e+02 7.334262e+00 7.334262e+00 1.630000e+00 1.100000e-01 1.100000e-01 3.733385e+02 7.104819e+00 7.104819e+00 1.845000e+00 1.050000e-01 1.050000e-01 3.616497e+02 6.891111e+00 6.891111e+00 2.065000e+00 1.150000e-01 1.150000e-01 3.409083e+02 6.498664e+00 6.498664e+00 2.340000e+00 1.600000e-01 1.600000e-01 3.154508e+02 6.196180e+00 6.196180e+00 END YODA_SCATTER2D -BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620_Z/d11-x01-y01 +BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d11-x01-y01 IsRef=1 -Path=/REF/ATLAS_2016_I1502620_Z/d11-x01-y01 +Path=/REF/ATLAS_2016_I1502620/d11-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t11 Type=Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 3.836050e+00 9.199245e-02 9.199245e-02 6.000000e-01 2.000000e-01 2.000000e-01 3.846584e+00 8.993030e-02 8.993030e-02 1.000000e+00 2.000000e-01 2.000000e-01 3.704517e+00 8.835253e-02 8.835253e-02 1.400000e+00 2.000000e-01 2.000000e-01 3.704713e+00 8.713009e-02 8.713009e-02 1.800000e+00 2.000000e-01 2.000000e-01 3.169417e+00 7.559839e-02 7.559839e-02 2.200000e+00 2.000000e-01 2.000000e-01 1.657037e+00 4.486258e-02 4.486258e-02 END YODA_SCATTER2D -BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620_Z/d12-x01-y01 +BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d12-x01-y01 IsRef=1 -Path=/REF/ATLAS_2016_I1502620_Z/d12-x01-y01 +Path=/REF/ATLAS_2016_I1502620/d12-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t12 Type=Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.000000e-01 1.000000e-01 1.000000e-01 1.324615e+02 2.431742e+00 2.431742e+00 3.000000e-01 1.000000e-01 1.000000e-01 1.319913e+02 2.421060e+00 2.421060e+00 5.000000e-01 1.000000e-01 1.000000e-01 1.315216e+02 2.411764e+00 2.411764e+00 7.000000e-01 1.000000e-01 1.000000e-01 1.303718e+02 2.392065e+00 2.392065e+00 9.000000e-01 1.000000e-01 1.000000e-01 1.298304e+02 2.382803e+00 2.382803e+00 1.100000e+00 1.000000e-01 1.000000e-01 1.265175e+02 2.322725e+00 2.322725e+00 1.300000e+00 1.000000e-01 1.000000e-01 1.176955e+02 2.162620e+00 2.162620e+00 1.500000e+00 1.000000e-01 1.000000e-01 1.054741e+02 1.942385e+00 1.942385e+00 1.700000e+00 1.000000e-01 1.000000e-01 8.840512e+01 1.640671e+00 1.640671e+00 1.900000e+00 1.000000e-01 1.000000e-01 6.773360e+01 1.257913e+00 1.257913e+00 2.100000e+00 1.000000e-01 1.000000e-01 4.494026e+01 8.424471e-01 8.424471e-01 2.300000e+00 1.000000e-01 1.000000e-01 2.190322e+01 4.321711e-01 4.321711e-01 END YODA_SCATTER2D -BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620_Z/d13-x01-y01 +BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d13-x01-y01 IsRef=1 -Path=/REF/ATLAS_2016_I1502620_Z/d13-x01-y01 +Path=/REF/ATLAS_2016_I1502620/d13-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t13 Type=Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 2.000000e-01 2.000000e-01 2.000000e-01 1.452167e+00 3.869146e-02 3.869146e-02 6.000000e-01 2.000000e-01 2.000000e-01 1.400482e+00 3.584221e-02 3.584221e-02 1.000000e+00 2.000000e-01 2.000000e-01 1.300185e+00 3.384954e-02 3.384954e-02 1.400000e+00 2.000000e-01 2.000000e-01 1.141063e+00 3.023385e-02 3.023385e-02 1.800000e+00 2.000000e-01 2.000000e-01 7.422612e-01 2.283536e-02 2.283536e-02 2.200000e+00 2.000000e-01 2.000000e-01 3.163080e-01 1.287475e-02 1.287475e-02 END YODA_SCATTER2D -BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620_Z/d14-x01-y01 +BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d14-x01-y01 IsRef=1 -Path=/REF/ATLAS_2016_I1502620_Z/d14-x01-y01 +Path=/REF/ATLAS_2016_I1502620/d14-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t14 Type=Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.300000e+00 1.000000e-01 1.000000e-01 7.329126e+00 3.222583e-01 3.222583e-01 1.500000e+00 1.000000e-01 1.000000e-01 1.724687e+01 6.475596e-01 6.475596e-01 1.700000e+00 1.000000e-01 1.000000e-01 3.148912e+01 1.065305e+00 1.065305e+00 1.900000e+00 1.000000e-01 1.000000e-01 4.922559e+01 1.779721e+00 1.779721e+00 2.100000e+00 1.000000e-01 1.000000e-01 6.726821e+01 2.625322e+00 2.625322e+00 2.300000e+00 1.000000e-01 1.000000e-01 8.468502e+01 2.771414e+00 2.771414e+00 2.600000e+00 2.000000e-01 2.000000e-01 8.435648e+01 3.305967e+00 3.305967e+00 3.000000e+00 2.000000e-01 2.000000e-01 3.967275e+01 2.314313e+00 2.314313e+00 3.400000e+00 2.000000e-01 2.000000e-01 1.059413e+01 8.160159e-01 8.160159e-01 END YODA_SCATTER2D BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d15-x01-y01 IsRef=1 -Path=/REF/ATLAS_2016_I1502620_Z/d15-x01-y01 +Path=/REF/ATLAS_2016_I1502620/d15-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t15 Type=Scatter2D --- # xval xerr- xerr+ yval yerr- yerr+ 1.400000e+00 2.000000e-01 2.000000e-01 2.874300e-01 3.787141e-02 3.787141e-02 1.800000e+00 2.000000e-01 2.000000e-01 5.232852e-01 6.252163e-02 6.252163e-02 2.200000e+00 2.000000e-01 2.000000e-01 8.827275e-01 1.309588e-01 1.309588e-01 2.600000e+00 2.000000e-01 2.000000e-01 8.958657e-01 1.938744e-01 1.938744e-01 3.000000e+00 2.000000e-01 2.000000e-01 4.178594e-01 7.018522e-02 7.018522e-02 3.400000e+00 2.000000e-01 2.000000e-01 6.610560e-02 1.317678e-02 1.317678e-02 END YODA_SCATTER2D BEGIN YODA_SCATTER2D /REF/ATLAS_2016_I1502620/d35-x01-y01 IsRef=1 Path=/REF/ATLAS_2016_I1502620/d35-x01-y01 Title=doi:10.17182/hepdata.76541.v1/t35 Type=Scatter2D # xval xerr- xerr+ yval yerr- yerr+ 1.050000e-01 1.050000e-01 1.050000e-01 1.384152e-01 1.822724e-03 1.822724e-03 3.150000e-01 1.050000e-01 1.050000e-01 1.423411e-01 1.789257e-03 1.789257e-03 5.250000e-01 1.050000e-01 1.050000e-01 1.503502e-01 1.550722e-03 1.550722e-03 7.350000e-01 1.050000e-01 1.050000e-01 1.606989e-01 1.517393e-03 1.517393e-03 9.450000e-01 1.050000e-01 1.050000e-01 1.721062e-01 1.754892e-03 1.754892e-03 1.210000e+00 1.600000e-01 1.600000e-01 1.925116e-01 1.542378e-03 1.542378e-03 1.445000e+00 7.500000e-02 7.500000e-02 2.115474e-01 2.806254e-03 2.806254e-03 1.630000e+00 1.100000e-01 1.100000e-01 2.302672e-01 1.684889e-03 1.684889e-03 1.845000e+00 1.050000e-01 1.050000e-01 2.475319e-01 1.959415e-03 1.959415e-03 2.065000e+00 1.150000e-01 1.150000e-01 2.646165e-01 1.837513e-03 1.837513e-03 2.340000e+00 1.600000e-01 1.600000e-01 2.725389e-01 2.500536e-03 2.500536e-03 END YODA_SCATTER2D diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.cc b/analyses/pluginATLAS/ATLAS_2016_I1502620_W.cc deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.cc +++ /dev/null @@ -1,130 +0,0 @@ -// -*- C++ -*- -#include "Rivet/Analysis.hh" -#include "Rivet/Projections/FinalState.hh" -#include "Rivet/Projections/WFinder.hh" - -namespace Rivet { - - /// @brief inclusive W cross sections at 7 TeV - class ATLAS_2016_I1502620_W : public Analysis { - public: - - /// Constructor - ATLAS_2016_I1502620_W(string name="ATLAS_2016_I1502620_W", size_t channel = 0, - string ref_data = "ATLAS_2016_I1502620") : Analysis(name) { - _mode = channel; // using electron channel by default - setRefDataName(ref_data); - } - - /// @name Analysis methods - //@{ - - /// Book histograms and initialise projections before the run - void init() { - - ///Initialise and register projections here - const FinalState fs; - - Cut cut = Cuts::pT >= 25*GeV; // minimum lepton pT - - WFinder wfinder_dressed(fs, cut, _mode? PID::MUON : PID::ELECTRON, 40*GeV, 13*TeV, 25*GeV, 0.1, - WFinder::CLUSTERNODECAY, WFinder::NOTRACK, WFinder::TRANSMASS); - - declare(wfinder_dressed, "WFinder_dressed"); - - /// Book histograms here - _h_Wp_eta = bookHisto1D( 9, 1, 1); - _h_Wm_eta = bookHisto1D( 10, 1, 1); - _h_W_asym = bookScatter2D(35, 1, 1); - - } - - - /// Perform the per-event analysis - void analyze(const Event& event) { - - const WFinder& wfinder = apply(event, "WFinder_dressed"); - if (wfinder.bosons().size() != 1) vetoEvent; - - const double weight = event.weight(); - const Particle lep = wfinder.constituentLeptons()[0]; - if (lep.charge3() > 0) _h_Wp_eta->fill(lep.abseta(), weight); - else _h_Wm_eta->fill(lep.abseta(), weight); - - } - - - /// Normalise histograms etc., after the run - void finalize() { - - // Construct asymmetry: (dsig+/deta - dsig-/deta) / (dsig+/deta + dsig-/deta) - //divide(*_h_Wp_eta - *_h_Wm_eta, *_h_Wp_eta + *_h_Wm_eta, _h_W_asym); - for (size_t i = 0; i < _h_Wp_eta->numBins(); ++i) { - YODA::HistoBin1D& bp = _h_Wp_eta->bin(i); - YODA::HistoBin1D& bm = _h_Wm_eta->bin(i); - const double sum = bp.height() + bm.height(); - //const double xerr = 0.5 * bp.xWidth(); - double val = 0., yerr = 0.; - - if (sum) { - const double pos2 = bp.height() * bp.height(); - const double min2 = bm.height() * bm.height(); - const double errp2 = bp.heightErr() * bp.heightErr(); - const double errm2 = bm.heightErr() * bm.heightErr(); - val = (bp.height() - bm.height()) / sum; - yerr = 2. * sqrt(errm2 * pos2 + errp2 * min2) / (sum * sum); - } - - _h_W_asym->addPoint(bp.midpoint(), val, 0.5*bp.xWidth(), yerr); - } - - // Print summary info - const double xs_pb(crossSection() / picobarn); - const double sumw(sumOfWeights()); - MSG_DEBUG( "Cross-section/pb : " << xs_pb ); - MSG_DEBUG( "Sum of weights : " << sumw ); - MSG_DEBUG( "nEvents : " << numEvents() ); - - /// Normalise, scale and otherwise manipulate histograms here - const double sf = 0.5 * xs_pb / sumw; // 0.5 accounts for rapidity bin width - scale(_h_Wp_eta, sf); - scale(_h_Wm_eta, sf); - - } - - //@} - - - protected: - size_t _mode; - - private: - - /// @name Histograms - //@{ - Histo1DPtr _h_Wp_eta, _h_Wm_eta; - Scatter2DPtr _h_W_asym; - - //@} - - }; - - - class ATLAS_2016_I1502620_W_EL : public ATLAS_2016_I1502620_W { - public: - ATLAS_2016_I1502620_W_EL() : ATLAS_2016_I1502620_W("ATLAS_2016_I1502620_W_EL", 0) { } - }; - - - class ATLAS_2016_I1502620_W_MU : public ATLAS_2016_I1502620_W { - public: - ATLAS_2016_I1502620_W_MU() : ATLAS_2016_I1502620_W("ATLAS_2016_I1502620_W_MU", 1) { } - }; - - - // The hook for the plugin system - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_W); - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_W_EL); - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_W_MU); - -} diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_W.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.info +++ /dev/null @@ -1,58 +0,0 @@ -Name: ATLAS_2016_I1502620_W -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - wboson -RunInfo: - p + p -> W + X ( W -> e nu ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [25] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_W_EL and ATLAS_2016_I1502620_W_MU to specify the decay channel directly. Note that when - merging multiple yoda files, the $W$ charge asymmetry $A_l = (W^+ - W^-) / (W^+ + W^-)$ may need to be recalculated from - the individual histogram. A post-processing script is provided.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_W.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W.plot +++ /dev/null @@ -1,27 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_W/d.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.9 -RatioPlotYMax=1.1 -XLabel=$|\eta_\ell|$ -YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W/d35 -Title=$W$ charge asymmetry, dressed level -YLabel=$A_\ell$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W/d09 -Title=$W^+\rightarrow \ell^+\nu$, dressed level -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W/d10 -Title=$W^-\rightarrow \ell^-\bar{\nu}$, dressed level -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.info +++ /dev/null @@ -1,58 +0,0 @@ -Name: ATLAS_2016_I1502620_W_EL -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - wboson -RunInfo: - p + p -> W + X ( W -> e nu ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [25] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_W_EL and ATLAS_2016_I1502620_W_MU to specify the decay channel directly. Note that when - merging multiple yoda files, the $W$ charge asymmetry $A_l = (W^+ - W^-) / (W^+ + W^-)$ may need to be recalculated from - the individual histogram. A post-processing script is provided.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_EL.plot +++ /dev/null @@ -1,27 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_W_EL/d.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.9 -RatioPlotYMax=1.1 -XLabel=$|\eta_\ell|$ -YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_EL/d35 -Title=$W$ charge asymmetry, dressed level -YLabel=$A_\ell$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_EL/d09 -Title=$W^+\rightarrow \ell^+\nu$, dressed level -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_EL/d10 -Title=$W^-\rightarrow \ell^-\bar{\nu}$, dressed level -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.info +++ /dev/null @@ -1,58 +0,0 @@ -Name: ATLAS_2016_I1502620_W_MU -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - wboson -RunInfo: - p + p -> W + X ( W -> mu nu ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [25] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_W_EL and ATLAS_2016_I1502620_W_MU to specify the decay channel directly. Note that when - merging multiple yoda files, the $W$ charge asymmetry $A_l = (W^+ - W^-) / (W^+ + W^-)$ may need to be recalculated from - the individual histogram. A post-processing script is provided.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_W_MU.plot +++ /dev/null @@ -1,27 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_W_MU/d.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.9 -RatioPlotYMax=1.1 -XLabel=$|\eta_\ell|$ -YLabel=$\text{d}\sigma / \text{d}\eta_\ell$ [pb] -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_MU/d35 -Title=$W$ charge asymmetry, dressed level -YLabel=$A_\ell$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_MU/d09 -Title=$W^+\rightarrow \ell^+\nu$, dressed level -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_W_MU/d10 -Title=$W^-\rightarrow \ell^-\bar{\nu}$, dressed level -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.cc b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.cc deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.cc +++ /dev/null @@ -1,128 +0,0 @@ -// -*- C++ -*- -#include "Rivet/Analysis.hh" -#include "Rivet/Projections/FinalState.hh" -#include "Rivet/Projections/ZFinder.hh" - -namespace Rivet { - - /// @brief inclusive Z cross sections at 7 TeV - class ATLAS_2016_I1502620_Z : public Analysis { - public: - - /// Constructor - ATLAS_2016_I1502620_Z(string name="ATLAS_2016_I1502620_Z", size_t channel = 0, - string ref_data = "ATLAS_2016_I1502620") : Analysis(name) { - _mode = channel; // using electron channel by default - setRefDataName(ref_data); - } - - /// @name Analysis methods - //@{ - - /// Book histograms and initialise projections before the run - void init() { - - const FinalState fs; - - Cut cuts = Cuts::pT >= 20.0*GeV; - ZFinder zfinder(fs, cuts, (_mode ? PID::MUON : PID::ELECTRON), 46.0*GeV, 150*GeV, 0.1, ZFinder::CLUSTERNODECAY, ZFinder::NOTRACK); - declare(zfinder, "ZFinder"); - - // Book histograms - _h_Zcenlow_y_dressed = bookHisto1D(11, 1, 1); - _h_Zcenpeak_y_dressed = bookHisto1D(12, 1, 1); - _h_Zcenhigh_y_dressed = bookHisto1D(13, 1, 1); - _h_Zfwdpeak_y_dressed = bookHisto1D(14, 1, 1); - _h_Zfwdhigh_y_dressed = bookHisto1D(15, 1, 1); - - } - - - /// Perform the per-event analysis - void analyze(const Event& event) { - - const ZFinder& zfinder = apply(event, "ZFinder"); - if (zfinder.bosons().size() != 1 ) vetoEvent; - - const Particle& Zboson = zfinder.boson(); - const double zrap = Zboson.absrap(); - const double zmass = Zboson.mass(); - - // Get/cut on Z boson leptons - const ParticleVector& leptons = zfinder.constituents(); - const double eta1 = leptons[0].abseta(); - const double eta2 = leptons[1].abseta(); - - const double weight = event.weight(); - - // separation into central/forward and three mass bins - if (eta1 < 2.5 && eta2 < 2.5) { - if (zmass < 66.0*GeV) _h_Zcenlow_y_dressed->fill(zrap, weight); - else if (zmass < 116.0*GeV) _h_Zcenpeak_y_dressed->fill(zrap, weight); - else _h_Zcenhigh_y_dressed->fill(zrap, weight); - } - else if ((eta1 < 2.5 && 2.5 < eta2 && eta2 < 4.9) || (eta2 < 2.5 && 2.5 < eta1 && eta1 < 4.9)) { - if (zmass < 66.0*GeV) vetoEvent; - if (zmass < 116.0*GeV) _h_Zfwdpeak_y_dressed->fill(zrap, weight); - else _h_Zfwdhigh_y_dressed->fill(zrap, weight); - } - } - - - /// Normalise histograms etc., after the run - void finalize() { - - // Print summary info - const double xs_pb(crossSection() / picobarn); - const double sumw(sumOfWeights()); - MSG_DEBUG("Cross-Section/pb: " << xs_pb ); - MSG_DEBUG("Sum of weights : " << sumw ); - MSG_DEBUG("nEvents : " << numEvents()); - - // Normalise, scale and otherwise manipulate histograms here - const double sf(0.5 * xs_pb / sumw); // 0.5 accounts for rapidity bin width - scale(_h_Zcenlow_y_dressed, sf); - scale(_h_Zcenpeak_y_dressed, sf); - scale(_h_Zcenhigh_y_dressed, sf); - scale(_h_Zfwdpeak_y_dressed, sf); - scale(_h_Zfwdhigh_y_dressed, sf); - - } - - //@} - - protected: - size_t _mode; - - private: - - /// @name Histograms - //@{ - Histo1DPtr _h_Zcenlow_y_dressed; - Histo1DPtr _h_Zcenpeak_y_dressed; - Histo1DPtr _h_Zcenhigh_y_dressed; - Histo1DPtr _h_Zfwdpeak_y_dressed; - Histo1DPtr _h_Zfwdhigh_y_dressed; - //@} - - }; - - - class ATLAS_2016_I1502620_Z_EL : public ATLAS_2016_I1502620_Z { - public: - ATLAS_2016_I1502620_Z_EL() : ATLAS_2016_I1502620_Z("ATLAS_2016_I1502620_Z_EL", 0) { } - }; - - - class ATLAS_2016_I1502620_Z_MU : public ATLAS_2016_I1502620_Z { - public: - ATLAS_2016_I1502620_Z_MU() : ATLAS_2016_I1502620_Z("ATLAS_2016_I1502620_Z_MU", 1) { } - }; - - - // The hook for the plugin system - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_Z); - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_Z_EL); - DECLARE_RIVET_PLUGIN(ATLAS_2016_I1502620_Z_MU); - -} diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.info +++ /dev/null @@ -1,56 +0,0 @@ -Name: ATLAS_2016_I1502620_Z -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - zboson -RunInfo: - p + p -> Z + X ( Z -> e e ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [20] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_Z_EL and ATLAS_2016_I1502620_Z_MU to specify the decay channel directly.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z.plot +++ /dev/null @@ -1,36 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d..-x..-y.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.85 -RatioPlotYMax=1.15 -YLabel=$\text{d}\sigma / \text{d}y_{\ell\ell}$ [pb] -XLabel=$|y_{\ell\ell}|$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d11 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $46 < m_{\ell\ell} < 66$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d12 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d13 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d14 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -LegendYPos=0.95 -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z/d15 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -LegendYPos=0.95 -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.info +++ /dev/null @@ -1,56 +0,0 @@ -Name: ATLAS_2016_I1502620_Z_EL -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - zboson -RunInfo: - p + p -> Z + X ( Z -> e e ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [20] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_Z_EL and ATLAS_2016_I1502620_Z_MU to specify the decay channel directly.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_EL.plot +++ /dev/null @@ -1,36 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d..-x..-y.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.85 -RatioPlotYMax=1.15 -YLabel=$\text{d}\sigma / \text{d}y_{\ell\ell}$ [pb] -XLabel=$|y_{\ell\ell}|$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d11 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $46 < m_{\ell\ell} < 66$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d12 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d13 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d14 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -LegendYPos=0.95 -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_EL/d15 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -LegendYPos=0.95 -# END PLOT - diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.info b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.info deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.info +++ /dev/null @@ -1,56 +0,0 @@ -Name: ATLAS_2016_I1502620_Z_MU -Year: 2016 -Summary: W and Z inclusive cross sections at 7 TeV -Experiment: ATLAS -Collider: LHC -InspireID: 1502620 -Status: VALIDATED -Authors: - - Jan Kretzschmar - - Christian Gutschow -References: - - Eur. Phys. J. C77 (2017) no.6, 367 - - doi:10.1140/epjc/s10052-017-4911-9 - - arXiv:1612.03016 [hep-ex] -Keywords: - - zboson -RunInfo: - p + p -> Z + X ( Z -> mu mu ) -Luminosity_fb: 4.9 -Beams: [p+, p+] -Energies: [7000] -PtCuts: [20] -NeedCrossSection: True -Description: - 'High-precision measurements by the ATLAS Collaboration are presented of inclusive $W^+\to\ell^+$, $W^-\to\ell^-$, - $Z/\gamma^\ast\to\ell\ell$ ($\ell=e,\mu$) Drell-Yan production cross sections at the LHC. The data were collected - in proton-proton collisions at $\sqrt{s}=7$ TeV with an integrated luminosity of 4.6 fb${}^{-1}$. Differential - $W^+$ and $W^-$ cross sections are measured in a lepton pseudorapidity range $|\eta_\ell| < 2.5$. Differential - $Z/\gamma^\ast$ cross sections are measured as a function of the absolute dilepton rapidity, for $|y_{\ell\ell}| < 3.6$, - for three intervals of dilepton mass, $m_{\ell\ell}$, extending from 46 to 150 GeV. The integrated and differential - electron- and muon-channel cross sections are combined and compared to theoretical predictions using recent sets of - parton distribution functions. The data, together with the final inclusive $e^\pm p$ scattering cross-section data - from H1 and ZEUS, are interpreted in a next-to-next-to-leading-order QCD analysis, and a new set of parton distribution - functions, ATLAS-epWZ16, is obtained. The ratio of strange-to-light sea-quark densities in the proton is determined - more accurately than in previous determinations based on collider data only, and is established to be close to unity in - the sensitivity range of the data. A new measurement of the CKM matrix element $|V_{cs}|$ is also provided. - N.B.: Use ATLAS_2016_I1502620_Z_EL and ATLAS_2016_I1502620_Z_MU to specify the decay channel directly.' -BibKey: Aaboud:2016btc -BibTeX: '@article{Aaboud:2016btc, - author = "Aaboud, Morad and others", - title = "{Precision measurement and interpretation of inclusive - $W^+$ , $W^-$ and $Z/\gamma ^*$ production cross sections - with the ATLAS detector}", - collaboration = "ATLAS", - journal = "Eur. Phys. J.", - volume = "C77", - year = "2017", - number = "6", - pages = "367", - doi = "10.1140/epjc/s10052-017-4911-9", - eprint = "1612.03016", - archivePrefix = "arXiv", - primaryClass = "hep-ex", - reportNumber = "CERN-EP-2016-272", - SLACcitation = "%%CITATION = ARXIV:1612.03016;%%" -}' diff --git a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.plot b/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.plot deleted file mode 100644 --- a/analyses/pluginATLAS/ATLAS_2016_I1502620_Z_MU.plot +++ /dev/null @@ -1,36 +0,0 @@ -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d..-x..-y.. -LeftMargin=1.5 -LogX=0 -LogY=0 -GofType=chi2 -GofLegend=0 -LegendYPos=0.25 -LegendXPos=0.05 -RatioPlotYMin=0.85 -RatioPlotYMax=1.15 -YLabel=$\text{d}\sigma / \text{d}y_{\ell\ell}$ [pb] -XLabel=$|y_{\ell\ell}|$ -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d11 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $46 < m_{\ell\ell} < 66$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d12 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d13 -Title=central $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d14 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $66 < m_{\ell\ell} < 116$ GeV -LegendYPos=0.95 -# END PLOT - -# BEGIN PLOT /ATLAS_2016_I1502620_Z_MU/d15 -Title=forward $Z/\gamma^*\rightarrow \ell\ell$, $116 < m_{\ell\ell} < 150$ GeV -LegendYPos=0.95 -# END PLOT -