diff --git a/.hgignore b/.hgignore --- a/.hgignore +++ b/.hgignore @@ -1,116 +1,118 @@ Makefile$ Makefile\.in$ \.deps$ \.libs$ \.l[ao]$ \.so$ \.so\. \.o$ ~$ \.pyc$ \.codereplace$ \.orig$ \.tar\.(gz|bz2)$ ^autom4te.cache$ ^config.herwig$ ^config.log$ ^config.status$ ^configure$ ^include/Herwig$ ^Config/config.guess$ ^Config/config.h$ ^Config/config.h.in$ ^Config/config.sub$ ^Config/depcomp$ ^Config/compile$ ^Config/install-sh$ ^Config/missing$ ^Config/stamp-h1$ ^Config/ar-lib$ ^Contrib/make_makefiles.sh$ ^Contrib/.*/.*\.(log|out|tex|run)$ ^Utilities/hgstamp.inc$ ^Doc/HerwigDefaults.in$ ^Doc/refman-html$ ^Doc/fixinterfaces.pl$ ^Doc/refman.conf$ ^Doc/refman.h$ ^Doc/AllInterfaces.h$ ^Doc/HerwigDefaults.rpo$ ^Doc/Herwig-refman.tag$ ^Doc/tagfileThePEG.tag$ ^Doc/.*\.log$ ^INSTALL$ ^aclocal.m4$ ^confdefs.h$ ^conftest.c$ ^conftest.err$ ^include/done-all-links$ ^libtool$ \.dirstamp$ ^src/hgstamp.inc$ ^src/herwigopts.h$ ^src/herwigopts.c$ ^src/defaults/Analysis.in$ ^src/defaults/Decays.in$ ^src/defaults/decayers.in$ ^src/herwig-config$ ^src/.*\.(run|tex|out|log|rpo|spc|top|dump|dot|aux|pdf|ps|png|svg|hepmc|dvi)$ ^src/Makefile-UserModules$ ^lib/done-all-links$ ^lib/apple-fixes$ ^src/defaults/PDF.in$ ^src/defaults/done-all-links$ ^src/tune$ ^src/Herwig$ ^src/Herwig-cache$ ^src/tests/.*\.(time|mult|Bmult|chisq)$ ^src/Merging/test/*yoda ^src/Merging/test/Herwig* ^src/Merging/test/L* ^src/Merging/test/done-all-links ^src/Merging/done-all-links ^Tests/.*/.*\.(top|ps|pyc|info|dat|pdf|png)$ ^Tests/.*\.(top|ps|pyc|info|dat|pdf|png|log|out)$ ^Tests/.*\.(top|run|tex|mult|Bmult|aida|yoda)$ ^Tests/Rivet-.*$ ^Tests/.cache$ ^Tests/Rivet/.*(LEP|DIS|LHC|TVT|Star|BFactory|ISR|SppS)-.*\.in$ ^Tests/plots$ ^Tests/Herwig$ ^Tests/.*index.html$ PDF/SaSPhotonPDF.cc ^Herwig\- ^Models/Feynrules/python/Makefile-FR$ ^MatrixElement/Matchbox/External/MadGraph/mg2herwig$ ^MatrixElement/Matchbox/Scales/MatchboxScale.cc$ ^Utilities/Statistics/herwig-combinedistributions$ ^Utilities/Statistics/herwig-combineruns$ ^Utilities/Statistics/herwig-makedistributions$ ^src/defaults/MatchboxDefaults.in$ ^src/defaults/setup.gosam.in$ ^src/Matchbox/LO-DefaultShower.in$ ^src/Matchbox/LO-DipoleShower.in$ ^src/Matchbox/LO-NoShower.in$ ^src/Matchbox/MCatLO-DefaultShower.in$ ^src/Matchbox/MCatLO-DipoleShower.in$ ^src/Matchbox/MCatNLO-DefaultShower.in$ ^src/Matchbox/MCatNLO-DipoleShower.in$ ^src/Matchbox/NLO-NoShower.in$ ^src/Matchbox/Powheg-DefaultShower.in$ ^src/Matchbox/Powheg-DipoleShower.in$ ^src/defaults/MatchboxMergingDefaults.in ^src/Matchbox/done-all-links$ ^src/snippets/done-all-links$ ^Utilities/XML/xml_test$ ^Utilities/utilities_test$ ^Utilities/versionstring.h$ ^MatrixElement/Matchbox/External/MadGraph/mg2herwig.py$ test\.(log|trs)$ test-suite\.log$ ^Config/test-driver$ param_card\.dat$ __all.cc$ .ccR$ ^tmp/* PDF/stamp-h2 +Tests/anatohepmc.txt +Tests/hepmctoana.txt diff --git a/Hadronization/ColourReconnector.h b/Hadronization/ColourReconnector.h --- a/Hadronization/ColourReconnector.h +++ b/Hadronization/ColourReconnector.h @@ -1,265 +1,271 @@ // -*- C++ -*- // // ColourReconnector.h is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2017 The Herwig Collaboration // // Herwig is licenced under version 3 of the GPL, see COPYING for details. // Please respect the MCnet academic guidelines, see GUIDELINES for details. // #ifndef HERWIG_ColourReconnector_H #define HERWIG_ColourReconnector_H #include #include "CluHadConfig.h" #include "ColourReconnector.fh" namespace Herwig { using namespace ThePEG; /** \ingroup Hadronization * \class ColourReconnector * \brief Class for changing colour reconnections of partons. * \author Alberto Ribon, Christian Roehr * * This class does the nonperturbative colour rearrangement, after the * nonperturbative gluon splitting and the "normal" cluster formation. * It uses the list of particles in the event record, and the collections of * "usual" clusters which is passed to the main method. If the colour * reconnection is actually accepted, then the previous collections of "usual" * clusters is first deleted and then the new one is created. * * * @see \ref ColourReconnectorInterfaces "The interfaces" * defined for ColourReconnector. */ class ColourReconnector: public Interfaced { public: /** * Does the colour rearrangement, starting out from the list of particles in * the event record and the collection of "usual" clusters passed as * arguments. If the actual rearrangement is accepted, the initial collection of * clusters is overridden by the old ones. */ void rearrange(ClusterVector & clusters); using CluVecIt = ClusterVector::iterator; private: /** PRIVATE MEMBER FUNCTIONS */ /** * @brief Calculates the sum of the squared cluster masses. * @arguments q, aq vectors containing the quarks and antiquarks respectively * @return Sum of cluster squared masses M^2_{q[i],aq[i]}. */ Energy2 _clusterMassSum(const PVector & q, const PVector & aq) const; /** * @brief Examines whether the cluster vector (under the given permutation of * the antiquarks) contains colour-octet clusters * @param cv Cluster vector * @param P Permutation, a vector of permutated indices from 0 to * cv.size()-1 */ bool _containsColour8(const ClusterVector & cv, const vector & P) const; /** * @brief A Metropolis-type algorithm which finds a local minimum in the * total sum of cluster masses * @arguments cv cluster vector */ void _doRecoStatistical(ClusterVector & cv) const; /** * @brief Plain colour reconnection as used in Herwig 2.5.0 * @arguments cv cluster vector */ void _doRecoPlain(ClusterVector & cv) const; /** * Baryonic Colour Reconnection model */ void _doRecoBaryonic(ClusterVector & cv) const; void _makeBaryonicClusters(ClusterPtr &c1, ClusterPtr &c2, ClusterPtr &c3, ClusterPtr &newcluster1, ClusterPtr &newcluster2) const; /** * @brief Finds the cluster in cv which, if reconnected with the given * cluster cl, would result in the smallest sum of cluster masses. * If no reconnection partner can be found, a pointer to the * original Cluster cl is returned. * @arguments cv cluster vector * cl cluster iterator (must be from cv) which wants to have a reconnection partner * @return iterator to the found cluster, or the original cluster pointer if * no mass-reducing combination can be found */ CluVecIt _findRecoPartner(CluVecIt cl, ClusterVector & cv) const; CluVecIt _findPartnerRapidity(CluVecIt cl, ClusterVector & cv) const; CluVecIt _findPartnerBaryonic(CluVecIt cl, ClusterVector & cv, bool & tetraCand, const ClusterVector& a, CluVecIt &baryonic1, CluVecIt &baryonic2 ) const; /** * @brief Reconnects the constituents of the given clusters to the (only) * other possible cluster combination. * @return pair of pointers to the two new clusters */ pair _reconnect(ClusterPtr &c1, ClusterPtr &c2) const; /** * Reconnection method for baryonic reconenction model */ pair _reconnectBaryonic(ClusterPtr &c1, ClusterPtr &c2) const; /** * @brief At random, swap two antiquarks, if not excluded by the * constraint that there must not be any colour-octet clusters. * @arguments q, aq vectors containing the quarks and antiquarks respectively * maxtries maximal number of tries to find a non-colour-octet * reconfiguration * @return Pair of ints indicating the indices of the antiquarks to be * swapped. Returns (-1,-1) if no valid reconfiguration could be * found after maxtries trials */ pair _shuffle(const PVector & q, const PVector & aq, unsigned maxtries = 10) const; /** DATA MEMBERS */ /** * Specifies the colour reconnection algorithm to be used. */ int _algorithm = 0; /** - * The annealing factor is the ratio of two successive temperature steps: - * T_n = _annealingFactor * T_(n-1) - */ - double _annealingFactor = 0.9; - - /** - * Number of temperature steps in the statistical annealing algorithm - */ - unsigned int _annealingSteps = 50; - - /** * Do we do colour reconnections? */ int _clreco = 0; + /** + * Statistical Reco: * Factor used to determine the initial temperature according to * InitialTemperature = _initTemp * median {energy changes in a few random * rearrangements} */ - double _initTemp = 0.1; + double _initTemp = 0.01; + + /** + * Statistical Reco: + * The annealing factor is the ratio of two successive temperature steps: + * T_n = _annealingFactor * T_(n-1) + */ + double _annealingFactor = 0.21; + + /** + * Statistical Reco: + * Number of temperature steps in the statistical annealing algorithm + */ + unsigned int _annealingSteps = 10; + + /** + * Statistical Reco: + * The number of tries per temperature steps is the number of clusters times + * this factor. + */ + double _triesPerStepFactor = 0.66; /** * Probability that a found reconnection possibility is actually accepted. */ double _preco = 0.5; double _precoBaryonic = 0.5; - - /** - * The number of tries per temperature steps is the number of clusters times - * this factor. - */ - double _triesPerStepFactor = 5.0; + /** * maximum allowed distance in the eta phi space for reconnection to occur */ /** * Maximium distance for reconnections */ Length _maxDistance = picometer; /** * @return true, if the two partons are splitting products of the same * gluon */ bool _isColour8(tcPPtr p, tcPPtr q) const; /** * Option for handling octets */ unsigned int _octetOption = 0; public: /** @name Functions used by the persistent I/O system. */ //@{ /** * Function used to write out object persistently. * @param os the persistent output stream written to. */ void persistentOutput(PersistentOStream & os) const; /** * Function used to read in object persistently. * @param is the persistent input stream read from. * @param version the version number of the object when written. */ void persistentInput(PersistentIStream & is, int version); //@} /** * Standard Init function used to initialize the interfaces. */ static void Init(); protected: /** @name Clone Methods. */ //@{ /** * Make a simple clone of this object. * @return a pointer to the new object. */ virtual IBPtr clone() const; /** Make a clone of this object, possibly modifying the cloned object * to make it sane. * @return a pointer to the new object. */ virtual IBPtr fullclone() const; //@} private: /** * Private and non-existent assignment operator. */ ColourReconnector & operator=(const ColourReconnector &) = delete; }; } #endif /* HERWIG_ColourReconnector_H */ diff --git a/MatrixElement/Hadron/MEMinBias.cc b/MatrixElement/Hadron/MEMinBias.cc --- a/MatrixElement/Hadron/MEMinBias.cc +++ b/MatrixElement/Hadron/MEMinBias.cc @@ -1,249 +1,259 @@ // -*- C++ -*- // // This is the implementation of the non-inlined, non-templated member // functions of the MEMinBias class. // #include "MEMinBias.h" #include "ThePEG/Utilities/DescribeClass.h" #include "ThePEG/Interface/Reference.h" #include "ThePEG/Interface/ClassDocumentation.h" #include "ThePEG/Utilities/SimplePhaseSpace.h" //#include "ThePEG/Repository/EventGenerator.h" #include "ThePEG/Handlers/StandardXComb.h" #include "ThePEG/Interface/Parameter.h" #include "ThePEG/Handlers/SamplerBase.h" #include "ThePEG/Persistency/PersistentOStream.h" #include "ThePEG/Persistency/PersistentIStream.h" using namespace Herwig; #include "ThePEG/PDT/EnumParticles.h" #include "ThePEG/MatrixElement/Tree2toNDiagram.h" void MEMinBias::getDiagrams() const { int maxflav(2); // Pomeron data tcPDPtr pom = getParticleData(990); for ( int i = 1; i <= maxflav; ++i ) { for( int j=1; j <= i; ++j){ tcPDPtr q1 = getParticleData(i); tcPDPtr q1b = q1->CC(); tcPDPtr q2 = getParticleData(j); tcPDPtr q2b = q2->CC(); // For each flavour we add: //qq -> qq add(new_ptr((Tree2toNDiagram(3), q1, pom, q2, 1, q1, 2, q2, -1))); //qqb -> qqb add(new_ptr((Tree2toNDiagram(3), q1, pom, q2b, 1, q1, 2, q2b, -2))); //qbqb -> qbqb add(new_ptr((Tree2toNDiagram(3), q1b, pom, q2b, 1, q1b, 2, q2b, -3))); } } } Energy2 MEMinBias::scale() const { return sqr(Scale_); } int MEMinBias::nDim() const { return 0; } void MEMinBias::setKinematics() { HwMEBase::setKinematics(); // Always call the base class method first. } bool MEMinBias::generateKinematics(const double *) { // generate the masses of the particles for ( int i = 2, N = meMomenta().size(); i < N; ++i ) { meMomenta()[i] = Lorentz5Momentum(mePartonData()[i]->generateMass()); } Energy q = ZERO; try { q = SimplePhaseSpace:: getMagnitude(sHat(), meMomenta()[2].mass(), meMomenta()[3].mass()); } catch ( ImpossibleKinematics & e ) { return false; } Energy pt = ZERO; meMomenta()[2].setVect(Momentum3( pt, pt, q)); meMomenta()[3].setVect(Momentum3(-pt, -pt, -q)); meMomenta()[2].rescaleEnergy(); meMomenta()[3].rescaleEnergy(); jacobian(1.0); return true; } double MEMinBias::correctionweight() const { // Here we calculate the weight to restore the inelastic-diffractiveXSec // given by the MPIHandler. // First get the eventhandler to get the current cross sections. static Ptr::tptr eh = dynamic_ptr_cast::tptr>(generator()->eventHandler()); // All diffractive processes make use of this ME. // The static map can be used to collect all the sumOfWeights. static map weightsmap; weightsmap[lastXCombPtr()]=lastXComb().stats().sumWeights(); // Define static variable to keep trac of reweighting static double rew_=1.; static int countUpdateWeight=50; static double sumRew=0.; static double countN=0; // if we produce events we count if(eh->integratedXSec()>ZERO)sumRew+=rew_; if(eh->integratedXSec()>ZERO)countN+=1.; if(countUpdateWeightsampler()->maxXSec()/eh->sampler()->attempts()*sum; CrossSection XS_wanted=MPIHandler_->inelasticXSec()-MPIHandler_->diffractiveXSec(); double deltaN=50; // Cross section without reweighting: XS_norew // XS_have = avcsNorm2*XS_norew (for large N) // We want to determine the rew that allows to get the wanted XS. // In deltaN points we want (left) and we get (right): // XS_wanted*(countN+deltaN) = XS_have*countN + rew*deltaN*XS_norew // Solve for rew: rew_=avRew*(XS_wanted*(countN+deltaN)-XS_have*countN)/(XS_have*deltaN); countUpdateWeight+=deltaN; } //Make sure we dont produce negative weights. // TODO: write finalize method that checks if reweighting was performed correctly. rew_=max(rew_,0.000001); rew_=min(rew_,10000.0); return rew_; } double MEMinBias::me2() const { //tuned so it gives the correct normalization for xmin = 0.11 return csNorm_*(sqr(generator()->maximumCMEnergy())/GeV2); } CrossSection MEMinBias::dSigHatDR() const { return me2()*jacobian()/sHat()*sqr(hbarc)*correctionweight(); } unsigned int MEMinBias::orderInAlphaS() const { return 2; } unsigned int MEMinBias::orderInAlphaEW() const { return 0; } Selector MEMinBias::diagrams(const DiagramVector & diags) const { Selector sel; for ( DiagramIndex i = 0; i < diags.size(); ++i ) sel.insert(1.0, i); return sel; } Selector MEMinBias::colourGeometries(tcDiagPtr diag) const { static ColourLines qq("1 4, 3 5"); static ColourLines qqb("1 4, -3 -5"); static ColourLines qbqb("-1 -4, -3 -5"); Selector sel; switch(diag->id()){ case -1: sel.insert(1.0, &qq); break; case -2: sel.insert(1.0, &qqb); break; case -3: sel.insert(1.0, &qbqb); break; } return sel; } IBPtr MEMinBias::clone() const { return new_ptr(*this); } IBPtr MEMinBias::fullclone() const { return new_ptr(*this); } // The following static variable is needed for the type // description system in ThePEG. DescribeClass describeHerwigMEMinBias("Herwig::MEMinBias", "HwMEHadron.so"); void MEMinBias::persistentOutput(PersistentOStream & os) const { os << csNorm_ << ounit(Scale_,GeV) << MPIHandler_; } void MEMinBias::persistentInput(PersistentIStream & is, int) { is >> csNorm_ >> iunit(Scale_,GeV) >> MPIHandler_; } void MEMinBias::Init() { static ClassDocumentation documentation ("There is no documentation for the MEMinBias class"); static Parameter interfacecsNorm ("csNorm", "Normalization of the min-bias cross section.", &MEMinBias::csNorm_, 1.0, 0.0, 100.0, false, false, Interface::limited); static Parameter interfaceScale ("Scale", "Scale for the Min Bias matrix element.", &MEMinBias::Scale_,GeV, 2.0*GeV, 0.0*GeV, 100.0*GeV, false, false, Interface::limited); static Reference interfaceMPIHandler ("MPIHandler", "The object that administers all additional scatterings.", &MEMinBias::MPIHandler_, false, false, true, true); + static Switch interfaceOnlyVal + ("OnlyValence" , + "Allow the dummy process to only extract valence quarks." , + &MEMinBias::onlyValQuarks_ , false , false , false ); + static SwitchOption interfaceOnlyValYes + ( interfaceOnlyVal , "Yes" , "" , true ); + static SwitchOption interfaceOnlyValNo + ( interfaceOnlyVal , "No" , "" , false ); + + } diff --git a/MatrixElement/Hadron/MEMinBias.h b/MatrixElement/Hadron/MEMinBias.h --- a/MatrixElement/Hadron/MEMinBias.h +++ b/MatrixElement/Hadron/MEMinBias.h @@ -1,212 +1,217 @@ // -*- C++ -*- #ifndef HERWIG_MEMinBias_H #define HERWIG_MEMinBias_H // // This is the declaration of the MEMinBias class. // #include "Herwig/MatrixElement/HwMEBase.h" #include "Herwig/Shower/UEBase.h" namespace Herwig { using namespace ThePEG; /** * The MEMinBias class provides a simple colour singlet exchange matrix element * to be used in the soft component of the multiple scattering model of the * underlying event * * @see \ref MEMinBiasInterfaces "The interfaces" * defined for MEMinBias. */ class MEMinBias: public HwMEBase { public: /** * The default constructor. */ MEMinBias() : csNorm_(1.), Scale_(2.*GeV) {} public: /** @name Virtual functions required by the MEBase class. */ //@{ /** * Return the order in \f$\alpha_S\f$ in which this matrix * element is given. */ virtual unsigned int orderInAlphaS() const; /** * Return the order in \f$\alpha_{EW}\f$ in which this matrix * element is given. */ virtual unsigned int orderInAlphaEW() const; /** * The matrix element for the kinematical configuration * previously provided by the last call to setKinematics(), suitably * scaled by sHat() to give a dimension-less number. * @return the matrix element scaled with sHat() to give a * dimensionless number. */ virtual double me2() const; /** * Correction weight to reweight the cross section to the inelastic cross * section subtracted by the diffractive cross section. */ double correctionweight() const; /** * Return the scale associated with the last set phase space point. */ virtual Energy2 scale() const; /** * Set the typed and momenta of the incoming and outgoing partons to * be used in subsequent calls to me() and colourGeometries() * according to the associated XComb object. If the function is * overridden in a sub class the new function must call the base * class one first. */ virtual void setKinematics(); /** * The number of internal degrees of freedom used in the matrix * element. */ virtual int nDim() const; /** * Generate internal degrees of freedom given nDim() uniform * random numbers in the interval \f$ ]0,1[ \f$. To help the phase space * generator, the dSigHatDR should be a smooth function of these * numbers, although this is not strictly necessary. * @param r a pointer to the first of nDim() consecutive random numbers. * @return true if the generation succeeded, otherwise false. */ virtual bool generateKinematics(const double * r); /** * Return the matrix element squared differential in the variables * given by the last call to generateKinematics(). */ virtual CrossSection dSigHatDR() const; /** * Add all possible diagrams with the add() function. */ virtual void getDiagrams() const; /** * Get diagram selector. With the information previously supplied with the * setKinematics method, a derived class may optionally * override this method to weight the given diagrams with their * (although certainly not physical) relative probabilities. * @param dv the diagrams to be weighted. * @return a Selector relating the given diagrams to their weights. */ virtual Selector diagrams(const DiagramVector & dv) const; /** * Return a Selector with possible colour geometries for the selected * diagram weighted by their relative probabilities. * @param diag the diagram chosen. * @return the possible colour geometries weighted by their * relative probabilities. */ virtual Selector colourGeometries(tcDiagPtr diag) const; //@} public: /** @name Functions used by the persistent I/O system. */ //@{ /** * Function used to write out object persistently. * @param os the persistent output stream written to. */ void persistentOutput(PersistentOStream & os) const; /** * Function used to read in object persistently. * @param is the persistent input stream read from. * @param version the version number of the object when written. */ void persistentInput(PersistentIStream & is, int version); //@} /** * The standard Init function used to initialize the interfaces. * Called exactly once for each class by the class description system * before the main function starts or * when this class is dynamically loaded. */ /** * The standard Init function used to initialize the interfaces. * Called exactly once for each class by the class description system * before the main function starts or * when this class is dynamically loaded. */ static void Init(); protected: /** @name Clone Methods. */ //@{ /** * Make a simple clone of this object. * @return a pointer to the new object. */ virtual IBPtr clone() const; /** Make a clone of this object, possibly modifying the cloned object * to make it sane. * @return a pointer to the new object. */ virtual IBPtr fullclone() const; //@} // If needed, insert declarations of virtual function defined in the // InterfacedBase class here (using ThePEG-interfaced-decl in Emacs). private: /** * Normalization of the min-bias cross section. * Note that the cross section is reweighted in addition to produce the * non-diffractive cross section given by the MPIHandler * csNorm can be modified to improve the unweighting effiency. */ double csNorm_; /** * Scale for the Min Bias matrix element */ Energy Scale_; /** + * Allow only valence quark extraction. + */ + bool onlyValQuarks_=false; + + /** * a MPIHandler to administer the creation of several (semihard) * partonic interactions. * Needed to comunicate the non-diffractive cross section. */ UEBasePtr MPIHandler_; /** * The assignment operator is private and must never be called. * In fact, it should not even be implemented. */ MEMinBias & operator=(const MEMinBias &) = delete; }; } #endif /* HERWIG_MEMinBias_H */ diff --git a/MatrixElement/Lepton/MEee2VectorMeson.cc b/MatrixElement/Lepton/MEee2VectorMeson.cc --- a/MatrixElement/Lepton/MEee2VectorMeson.cc +++ b/MatrixElement/Lepton/MEee2VectorMeson.cc @@ -1,231 +1,228 @@ // -*- C++ -*- // // MEee2VectorMeson.cc is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2017 The Herwig Collaboration // // Herwig is licenced under version 3 of the GPL, see COPYING for details. // Please respect the MCnet academic guidelines, see GUIDELINES for details. // // // This is the implementation of the non-inlined, non-templated member // functions of the MEee2VectorMeson class. // #include "MEee2VectorMeson.h" #include "ThePEG/Utilities/DescribeClass.h" #include "ThePEG/Interface/ClassDocumentation.h" #include "ThePEG/Interface/Switch.h" #include "ThePEG/Interface/Parameter.h" #include "ThePEG/Interface/Reference.h" #include "ThePEG/Persistency/PersistentOStream.h" #include "ThePEG/Persistency/PersistentIStream.h" #include "ThePEG/PDT/EnumParticles.h" #include "ThePEG/MatrixElement/Tree2toNDiagram.h" #include "ThePEG/Cuts/Cuts.h" #include "Herwig/PDT/GenericMassGenerator.h" #include "ThePEG/Handlers/StandardXComb.h" +#include "Herwig/Models/StandardModel/StandardModel.h" #include "Herwig/MatrixElement/HardVertex.h" using namespace Herwig; using namespace ThePEG; using namespace ThePEG::Helicity; - void MEee2VectorMeson::getDiagrams() const { tcPDPtr em = getParticleData(ParticleID::eminus); tcPDPtr ep = getParticleData(ParticleID::eplus); - add(new_ptr((Tree2toNDiagram(2), em, ep, 1, _vector,-1))); + add(new_ptr((Tree2toNDiagram(2), em, ep, 1, vector_,-1))); } Energy2 MEee2VectorMeson::scale() const { return sHat(); } int MEee2VectorMeson::nDim() const { - return 1; + return 0; } void MEee2VectorMeson::setKinematics() { - MEBase::setKinematics(); // Always call the base class method first. + MEBase::setKinematics(); } -bool MEee2VectorMeson::generateKinematics(const double *r) { +bool MEee2VectorMeson::generateKinematics(const double *) { Lorentz5Momentum pout=meMomenta()[0]+meMomenta()[1]; pout.rescaleMass(); meMomenta()[2] = pout; jacobian(1.0); // check passes all the cuts vector out(1,meMomenta()[2]); tcPDVector tout(1,mePartonData()[2]); - jacobian(1.+0.002*(0.5-r[0])); - // return true if passes the cuts return lastCuts().passCuts(tout, out, mePartonData()[0], mePartonData()[1]); } unsigned int MEee2VectorMeson::orderInAlphaS() const { return 0; } unsigned int MEee2VectorMeson::orderInAlphaEW() const { - return 0; + return 2; } Selector MEee2VectorMeson::colourGeometries(tcDiagPtr) const { static ColourLines neutral ( " " ); Selector sel;sel.insert(1.,&neutral); return sel; } void MEee2VectorMeson::persistentOutput(PersistentOStream & os) const { - os << _coupling << _vector << _massgen << _lineshape; + os << coupling_ << vector_ << massGen_ << lineShape_; } void MEee2VectorMeson::persistentInput(PersistentIStream & is, int) { - is >> _coupling >> _vector >> _massgen >> _lineshape; + is >> coupling_ >> vector_ >> massGen_ >> lineShape_; } // The following static variable is needed for the type // description system in ThePEG. DescribeClass describeHerwigMEee2VectorMeson("Herwig::MEee2VectorMeson", "HwMELepton.so"); void MEee2VectorMeson::Init() { static ClassDocumentation documentation ("The MEee2VectorMeson class implements the production of a vector meson" " in e+e- collisions and is primilarly intended to test the hadron decay package"); static Switch interfaceLineShape ("LineShape", "Option for the vector meson lineshape", - &MEee2VectorMeson::_lineshape, false, false, false); + &MEee2VectorMeson::lineShape_, false, false, false); static SwitchOption interfaceLineShapeMassGenerator (interfaceLineShape, "MassGenerator", "Use the mass generator if available", true); static SwitchOption interfaceLineShapeBreitWigner (interfaceLineShape, "BreitWigner", "Use a Breit-Wigner with the naive running width", false); static Reference interfaceVectorMeson ("VectorMeson", "The vector meson produced", - &MEee2VectorMeson::_vector, false, false, true, false, false); + &MEee2VectorMeson::vector_, false, false, true, false, false); static Parameter interfaceCoupling ("Coupling", "The leptonic coupling of the vector meson", - &MEee2VectorMeson::_coupling, 0.0012, 0.0, 10.0, + &MEee2VectorMeson::coupling_, 0., 0.0, 100.0, false, false, Interface::limited); } Selector MEee2VectorMeson::diagrams(const DiagramVector &) const { Selector sel;sel.insert(1.0, 0); return sel; } CrossSection MEee2VectorMeson::dSigHatDR() const { InvEnergy2 wgt; - Energy M(_vector->mass()),G(_vector->width()); + Energy M(vector_->mass()),G(vector_->width()); Energy2 M2(sqr(M)),GM(G*M); - if(_massgen&&_lineshape) { - wgt =Constants::pi*_massgen->weight(sqrt(sHat()))/(sqr(sHat()-M2)+sqr(GM))*UnitRemoval::E2; - } - else { + if(massGen_&&lineShape_) + wgt = Constants::pi*massGen_->BreitWignerWeight(sqrt(sHat())); + else wgt = sHat()*G/M/(sqr(sHat()-M2)+sqr(sHat()*G/M)); - } - return me2()*jacobian()*wgt*sqr(hbarc); + return sqr(4.*Constants::pi*SM().alphaEM(sHat()))*me2()*jacobian()*wgt*sqr(hbarc)*sqr(M2/sHat()); } void MEee2VectorMeson::doinit() { MEBase::doinit(); // mass generator - tMassGenPtr mass=_vector->massGenerator(); + tMassGenPtr mass=vector_->massGenerator(); if(mass) { - _massgen=dynamic_ptr_cast(mass); + massGen_=dynamic_ptr_cast(mass); } } double MEee2VectorMeson::me2() const { double aver=0.; // get the order right int ielectron(0),ipositron(1); if(mePartonData()[0]->id()!=11) swap(ielectron,ipositron); // the vectors for the wavefunction to be passed to the matrix element vector fin; vector ain; vector vout; for(unsigned int ihel=0;ihel<2;++ihel) { fin.push_back(SpinorWaveFunction(meMomenta()[ielectron], mePartonData()[ielectron],ihel,incoming)); ain.push_back(SpinorBarWaveFunction(meMomenta()[ipositron], mePartonData()[ipositron],ihel,incoming)); } for(unsigned int ihel=0;ihel<3;++ihel) { vout.push_back(VectorWaveFunction(meMomenta()[2],mePartonData()[2],ihel,outgoing)); } ProductionMatrixElement temp=HelicityME(fin,ain,vout,aver); return aver; } // the helicity amplitude matrix element ProductionMatrixElement MEee2VectorMeson::HelicityME(vector fin, vector ain, vector vout, double & aver) const { ProductionMatrixElement output(PDT::Spin1Half,PDT::Spin1Half,PDT::Spin1); Complex product; // sum over helicities to get the matrix element unsigned int inhel1,inhel2,outhel1; - double me(0.); - LorentzPolarizationVector vec; + aver = 0.; + LorentzPolarizationVectorE vec; Complex ii(0.,1.); + Energy ecms = sqrt(sHat()); for(inhel1=0;inhel1<2;++inhel1) { for(inhel2=0;inhel2<2;++inhel2) { - vec = fin[inhel1].wave().vectorCurrent(ain[inhel2].wave()); - vec*=_coupling; + vec = fin[inhel1].dimensionedWave().vectorCurrent(ain[inhel2].dimensionedWave()); + vec /= coupling_; for(outhel1=0;outhel1<3;++outhel1) { - product = vec.dot(vout[outhel1].wave()); + product = vec.dot(vout[outhel1].wave())/ecms; output(inhel1,inhel2,outhel1)=product; - me+=real(product*conj(product)); + aver += norm(product); } } } - aver=(me*UnitRemoval::E2)/sHat(); + aver *= 0.25; return output; } void MEee2VectorMeson::constructVertex(tSubProPtr sub) { // extract the particles in the hard process ParticleVector hard; hard.push_back(sub->incoming().first);hard.push_back(sub->incoming().second); hard.push_back(sub->outgoing()[0]); if(hard[0]->id()id()) swap(hard[0],hard[1]); vector fin; vector ain; vector vout; SpinorWaveFunction( fin ,hard[0],incoming,false,true); SpinorBarWaveFunction(ain ,hard[1],incoming,false,true); VectorWaveFunction(vout ,hard[2],outgoing,true,false,true); double dummy; ProductionMatrixElement prodme=HelicityME(fin,ain,vout,dummy); // construct the vertex HardVertexPtr hardvertex=new_ptr(HardVertex()); // set the matrix element for the vertex hardvertex->ME(prodme); // set the pointers and to and from the vertex for(unsigned int ix=0;ix<3;++ix) { (hard[ix]->spinInfo())->productionVertex(hardvertex); } } diff --git a/MatrixElement/Lepton/MEee2VectorMeson.h b/MatrixElement/Lepton/MEee2VectorMeson.h --- a/MatrixElement/Lepton/MEee2VectorMeson.h +++ b/MatrixElement/Lepton/MEee2VectorMeson.h @@ -1,236 +1,236 @@ // -*- C++ -*- // // MEee2VectorMeson.h is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2017 The Herwig Collaboration // // Herwig is licenced under version 3 of the GPL, see COPYING for details. // Please respect the MCnet academic guidelines, see GUIDELINES for details. // -#ifndef THEPEG_MEee2VectorMeson_H -#define THEPEG_MEee2VectorMeson_H +#ifndef HERWIG_MEee2VectorMeson_H +#define HERWIG_MEee2VectorMeson_H // // This is the declaration of the MEee2VectorMeson class. // #include "ThePEG/MatrixElement/MEBase.h" #include "Herwig/PDT/GenericMassGenerator.fh" #include "Herwig/MatrixElement/ProductionMatrixElement.h" #include "ThePEG/Helicity/WaveFunction/SpinorWaveFunction.h" #include "ThePEG/Helicity/WaveFunction/SpinorBarWaveFunction.h" #include "ThePEG/Helicity/WaveFunction/VectorWaveFunction.h" namespace Herwig { using namespace ThePEG; using Helicity::SpinorWaveFunction; using Helicity::SpinorBarWaveFunction; using Helicity::VectorWaveFunction; /** * The MEee2VectorMeson class is designed to produce neutral vector mesons * in \f$e^+e^-\f$ collisions and is primarily intended to test the hadronic * decay package. * * @see \ref MEee2VectorMesonInterfaces "The interfaces" * defined for MEee2VectorMeson. */ class MEee2VectorMeson: public MEBase { public: /** * The default constructor. */ - inline MEee2VectorMeson() :_coupling(0.0012), _lineshape(false) + MEee2VectorMeson() : coupling_(0.0012), lineShape_(false) {} /** @name Virtual functions required by the MEBase class. */ //@{ /** * Return the order in \f$\alpha_S\f$ in which this matrix * element is given. */ virtual unsigned int orderInAlphaS() const; /** * Return the order in \f$\alpha_{EW}\f$ in which this matrix * element is given. */ virtual unsigned int orderInAlphaEW() const; /** * The matrix element for the kinematical configuration * previously provided by the last call to setKinematics(), suitably * scaled by sHat() to give a dimension-less number. * @return the matrix element scaled with sHat() to give a * dimensionless number. */ virtual double me2() const; /** * Return the scale associated with the last set phase space point. */ virtual Energy2 scale() const; /** * Set the typed and momenta of the incoming and outgoing partons to * be used in subsequent calls to me() and colourGeometries() * according to the associated XComb object. If the function is * overridden in a sub class the new function must call the base * class one first. */ virtual void setKinematics(); /** * The number of internal degrees of freedom used in the matrix * element. */ virtual int nDim() const; /** * Generate internal degrees of freedom given nDim() uniform * random numbers in the interval \f$ ]0,1[ \f$. To help the phase space * generator, the dSigHatDR should be a smooth function of these * numbers, although this is not strictly necessary. * @param r a pointer to the first of nDim() consecutive random numbers. * @return true if the generation succeeded, otherwise false. */ virtual bool generateKinematics(const double * r); /** * Return the matrix element squared differential in the variables * given by the last call to generateKinematics(). */ virtual CrossSection dSigHatDR() const; /** * Add all possible diagrams with the add() function. */ virtual void getDiagrams() const; /** * Get diagram selector. With the information previously supplied with the * setKinematics method, a derived class may optionally * override this method to weight the given diagrams with their * (although certainly not physical) relative probabilities. * @param dv the diagrams to be weighted. * @return a Selector relating the given diagrams to their weights. */ virtual Selector diagrams(const DiagramVector & dv) const; /** * Return a Selector with possible colour geometries for the selected * diagram weighted by their relative probabilities. * @param diag the diagram chosen. * @return the possible colour geometries weighted by their * relative probabilities. */ virtual Selector colourGeometries(tcDiagPtr diag) const; /** * Set up the spin correlations */ virtual void constructVertex(tSubProPtr sub); //@} public: /** @name Functions used by the persistent I/O system. */ //@{ /** * Function used to write out object persistently. * @param os the persistent output stream written to. */ void persistentOutput(PersistentOStream & os) const; /** * Function used to read in object persistently. * @param is the persistent input stream read from. * @param version the version number of the object when written. */ void persistentInput(PersistentIStream & is, int version); //@} /** * The standard Init function used to initialize the interfaces. * Called exactly once for each class by the class description system * before the main function starts or * when this class is dynamically loaded. */ static void Init(); protected: /** @name Clone Methods. */ //@{ /** * Make a simple clone of this object. * @return a pointer to the new object. */ inline virtual IBPtr clone() const {return new_ptr(*this);} /** Make a clone of this object, possibly modifying the cloned object * to make it sane. * @return a pointer to the new object. */ inline virtual IBPtr fullclone() const {return new_ptr(*this);} //@} protected: /** @name Standard Interfaced functions. */ //@{ /** * Initialize this object after the setup phase before saving an * EventGenerator to disk. * @throws InitException if object could not be initialized properly. */ virtual void doinit(); //@} private: /** * Member to return the helicity amplitudes */ ProductionMatrixElement HelicityME(vector fin, vector ain, vector vout,double& me) const; private: /** * The assignment operator is private and must never be called. * In fact, it should not even be implemented. */ MEee2VectorMeson & operator=(const MEee2VectorMeson &) = delete; private: /** * The vector meson being produced */ - PDPtr _vector; + PDPtr vector_; /** * The coupling */ - double _coupling; + double coupling_; /** * Use the mass generator for the line shape */ - bool _lineshape; + bool lineShape_; /** * Pointer to the mass generator for the Higgs */ - GenericMassGeneratorPtr _massgen; + GenericMassGeneratorPtr massGen_; }; } -#endif /* THEPEG_MEee2VectorMeson_H */ +#endif /* HERWIG_MEee2VectorMeson_H */ diff --git a/MatrixElement/Matchbox/External/MadGraph/mg2herwig.in b/MatrixElement/Matchbox/External/MadGraph/mg2herwig.in --- a/MatrixElement/Matchbox/External/MadGraph/mg2herwig.in +++ b/MatrixElement/Matchbox/External/MadGraph/mg2herwig.in @@ -1,389 +1,392 @@ #! /usr/bin/env python import os,sys,glob,errno,shutil,time,fnmatch,tempfile from optparse import OptionParser def mkdir_p(path): """Recursive mkdir""" if not os.path.isdir(path): os.makedirs(path) def finddirs(pattern, path): """Find all paths which contain a filename matching 'pattern'""" result = [ root for root, _, files in os.walk(path) if fnmatch.filter(files, pattern) ] return result # fill the proc.dat file from BornAmplitudes.dat and VirtAmplitudes.dat. def fillprocs(model,oras,orew): """Fill proc.dat from BornAmplitudes.dat and VirtAmplitudes.dat""" oras=int(oras) orew=int(orew) bornlist=[] virtlist=[] result = [] result.append('set fortran_compiler @FC@ --no_save') result.append("import model "+model) borns="BornAmplitudes.dat" virts="VirtAmplitudes.dat" procnr=0 virtlines=[] bornlines=[] # first pass to work out leg numbers minlegs=100 legs=0 for i in [borns, virts]: with open(i, "r") as f: for line in f: line = line.split(" ") N = len(line) if N < minlegs: minlegs = N for it in line: if it.replace("-","").isdigit(): legs += 1 #conversion for heft model to go from (2QCD+1QED)->1HIG for each FS HIGGS. if model=="heft": HIG = oras+orew-legs+2 if HIG % 2 == 0: HIG = HIG//2 else: sys.stderr.write("Warning: No possible coupling power:(int(oras)+int(orew)-legs+2)%2!=0\n") exit(1) else: HIG = 0 with open(borns, "r") as f: for i, line in enumerate(f): #this assumes extra QCD emmissions addalphas = len(line.split(" ")) - minlegs line = line.rstrip() procnr += 1 bornlist.append(str(procnr)) cmd = "generate " if i==0 else "add process" hig = "" qcd = oras+addalphas qed = orew if HIG: hig = "HIG=%s" % HIG qcd -= 2*HIG qed -= HIG bornlines.append("{cmd} {line} {hig} QCD<={qcd} QED<={qed} @{procnr}".format(**locals())) result.extend(bornlines) with open(virts, "r") as f: for i, line in enumerate(f): addalphas = len(line.split(" ")) - minlegs line = line.rstrip() procnr += 1 virtlist.append(str(procnr)) cmd = "generate " if i==0 else "add process" qcd = oras+addalphas qed = orew virtlines.append("{cmd} {line} QCD<={qcd} QED<={qed} [ virt=QCD ] @{procnr}".format(**locals())) if virtlines and bornlines: result.append("output matchbox MG5 --postpone_model") result.extend(virtlines) result.append("output matchbox MG5 -f\n") with open("proc.dat","w") as f: f.write('\n'.join(result)) return bornlist,virtlist def build_matchbox_tmp(pwd,buildpath,absolute_links): """Create the working directories and link the required files from central MG""" pwd = os.path.abspath(pwd) if not os.path.isabs(buildpath): buildpath = os.path.join(pwd,buildpath) resources =glob.glob(os.path.join(buildpath,"MG5","SubProcesses","MadLoop5_resources","*")) resources+=glob.glob(os.path.join(buildpath,"MG5","Cards","*")) resources+=glob.glob(os.path.join(buildpath,"MG5","Cards","SubProcesses","*")) for i in resources: f = os.path.join(MG_TMP, os.path.basename(i)) if not os.path.isfile(f) and not os.path.islink(f): if absolute_links: os.symlink(i,f) else: os.symlink(os.path.relpath(i,MG_TMP), f) parser = OptionParser() parser.add_option("-a", "--buildpath", dest="buildpath",help="Do not use this script. Only for Herwig internal use. ") parser.add_option("-b", "--build", action="store_true", dest="build", default=True,help="Do not use this script. Only for Herwig internal use.") parser.add_option("-c", "--madgraph", dest="madgraph",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-d", "--runpath", dest="runpath",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-e", "--model", dest="model",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-f", "--orderas", dest="orderas",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-g", "--orderew", dest="orderew",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-i", "--datadir",dest="datadir",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-I", "--includedir",dest="includedir",help="Do not use this script. Only for Herwig internal use.") parser.add_option("-l", "--absolute-links",action="store_true", dest="absolute_links", default=False,\ help="Do not use this script. Only for Herwig internal use.") parser.add_option("--cacheprefix", dest="cacheprefix",help="Do not use this script. Only for Herwig internal use.") (options, args) = parser.parse_args() if not options.cacheprefix: sys.stderr.write("Need a value for --cacheprefix\n") exit(1) cachedir = os.path.abspath(options.cacheprefix) mkdir_p(cachedir) #MG_TMP = tempfile.mkdtemp(prefix='MG_tmp_',dir=cachedir) MG_TMP = os.path.join(cachedir, 'MG_tmp') mkdir_p(MG_TMP) pwd=os.getcwd() param_card="" if options.model=="loop_sm" or options.model=="heft": if options.model=="loop_sm": param_card="param_card.dat" else: param_card="param_card_"+options.model+".dat" file = open("%s/MadGraphInterface/%s.in" % (options.datadir,param_card) , "r") paramcard = file.read() file.close() file = open(options.runpath+"/"+param_card, "w") params=open(options.runpath+"/MG-Parameter.dat", "r") for line in params: a=line.split() paramcard=paramcard.replace(a[0],a[1]) params.close() file.write(paramcard) file.close() elif options.model.startswith("/"): os.system("python %s/write_param_card.py " % options.model) else: print "---------------------------------------------------------------" print "---------------------------------------------------------------" print "Warning: The model set for the MadGraph Interface " print " needs a parameter setting by hand." print " Please fill the param_card_"+options.model+".dat" print " with your favourite assumptions." print " And make sure Herwig uses the same parameters." print "---------------------------------------------------------------" print "---------------------------------------------------------------" if os.path.isfile(options.buildpath +"/MG5/Cards/param_card.dat") and not os.path.isfile(options.runpath+"/"+"param_card_"+options.model+".dat"): shutil.copyfile(options.buildpath +"/MG5/Cards/param_card.dat", options.runpath+"/"+"param_card_"+options.model+".dat") time.sleep(1) if not os.path.isdir(options.buildpath): print "The MadGraph Install path did not exist. It has been created for you." print "Just start Herwig read again.." mkdir_p(options.buildpath) exit() os.chdir(options.buildpath) if os.path.isfile("InterfaceMadGraph.so"): build_matchbox_tmp(pwd,options.buildpath,options.absolute_links) exit() Bornlist,Virtlist=fillprocs(options.model,options.orderas,options.orderew) if not options.madgraph and not os.path.isfile("InterfaceMadGraph.so"): sys.stderr.write("*** MadGraph build failed, check logfile for details ***") exit(1) os.system("python "+options.madgraph+"/mg5_aMC proc.dat") def make_case_stmts(func): """Create Fortran case statements for all processes""" result = [] # add a case option for each item for i in Bornlist + list(set(Virtlist) - set(Bornlist)): if func == "SLOOPMATRIX(momenta,virt)" and i not in Virtlist: continue result.append(" CASE(%s)" % i) result.append(" CALL MG5_%s_%s" % (i,func)) # if we have anything, add header and footer if result: result.insert(0, " SELECT CASE (proc)") result.append(" CASE DEFAULT") result.append(" WRITE(*,*) '##W02A WARNING No id found '") result.append(" END SELECT ") return "\n".join(result) else: return "" def write_interfaceMG(): """Create the InterfaceMadGraph.f FORTRAN file""" subs = { "MG_CalculateBORNtxt" : make_case_stmts("BORN(momenta,hel)"), "MG_CalculateVIRTtxt" : make_case_stmts("SLOOPMATRIX(momenta,virt)"), "MG_Jamptxt" : make_case_stmts("GET_JAMP(color,Jamp)"), "MG_LNJamptxt" : make_case_stmts("GET_LNJAMP(color,Jamp)"), "MG_NColtxt" : make_case_stmts("GET_NCOL(color)"), "MG_ColourMattxt" : make_case_stmts("GET_NCOLOR(i,j,color)"), } baseN = 5 if subs["MG_CalculateVIRTtxt"] else 3 subs["MG_vxxxxxtxt"] = """\ subroutine MG_vxxxxx(p, n,inc,VC) $ bind(c, name='MG_vxxxxx') IMPLICIT NONE double precision p(0:3) double precision n(0:3) INTEGER inc double precision VC(0:7) double complex VCtmp({d}) call vxxxxx(p, 0d0,1,inc ,VCtmp) VC(0)= real(VCtmp({a})) VC(1)=aimag(VCtmp({a})) VC(2)= real(VCtmp({b})) VC(3)=aimag(VCtmp({b})) VC(4)= real(VCtmp({c})) VC(5)=aimag(VCtmp({c})) VC(6)= real(VCtmp({d})) VC(7)=aimag(VCtmp({d})) END """.format(a=baseN, b=baseN+1, c=baseN+2, d=baseN+3) fname = os.path.join( options.datadir, "MadGraphInterface", "InterfaceMadGraph.f.in" ) with open(fname, 'r') as f: tmp = f.read() with open("InterfaceMadGraph.f", 'w') as f: f.write(tmp.format(**subs)) write_interfaceMG() make=" " fortanfiles=glob.glob('*/*/*.f')+glob.glob('*/*/*/*.f') for i in fortanfiles: if "check_sa" not in i and "f2py_wrapper" not in i: if not os.path.islink(i): make += " "+i+"\\\n " incfiles=glob.glob('*/*/*.inc')+glob.glob('*/*/*/*.inc') coefdir="" for i in incfiles: if "nexternal.inc" in i: coefdir+=" -I"+i.replace("nexternal.inc"," ") file=open("makefile","w") file.write("include MG5/Source/make_opts ") if Virtlist!=[]: collierlib=options.madgraph collierlib=collierlib.replace("bin","HEPTools/collier") onelooplib=options.madgraph onelooplib=onelooplib.replace("bin","HEPTools/oneloop") file.write("\nLIBDIR = MG5/lib") file.write("\nLINKLIBS =-L$(LIBDIR) -lcts -liregi ") if (os.path.exists("MG5/lib/ninja_lib")): file.write("\nLINKLIBS += -L$(LIBDIR)/ninja_lib -lninja ") if (os.path.exists(collierlib)): file.write("\nLINKLIBS += -L%s -lcollier "%(collierlib)) if (os.path.exists(onelooplib)): file.write("\nLINKLIBS += -L%s -lavh_olo "%(onelooplib)) if (os.path.exists("MG5/lib/golem95_lib")): file.write("\nLINKLIBS += -L$(LIBDIR)/golem95_lib -lgolem") file.write("\nPROCESS= InterfaceMadGraph.f "+make+"\n\nall: \n\t @FC@ @FFLAGS@ -w -fbounds-check -ffixed-line-length-none -fPIC -fno-f2c -shared -s -o InterfaceMadGraph.so -IMG5/SubProcesses/" ) if Virtlist!=[]: if (os.path.exists("MG5/lib/golem95_include")): file.write(" -IMG5/lib/golem95_include ") if (os.path.exists("MG5/lib/ninja_include")): file.write(" -IMG5/lib/ninja_include ") incldir=options.madgraph.replace("bin","HEPTools/include") file.write(" -I%s -I./ "%incldir) # Find all .mod files also in /usr/include if golem was build there. # There can be an error message in the MadGraph output to add the golem include path to the makefiles. # Usually MadGraph finds the path if its Golem was build in an separate dictionary. # Our bootstrap script installs golem with gosam beside boost. Here MadGraph creates a link (->errormessage). # If we can find the modfiles easily the user doesn't need to change the makefiles. moddirs=finddirs('*.mod',options.includedir) for moddir in moddirs: file.write(" -I%s " % moddir) if os.path.isdir("/usr/include"): moddirs=finddirs('*.mod',"/usr/include") for moddir in moddirs: file.write(" -I%s " % moddir) if coefdir != "": file.write(coefdir) file.write(" $(PROCESS) $(LINKLIBS) ") file.close() def replacetext(filename, sourceText, replaceText): """Replace text in existing file.""" with open(filename, "r") as f: text = f.read() with open(filename, "w") as f: f.write(text.replace(sourceText, replaceText)) os.chdir(pwd) os.chdir(options.buildpath) -replacetext("MG5/Source/MODEL/lha_read.f", "ident_card.dat", os.path.join(MG_TMP,"ident_card.dat")) -replacetext("MG5/Source/MODEL/lha_read.f", "param.log", os.path.join(MG_TMP,"param.log")) + +replacetext("MG5/Source/MODEL/lha_read.f", "ident_card.dat", os.path.join(options.cacheprefix, + "MG_tmp","ident_card.dat")) +replacetext("MG5/Source/MODEL/lha_read.f", "param.log", os.path.join(options.cacheprefix, + "MG_tmp","param.log")) if Virtlist: replacetext("MG5/SubProcesses/MadLoopCommons.f", "PREFIX='./'", "PREFIX='%s'" % MG_TMP) os.system("make") if not os.path.isfile("InterfaceMadGraph.so"): print "Second trial to make MadGraph Interface. " print "Needed if new .mod files are produced by make." os.system("make") build_matchbox_tmp(pwd,options.buildpath,options.absolute_links) diff --git a/Models/Feynrules/python/ufo2herwig b/Models/Feynrules/python/ufo2herwig --- a/Models/Feynrules/python/ufo2herwig +++ b/Models/Feynrules/python/ufo2herwig @@ -1,451 +1,444 @@ #! /usr/bin/env python from __future__ import division import os, sys, pprint, argparse, re,copy from string import strip, Template # add path to the ufo conversion modules modulepath = os.path.join("@PKGLIBDIR@",'python') sys.path.append(modulepath) from ufo2peg import * # set up the option parser for command line input parser = argparse.ArgumentParser( description='Create Herwig model files from Feynrules UFO input.' ) parser.add_argument( 'ufodir', metavar='UFO_directory', help='the UFO model directory' ) parser.add_argument( '-v', '--verbose', action="store_true", help="print verbose output" ) parser.add_argument( '-n','--name', default="FRModel", help="set custom nametag for the model" ) parser.add_argument( '--ignore-skipped', action="store_true", help="ignore skipped vertices and produce output anyway" ) parser.add_argument( '--split-model', action="store_true", help="Split the model file into pieces to improve compilation for models with many parameters" ) parser.add_argument( '--no-generic-loop-vertices', action="store_true", help="Don't include the automatically generated generic loop vertices for h->gg and h->gamma gamma" ) parser.add_argument( '--include-generic', action="store_true", - help="Include support for generic spin structures (still experimental)" + help="Include support for generic spin structures" +) +parser.add_argument( + '--use-Herwig-Higgs', + action="store_true", + help="Use the internal Herwig SM modeling and vertices for Higgs interactions, there may be sign issues but some UFO models have very minimal Higgs interactions" ) parser.add_argument( '--use-generic-for-tensors', action="store_true", help="Use the generic machinery for all tensor vertices (debugging only)" ) parser.add_argument( '--forbidden-particle-name', action="append", default=["eta","phi"], help="Add particle names not allowed as names in UFO models to avoid conflicts with"+\ "Herwig internal particles, names will have _UFO appended" ) # get the arguments args = parser.parse_args() # import the model import imp path,mod = os.path.split(os.path.abspath(args.ufodir)) FR = imp.load_module(mod,*imp.find_module(mod,[path])) - ################################################## ################################################## # get the Model name from the arguments modelname = args.name libname = modelname + '.so' # define arrays and variables #allplist = "" parmdecls = [] parmgetters = [] parmconstr = [] doinit = [] paramstoreplace_ = [] paramstoreplace_expressions_ = [] # get external parameters for printing parmsubs = dict( [ (p.name, p.value) for p in FR.all_parameters if p.nature == 'external' ] ) # evaluate python cmath def evaluate(x): import cmath return eval(x, {'cmath':cmath, 'complexconjugate':FR.function_library.complexconjugate, 'im':FR.function_library.im, 're':FR.function_library.re}, parmsubs) ## get internal params into arrays internal = ( p for p in FR.all_parameters if p.nature == 'internal' ) #paramstoreplaceEW_ = [] #paramstoreplaceEW_expressions_ = [] # calculate internal parameters for p in internal: parmsubs.update( { p.name : evaluate(p.value) } ) # if 'aS' in p.value and p.name != 'aS': # paramstoreplace_.append(p.name) # paramstoreplace_expressions_.append(p.value) # if 'aEWM1' in p.value and p.name != 'aEWM1': # paramstoreplaceEW_.append(p.name) # paramstoreplaceEW_expressions_.append(p.value) parmvalues=copy.copy(parmsubs) # more arrays used for substitution in templates paramsforstream = [] parmmodelconstr = [] # loop over parameters and fill in template stuff according to internal/external and complex/real # WARNING: Complex external parameter input not tested! if args.verbose: print 'verbose mode on: printing all parameters' print '-'*60 paramsstuff = ('name', 'expression', 'default value', 'nature') pprint.pprint(paramsstuff) interfacedecl_T = """\ static Parameter<{modelname}, {type}> interface{pname} ("{pname}", "The interface for parameter {pname}", &{modelname}::{pname}_, {value}, 0, 0, false, false, Interface::nolimits); """ # sort out the couplings couplingDefns = { "QED" : 99, "QCD" : 99 } try : for coupling in FR.all_orders: name = coupling.name.upper() couplingDefns[name]= coupling.expansion_order except: for coupling in FR.all_couplings: for name,value in coupling.order.iteritems(): if(name not in couplingDefns) : couplingDefns[name]=99 # sort out the particles massnames = {} widthnames = {} for particle in FR.all_particles: # skip ghosts and goldstones if(isGhost(particle) or isGoldstone(particle)) : continue if particle.mass != 'ZERO' and particle.mass.name != 'ZERO': if(particle.mass in massnames) : if(abs(particle.pdg_code) not in massnames[particle.mass]) : massnames[particle.mass].append(abs(particle.pdg_code)) else : massnames[particle.mass] = [abs(particle.pdg_code)] if particle.width != 'ZERO' and particle.width.name != 'ZERO': if(particle.width in widthnames) : if(abs(particle.pdg_code) not in widthnames[particle.width]) : widthnames[particle.width].append(abs(particle.pdg_code)) else : widthnames[particle.width] = [abs(particle.pdg_code)] interfaceDecls = [] modelparameters = {} for p in FR.all_parameters: value = parmsubs[p.name] if p.type == 'real': assert( value.imag < 1.0e-16 ) value = value.real if p.nature == 'external': if p not in massnames and p not in widthnames: interfaceDecls.append( interfacedecl_T.format(modelname=modelname, pname=p.name, value=value, type=typemap(p.type)) ) else: interfaceDecls.append('\n// no interface for %s. Use particle definition instead.\n' % p.name) if hasattr(p,'lhablock'): lhalabel = '{lhablock}_{lhacode}'.format( lhablock=p.lhablock.upper(), lhacode='_'.join(map(str,p.lhacode)) ) if p not in massnames and p not in widthnames: parmmodelconstr.append('set %s:%s ${%s}' % (modelname, p.name, lhalabel)) else: parmmodelconstr.append('# %s is taken from the particle setup' % p.name) modelparameters[lhalabel] = value parmsubs[p.name] = lhalabel else: if p not in massnames and p not in widthnames: parmmodelconstr.append('set %s:%s %s' % (modelname, p.name, value)) else: parmmodelconstr.append('# %s is taken from the particle setup' % p.name) parmsubs[p.name] = value if p not in massnames and p not in widthnames: parmconstr.append('%s_(%s)' % (p.name, value)) else: parmconstr.append('%s_()' % p.name) else : parmconstr.append('%s_()' % p.name) parmsubs[p.name] = value elif p.type == 'complex': value = complex(value) if p.nature == 'external': -# -# TODO: WE DO NOT HAVE COMPLEX INTERFACES IN THEPEG (yet?) -# -# interfaceDecls.append( -# interfacedecl_T.format(modelname=modelname, -# pname=p.name, -# value='Complex(%s,%s)'%(value.real,value.imag), -# type=typemap(p.type)) -# ) -# -# parmmodelconstr.append('set %s:%s (%s,%s)' % (modelname, p.name, value.real, value.imag)) parmconstr.append('%s_(%s,%s)' % (p.name, value.real, value.imag)) else : parmconstr.append('%s_(%s,%s)' % (p.name, 0.,0.)) parmsubs[p.name] = value else: raise Exception('Unknown data type "%s".' % p.type) parmdecls.append(' %s %s_;' % (typemap(p.type), p.name)) parmgetters.append(' %s %s() const { return %s_; }' % (typemap(p.type),p.name, p.name)) paramsforstream.append('%s_' % p.name) expression, symbols = 'return %s_' % p.name, None if p.nature != 'external': expression, symbols = py2cpp(p.value) text = add_brackets(expression, symbols) text=text.replace('()()','()') doinit.append(' %s_ = %s;' % (p.name, text) ) if p in massnames: for idCode in massnames[p] : doinit.append(' resetMass(%s,%s_ * GeV);' % (idCode, p.name) ) if p in widthnames: for idCode in widthnames[p] : doinit.append(' getParticleData(%s)->width(%s_ * GeV);' % (idCode, p.name) ) doinit.append(' getParticleData(%s)->cTau (%s_ == 0.0 ? Length() : hbarc/(%s_*GeV));' % (idCode, p.name, p.name) ) doinit.append(' getParticleData(%s)->widthCut(10. * %s_ * GeV);' % (idCode, p.name) ) elif p.nature == 'external': if p in massnames: for idCode in massnames[p] : doinit.append(' %s_ = getParticleData(%s)->mass() / GeV;' % (p.name, idCode) ) if p in widthnames: for idCode in widthnames[p] : doinit.append(' %s_ = getParticleData(%s)->width() / GeV;' % (p.name, idCode) ) if args.verbose: pprint.pprint((p.name,p.value, value, p.nature)) pcwriter = ParamCardWriter(FR.all_parameters) paramcard_output = '\n'.join(pcwriter.output) ### special treatment # if p.name == 'aS': # expression = '0.25 * sqr(strongCoupling(q2)) / Constants::pi' # elif p.name == 'aEWM1': # expression = '4.0 * Constants::pi / sqr(electroMagneticCoupling(q2))' # elif p.name == 'Gf': # expression = 'generator()->standardModel()->fermiConstant() * GeV2' paramconstructor=': ' for ncount in range(0,len(parmconstr)) : paramconstructor += parmconstr[ncount] if(ncount != len(parmconstr) -1) : paramconstructor += ',' if(ncount%5 == 0 ) : paramconstructor += "\n" paramout="" paramin ="" for ncount in range(0,len(paramsforstream)) : if(ncount !=0 ) : paramout += "<< " + paramsforstream[ncount] paramin += ">> " + paramsforstream[ncount] else : paramout += paramsforstream[ncount] paramin += paramsforstream[ncount] if(ncount%5 == 0 ) : paramout += "\n" paramin += "\n" parmtextsubs = { 'parmgetters' : '\n'.join(parmgetters), 'parmdecls' : '\n'.join(parmdecls), 'parmconstr' : paramconstructor, 'getters' : '', 'decls' : '', 'addVertex' : '', 'doinit' : '\n'.join(doinit), 'ostream' : paramout, 'istream' : paramin , 'refs' : '', 'parmextinter': ''.join(interfaceDecls), 'ModelName': modelname, 'calcfunctions': '', 'param_card_data': paramcard_output } ################################################## ################################################## ################################################## # set up the conversion of the vertices vertexConverter = VertexConverter(FR,parmvalues,couplingDefns) vertexConverter.readArgs(args) # convert the vertices vertexConverter.convert() cdefs="" couplingOrders="" ncount=2 for name,value in couplingDefns.iteritems() : if(name=="QED") : couplingOrders+=" setCouplings(\"%s\",make_pair(%s,%s));\n" %(name,1,value) elif (name=="QCD") : couplingOrders+=" setCouplings(\"%s\",make_pair(%s,%s));\n" %(name,2,value) else : ncount+=1 cdefs +=" const T %s = %s;\n" % (name,ncount) couplingOrders+=" setCouplings(\"%s\",make_pair(%s,%s));\n" % (name,ncount,value) # coupling definitions couplingTemplate= """\ namespace ThePEG {{ namespace Helicity {{ namespace CouplingType {{ typedef unsigned T; /** * Enums for couplings */ {coup} }} }} }} """ if(cdefs!="") : cdefs = couplingTemplate.format(coup=cdefs) parmtextsubs['couplings'] = cdefs parmtextsubs['couplingOrders'] = couplingOrders # particles -plist, names = thepeg_particles(FR,parmsubs,modelname,modelparameters,args.forbidden_particle_name) +plist, names = thepeg_particles(FR,parmsubs,modelname,modelparameters,args.forbidden_particle_name,args.use_Herwig_Higgs) particlelist = [ "# insert HPConstructor:Outgoing 0 /Herwig/{n}/Particles/{p}".format(n=modelname,p=p) for p in names ] # make the first one active to have something runnable in the example .in file particlelist[0] = particlelist[0][2:] particlelist = '\n'.join(particlelist) modelfilesubs = { 'plist' : plist, 'vlist' : vertexConverter.get_vertices(libname), 'setcouplings': '\n'.join(parmmodelconstr), 'ModelName': modelname } # write the files from templates according to the above subs if vertexConverter.should_print(): MODEL_HWIN = getTemplate('LHC-FR.in') if(not args.split_model) : MODEL_CC = [getTemplate('Model.cc')] else : MODEL_EXTRA_CC=getTemplate('Model6.cc') extra_names=[] extra_calcs=[] parmtextsubs['doinit']="" for i in range(0,len(doinit)) : if( i%20 == 0 ) : function_name = "initCalc" +str(int(i/20)) parmtextsubs['doinit'] += function_name +"();\n" parmtextsubs['calcfunctions'] += "void " + function_name + "();\n" extra_names.append(function_name) extra_calcs.append("") extra_calcs[-1] += doinit[i] + "\n" for i in range(0,len(extra_names)) : ccname = '%s_extra_%s.cc' % (modelname,i) writeFile( ccname, MODEL_EXTRA_CC.substitute({'ModelName' : modelname, 'functionName' : extra_names[i], 'functionCalcs' : extra_calcs[i] }) ) MODEL_CC = [getTemplate('Model1.cc'),getTemplate('Model2.cc'),getTemplate('Model3.cc'), getTemplate('Model4.cc'),getTemplate('Model5.cc')] MODEL_H = getTemplate('Model.h') print 'LENGTH',len(MODEL_CC) MODELINFILE = getTemplate('FR.model') writeFile( 'LHC-%s.in' % modelname, MODEL_HWIN.substitute({ 'ModelName' : modelname, 'Particles' : particlelist }) ) modeltemplate = Template( MODELINFILE.substitute(modelfilesubs) ) writeFile( '%s.h' % modelname, MODEL_H.substitute(parmtextsubs) ) for i in range(0,len(MODEL_CC)) : if(len(MODEL_CC)==1) : ccname = '%s.cc' % modelname else : ccname = '%s.cc' % (modelname + str(i)) writeFile( ccname, MODEL_CC[i].substitute(parmtextsubs) ) writeFile( modelname +'.template', modeltemplate.template ) writeFile( modelname +'.model', modeltemplate.substitute( modelparameters ) ) # copy the Makefile-FR to current directory, # replace with the modelname for compilation with open(os.path.join(modulepath,'Makefile-FR'),'r') as orig: with open('Makefile','w') as dest: dest.write(orig.read().replace("FeynrulesModel.so", libname)) print 'finished generating model:\t', modelname print 'model directory:\t\t', args.ufodir print 'generated:\t\t\t', len(FR.all_vertices), 'vertices' print '='*60 print 'library:\t\t\t', libname print 'input file:\t\t\t', 'LHC-' + modelname +'.in' print 'model file:\t\t\t', modelname +'.model' print '='*60 print """\ To complete the installation, compile by typing "make". An example input file is provided as LHC-FRModel.in, you'll need to change the required particles in there. """ print 'DONE!' print '='*60 diff --git a/Models/Feynrules/python/ufo2peg/FR.model.template b/Models/Feynrules/python/ufo2peg/FR.model.template --- a/Models/Feynrules/python/ufo2peg/FR.model.template +++ b/Models/Feynrules/python/ufo2peg/FR.model.template @@ -1,91 +1,92 @@ +# -*- ThePEG-repository -*- ################################################### # # Particle Data objects # ################################################### mkdir /Herwig/${ModelName} mkdir /Herwig/${ModelName}/Particles cd /Herwig/${ModelName}/Particles create Herwig::GenericHPPVertex /Herwig/${ModelName}/V_GenericHPP create Herwig::GenericHGGVertex /Herwig/${ModelName}/V_GenericHGG ${plist} ################################################### # # Main directory and model object # ################################################### mkdir /Herwig/${ModelName} cd /Herwig/${ModelName} library ${ModelName}.so #### create Herwig::${ModelName} ${ModelName} create Herwig::${ModelName} ${ModelName} # cp /Herwig/Model ${ModelName} # SM couplings set ${ModelName}:QCD/RunningAlphaS /Herwig/Couplings/NLOAlphaS set ${ModelName}:EW/RunningAlphaEM /Herwig/Couplings/AlphaEM set ${ModelName}:EW/CKM /Herwig/CKM set ${ModelName}:RunningMass /Herwig/RunningMass ${setcouplings} ################################################### # # Vertices # ################################################### # create FR model vertices # SM vertices set ${ModelName}:Vertex/FFZ /Herwig/Vertices/FFZVertex set ${ModelName}:Vertex/FFW /Herwig/Vertices/FFWVertex set ${ModelName}:Vertex/FFH /Herwig/Vertices/FFHVertex set ${ModelName}:Vertex/FFG /Herwig/Vertices/FFGVertex set ${ModelName}:Vertex/FFP /Herwig/Vertices/FFPVertex set ${ModelName}:Vertex/GGG /Herwig/Vertices/GGGVertex set ${ModelName}:Vertex/GGGG /Herwig/Vertices/GGGGVertex set ${ModelName}:Vertex/WWH /Herwig/Vertices/WWHVertex set ${ModelName}:Vertex/WWW /Herwig/Vertices/WWWVertex set ${ModelName}:Vertex/WWWW /Herwig/Vertices/WWWWVertex set ${ModelName}:Vertex/HGG /Herwig/Vertices/HGGVertex set ${ModelName}:Vertex/HPP /Herwig/Vertices/HPPVertex ${vlist} ################################################### # # Set up spin correlation Decayers # ################################################### cd /Herwig/NewPhysics set TwoBodyDC:CreateDecayModes Yes set ThreeBodyDC:CreateDecayModes Yes set WeakDecayConstructor:CreateDecayModes Yes ################################################### # Set up the model framework ################################################### set /Herwig/${ModelName}/${ModelName}:ModelGenerator NewModel ################################################### # # Choose FR over SM # ################################################### cd /Herwig/Generators erase DefaultStrategy:DefaultParticlesDirs[0] insert DefaultStrategy:DefaultParticlesDirs[0] /Herwig/${ModelName}/Particles set EventGenerator:StandardModelParameters /Herwig/${ModelName}/${ModelName} diff --git a/Models/Feynrules/python/ufo2peg/LHC-FR.in.template b/Models/Feynrules/python/ufo2peg/LHC-FR.in.template --- a/Models/Feynrules/python/ufo2peg/LHC-FR.in.template +++ b/Models/Feynrules/python/ufo2peg/LHC-FR.in.template @@ -1,92 +1,94 @@ +# -*- ThePEG-repository -*- + read snippets/PPCollider.in read ${ModelName}.model cd /Herwig/NewPhysics #################################### # # Modify the required process here # #################################### insert HPConstructor:Incoming 0 /Herwig/Particles/d insert HPConstructor:Incoming 0 /Herwig/Particles/dbar insert HPConstructor:Incoming 0 /Herwig/Particles/u insert HPConstructor:Incoming 0 /Herwig/Particles/ubar insert HPConstructor:Incoming 0 /Herwig/Particles/s insert HPConstructor:Incoming 0 /Herwig/Particles/sbar insert HPConstructor:Incoming 0 /Herwig/Particles/c insert HPConstructor:Incoming 0 /Herwig/Particles/cbar insert HPConstructor:Incoming 0 /Herwig/Particles/b insert HPConstructor:Incoming 0 /Herwig/Particles/bbar insert HPConstructor:Incoming 0 /Herwig/Particles/g ${Particles} set HPConstructor:Processes SingleParticleInclusive ############################################################# ## Additionally, you can use new particles as intermediates ## with the ResConstructor: ############################################################# # insert ResConstructor:Incoming 0 /Herwig/Particles/d # insert ResConstructor:Incoming 0 /Herwig/Particles/dbar # insert ResConstructor:Incoming 0 /Herwig/Particles/u # insert ResConstructor:Incoming 0 /Herwig/Particles/ubar # insert ResConstructor:Incoming 0 /Herwig/Particles/s # insert ResConstructor:Incoming 0 /Herwig/Particles/sbar # insert ResConstructor:Incoming 0 /Herwig/Particles/c # insert ResConstructor:Incoming 0 /Herwig/Particles/cbar # insert ResConstructor:Incoming 0 /Herwig/Particles/b # insert ResConstructor:Incoming 0 /Herwig/Particles/bbar # insert ResConstructor:Incoming 0 /Herwig/Particles/g # # insert ResConstructor:Intermediates 0 [PARTICLE_NAME] # # insert ResConstructor:Outgoing 0 /Herwig/Particles/e+ # insert ResConstructor:Outgoing 1 /Herwig/Particles/W+ # insert ResConstructor:Outgoing 2 /Herwig/Particles/Z0 # insert ResConstructor:Outgoing 3 /Herwig/Particles/gamma ########################################################### # Specialized 2->3 higgs constructors are also available, # where incoming lines don't need to be set. ########################################################### ## Higgs + t tbar # set /Herwig/NewPhysics/QQHiggsConstructor:QuarkType Top # insert /Herwig/NewPhysics/QQHiggsConstructor:HiggsBoson 0 [HIGGS_NAME] # ## Higgs VBF # insert /Herwig/NewPhysics/HiggsVBFConstructor:HiggsBoson 0 [HIGGS_NAME] # ## Higgs + W/Z, with full 2->3 ME # set /Herwig/NewPhysics/HVConstructor:CollisionType Hadron # insert /Herwig/NewPhysics/HVConstructor:VectorBoson 0 /Herwig/Particles/Z0 # insert /Herwig/NewPhysics/HVConstructor:HiggsBoson 0 [HIGGS_NAME] #################################### #################################### #################################### # Intrinsic pT tune extrapolated to LHC energy set /Herwig/Shower/ShowerHandler:IntrinsicPtGaussian 2.2*GeV # disable default cuts if required # cd /Herwig/EventHandlers # create ThePEG::Cuts /Herwig/Cuts/NoCuts # set EventHandler:Cuts /Herwig/Cuts/NoCuts # Other parameters for run cd /Herwig/Generators set EventGenerator:EventHandler:LuminosityFunction:Energy 13000.0 set EventGenerator:NumberOfEvents 10000000 set EventGenerator:RandomNumberGenerator:Seed 31122001 set EventGenerator:DebugLevel 0 set EventGenerator:EventHandler:StatLevel Full set EventGenerator:PrintEvent 100 set EventGenerator:MaxErrors 10000 saverun LHC-${ModelName} EventGenerator diff --git a/Models/Feynrules/python/ufo2peg/particles.py b/Models/Feynrules/python/ufo2peg/particles.py --- a/Models/Feynrules/python/ufo2peg/particles.py +++ b/Models/Feynrules/python/ufo2peg/particles.py @@ -1,243 +1,243 @@ from string import Template # ignore these, they're in Hw++ already # TODO reset Hw++ settings instead SMPARTICLES = { 1:'d', 2:'u', 3:'s', 4:'c', 5:'b', 6:'t', # think about this one later 11:'e-', 12:'nu_e', 13:'mu-', 14:'nu_mu', 15:'tau-', 16:'nu_tau', 21:'g', 22:'gamma', 23:'Z0', 24:'W+', -1:'dbar', -2:'ubar', -3:'sbar', -4:'cbar', -5:'bbar', -6:'tbar', -11:'e+', -12:'nu_ebar', -13:'mu+', -14:'nu_mubar', -15:'tau+', -16:'nu_taubar', -24:'W-', } particleT = Template( """ create ThePEG::ParticleData $name # values set to 999999 are recalculated later from other model parameters setup $name $pdg_code $name $mass $width $wcut $ctau $charge $color $spin 0 """ ) class ParticleConverter: 'Convert a FR particle to extract the information ThePEG needs.' def __init__(self,p,parmsubs,modelparameters): self.name = p.name self.pdg_code = p.pdg_code self.spin = p.spin self.color = p.color if self.color == 1: self.color = 0 self.selfconjugate = 0 self.mass = parmsubs[str(p.mass)] if type(self.mass) == str: value = modelparameters[self.mass] try: value = value.real except: pass newname = '%s_ABS' % self.mass self.mass = '${%s}' % newname modelparameters[newname] = abs(value) else: try: self.mass = self.mass.real except: pass self.mass = 999999. # abs(self.mass) hbarc = 197.3269631e-15 # GeV mm (I hope ;-) ) self.width = parmsubs[str(p.width)] if type(self.width) == str: width = modelparameters[self.width] ctau = (hbarc / width) if width != 0 else 0 newname = '%s_CTAU' % self.width self.ctau = '${%s}' % newname modelparameters[newname] = ctau wcut = 10 * width newname = '%s_WCUT' % self.width self.wcut = '${%s}' % newname modelparameters[newname] = wcut self.width = '${%s}' % self.width else: self.ctau = 999999. # (hbarc / self.width) if self.width != 0 else 0 self.wcut = 999999. #10.0 * self.width self.width = 999999. # was blank line before self.charge = int(3 * p.charge) def subs(self): return self.__dict__ def check_effective_vertex(FR,p,ig) : for vertex in FR.all_vertices: if(len(vertex.particles) != 3) : continue if(p not in vertex.particles ) : continue ng=0 for part in vertex.particles : if(part.pdg_code==ig) : ng+=1 if(ng==2) : return False return True -def thepeg_particles(FR,parameters,modelname,modelparameters,forbidden_names): +def thepeg_particles(FR,parameters,modelname,modelparameters,forbidden_names,hw_higgs): plist = [] antis = {} names = [] splittings = [] done_splitting_QCD=[] done_splitting_QED=[] for p in FR.all_particles: if p.spin == -1: continue gsnames = ['goldstone', 'goldstoneboson', 'GoldstoneBoson'] def gstest(name): try: return getattr(p,name) except AttributeError: return False if any(map(gstest, gsnames)): continue if p.pdg_code in SMPARTICLES: continue - if p.pdg_code == 25: + if p.pdg_code == 25 and not hw_higgs: plist.append( """ set /Herwig/Particles/h0:Mass_generator NULL set /Herwig/Particles/h0:Width_generator NULL rm /Herwig/Masses/HiggsMass rm /Herwig/Widths/hWidth """ ) if p.name in forbidden_names: print 'RENAMING PARTICLE',p.name,'as ',p.name+'_UFO' p.name +="_UFO" - subs = ParticleConverter(p,parameters,modelparameters).subs() - plist.append( particleT.substitute(subs) ) + if not (p.pdg_code == 25 and hw_higgs) : + plist.append( particleT.substitute(subs) ) pdg, name = subs['pdg_code'], subs['name'] names.append(name) if -pdg in antis: plist.append( 'makeanti %s %s\n' % (antis[-pdg], name) ) - else: + elif not (p.pdg_code == 25 and hw_higgs) : plist.append( 'insert /Herwig/NewPhysics/NewModel:DecayParticles 0 %s\n' % name ) plist.append( 'insert /Herwig/Shower/ShowerHandler:DecayInShower 0 %s # %s' % (abs(pdg), name) ) antis[pdg] = name selfconjugate = 1 class SkipMe(Exception): pass def spin_name(s): spins = { 1 : 'Zero', 2 : 'Half', 3 : 'One' } if s not in spins: raise SkipMe() else: return spins[s] def col_name(c): cols = { 3 : 'Triplet', 6 : 'Sextet', 8 : 'Octet' } return cols[c] try: # QCD splitting functions if p.color in [3,6,8] and abs(pdg) not in done_splitting_QCD: # which colors? done_splitting_QCD.append(abs(pdg)) splitname = '{name}SplitFnQCD'.format(name=p.name) sudname = '{name}SudakovQCD'.format(name=p.name) splittings.append( """ create Herwig::{s}{s}OneSplitFn {name} set {name}:InteractionType QCD set {name}:ColourStructure {c}{c}Octet cp /Herwig/Shower/SudakovCommon {sudname} set {sudname}:SplittingFunction {name} do /Herwig/Shower/SplittingGenerator:AddFinalSplitting {pname}->{pname},g; {sudname} """.format(s=spin_name(p.spin), name=splitname, c=col_name(p.color), pname=p.name, sudname=sudname) ) except SkipMe: pass # QED splitting functions try: if p.charge != 0 and abs(pdg) not in done_splitting_QED: done_splitting_QED.append(abs(pdg)) splitname = '{name}SplitFnQED'.format(name=p.name) sudname = '{name}SudakovQED'.format(name=p.name) splittings.append( """ create Herwig::{s}{s}OneSplitFn {name} set {name}:InteractionType QED set {name}:ColourStructure ChargedChargedNeutral cp /Herwig/Shower/SudakovCommon {sudname} set {sudname}:SplittingFunction {name} set {sudname}:Alpha /Herwig/Shower/AlphaQED do /Herwig/Shower/SplittingGenerator:AddFinalSplitting {pname}->{pname},gamma; {sudname} """.format(s=spin_name(p.spin), name=splitname, pname=p.name, sudname=sudname) ) except SkipMe: pass - if p.charge == 0 and p.color == 1 and p.spin == 1: + if p.charge == 0 and p.color == 1 and p.spin == 1 and not (p.pdg_code == 25 and hw_higgs) : if(check_effective_vertex(FR,p,21)) : plist.append( """ insert /Herwig/{ModelName}/V_GenericHGG:Bosons 0 {pname} """.format(pname=p.name, ModelName=modelname) ) if(check_effective_vertex(FR,p,22)) : plist.append( """ insert /Herwig/{ModelName}/V_GenericHPP:Bosons 0 {pname} """.format(pname=p.name, ModelName=modelname) ) return ''.join(plist)+''.join(splittings), names diff --git a/Models/Feynrules/python/ufo2peg/vertices.py b/Models/Feynrules/python/ufo2peg/vertices.py --- a/Models/Feynrules/python/ufo2peg/vertices.py +++ b/Models/Feynrules/python/ufo2peg/vertices.py @@ -1,858 +1,894 @@ import sys,pprint from .helpers import CheckUnique,getTemplate,writeFile,coupling_orders,def_from_model from .converter import py2cpp from .collapse_vertices import collapse_vertices from .check_lorentz import tensorCouplings,VVVordering,lorentzScalar,\ processTensorCouplings,scalarCouplings,processScalarCouplings,scalarVectorCouplings,\ processScalarVectorCouplings,vectorCouplings,processVectorCouplings,fermionCouplings,processFermionCouplings,\ RSCouplings from .general_lorentz import convertLorentz,generateEvaluateFunction,multipleEvaluate from .helpers import SkipThisVertex,extractAntiSymmetricIndices,isGoldstone # prefactors for vertices lfactors = { 'FFV' : '-complex(0,1)', # ok 'VVV' : 'complex(0,1)', # changed to fix ttbar 'VVVS' : 'complex(0,1)', # should be as VVV 'VVVV' : 'complex(0,1)', 'VVS' : '-complex(0,1)', 'VSS' : '-complex(0,1)', # changed to minus to fix dL ->x1 W- d 'SSS' : '-complex(0,1)', # ok 'VVSS' : '-complex(0,1)', # ok 'VVT' : 'complex(0,2)', 'VVVT' : '-complex(0,2)', 'SSSS' : '-complex(0,1)', # ok 'FFS' : '-complex(0,1)', # ok 'SST' : 'complex(0,2)', 'FFT' : '-complex(0,8)', 'FFVT' : '-complex(0,4)', 'RFS' : 'complex(0,1)', 'RFV' : 'complex(0,1)', } genericVertices=['FFFF','FFVV','FFSS','FFVS','VVVV','VVVT','FFVT', 'RFVV','RFVS','RFSS','SSST','VVST','FFST'] skipped5Point=False # template for the header for a vertex VERTEXHEADER = """\ #include "ThePEG/Helicity/Vertex/{spindirectory}/{lorentztag}Vertex.h" """ GENERALVERTEXHEADER = """\ #include "ThePEG/Helicity/Vertex/Abstract{lorentztag}Vertex.h" """ # template for the implmentation for a vertex VERTEXCLASS = getTemplate('Vertex_class') GENERALVERTEXCLASS = getTemplate('GeneralVertex_class') # template for the .cc file for vertices VERTEX = getTemplate('Vertex.cc') vertexline = """\ create Herwig::FRModel{classname} /Herwig/{modelname}/{classname} insert {modelname}:ExtraVertices 0 /Herwig/{modelname}/{classname} """ def get_lorentztag(spin): """Produce a ThePEG spin tag for the given numeric FR spins.""" spins = { 1 : 'S', 2 : 'F', 3 : 'V', 4 : 'R', 5 : 'T', -1 : 'U' } result=[] for i in range(0,len(spin)) : result.append((spins[spin[i]],i+1)) def spinsort(a,b): """Helper function for ThePEG's FVST spin tag ordering.""" (a1,a2) = a (b1,b2) = b if a1 == b1: return 0 for letter in 'URFVST': if a1 == letter: return -1 if b1 == letter: return 1 result = sorted(result, cmp=spinsort) order=[] output="" for i in range(0,len(result)) : (a,b) = result[i] order.append(b) output+=a return (output,order) def unique_lorentztag(vertex): """Check and return the Lorentz tag of the vertex.""" unique = CheckUnique() for l in vertex.lorentz: (lorentztag,order) = get_lorentztag(l.spins) unique( lorentztag ) lname = l.name[:len(lorentztag)] if sorted(lorentztag) != sorted(lname): raise Exception("Lorentztags: %s is not %s in %s" % (lorentztag,lname,vertex)) return (lorentztag,order) def colors(vertex) : try: unique = CheckUnique() for pl in vertex.particles_list: struct = [ p.color for p in pl ] unique(struct) except: struct = [ p.color for p in vertex.particles ] pos = colorpositions(struct) L = len(struct) return (L,pos) def coloursort(a,b) : if a == b: return 0 i1=int(a[4]) i2=int(b[4]) if(i1==i2) : return 0 elif(i1id()=={id1} && p2->id()=={id3} && p3->id()=={id2}) || (p1->id()=={id2} && p2->id()=={id1} && p3->id()=={id3}) || (p1->id()=={id3} && p2->id()=={id2} && p3->id()=={id1})) {{ sign *= -1.; }} norm(norm()*sign); """ if(not "p1" in couplingptrs[0]) : couplingptrs[0] += ' p1' if(not "p2" in couplingptrs[1]) : couplingptrs[1] += ' p2' if(not "p3" in couplingptrs[2]) : couplingptrs[2] += ' p3' if("Bar" not in vertex.color[0]) : order,sign = extractAntiSymmetricIndices(vertex.color[0],"Epsilon(") else : order,sign = extractAntiSymmetricIndices(vertex.color[0],"EpsilonBar(") subs = {"id1" : vertex.particles[int(order[0])-1].pdg_code, "id2" : vertex.particles[int(order[1])-1].pdg_code, "id3" : vertex.particles[int(order[2])-1].pdg_code, "epssign" : sign } append+=EPSSIGN.format(**subs) return couplingptrs,append class VertexConverter: 'Convert the vertices in a FR model to extract the information ThePEG needs.' def __init__(self,model,parmsubs,defns) : 'Initialize the parameters' self.verbose=False self.vertex_skipped=False self.ignore_skipped=False self.model=model self.all_vertices= [] self.vertex_names = {} self.modelname="" self.no_generic_loop_vertices = False self.parmsubs = parmsubs self.couplingDefns = defns self.genericTensors = False + self.hw_higgs = False def readArgs(self,args) : 'Extract the relevant command line arguments' self.ignore_skipped = args.ignore_skipped self.verbose = args.verbose self.modelname = args.name self.no_generic_loop_vertices = args.no_generic_loop_vertices self.include_generic = args.include_generic self.genericTensors = args.use_generic_for_tensors + self.hw_higgs = args.use_Herwig_Higgs def should_print(self) : 'Check if we should output the results' return not self.vertex_skipped or self.ignore_skipped def convert(self) : 'Convert the vertices' if(self.verbose) : print 'verbose mode on: printing all vertices' print '-'*60 labels = ('vertex', 'particles', 'Lorentz', 'C_L', 'C_R', 'norm') pprint.pprint(labels) # extract the vertices self.all_vertices = self.model.all_vertices + # find the SM Higgs boson + higgs=None + if(self.hw_higgs) : + for part in self.model.all_particles: + if(part.pdg_code==25) : + higgs=part + break # convert the vertices vertexclasses, vertexheaders = [], set() ifile=1 icount=0 for vertexnumber,vertex in enumerate(self.all_vertices,1) : # process the vertex (skip,vertexClass,vertexHeader) = \ self.processVertex(vertexnumber,vertex) # check it can be handled if(skip) : continue + # check if Higgs and skip if using Hw higgs sector + if higgs in vertex.particles : + nH = vertex.particles.count(higgs) + # skip trilinear and quartic higgs vertices + if ( nH == len(vertex.particles) ) : + vertex.herwig_skip_vertex = True + continue + elif (len(vertex.particles)-nH==2) : + p=[] + for part in vertex.particles : + if(part!=higgs) : p.append(part) + if(nH==1 and p[0].pdg_code==-p[1].pdg_code and + abs(p[0].pdg_code) in [1,2,3,4,5,6,11,13,15,24]) : + vertex.herwig_skip_vertex = True + continue + elif((nH==1 or nH==2) and p[0].pdg_code==p[1].pdg_code and + p[0].pdg_code ==23) : + vertex.herwig_skip_vertex = True + continue + elif(nH==2 and p[0].pdg_code==-p[1].pdg_code and + abs(p[0].pdg_code)==24) : + vertex.herwig_skip_vertex = True + continue # add to the list icount +=1 vertexclasses.append(vertexClass) vertexheaders.add(vertexHeader) WRAP = 25 if icount % WRAP == 0 or vertexHeader.find("Abstract")>=0: write_vertex_file({'vertexnumber' : ifile, 'vertexclasses' : '\n'.join(vertexclasses), 'vertexheaders' : ''.join(vertexheaders), 'ModelName' : self.modelname}) vertexclasses = [] vertexheaders = set() icount=0 ifile+=1 # exit if there's vertices we can't handle if not self.should_print(): sys.stderr.write( """ Error: The conversion was unsuccessful, some vertices could not be -generated. If you think the missing vertices are not important +generated. The new --include-generic option should be able to generate +these. Otherwise, if you think the missing vertices are not important and want to go ahead anyway, use --ignore-skipped. Herwig may not give correct results, though. """ ) sys.exit(1) # if still stuff to output it do it if vertexclasses: write_vertex_file({'vertexnumber' : ifile + 1, 'vertexclasses' : '\n'.join(vertexclasses), 'vertexheaders' : ''.join(vertexheaders), 'ModelName' : self.modelname}) print '='*60 def setCouplingPtrs(self,lorentztag,qcd,append,prepend) : couplingptrs = [',tcPDPtr']*len(lorentztag) if lorentztag == 'VSS': couplingptrs[1] += ' p2' elif lorentztag == 'FFV': couplingptrs[0] += ' p1' elif (lorentztag == 'VVV' or lorentztag == 'VVVS' or lorentztag == "SSS" or lorentztag == "VVVT" ) \ and (append or prepend ) : couplingptrs[0] += ' p1' couplingptrs[1] += ' p2' couplingptrs[2] += ' p3' elif (lorentztag == 'VVVV' and (qcd < 2 or append)) or\ (lorentztag == "SSSS" and prepend ): couplingptrs[0] += ' p1' couplingptrs[1] += ' p2' couplingptrs[2] += ' p3' couplingptrs[3] += ' p4' return couplingptrs def processVertex(self,vertexnumber,vertex) : global skipped5Point # get the Lorentz tag for the vertex lorentztag,order = unique_lorentztag(vertex) # check if we should skip the vertex vertex.herwig_skip_vertex = checkGhostGoldstoneVertex(lorentztag,vertex) # check the order of the vertex and skip 5 points if(len(lorentztag)>=5) : vertex.herwig_skip_vertex = True if(not skipped5Point) : skipped5Point = True print "Skipping 5 point vertices which aren\'t used in Herwig7" if(vertex.herwig_skip_vertex) : return (True,"","") # check if we support this at all if( lorentztag not in lfactors and lorentztag not in genericVertices) : msg = 'Warning: Lorentz structure {tag} ( {ps} ) in {name} ' \ 'is not supported.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") # get the factor for the vertex generic = False try: lf = lfactors[lorentztag] if( self.genericTensors and "T" in lorentztag) : raise KeyError() except KeyError: if(not self.include_generic) : msg = 'Warning: Lorentz structure {tag} ( {ps} ) in {name} ' \ 'is not supported.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") else : lf=1. generic=True # get the ids of the particles at the vertex plistarray = [ ','.join([ str(vertex.particles[o-1].pdg_code) for o in order ]) ] # parse the colour structure for the vertex try: L,pos = colors(vertex) cs,cf = colorfactor(vertex,L,pos,lorentztag) except SkipThisVertex: msg = 'Warning: Color structure for vertex ( {ps} ) in {name} ' \ 'is not supported.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") ### classname classname = 'V_%s' % vertex.name if(not generic) : try : return self.extractGeneric(vertex,order,lorentztag,classname,plistarray,pos,lf,cf,cs) except SkipThisVertex: if(not self.include_generic) : msg = 'Warning: Lorentz structure {tag} ( {ps} ) in {name} ' \ 'is not supported, may have a non-perturbative form.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") else : try : return self.extractGeneral(vertex,order,lorentztag,classname,plistarray,pos,cf,cs) except SkipThisVertex: msg = 'Warning: Lorentz structure {tag} ( {ps} ) in {name} ' \ 'is not supported, may have a non-perturbative form.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") else : try : return self.extractGeneral(vertex,order,lorentztag,classname,plistarray,pos,cf,cs) except SkipThisVertex: msg = 'Warning: Lorentz structure {tag} ( {ps} ) in {name} ' \ 'is not supported, may have a non-perturbative form.\n'.format(tag=lorentztag, name=vertex.name, ps=' '.join(map(str,vertex.particles))) sys.stderr.write(msg) vertex.herwig_skip_vertex = True self.vertex_skipped=True return (True,"","") def extractGeneric(self,vertex,order,lorentztag,classname,plistarray,pos,lf,cf,cs) : classes="" headers="" # identify the maximum colour flow and orders of the couplings maxColour=0 couplingOrders=[] self.vertex_names[vertex.name] = [classname] for (color_idx,lorentz_idx),coupling in vertex.couplings.iteritems(): maxColour=max(maxColour,color_idx) orders = coupling_orders(vertex, coupling, self.couplingDefns) if(orders not in couplingOrders) : couplingOrders.append(orders) # loop the order of the couplings iorder = 0 for corder in couplingOrders : iorder +=1 cname=classname if(iorder!=1) : cname= "%s_%s" % (classname,iorder) self.vertex_names[vertex.name].append(cname) header = "" prepend="" append="" all_couplings=[] for ix in range(0,maxColour+1) : all_couplings.append([]) # loop over the colour structures for colour in range(0,maxColour+1) : for (color_idx,lorentz_idx),coupling in vertex.couplings.iteritems() : # check colour structure and coupling order if(color_idx!=colour) : continue if(coupling_orders(vertex, coupling, self.couplingDefns)!=corder) : continue # get the prefactor for the lorentz structure L = vertex.lorentz[lorentz_idx] prefactors = calculatePrefactor(lf,cf[color_idx]) # calculate the value of the coupling value = couplingValue(coupling) # handling of the different types of couplings if lorentztag in ['FFS','FFV']: all_couplings[color_idx] = fermionCouplings(value,prefactors,L,all_couplings[color_idx],order) elif 'T' in lorentztag : append, all_couplings[color_idx] = tensorCouplings(vertex,value,prefactors,L,lorentztag,pos, all_couplings[color_idx],order) elif 'R' in lorentztag : all_couplings[color_idx] = RSCouplings(value,prefactors,L,all_couplings[color_idx],order) elif lorentztag == 'VVS' or lorentztag == "VVSS" or lorentztag == "VSS" : all_couplings[color_idx] = scalarVectorCouplings(value,prefactors,L,lorentztag, all_couplings[color_idx],order) elif lorentztag == "SSS" or lorentztag == "SSSS" : prepend, header, all_couplings[color_idx] = scalarCouplings(vertex,value,prefactors,L,lorentztag, all_couplings[color_idx],prepend,header) elif "VVV" in lorentztag : all_couplings[color_idx],append = vectorCouplings(vertex,value,prefactors,L,lorentztag,pos, all_couplings[color_idx],append,corder["QCD"],order) else: raise SkipThisVertex() # final processing of the couplings symbols = set() if(lorentztag in ['FFS','FFV']) : (normcontent,leftcontent,rightcontent,append) = processFermionCouplings(lorentztag,vertex, self.model,self.parmsubs, all_couplings,order) elif('T' in lorentztag) : (leftcontent,rightcontent,normcontent) = processTensorCouplings(lorentztag,vertex,self.model, self.parmsubs,all_couplings,order) elif(lorentztag=="SSS" or lorentztag=="SSSS") : normcontent = processScalarCouplings(self.model,self.parmsubs,all_couplings) elif(lorentztag=="VVS" or lorentztag =="VVSS" or lorentztag=="VSS") : normcontent,append,lorentztag,header,sym = processScalarVectorCouplings(lorentztag,vertex, self.model,self.parmsubs, all_couplings,header,order) symbols |=sym elif("VVV" in lorentztag) : normcontent,append,header =\ processVectorCouplings(lorentztag,vertex,self.model,self.parmsubs,all_couplings,append,header) else : SkipThisVertex() # set the coupling ptrs in the setCoupling call couplingptrs = self.setCouplingPtrs(lorentztag.replace("General",""), corder["QCD"],append != '',prepend != '') ### do we need left/right? if 'FF' in lorentztag and lorentztag != "FFT": #leftcalc = aStoStrongCoup(py2cpp(leftcontent)[0], paramstoreplace_, paramstoreplace_expressions_) #rightcalc = aStoStrongCoup(py2cpp(rightcontent)[0], paramstoreplace_, paramstoreplace_expressions_) leftcalc, sym = py2cpp(leftcontent) symbols |= sym rightcalc, sym = py2cpp(rightcontent) symbols |= sym left = 'left(' + leftcalc + ');' right = 'right(' + rightcalc + ');' else: left = '' right = '' leftcalc = '' rightcalc = '' #normcalc = aStoStrongCoup(py2cpp(normcontent)[0], paramstoreplace_, paramstoreplace_expressions_) normcalc, sym = py2cpp(normcontent) symbols |= sym # UFO is GeV by default if lorentztag in ['VVS','SSS']: normcalc = 'Complex((%s) * GeV / UnitRemoval::E)' % normcalc elif lorentztag in ['GeneralVVS']: normcalc = 'Complex(-(%s) * UnitRemoval::E / GeV )' % normcalc elif lorentztag in ['FFT','VVT', 'SST', 'FFVT', 'VVVT' , 'VVVS' ]: normcalc = 'Complex((%s) / GeV * UnitRemoval::E)' % normcalc norm = 'norm(' + normcalc + ');' # finally special handling for eps tensors if(len(vertex.color)==1 and vertex.color[0].find("Epsilon")>=0) : couplingptrs, append = epsilonSign(vertex,couplingptrs,append) # define unkown symbols from the model symboldefs = [ def_from_model(self.model,s) for s in symbols ] couplingOrder="" for coupName,coupVal in corder.iteritems() : couplingOrder+=" orderInCoupling(CouplingType::%s,%s);\n" %(coupName,coupVal) ### assemble dictionary and fill template subs = { 'lorentztag' : lorentztag, # ok 'classname' : cname, # ok 'symbolrefs' : '\n '.join(symboldefs), 'left' : left, # doesn't always exist in base 'right' : right, # doesn't always exist in base 'norm' : norm, # needs norm, too 'addToPlist' : '\n'.join([ 'addToList(%s);'%s for s in plistarray]), 'parameters' : '', 'couplingOrders' : couplingOrder, 'colourStructure' : cs, 'couplingptrs' : ''.join(couplingptrs), 'spindirectory' : spindirectory(lorentztag), 'ModelName' : self.modelname, 'prepend' : prepend, 'append' : append, 'header' : header } # ok # print info if required if self.verbose: print '-'*60 pprint.pprint(( classname, plistarray, leftcalc, rightcalc, normcalc )) headers+=VERTEXHEADER.format(**subs) classes+=VERTEXCLASS.substitute(subs) return (False,classes,headers) def extractGeneral(self,vertex,order,lorentztag,classname,plistarray,pos,cf,cs) : eps=False classes="" headers="" # check the colour flows, three cases supported either 1 flow or 3 in gggg # or multiple wierd ones in FFFF cidx=-1 gluon4point = (len(pos[8])==4 and vertex.lorentz[0].spins.count(3)==4) FFFF = (len(pos[3])==2 and len(pos[-3])==2 and vertex.lorentz[0].spins.count(2)==4) couplingOrders=[] colours={} for (color_idx,lorentz_idx),coupling in vertex.couplings.iteritems() : orders = coupling_orders(vertex, coupling, self.couplingDefns) if(orders not in couplingOrders) : couplingOrders.append(orders) if(gluon4point) : color = vertex.color[color_idx] f = color.split("*") (o1,s1) = extractAntiSymmetricIndices(f[0],"f(") (o2,s2) = extractAntiSymmetricIndices(f[1],"f(") if(o2[0]1 and i!=2) : mult[i] = [] for i in range(0,imax) : (evalHeader,evalCC) = generateEvaluateFunction(self.model,vertex,i,values,defns[i],vertexEval[i],cfactor,order) if(i!=0 and spins[i-1] in mult) : if(len(mult[spins[i-1]])==0) : mult[spins[i-1]].append(evalHeader) evalHeader=evalHeader.replace("evaluate(","evaluate%s(" % i) evalCC =evalCC .replace("evaluate(","evaluate%s(" % i) mult[spins[i-1]].append(evalHeader) header+=" "+evalHeader+";\n" impls+=evalCC # combine the multiple defn if needed for (key,val) in mult.iteritems() : (evalHeader,evalCC) = multipleEvaluate(vertex,key,val) if(evalHeader!="") : header += " "+evalHeader+";\n" if(evalCC!="") : impls += evalCC impls=impls.replace("evaluate", "FRModel%s::evaluate" % cname) couplingOrder="" for coupName,coupVal in corder.iteritems() : couplingOrder+=" orderInCoupling(CouplingType::%s,%s);\n" %(coupName,coupVal) ### assemble dictionary and fill template subs = { 'lorentztag' : lorentztag, 'classname' : cname, 'addToPlist' : '\n'.join([ 'addToList(%s);'%s for s in plistarray]), 'ModelName' : self.modelname, 'couplingOrders' : couplingOrder, 'colourStructure' : cstruct, 'evaldefs' : header, 'evalimpls' : impls} newHeader = GENERALVERTEXHEADER.format(**subs) if(eps) : newHeader +="#include \"ThePEG/Helicity/epsilon.h\"\n" headers+=newHeader classes+=GENERALVERTEXCLASS.substitute(subs) return (False,classes,headers) def get_vertices(self,libname): vlist = ['library %s\n' % libname] for v in self.all_vertices: if v.herwig_skip_vertex: continue for name in self.vertex_names[v.name] : vlist.append( vertexline.format(modelname=self.modelname, classname=name) ) - if( not self.no_generic_loop_vertices) : + + if( not self.no_generic_loop_vertices and not self.hw_higgs ) : vlist.append('insert {modelname}:ExtraVertices 0 /Herwig/{modelname}/V_GenericHPP\n'.format(modelname=self.modelname) ) vlist.append('insert {modelname}:ExtraVertices 0 /Herwig/{modelname}/V_GenericHGG\n'.format(modelname=self.modelname) ) + # add Hw higgs vertices if required + if(self.hw_higgs) : + for vertex in ["FFH","HGG","HHH","HPP","HZP","WWHH","WWH"]: + vlist.append('insert %s:ExtraVertices 0 /Herwig/Vertices/%sVertex\n' % (self.modelname,vertex) ) return ''.join(vlist) - - diff --git a/PDF/HwRemDecayer.cc b/PDF/HwRemDecayer.cc --- a/PDF/HwRemDecayer.cc +++ b/PDF/HwRemDecayer.cc @@ -1,1974 +1,1973 @@ // -*- C++ -*- // // HwRemDecayer.cc is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2017 The Herwig Collaboration // // Herwig is licenced under version 3 of the GPL, see COPYING for details. // Please respect the MCnet academic guidelines, see GUIDELINES for details. // // // This is the implementation of the non-inlined, non-templated member // functions of the HwRemDecayer class. // #include "HwRemDecayer.h" #include "ThePEG/Utilities/DescribeClass.h" #include "ThePEG/Interface/ClassDocumentation.h" #include "ThePEG/Persistency/PersistentOStream.h" #include "ThePEG/Persistency/PersistentIStream.h" #include "ThePEG/Interface/Reference.h" #include "ThePEG/Interface/Parameter.h" #include "ThePEG/Interface/Switch.h" #include "ThePEG/Utilities/UtilityBase.h" #include "ThePEG/Utilities/SimplePhaseSpace.h" #include "ThePEG/Utilities/Throw.h" #include "Herwig/Shower/ShowerHandler.h" using namespace Herwig; namespace{ const bool dbg = false; void reShuffle(Lorentz5Momentum &p1, Lorentz5Momentum &p2, Energy m1, Energy m2){ Lorentz5Momentum ptotal(p1+p2); ptotal.rescaleMass(); if( ptotal.m() < m1+m2 ) { if(dbg) cerr << "Not enough energy to perform reshuffling \n"; throw HwRemDecayer::ExtraSoftScatterVeto(); } Boost boostv = -ptotal.boostVector(); ptotal.boost(boostv); p1.boost(boostv); // set the masses and energies, p1.setMass(m1); p1.setE(0.5/ptotal.m()*(ptotal.m2()+sqr(m1)-sqr(m2))); p1.rescaleRho(); // boost back to the lab p1.boost(-boostv); p2.boost(boostv); // set the masses and energies, p2.setMass(m2); p2.setE(0.5/ptotal.m()*(ptotal.m2()+sqr(m2)-sqr(m1))); p2.rescaleRho(); // boost back to the lab p2.boost(-boostv); } } void HwRemDecayer::initialize(pair rems, tPPair beam, Step & step, Energy forcedSplitScale) { // the step thestep = &step; // valence content of the hadrons theContent.first = getHadronContent(beam.first); theContent.second = getHadronContent(beam.second); // momentum extracted from the hadrons theUsed.first = Lorentz5Momentum(); theUsed.second = Lorentz5Momentum(); theMaps.first.clear(); theMaps.second.clear(); theX.first = 0.0; theX.second = 0.0; theRems = rems; _forcedSplitScale = forcedSplitScale; // check remnants attached to the right hadrons if( (theRems.first && parent(theRems.first ) != beam.first ) || (theRems.second && parent(theRems.second) != beam.second) ) throw Exception() << "Remnant order wrong in " << "HwRemDecayer::initialize(...)" << Exception::runerror; return; } void HwRemDecayer::split(tPPtr parton, HadronContent & content, tRemPPtr rem, Lorentz5Momentum & used, PartnerMap &partners, tcPDFPtr pdf, bool first) { theBeam = parent(rem); theBeamData = dynamic_ptr_cast::const_pointer> (theBeam->dataPtr()); double currentx = parton->momentum().rho()/theBeam->momentum().rho(); double check = rem==theRems.first ? theX.first : theX.second; check += currentx; if(1.0-check < 1e-3) throw ShowerHandler::ExtraScatterVeto(); bool anti; Lorentz5Momentum lastp(parton->momentum()); int lastID(parton->id()); Energy oldQ(_forcedSplitScale); _pdf = pdf; //do nothing if already valence quark if(first && content.isValenceQuark(parton)) { //set the extracted value, because otherwise no RemID could be generated. content.extract(lastID); // add the particle to the colour partners partners.push_back(make_pair(parton, tPPtr())); //set the sign anti = parton->hasAntiColour() && parton->id()!=ParticleID::g; if(rem==theRems.first) theanti.first = anti; else theanti.second = anti; // add the x and return if(rem==theRems.first) theX.first += currentx; else theX.second += currentx; return; } //or gluon for secondaries else if(!first && lastID == ParticleID::g) { partners.push_back(make_pair(parton, tPPtr())); // add the x and return if(rem==theRems.first) theX.first += currentx; else theX.second += currentx; return; } // if a sea quark.antiquark forced splitting to a gluon // Create the new parton with its momentum and parent/child relationship set PPtr newSea; if( !(lastID == ParticleID::g || lastID == ParticleID::gamma) ) { newSea = forceSplit(rem, -lastID, oldQ, currentx, lastp, used,content); ColinePtr cl = new_ptr(ColourLine()); if(newSea->id() > 0) cl-> addColoured(newSea); else cl->addAntiColoured(newSea); // if a secondard scatter finished so return if(!first || content.isValenceQuark(ParticleID::g) ){ partners.push_back(make_pair(parton, newSea)); // add the x and return if(rem==theRems.first) theX.first += currentx; else theX.second += currentx; if(first) content.extract(ParticleID::g); return; } } // otherwise evolve back to valence // final valence splitting PPtr newValence = forceSplit(rem, lastID!=ParticleID::gamma ? ParticleID::g : ParticleID::gamma, oldQ, currentx , lastp, used, content); // extract from the hadron to allow remnant to be determined content.extract(newValence->id()); // case of a gluon going into the hard subprocess if( lastID == ParticleID::g ) { partners.push_back(make_pair(parton, tPPtr())); anti = newValence->hasAntiColour(); if(rem==theRems.first) theanti.first = anti; else theanti.second = anti; parton->colourLine(!anti)->addColoured(newValence, anti); return; } else if( lastID == ParticleID::gamma) { partners.push_back(make_pair(parton, newValence)); anti = newValence->hasAntiColour(); ColinePtr newLine(new_ptr(ColourLine())); newLine->addColoured(newValence, anti); if(rem==theRems.first) theanti.first = anti; else theanti.second = anti; // add the x and return if(rem==theRems.first) theX.first += currentx; else theX.second += currentx; return; } //The valence quark will always be connected to the sea quark with opposite sign tcPPtr particle; if(lastID*newValence->id() < 0){ particle = parton; partners.push_back(make_pair(newSea, tPPtr())); } else { particle = newSea; partners.push_back(make_pair(parton, tPPtr())); } anti = newValence->hasAntiColour(); if(rem==theRems.first) theanti.first = anti; else theanti.second = anti; if(particle->colourLine()) particle->colourLine()->addAntiColoured(newValence); if(particle->antiColourLine()) particle->antiColourLine()->addColoured(newValence); // add the x and return if(rem==theRems.first) theX.first += currentx; else theX.second += currentx; return; } void HwRemDecayer::doSplit(pair partons, pair pdfs, bool first) { if(theRems.first) { ParticleVector children=theRems.first->children(); for(unsigned int ix=0;ixdataPtr()==theRems.first->dataPtr()) theRems.first = dynamic_ptr_cast(children[ix]); } } if(theRems.second) { ParticleVector children=theRems.second->children(); for(unsigned int ix=0;ixdataPtr()==theRems.second->dataPtr()) theRems.second = dynamic_ptr_cast(children[ix]); } } // forced splitting for first parton if(isPartonic(partons.first )) { try { split(partons.first, theContent.first, theRems.first, theUsed.first, theMaps.first, pdfs.first, first); } catch(ShowerHandler::ExtraScatterVeto) { throw ShowerHandler::ExtraScatterVeto(); } } // forced splitting for second parton if(isPartonic(partons.second)) { try { split(partons.second, theContent.second, theRems.second, theUsed.second, theMaps.second, pdfs.second, first); // additional check for the remnants // if can't do the rescale veto the emission if(!first&&partons.first->data().coloured()&& partons.second->data().coloured()) { Lorentz5Momentum pnew[2]= {theRems.first->momentum() - theUsed.first - partons.first->momentum(), theRems.second->momentum() - theUsed.second - partons.second->momentum()}; pnew[0].setMass(getParticleData(theContent.first.RemID())->constituentMass()); pnew[0].rescaleEnergy(); pnew[1].setMass(getParticleData(theContent.second.RemID())->constituentMass()); pnew[1].rescaleEnergy(); for(unsigned int iy=0; iychildren().size(); ++iy) pnew[0] += theRems.first->children()[iy]->momentum(); for(unsigned int iy=0; iychildren().size(); ++iy) pnew[1] += theRems.second->children()[iy]->momentum(); Lorentz5Momentum ptotal= theRems.first ->momentum()-partons.first ->momentum()+ theRems.second->momentum()-partons.second->momentum(); // add x limits if(ptotal.m() < (pnew[0].m() + pnew[1].m()) ) { if(partons.second->id() != ParticleID::g){ if(partons.second==theMaps.second.back().first) theUsed.second -= theMaps.second.back().second->momentum(); else theUsed.second -= theMaps.second.back().first->momentum(); thestep->removeParticle(theMaps.second.back().first); thestep->removeParticle(theMaps.second.back().second); } theMaps.second.pop_back(); theX.second -= partons.second->momentum().rho()/ parent(theRems.second)->momentum().rho(); throw ShowerHandler::ExtraScatterVeto(); } } } catch(ShowerHandler::ExtraScatterVeto){ if(!partons.first||!partons.second|| !theRems.first||!theRems.second) throw ShowerHandler::ExtraScatterVeto(); //case of the first forcedSplitting worked fine theX.first -= partons.first->momentum().rho()/ parent(theRems.first)->momentum().rho(); //case of the first interaction //throw veto immediately, because event get rejected anyway. if(first) throw ShowerHandler::ExtraScatterVeto(); //secondary interactions have to end on a gluon, if parton //was NOT a gluon, the forced splitting particles must be removed if(partons.first->id() != ParticleID::g) { if(partons.first==theMaps.first.back().first) theUsed.first -= theMaps.first.back().second->momentum(); else theUsed.first -= theMaps.first.back().first->momentum(); thestep->removeParticle(theMaps.first.back().first); thestep->removeParticle(theMaps.first.back().second); } theMaps.first.pop_back(); throw ShowerHandler::ExtraScatterVeto(); } } // veto if not enough energy for extraction if( !first &&(theRems.first ->momentum().e() - partons.first ->momentum().e() < 1.0e-3*MeV || theRems.second->momentum().e() - partons.second->momentum().e() < 1.0e-3*MeV )) { if(partons.first->id() != ParticleID::g) { if(partons.first==theMaps.first.back().first) theUsed.first -= theMaps.first.back().second->momentum(); else theUsed.first -= theMaps.first.back().first->momentum(); thestep->removeParticle(theMaps.first.back().first); thestep->removeParticle(theMaps.first.back().second); } theMaps.first.pop_back(); if(partons.second->id() != ParticleID::g) { if(partons.second==theMaps.second.back().first) theUsed.second -= theMaps.second.back().second->momentum(); else theUsed.second -= theMaps.second.back().first->momentum(); thestep->removeParticle(theMaps.second.back().first); thestep->removeParticle(theMaps.second.back().second); } theMaps.second.pop_back(); throw ShowerHandler::ExtraScatterVeto(); } } void HwRemDecayer::mergeColour(tPPtr pold, tPPtr pnew, bool anti) const { ColinePtr clnew, clold; //save the corresponding colour lines clold = pold->colourLine(anti); clnew = pnew->colourLine(!anti); assert(clold); // There is already a colour line (not the final diquark) if(clnew){ if( (clnew->coloured().size() + clnew->antiColoured().size()) > 1 ){ if( (clold->coloured().size() + clold->antiColoured().size()) > 1 ){ //join the colour lines //I don't use the join method, because potentially only (anti)coloured //particles belong to one colour line if(clold!=clnew){//procs are not already connected while ( !clnew->coloured().empty() ) { tPPtr p = clnew->coloured()[0]; clnew->removeColoured(p); clold->addColoured(p); } while ( !clnew->antiColoured().empty() ) { tPPtr p = clnew->antiColoured()[0]; clnew->removeAntiColoured(p); clold->addAntiColoured(p); } } }else{ //if pold is the only member on it's //colour line, remove it. clold->removeColoured(pold, anti); //and add it to clnew clnew->addColoured(pold, anti); } } else{//pnnew is the only member on it's colour line. clnew->removeColoured(pnew, !anti); clold->addColoured(pnew, !anti); } } else {//there is no coline at all for pnew clold->addColoured(pnew, !anti); } } void HwRemDecayer::fixColours(PartnerMap partners, bool anti, double colourDisrupt) const { PartnerMap::iterator prev; tPPtr pnew, pold; assert(partners.size()>=2); PartnerMap::iterator it=partners.begin(); while(it != partners.end()) { //skip the first one to have a partner if(it==partners.begin()){ it++; continue; } prev = it - 1; //determine the particles to work with pold = prev->first; if(prev->second) { if(!pold->coloured()) pold = prev->second; else if(pold->hasAntiColour() != anti) pold = prev->second; } assert(pold); pnew = it->first; if(it->second) { if(it->second->colourLine(!anti)) //look for the opposite colour pnew = it->second; } assert(pnew); // Implement the disruption of colour connections if( it != partners.end()-1 ) {//last one is diquark-has to be connected //has to be inside the if statement, so that the probability is //correctly counted: if( UseRandom::rnd() < colourDisrupt ){ if(!it->second){//check, whether we have a gluon mergeColour(pnew, pnew, anti); }else{ if(pnew==it->first)//be careful about the order mergeColour(it->second, it->first, anti); else mergeColour(it->first, it->second, anti); } it = partners.erase(it); continue; } } // regular merging mergeColour(pold, pnew, anti); //end of loop it++; } return; } PPtr HwRemDecayer::forceSplit(const tRemPPtr rem, long child, Energy &lastQ, double &lastx, Lorentz5Momentum &pf, Lorentz5Momentum &p, HadronContent & content) const { static const double eps=1e-6; // beam momentum Lorentz5Momentum beam = theBeam->momentum(); // the last scale is minimum of last value and upper limit Energy minQ=_range*_kinCutoff*sqrt(lastx)/(1-lastx); if(minQ>lastQ) lastQ=minQ; // generate the new value of qtilde // weighted towards the lower value: dP/dQ = 1/Q -> Q(R) = // Q0 (Qmax/Q0)^R Energy q; unsigned int ntry=0,maxtry=100; double xExtracted = rem==theRems.first ? theX.first : theX.second; double zmin= lastx/(1.-xExtracted) ,zmax,yy; if(1-lastx ids; if(child==21||child==22) { ids=content.flav; for(unsigned int ix=0;ix > > partonprob; double ptotal(0.); for(unsigned int iflav=0;iflav prob; for(unsigned int iz=0;izvalue(sqr(max(wz*q,_kinCutoff))) : _alphaEM->value(sqr(max(wz*q,_kinCutoff))); double az=wz*zz*coup; // g -> q qbar if(ids[iflav]==ParticleID::g) { // calculate splitting function // SP as q is always less than forcedSplitScale, the pdf scale is fixed // pdfval = _pdf->xfx(theBeamData,in,sqr(q),lastx*zr); double pdfval=_pdf->xfx(theBeamData,in,sqr(_forcedSplitScale),lastx*zr); if(pdfval>0.) psum += pdfval*az*0.5*(sqr(zz)+sqr(wz)); } // q -> q g else { // calculate splitting function // SP as q is always less than forcedSplitScale, the pdf scale is fixed // pdfval = _pdf->xfx(theBeamData,in,sqr(q),lastx*zr); double pdfval=_pdf->xfx(theBeamData,in,sqr(_forcedSplitScale),lastx*zr); if(pdfval>0.) psum += pdfval*az*4./3.*(1.+sqr(wz))*zr; } if(psum>0.) prob.push_back(psum); yy+=dely; } if(psum>0.) partonprob[ids[iflav]] = make_pair(psum,prob); ptotal+=psum; } // select the flavour if(ptotal==0.) throw ShowerHandler::ExtraScatterVeto(); ptotal *= UseRandom::rnd(); map > >::const_iterator pit; for(pit=partonprob.begin();pit!=partonprob.end();++pit) { if(pit->second.first>=ptotal) break; else ptotal -= pit->second.first; } if(pit==partonprob.end()) throw Exception() << "Can't select parton for forced backward evolution in " << "HwRemDecayer::forceSplit" << Exception::eventerror; // select z unsigned int iz=0; for(;izsecond.second.size();++iz) { if(pit->second.second[iz]>ptotal) break; } if(iz==pit->second.second.size()) --iz; double ey=exp(ymin+dely*(float(iz+1)-UseRandom::rnd())); double z=ey/(1.+ey); Energy2 pt2=sqr((1.-z)*q)- z*sqr(_kinCutoff); // create the particle if(pit->first!=ParticleID::g) child=pit->first; PPtr parton = getParticleData(child)->produceParticle(); Energy2 emittedm2 = sqr(parton->dataPtr()->constituentMass()); // Now boost pcm and pf to z only frame Lorentz5Momentum p_ref = Lorentz5Momentum(ZERO, beam.vect()); Lorentz5Momentum n_ref = Lorentz5Momentum(ZERO, -beam.vect()); // generate phi and compute pt of branching double phi = Constants::twopi*UseRandom::rnd(); Energy pt=sqrt(pt2); Lorentz5Momentum qt = LorentzMomentum(pt*cos(phi), pt*sin(phi), ZERO, ZERO); Axis axis(p_ref.vect().unit()); if(axis.perp2()>0.) { LorentzRotation rot; double sinth(sqrt(sqr(axis.x())+sqr(axis.y()))); rot.setRotate(acos(axis.z()),Axis(-axis.y()/sinth,axis.x()/sinth,0.)); qt.transform(rot); } // compute alpha for previous particle Energy2 p_dot_n = p_ref*n_ref; double lastalpha = pf*n_ref/p_dot_n; Lorentz5Momentum qtout=qt; Energy2 qtout2=-qt*qt; double alphaout=(1.-z)/z*lastalpha; double betaout=0.5*(emittedm2+qtout2)/alphaout/p_dot_n; Lorentz5Momentum k=alphaout*p_ref+betaout*n_ref+qtout; k.rescaleMass(); parton->set5Momentum(k); pf+=k; lastQ=q; lastx/=z; p += parton->momentum(); thestep->addDecayProduct(rem,parton,false); return parton; } void HwRemDecayer::setRemMasses() const { // get the masses of the remnants Energy mrem[2]; Lorentz5Momentum ptotal,pnew[2]; vector theprocessed; theprocessed.push_back(theRems.first); theprocessed.push_back(theRems.second); // one remnant in e.g. DIS if(!theprocessed[0]||!theprocessed[1]) { tRemPPtr rem = theprocessed[0] ? theprocessed[0] : theprocessed[1]; Lorentz5Momentum deltap(rem->momentum()); // find the diquark and momentum we still need in the energy tPPtr diquark; vector progenitors; for(unsigned int ix=0;ixchildren().size();++ix) { if(!DiquarkMatcher::Check(rem->children()[ix]->data())) { progenitors.push_back(rem->children()[ix]); deltap -= rem->children()[ix]->momentum(); } else diquark = rem->children()[ix]; } // now find the total momentum of the hadronic final-state to // reshuffle against // find the hadron for this remnant tPPtr hadron=rem; do hadron=hadron->parents()[0]; while(!hadron->parents().empty()); // find incoming parton to hard process from this hadron tPPtr hardin = generator()->currentEvent()->primaryCollision()->incoming().first==hadron ? generator()->currentEvent()->primarySubProcess()->incoming().first : generator()->currentEvent()->primarySubProcess()->incoming().second; tPPtr parent=hardin; vector tempprog; // find the outgoing particles emitted from the backward shower do { assert(!parent->parents().empty()); tPPtr newparent=parent->parents()[0]; if(newparent==hadron) break; for(unsigned int ix=0;ixchildren().size();++ix) { if(newparent->children()[ix]!=parent) findChildren(newparent->children()[ix],tempprog); } parent=newparent; } while(parent!=hadron); // add to list of potential particles to reshuffle against in right order for(unsigned int ix=tempprog.size();ix>0;--ix) progenitors.push_back(tempprog[ix-1]); // final-state particles which are colour connected tColinePair lines = make_pair(hardin->colourLine(),hardin->antiColourLine()); vector others; for(ParticleVector::const_iterator cit = generator()->currentEvent()->primarySubProcess()->outgoing().begin(); cit!= generator()->currentEvent()->primarySubProcess()->outgoing().end();++cit) { // colour connected if(lines.first&&lines.first==(**cit).colourLine()) { findChildren(*cit,progenitors); continue; } // anticolour connected if(lines.second&&lines.second==(**cit).antiColourLine()) { findChildren(*cit,progenitors); continue; } // not connected for(unsigned int ix=0;ix<(**cit).children().size();++ix) others.push_back((**cit).children()[ix]); } // work out how much of the system needed for rescaling unsigned int iloc=0; Lorentz5Momentum psystem,ptotal; do { psystem+=progenitors[iloc]->momentum(); ptotal = psystem + deltap; ptotal.rescaleMass(); psystem.rescaleMass(); ++iloc; if(ptotal.mass() > psystem.mass() + diquark->mass() && psystem.mass()>1*MeV && DISRemnantOpt_<2 && ptotal.e() > 0.*GeV ) break; } while(iloc psystem.mass() + diquark->mass()) --iloc; if(iloc==progenitors.size()) { // try touching the lepton in dis as a last restort for(unsigned int ix=0;ixmomentum(); ptotal = psystem + deltap; ptotal.rescaleMass(); psystem.rescaleMass(); ++iloc; } --iloc; if(ptotal.mass() > psystem.mass() + diquark->mass()) { if(DISRemnantOpt_==0||DISRemnantOpt_==2) Throw() << "Warning had to adjust the momentum of the" << " non-colour connected" << " final-state, e.g. the scattered lepton in DIS" << Exception::warning; else throw Exception() << "Can't set remnant momentum without adjusting " << "the momentum of the" << " non-colour connected" << " final-state, e.g. the scattered lepton in DIS" << " vetoing event" << Exception::eventerror; } else { throw Exception() << "Can't put the remnant on-shell in HwRemDecayer::setRemMasses()" << Exception::eventerror; } } psystem.rescaleMass(); LorentzRotation R = Utilities::getBoostToCM(make_pair(psystem, deltap)); Energy pz = SimplePhaseSpace::getMagnitude(sqr(ptotal.mass()), psystem.mass(), diquark->mass()); LorentzRotation Rs(-(R*psystem).boostVector()); Rs.boost(0.0, 0.0, pz/sqrt(sqr(pz) + sqr(psystem.mass()))); Rs = Rs*R; // put remnant on shell deltap.transform(R); deltap.setMass(diquark->mass()); deltap.setE(sqrt(sqr(diquark->mass())+sqr(pz))); deltap.rescaleRho(); R.invert(); deltap.transform(R); Rs = R*Rs; // apply transformation to required particles to absorb recoil for(unsigned int ix=0;ix<=iloc;++ix) { progenitors[ix]->deepTransform(Rs); } diquark->set5Momentum(deltap); } // two remnants else { for(unsigned int ix=0;ix<2;++ix) { if(!theprocessed[ix]) continue; pnew[ix]=Lorentz5Momentum(); for(unsigned int iy=0;iychildren().size();++iy) { pnew[ix]+=theprocessed[ix]->children()[iy]->momentum(); } mrem[ix]=sqrt(pnew[ix].m2()); } // now find the remnant remnant cmf frame Lorentz5Momentum prem[2]={theprocessed[0]->momentum(), theprocessed[1]->momentum()}; ptotal=prem[0]+prem[1]; ptotal.rescaleMass(); // boost momenta to this frame if(ptotal.m()< (pnew[0].m()+pnew[1].m())) throw Exception() << "Not enough energy in both remnants in " << "HwRemDecayer::setRemMasses() " << Exception::eventerror; Boost boostv(-ptotal.boostVector()); ptotal.boost(boostv); for(unsigned int ix=0;ix<2;++ix) { prem[ix].boost(boostv); // set the masses and energies, prem[ix].setMass(mrem[ix]); prem[ix].setE(0.5/ptotal.m()*(sqr(ptotal.m())+sqr(mrem[ix])-sqr(mrem[1-ix]))); prem[ix].rescaleRho(); // boost back to the lab prem[ix].boost(-boostv); // set the momenta of the remnants theprocessed[ix]->set5Momentum(prem[ix]); } // boost the decay products Lorentz5Momentum ptemp; for(unsigned int ix=0;ix<2;++ix) { Boost btorest(-pnew[ix].boostVector()); Boost bfmrest( prem[ix].boostVector()); for(unsigned int iy=0;iychildren().size();++iy) { ptemp=theprocessed[ix]->children()[iy]->momentum(); ptemp.boost(btorest); ptemp.boost(bfmrest); theprocessed[ix]->children()[iy]->set5Momentum(ptemp); } } } } void HwRemDecayer::initSoftInteractions(Energy ptmin, InvEnergy2 beta){ ptmin_ = ptmin; beta_ = beta; } Energy HwRemDecayer::softPt() const { Energy2 pt2(ZERO); double xmin(0.0), xmax(1.0), x(0); if(beta_ == ZERO){ return UseRandom::rnd(0.0,(double)(ptmin_/GeV))*GeV; } if(beta_ < ZERO){ xmin = 1.0; xmax = exp( -beta_*sqr(ptmin_) ); }else{ xmin = exp( -beta_*sqr(ptmin_) ); xmax = 1.0; } x = UseRandom::rnd(xmin, xmax); pt2 = 1.0/beta_ * log(1/x); if( pt2 < ZERO || pt2 > sqr(ptmin_) ) throw Exception() << "HwRemDecayer::softPt generation of pt " << "outside allowed range [0," << ptmin_/GeV << "]." << Exception::runerror; //ofstream myfile2("softPt.txt", ios::app ); //myfile2 << pt2/GeV2 <<" "<currentEventHandler()->currentCollision()->incoming()); Lorentz5Momentum P1(beam.first->momentum()), P2(beam.second->momentum()); if(dbg){ cerr << "new event --------------------\n" << *(beam.first) << *(softRems_.first) << "-------------------\n" << *(beam.second) << *(softRems_.second) << endl; } //parton mass Energy mp; if(quarkPair_){ mp = getParticleData(ParticleID::u)->constituentMass(); }else{ mp = mg_; } //Get x_g1 and x_g2 //first limits double xmin = sqr(ptmin_)/4.0/(P1+P2).m2(); double x1max = (r1.e()+abs(r1.z()))/(P1.e() + abs(P1.z())); double x2max = (r2.e()+abs(r2.z()))/(P2.e() + abs(P2.z())); double x1; if(!multiPeriph_){ //now generate according to 1/x x_g1 = xmin * exp(UseRandom::rnd(log(x1max/xmin))); x_g2 = xmin * exp(UseRandom::rnd(log(x2max/xmin))); }else{ if(valOfN_==0) return; double param = (1/(2*valOfN_+1))*initTotRap_; do{ // need 1-x instead of x to get the proper final momenta x1 = UseRandom::rndGauss(gaussWidth_, 1 - (exp(param)-1)/exp(param)); }while(x1 < 0 || x1>=1.0); x_g1 = x1max*x1; x_g2 = x2max*x1; } if(dbg) cerr << x1max << " " << x_g1 << endl << x2max << " " << x_g2 << endl; Lorentz5Momentum ig1, ig2, cmf; ig1 = x_g1*P1; ig2 = x_g2*P2; ig1.setMass(mp); ig2.setMass(mp); ig1.rescaleEnergy(); ig2.rescaleEnergy(); cmf = ig1 + ig2; //boost vector from cmf to lab Boost boostv(cmf.boostVector()); //outgoing gluons in cmf g1.setMass(mp); g2.setMass(mp); g1.setX(pt*cos(phi)); g2.setX(-pt*cos(phi)); g1.setY(pt*sin(phi)); g2.setY(-pt*sin(phi)); pz2 = cmf.m2()/4 - sqr(mp) - (pt*pt); if( pz2/GeV2 < 0.0 ){ if(dbg) cerr << "EXCEPTION not enough energy...." << endl; throw ExtraSoftScatterVeto(); } if(!multiPeriph_){ if(UseRandom::rndbool()){ pz = sqrt(pz2); }else pz = -sqrt(pz2); }else{ pz = pz2 > ZERO ? sqrt(pz2) : ZERO; } if(dbg) cerr << "pz1 has been calculated to: " << pz/GeV << endl; g1.setZ(pz); g2.setZ(-pz); g1.rescaleEnergy(); g2.rescaleEnergy(); if(dbg){ cerr << "check inv mass in cmf frame: " << (g1+g2).m()/GeV << " vs. lab frame: " << (ig1+ig2).m()/GeV << endl; } g1.boost(boostv); g2.boost(boostv); //recalc the remnant momenta Lorentz5Momentum r1old(r1), r2old(r2); r1 -= g1; r2 -= g2; try{ reShuffle(r1, r2, r1old.m(), r2old.m()); }catch(ExtraSoftScatterVeto){ r1 = r1old; r2 = r2old; throw ExtraSoftScatterVeto(); } if(dbg){ cerr << "remnant 1,2 momenta: " << r1/GeV << "--" << r2/GeV << endl; cerr << "remnant 1,2 masses: " << r1.m()/GeV << " " << r2.m()/GeV << endl; cerr << "check momenta in the lab..." << (-r1old-r2old+r1+r2+g1+g2)/GeV << endl; } } void HwRemDecayer::doSoftInteractions_old(unsigned int N) { if(N == 0) return; if(!softRems_.first || !softRems_.second) throw Exception() << "HwRemDecayer::doSoftInteractions: no " << "Remnants available." << Exception::runerror; if( ptmin_ == -1.*GeV ) throw Exception() << "HwRemDecayer::doSoftInteractions: init " << "code has not been called! call initSoftInteractions." << Exception::runerror; Lorentz5Momentum g1, g2; Lorentz5Momentum r1(softRems_.first->momentum()), r2(softRems_.second->momentum()); unsigned int tries(1), i(0); for(i=0; i maxtrySoft_) break; if(dbg){ cerr << "new try \n" << *softRems_.first << *softRems_.second << endl; } try{ softKinematics(r1, r2, g1, g2); }catch(ExtraSoftScatterVeto){ tries++; i--; continue; } PPair oldrems = softRems_; PPair gluons = make_pair(addParticle(softRems_.first, ParticleID::g, g1), addParticle(softRems_.second, ParticleID::g, g2)); //now reset the remnants with the new ones softRems_.first = addParticle(softRems_.first, softRems_.first->id(), r1); softRems_.second = addParticle(softRems_.second, softRems_.second->id(), r2); //do the colour connections pair anti = make_pair(oldrems.first->hasAntiColour(), oldrems.second->hasAntiColour()); ColinePtr cl1 = new_ptr(ColourLine()); ColinePtr cl2 = new_ptr(ColourLine()); // case 2: oldrems.first->colourLine(anti.first) ->addColoured(gluons.second,anti.second); cl2->addColoured(softRems_.first, anti.second); cl2->addColoured(gluons.second, !anti.second); oldrems.first->colourLine(anti.first) ->addColoured(gluons.second,anti.second); oldrems.second->colourLine(anti.second) ->addColoured(gluons.first,anti.first); cl1->addColoured(softRems_.second, anti.first); cl1->addColoured(gluons.first, !anti.first); cl2->addColoured(softRems_.first, anti.second); cl2->addColoured(gluons.second, !anti.second); //reset counter tries = 1; } if(dbg) cerr << "generated " << i << "th soft scatters\n"; } // Solve the reshuffling equation to rescale the remnant momenta double bisectReshuffling(const vector& particles, Energy w, double target = -16., double maxLevel = 80.) { - double level = 0; double left = 0; double right = 1; double check = -1.; double xi = -1; while ( level < maxLevel ) { xi = (left+right)*pow(0.5,level+1.); check = 0.; for (vector::const_iterator p = particles.begin(); p != particles.end(); ++p){ check += sqrt(sqr(xi)*((*p)->momentum().vect().mag2())+sqr((*p)->mass()))/w; } - if ( log10(abs(1.-check)) <= target ) + if ( check==1. || log10(abs(1.-check)) <= target ) break; left *= 2.; right *= 2.; if ( check >= 1. ) { right -= 1.; ++level; } if ( check < 1. ) { left += 1.; ++level; } } return xi; } LorentzRotation HwRemDecayer::rotate(const LorentzMomentum &p) const { LorentzRotation R; static const double ptcut = 1e-20; Energy2 pt2 = sqr(p.x())+sqr(p.y()); Energy2 pp2 = sqr(p.z())+pt2; double phi, theta; if(pt2 <= pp2*ptcut) { if(p.z() > ZERO) theta = 0.; else theta = Constants::pi; phi = 0.; } else { Energy pp = sqrt(pp2); Energy pt = sqrt(pt2); double ct = p.z()/pp; double cf = p.x()/pt; phi = -acos(cf); theta = acos(ct); } // Rotate first around the z axis to put p in the x-z plane // Then rotate around the Y axis to put p on the z axis R.rotateZ(phi).rotateY(theta); return R; } struct vectorSort{ bool operator() (Lorentz5Momentum i,Lorentz5Momentum j) {return(i.rapidity() < j.rapidity());} } ySort; void HwRemDecayer::doSoftInteractions_multiPeriph(unsigned int N) { if(N == 0) return; int Nmpi = N; for(int j=0;jmaximumCMEnergy()); - double reference = sqr(energy/TeV); + //double reference = sqr(energy/TeV); // double ladderMult_; // Parametrization of the ladder multiplicity // ladderMult_ = ladderNorm_ * pow( ( reference ) , ladderPower_ ); double avgN = 2.*ladderMult_*log((softRems_.first->momentum() +softRems_.second->momentum()).m()/mg_) + ladderbFactor_; initTotRap_ = abs(softRems_.first->momentum().rapidity()) +abs(softRems_.second->momentum().rapidity()); // Generate the poisson distribution with mean avgN N=UseRandom::rndPoisson(avgN); valOfN_=N; if(N <= 1){ // j--; //TODO: Do we want to make all Nmpi soft MPIs? // Compare to MaxTryMPI for hard mpis. continue; } if(!softRems_.first || !softRems_.second) throw Exception() << "HwRemDecayer::doSoftInteractions: no " << "Remnants available." << Exception::runerror; if( ptmin_ == -1.*GeV ) throw Exception() << "HwRemDecayer::doSoftInteractions: init " << "code has not been called! call initSoftInteractions." << Exception::runerror; // The remnants PPtr rem1 = softRems_.first; PPtr rem2 = softRems_.second; // Vector for the ladder particles vector ladderMomenta; // Remnant momenta Lorentz5Momentum r1(softRems_.first->momentum()), r2(softRems_.second->momentum()); Lorentz5Momentum cm =r1+r2; // Initialize partons in the ladder // The toy masses are needed for the correct calculation of the available energy Lorentz5Momentum sumMomenta; for(unsigned int i = 0; i < N; i++) { // choose constituents Energy newMass = ZERO; Energy toyMass; if(i<2){ // u and d have the same mass so its enough to use u toyMass = getParticleData(ParticleID::u)->constituentMass(); } else{ toyMass = getParticleData(ParticleID::g)->constituentMass(); } Lorentz5Momentum cp(ZERO,ZERO,ZERO,newMass,newMass); // dummy container for the momentum that is used for momentum conservation Lorentz5Momentum dummy(ZERO,ZERO,ZERO,toyMass,toyMass); ladderMomenta.push_back(cp); sumMomenta+=dummy; } // Get the beam energy tcPPair beam(generator()->currentEventHandler()->currentCollision()->incoming()); Lorentz5Momentum P1(beam.first->momentum()), P2(beam.second->momentum()); // Calculate available energy for the partons double x1,x2; double param = (1./(valOfN_+1.))*initTotRap_; do{ // Need 1-x instead of x to get the proper final momenta // TODO: physical to use different x's (see comment below) x1 = UseRandom::rndGauss( gaussWidth_ , exp(-param) ); // x2 = UseRandom::rndGauss( gaussWidth_ , exp(-param) ); }while(x1 < 0 || x1>=1.0); // x2 < 0 || x2>=1.0); // Remnants 1 and 2 need to be rescaled later by this amount Lorentz5Momentum ig1 = x1*r1; Lorentz5Momentum ig2 = x1*r2; //TODO: x2*r2 // requires boost of Ladder in x1/x2-dependent // frame. // The available energy that is used to generate the ladder // sumMomenta is the the sum of rest masses of the ladder partons // the available energy goes all into the kinematics Energy availableEnergy = (ig1+ig2).m() - sumMomenta.m(); // If not enough energy then continue // The available energy has to be larger then the rest mass of the remnants if ( availableEnergy < ZERO ) { // j--; //TODO: Do we want to make all Nmpi soft MPIs? continue; } unsigned int its(0); // Generate the momenta of the partons in the ladder if ( !(doPhaseSpaceGenerationGluons(ladderMomenta,availableEnergy,its)) ){ // j--; //TODO: Do we want to make all Nmpi soft MPIs? continue; } // Add gluon mass and rescale Lorentz5Momentum totalMomPartons; Lorentz5Momentum totalMassLessPartons; // Sort the ladder partons according to their rapidity and then choose which ones will be the quarks sort(ladderMomenta.begin(),ladderMomenta.end(),ySort); int countPartons=0; long quarkID=0; // Choose between up and down quarks int choice = UseRandom::rnd2(1,1); switch (choice) { case 0: quarkID = ParticleID::u; break; case 1: quarkID = ParticleID::d; break; } for (auto &p:ladderMomenta){ totalMomPartons+=p; // Set the mass of the gluons and the two quarks in the ladder if(countPartons==0 || countPartons==(ladderMomenta.size()-1)){ p.setMass( getParticleData(quarkID)->constituentMass() ); }else{ p.setMass( getParticleData(ParticleID::g)->constituentMass() ); } p.rescaleEnergy(); countPartons++; } // Continue if energy conservation is violated if ( abs(availableEnergy - totalMomPartons.m()) > 1e-8*GeV){ // j--; //TODO: Do we want to make all Nmpi soft MPIs? continue; } // Boost momenta into CM frame const Boost boostv(-totalMomPartons.boostVector()); Lorentz5Momentum totalMomentumAfterBoost; for ( unsigned int i=0; i remnants; rem1->set5Momentum(r1); rem2->set5Momentum(r2); remnants.push_back(rem1); remnants.push_back(rem2); vector reshuffledRemnants; Lorentz5Momentum totalMomentumAll; // Bisect reshuffling for rescaling of remnants double xi_remnants = bisectReshuffling(remnants,remainingEnergy); // Rescale remnants for ( auto &rems: remnants ) { Lorentz5Momentum reshuffledMomentum; reshuffledMomentum = xi_remnants*rems->momentum(); reshuffledMomentum.setMass(getParticleData(softRems_.first->id())->constituentMass()); reshuffledMomentum.rescaleEnergy(); reshuffledMomentum.boost(-boostvR); rems->set5Momentum(reshuffledMomentum); totalMomentumAll+=reshuffledMomentum; } // Then the other particles for ( auto &p:ladderMomenta ) { p.boost(-boostvR); totalMomentumAll+=p; } // sort again sort(ladderMomenta.begin(),ladderMomenta.end(),ySort); // Do the colour connections // Original rems are the ones which are connected to other parts of the event PPair oldRems_ = softRems_; pair anti = make_pair(oldRems_.first->hasAntiColour(), oldRems_.second->hasAntiColour()); // Replace first remnant softRems_.first = addParticle(softRems_.first, softRems_.first->id(), remnants[0]->momentum()); // Connect the old remnant to the new remnant oldRems_.first->colourLine(anti.first)->addColoured(softRems_.first, anti.first); // Replace second remnant softRems_.second = addParticle(softRems_.second, softRems_.second->id(), remnants[1]->momentum()); // This connects the old remnants to the new remnants oldRems_.second->colourLine(anti.second)->addColoured(softRems_.second, anti.second); // Add all partons to the first remnant for the event record vector partons; vector quarks; int count=0; // Choose the colour connections and position of quark antiquark // Choose between R1-q-g..g-qbar-R2 or R1-qbar-g...g-q-R2 // (place of quark antiquarks in the ladder) int quarkPosition = UseRandom::rnd2(1,1); for (auto &p:ladderMomenta){ if(p.mass()==getParticleData(ParticleID::u)->constituentMass()){ if(count==0){ if(quarkPosition==0){ quarks.push_back(addParticle(softRems_.first, quarkID, p)); count++; }else{ quarks.push_back(addParticle(softRems_.first, -quarkID, p)); count++; } }else{ if(quarkPosition==0){ quarks.push_back(addParticle(softRems_.first, -quarkID, p)); }else{ quarks.push_back(addParticle(softRems_.first, quarkID, p)); } } }else{ partons.push_back(addParticle(softRems_.first, ParticleID::g, p)); } softRems_.first = addParticle(softRems_.first, softRems_.first->id(), softRems_.first->momentum()); oldRems_.first->colourLine(anti.first)->addColoured(softRems_.first, anti.first); } // Need to differenciate between the two quark positions, this defines the // colour connections to the new remnants and old remnants if(quarkPosition==0){ // ladder self contained if(partons.size()==0 && quarks.size()>0){ ColinePtr clq = new_ptr(ColourLine()); clq->addColoured(quarks[0]); clq->addAntiColoured(quarks[1]); } ColinePtr clfirst = new_ptr(ColourLine()); ColinePtr cllast = new_ptr(ColourLine()); if(partons.size()>0){ clfirst->addColoured(quarks[0]); clfirst->addAntiColoured(partons[0]); cllast->addAntiColoured(quarks[1]); cllast->addColoured(partons[partons.size()-1]); //now the remaining gluons for (unsigned int i=0; iaddColoured(partons[i]); cl->addAntiColoured(partons[i+1]); } } } else { if(partons.size()==0 && quarks.size()>0){ ColinePtr clq = new_ptr(ColourLine()); clq->addAntiColoured(quarks[0]); clq->addColoured(quarks[1]); } ColinePtr clfirst = new_ptr(ColourLine()); ColinePtr cllast = new_ptr(ColourLine()); if(partons.size()>0){ clfirst->addAntiColoured(quarks[0]); clfirst->addColoured(partons[0]); cllast->addColoured(quarks[1]); cllast->addAntiColoured(partons[partons.size()-1]); //now the remaining gluons for (unsigned int i=0; iaddAntiColoured(partons[i]); cl->addColoured(partons[i+1]); } } }// end colour connection loop }// end Nmpi loop }//end function // Do the phase space generation here is 1 to 1 the same from UA5 model bool HwRemDecayer::doPhaseSpaceGenerationGluons(vector &softGluons, Energy CME, unsigned int &its) const{ // Define the parameters unsigned int _maxtries = 300; double alog = log(CME*CME/GeV2); unsigned int ncl = softGluons.size(); // calculate the slope parameters for the different clusters // outside loop to save time vector mom(ncl); // Sets the slopes depending on the constituent quarks of the cluster for(unsigned int ix=0;ix xi(ncl); vector tempEnergy(ncl); Energy sum1(ZERO); double yy(0.); // We want to make sure that the first Pt is from the // desired pt-distribution. If we select the first pt in the // trial loop we introduce a bias. Energy firstPt=softPt(); while(its < _maxtries) { ++its; Energy sumx = ZERO; Energy sumy = ZERO; unsigned int iterations(0); unsigned int _maxtriesNew = 100; while(iterations < _maxtriesNew) { iterations++; Energy sumxIt = ZERO; Energy sumyIt = ZERO; bool success=false; Energy pTmax=ZERO; for(unsigned int i = 0; ipT2...pTN //2) pT1>pT2>..>pTN //3) flat //4) y dependent //5) Frist then flat int triesPt=0; Energy pt; Energy ptTest; switch(PtDistribution_) { case 0: //default softPt() pt=softPt(); break; case 1: //pTordered if(i==0){ pt=softPt(); pTmax=pt; }else{ do{ pt=softPt(); }while(pt>pTmax); } break; case 2: //strongly pT ordered if ( i==0 ) { pt=softPt(); pTmax=pt; } else { do { if ( triesPt==20 ) { pt=pTmax; break; } pt=softPt(); triesPt++; } while ( pt>pTmax ); pTmax=pt; } break; case 3: //flat pt = UseRandom::rnd(0.0,(double)(ptmin_/GeV))*GeV; break; case 4: //flat below first pT if ( i==0 ) { pt = firstPt; } else { pt = firstPt * UseRandom::rnd(); } break; case 5: //flat but rising below first pT if ( i==0 ) { pt=firstPt; } else { pt = firstPt * pow(UseRandom::rnd(),1/2); } } Energy2 ptp = pt*pt; if(ptp <= ZERO) pt = - sqrt(-ptp); else pt = sqrt(ptp); // randomize azimuth Energy px,py; //randomize the azimuth, but the last one should cancel all others if(i CME) continue; // randomize the mom vector to get the first and the compensating parton // at all possible positions: long (*p_irnd)(long) = UseRandom::irnd; random_shuffle(mom.begin(),mom.end(),p_irnd); for(unsigned int i = 0; i=1; i--) xi[i+1] = (xi[i]-ximin)/ximax; xi[1] = 1.; yy= log(CME*CME/(mom[0].z()*mom[1].z())); bool suceeded=false; Energy sum2,sum3,sum4; for(unsigned int j = 0; j<10; j++) { sum1 = sum2 = sum3 = sum4 = ZERO; for(unsigned int i = 0; i 100) eps *= 10.; } if(its==_maxtries){ return false; } // throw Exception() << "Can't generate soft underlying event in " // << "UA5Handler::generateCylindricalPS" // << Exception::eventerror; double zz = log(CME/sum1); for(unsigned int i = 0; iDiquark or Rem->quark "decay" if(theRems.first) { diquarks.first = finalSplit(theRems.first, theContent.first.RemID(), theUsed.first); theMaps.first.push_back(make_pair(diquarks.first, tPPtr())); } if(theRems.second) { diquarks.second = finalSplit(theRems.second, theContent.second.RemID(), theUsed.second); theMaps.second.push_back(make_pair(diquarks.second, tPPtr())); } setRemMasses(); if(theRems.first) { fixColours(theMaps.first, theanti.first, colourDisrupt); if(theContent.first.hadron->id()==ParticleID::pomeron&& pomeronStructure_==0) fixColours(theMaps.first, !theanti.first, colourDisrupt); } if(theRems.second) { fixColours(theMaps.second, theanti.second, colourDisrupt); if(theContent.second.hadron->id()==ParticleID::pomeron&& pomeronStructure_==0) fixColours(theMaps.second, !theanti.second, colourDisrupt); } if( !theRems.first || !theRems.second ) return; //stop here if we don't have two remnants softRems_ = diquarks; doSoftInteractions(softInt); } HwRemDecayer::HadronContent HwRemDecayer::getHadronContent(tcPPtr hadron) const { HadronContent hc; hc.hadron = hadron->dataPtr(); long id(hadron->id()); // baryon if(BaryonMatcher::Check(hadron->data())) { hc.sign = id < 0? -1: 1; hc.flav.push_back((id = abs(id)/10)%10); hc.flav.push_back((id /= 10)%10); hc.flav.push_back((id /= 10)%10); hc.extracted = -1; } else if(hadron->data().id()==ParticleID::gamma || (hadron->data().id()==ParticleID::pomeron && pomeronStructure_==1)) { hc.sign = 1; for(int ix=1;ix<6;++ix) { hc.flav.push_back( ix); hc.flav.push_back(-ix); } } else if(hadron->data().id()==ParticleID::pomeron ) { hc.sign = 1; hc.flav.push_back(ParticleID::g); hc.flav.push_back(ParticleID::g); } else if(hadron->data().id()==ParticleID::reggeon ) { hc.sign = 1; for(int ix=1;ix<3;++ix) { hc.flav.push_back( ix); hc.flav.push_back(-ix); } } hc.pomeronStructure = pomeronStructure_; return hc; } long HwRemDecayer::HadronContent::RemID() const{ if(extracted == -1) throw Exception() << "Try to build a Diquark id without " << "having extracted something in " << "HwRemDecayer::RemID(...)" << Exception::runerror; //the hadron was a meson or photon if(flav.size()==2) return sign*flav[(extracted+1)%2]; long remId; int id1(sign*flav[(extracted+1)%3]), id2(sign*flav[(extracted+2)%3]), sign(0), spin(0); if (abs(id1) > abs(id2)) swap(id1, id2); sign = (id1 < 0) ? -1 : 1; // Needed for the spin 0/1 part remId = id2*1000+id1*100; // Now decide if we have spin 0 diquark or spin 1 diquark if(id1 == id2) spin = 3; // spin 1 else spin = 1; // otherwise spin 0 remId += sign*spin; return remId; } tPPtr HwRemDecayer::addParticle(tcPPtr parent, long id, Lorentz5Momentum p) const { PPtr newp = new_ptr(Particle(getParticleData(id))); newp->set5Momentum(p); // Add the new remnant to the step, but don't do colour connections thestep->addDecayProduct(parent,newp,false); return newp; } void HwRemDecayer::findChildren(tPPtr part,vector & particles) const { if(part->children().empty()) particles.push_back(part); else { for(unsigned int ix=0;ixchildren().size();++ix) findChildren(part->children()[ix],particles); } } ParticleVector HwRemDecayer::decay(const DecayMode &, const Particle &, Step &) const { throw Exception() << "HwRemDecayer::decay(...) " << "must not be called explicitely." << Exception::runerror; } void HwRemDecayer::persistentOutput(PersistentOStream & os) const { os << ounit(_kinCutoff, GeV) << _range << _zbin << _ybin << _nbinmax << _alphaS << _alphaEM << DISRemnantOpt_ << maxtrySoft_ << colourDisrupt_ << ladderPower_<< ladderNorm_ << ladderMult_ << ladderbFactor_ << pomeronStructure_ << ounit(mg_,GeV) << ounit(ptmin_,GeV) << ounit(beta_,sqr(InvGeV)) << allowTop_ << multiPeriph_ << valOfN_ << initTotRap_ << PtDistribution_; } void HwRemDecayer::persistentInput(PersistentIStream & is, int) { is >> iunit(_kinCutoff, GeV) >> _range >> _zbin >> _ybin >> _nbinmax >> _alphaS >> _alphaEM >> DISRemnantOpt_ >> maxtrySoft_ >> colourDisrupt_ >> ladderPower_ >> ladderNorm_ >> ladderMult_ >> ladderbFactor_ >> pomeronStructure_ >> iunit(mg_,GeV) >> iunit(ptmin_,GeV) >> iunit(beta_,sqr(InvGeV)) >> allowTop_ >> multiPeriph_ >> valOfN_ >> initTotRap_ >> PtDistribution_; } // The following static variable is needed for the type // description system in ThePEG. DescribeClass describeHerwigHwRemDecayer("Herwig::HwRemDecayer", "HwShower.so"); void HwRemDecayer::Init() { static ClassDocumentation documentation ("The HwRemDecayer class decays the remnant for Herwig"); static Parameter interfaceZBinSize ("ZBinSize", "The size of the vbins in z for the interpolation of the splitting function.", &HwRemDecayer::_zbin, 0.05, 0.001, 0.1, false, false, Interface::limited); static Parameter interfaceMaxBin ("MaxBin", "Maximum number of z bins", &HwRemDecayer::_nbinmax, 100, 10, 1000, false, false, Interface::limited); static Reference interfaceAlphaS ("AlphaS", "Pointer to object to calculate the strong coupling", &HwRemDecayer::_alphaS, false, false, true, false, false); static Reference interfaceAlphaEM ("AlphaEM", "Pointer to object to calculate the electromagnetic coupling", &HwRemDecayer::_alphaEM, false, false, true, false, false); static Parameter interfaceKinCutoff ("KinCutoff", "Parameter kinCutoff used to constrain qtilde", &HwRemDecayer::_kinCutoff, GeV, 0.75*GeV, 0.5*GeV, 10.0*GeV, false, false, Interface::limited); static Parameter interfaceEmissionRange ("EmissionRange", "Factor above the minimum possible value in which the forced splitting is allowed.", &HwRemDecayer::_range, 1.1, 1.0, 10.0, false, false, Interface::limited); static Switch interfaceDISRemnantOption ("DISRemnantOption", "Options for the treatment of the remnant in DIS", &HwRemDecayer::DISRemnantOpt_, 0, false, false); static SwitchOption interfaceDISRemnantOptionDefault (interfaceDISRemnantOption, "Default", "Use the minimum number of particles needed to take the recoil" " and allow the lepton to be used if needed", 0); static SwitchOption interfaceDISRemnantOptionNoLepton (interfaceDISRemnantOption, "NoLepton", "Use the minimum number of particles needed to take the recoil but" " veto events where the lepton kinematics would need to be altered", 1); static SwitchOption interfaceDISRemnantOptionAllParticles (interfaceDISRemnantOption, "AllParticles", "Use all particles in the colour connected system to take the recoil" " and use the lepton if needed.", 2); static SwitchOption interfaceDISRemnantOptionAllParticlesNoLepton (interfaceDISRemnantOption, "AllParticlesNoLepton", "Use all the particles in the colour connected system to take the" " recoil but don't use the lepton.", 3); static Parameter interfaceMaxTrySoft ("MaxTrySoft", "The maximum number of regeneration attempts for an additional soft scattering", &HwRemDecayer::maxtrySoft_, 10, 0, 100, false, false, Interface::limited); static Parameter interfacecolourDisrupt ("colourDisrupt", "Fraction of connections to additional soft subprocesses, which are colour disrupted.", &HwRemDecayer::colourDisrupt_, 1.0, 0.0, 1.0, false, false, Interface::limited); static Parameter interaceladderPower ("ladderPower", "The power factor in the ladder parameterization.", &HwRemDecayer::ladderPower_, 1.0, -5.0, 10.0, false, false, Interface::limited); static Parameter interfaceladderNorm ("ladderNorm", "The normalization factor in the ladder parameterization", &HwRemDecayer::ladderNorm_, 1.0, 0.0, 10.0, false, false, Interface::limited); static Parameter interfaceladderMult ("ladderMult", "The ladder multiplicity factor ", &HwRemDecayer::ladderMult_, 1.0, 0.0, 10.0, false, false, Interface::limited); static Parameter interfaceladderbFactor ("ladderbFactor", "The additive factor in the multiperipheral ladder multiplicity.", &HwRemDecayer::ladderbFactor_, 1.0, 0.0, 10.0, false, false, Interface::limited); static Parameter interfacegaussWidth ("gaussWidth", "The gaussian width of the fluctuation of longitudinal momentum fraction.", &HwRemDecayer::gaussWidth_, 0.1, 0.0, 1.0, false, false, Interface::limited); static Switch interfacePomeronStructure ("PomeronStructure", "Option for the treatment of the valance structure of the pomeron", &HwRemDecayer::pomeronStructure_, 0, false, false); static SwitchOption interfacePomeronStructureGluon (interfacePomeronStructure, "Gluon", "Assume the pomeron is a two gluon state", 0); static SwitchOption interfacePomeronStructureQQBar (interfacePomeronStructure, "QQBar", "Assumne the pomeron is q qbar as for the photon," " this option is not recommended and is provide for compatiblity with POMWIG", 1); static Switch interfaceAllowTop ("AllowTop", "Allow top quarks in the hadron", &HwRemDecayer::allowTop_, false, false, false); static SwitchOption interfaceAllowTopNo (interfaceAllowTop, "No", "Don't allow them", false); static SwitchOption interfaceAllowTopYes (interfaceAllowTop, "Yes", "Allow them", true); static Switch interfaceMultiPeriph ("MultiPeriph", "Use multiperipheral kinematics", &HwRemDecayer::multiPeriph_, false, false, false); static SwitchOption interfaceMultiPeriphNo (interfaceMultiPeriph, "No", "Don't use multiperipheral", false); static SwitchOption interfaceMultiPeriphYes (interfaceMultiPeriph, "Yes", "Use multiperipheral kinematics", true); static Switch interfacePtDistribution ("PtDistribution", "Options for different pT generation methods", &HwRemDecayer::PtDistribution_, 0, false, false); static SwitchOption interfacePtDistributionDefault (interfacePtDistribution, "Default", "Default generation of pT", 0); static SwitchOption interfacePtDistributionOrdered (interfacePtDistribution, "Ordered", "Ordered generation of pT,where the first pT is the hardest", 1); static SwitchOption interfacePtDistributionStronglyOrdered (interfacePtDistribution, "StronglyOrdered", "Strongly ordered generation of pT", 2); static SwitchOption interfacePtDistributionFlat (interfacePtDistribution, "Flat", "Sample from a flat pT distribution", 3); static SwitchOption interfacePtDistributionFlatOrdered (interfacePtDistribution, "FlatOrdered", "First pT normal, then flat", 4); static SwitchOption interfacePtDistributionFlatOrdered2 (interfacePtDistribution, "FlatOrdered2", "First pT normal, then flat but steep", 5); } bool HwRemDecayer::canHandle(tcPDPtr particle, tcPDPtr parton) const { if(! (StandardQCDPartonMatcher::Check(*parton) || parton->id()==ParticleID::gamma) ) { if(abs(parton->id())==ParticleID::t) { if(!allowTop_) throw Exception() << "Top is not allow as a parton in the remant handling, please " << "use a PDF which does not contain top for the remnant" << " handling (preferred) or allow top in the remnant using\n" << " set " << fullName() << ":AllowTop Yes\n" << Exception::runerror; } else return false; } return HadronMatcher::Check(*particle) || particle->id()==ParticleID::gamma || particle->id()==ParticleID::pomeron || particle->id()==ParticleID::reggeon; } bool HwRemDecayer::isPartonic(tPPtr parton) const { if(parton->parents().empty()) return false; tPPtr parent = parton->parents()[0]; bool partonic = false; for(unsigned int ix=0;ixchildren().size();++ix) { if(dynamic_ptr_cast(parent->children()[ix])) { partonic = true; break; } } return partonic; } diff --git a/Tests/Makefile.am b/Tests/Makefile.am --- a/Tests/Makefile.am +++ b/Tests/Makefile.am @@ -1,391 +1,371 @@ AM_LDFLAGS += -module -avoid-version -rpath /dummy/path/not/used EXTRA_DIST = Inputs python Rivet EXTRA_LTLIBRARIES = LeptonTest.la GammaTest.la HadronTest.la DISTest.la if WANT_LIBFASTJET EXTRA_LTLIBRARIES += HadronJetTest.la LeptonJetTest.la HadronJetTest_la_SOURCES = \ Hadron/VHTest.h Hadron/VHTest.cc\ Hadron/VTest.h Hadron/VTest.cc\ Hadron/HTest.h Hadron/HTest.cc HadronJetTest_la_CPPFLAGS = $(AM_CPPFLAGS) $(FASTJETINCLUDE) \ -I$(FASTJETPATH) HadronJetTest_la_LIBADD = $(FASTJETLIBS) LeptonJetTest_la_SOURCES = \ Lepton/TopDecay.h Lepton/TopDecay.cc LeptonJetTest_la_CPPFLAGS = $(AM_CPPFLAGS) $(FASTJETINCLUDE) \ -I$(FASTJETPATH) LeptonJetTest_la_LIBADD = $(FASTJETLIBS) endif LeptonTest_la_SOURCES = \ Lepton/VVTest.h Lepton/VVTest.cc \ Lepton/VBFTest.h Lepton/VBFTest.cc \ Lepton/VHTest.h Lepton/VHTest.cc \ Lepton/FermionTest.h Lepton/FermionTest.cc GammaTest_la_SOURCES = \ Gamma/GammaMETest.h Gamma/GammaMETest.cc \ Gamma/GammaPMETest.h Gamma/GammaPMETest.cc DISTest_la_SOURCES = \ DIS/DISTest.h DIS/DISTest.cc HadronTest_la_SOURCES = \ Hadron/HadronVVTest.h Hadron/HadronVVTest.cc\ Hadron/HadronVBFTest.h Hadron/HadronVBFTest.cc\ Hadron/WHTest.h Hadron/WHTest.cc\ Hadron/ZHTest.h Hadron/ZHTest.cc\ Hadron/VGammaTest.h Hadron/VGammaTest.cc\ Hadron/ZJetTest.h Hadron/ZJetTest.cc\ Hadron/WJetTest.h Hadron/WJetTest.cc\ Hadron/QQHTest.h Hadron/QQHTest.cc REPO = $(top_builddir)/src/HerwigDefaults.rpo HERWIG = $(top_builddir)/src/Herwig HWREAD = $(HERWIG) read --repo $(REPO) -L $(builddir)/.libs -i $(top_builddir)/src HWBUILD = $(HERWIG) build --repo $(REPO) -L $(builddir)/.libs -i $(top_builddir)/src HWINTEGRATE = $(HERWIG) integrate HWRUN = $(HERWIG) run -N $${NUMEVENTS:-10000} tests : tests-LEP tests-DIS tests-LHC tests-Gamma LEPDEPS = \ test-LEP-VV \ test-LEP-VH \ test-LEP-VBF \ test-LEP-BB \ test-LEP-Quarks \ test-LEP-Leptons if WANT_LIBFASTJET LEPDEPS += test-LEP-TopDecay endif tests-LEP : $(LEPDEPS) tests-DIS : test-DIS-Charged test-DIS-Neutral LHCDEPS = \ test-LHC-WW test-LHC-WZ test-LHC-ZZ \ test-LHC-ZGamma test-LHC-WGamma \ test-LHC-ZH test-LHC-WH \ test-LHC-ZJet test-LHC-WJet \ test-LHC-Z test-LHC-W \ test-LHC-ZZVBF test-LHC-VBF \ test-LHC-WWVBF \ test-LHC-bbH test-LHC-ttH \ test-LHC-GammaGamma test-LHC-GammaJet \ test-LHC-Higgs test-LHC-HiggsJet \ test-LHC-QCDFast test-LHC-QCD \ test-LHC-Top if WANT_LIBFASTJET LHCDEPS += \ test-LHC-Bottom \ test-LHC-WHJet test-LHC-ZHJet test-LHC-HJet \ test-LHC-ZShower test-LHC-WShower \ test-LHC-WHJet-Powheg test-LHC-ZHJet-Powheg test-LHC-HJet-Powheg \ test-LHC-ZShower-Powheg test-LHC-WShower-Powheg endif tests-LHC : $(LHCDEPS) tests-Gamma : test-Gamma-FF test-Gamma-WW test-Gamma-P LEPLIBS = LeptonTest.la HADLIBS = HadronTest.la if WANT_LIBFASTJET LEPLIBS += LeptonJetTest.la HADLIBS += HadronJetTest.la endif test-LEP-% : Inputs/LEP-%.in $(LEPLIBS) $(HWREAD) $< $(HWRUN) $(notdir $(subst .in,.run,$<)) test-Gamma-% : Inputs/Gamma-%.in GammaTest.la $(HWREAD) $< $(HWRUN) $(notdir $(subst .in,.run,$<)) test-DIS-% : Inputs/DIS-%.in DISTest.la $(HWREAD) $< $(HWRUN) $(notdir $(subst .in,.run,$<)) test-LHC-% : Inputs/LHC-%.in GammaTest.la $(HADLIBS) $(HWREAD) $< $(HWRUN) $(notdir $(subst .in,.run,$<)) - - - - -tests-Rivet : Rivet-LEP Rivet-BFactory Rivet-DIS Rivet-Star Rivet-SppS \ - Rivet-TVT-WZ Rivet-TVT-Photon Rivet-TVT-Jets \ - Rivet-LHC-Jets Rivet-LHC-EW Rivet-LHC-Photon Rivet-LHC-Higgs - - +tests-Rivet : Rivet-EE Rivet-DIS Rivet-Star Rivet-SppS \ + Rivet-TVT-WZ Rivet-TVT-Photon Rivet-TVT-Jets \ + Rivet-LHC-Jets Rivet-LHC-EW Rivet-LHC-Photon Rivet-LHC-Higgs Rivet-%.run : Rivet/%.in $(HWBUILD) -c .cache/$(subst .run,,$@) $< Rivet-Matchbox-%.yoda : Rivet-Matchbox-%.run $(HWINTEGRATE) -c .cache/$(subst .run,,$<) $< $(HWRUN) -c .cache/$(subst .run,,$<) $< Rivet-%.yoda : Rivet-%.run $(HWRUN) $< Rivet/%.in : python/make_input_files.py $(notdir $(subst .in,,$@)) - - -Rivet-inputfiles: $(shell echo Rivet/LEP{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg,-Merging}-{9.4,12,13,17,27.6,29,30.2,30.7,30,31.3,34.8,41,43.6,45,50,52,55,56,57,60.8,60,61.4,66,76,82,8510,12.8,22,26.8,35,44,48.0,91,93.0,130,133,136,161,172,177,183,189,192,196,197,200,202,206,91-nopi}.in) \ - $(shell echo Rivet/LEP{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Powheg,-Matchbox-Powheg}-14.in) \ - $(shell echo Rivet/LEP{,-Dipole}-{10.5,11.96,12.8,13.96,16.86,21.84,26.8,28.48,35.44,48.0,97.0}-gg.in) \ - $(shell echo Rivet/BFactory{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg}-{10.52,10.52-sym,10.54,10.45,10.47}.in) \ - $(shell echo Rivet/BFactory{,-Dipole}-{Upsilon,Upsilon2,Upsilon4,Tau,10.58-res}.in) \ +Rivet-inputfiles: $(shell echo Rivet/EE{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg,-Merging}-{7.7,9.4,12,13,17,27.6,29,30.2,30.7,30,31.3,34,34.8,41,42.1,42.6,43.6,45,50,52,53.3,55,56,57,58,59.5,60.8,60,61.4,66,76,82,85,10,12.8,21.5,22,25,26.8,34.5,35,36.2,44,48.0,91,93.0,130,133,136,161,172,177,183,189,192,196,197,200,202,205,206,207,91-nopi}.in) \ + $(shell echo Rivet/EE{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Powheg,-Matchbox-Powheg}-{14,14.8}.in) \ + $(shell echo Rivet/EE{,-Dipole}-{10.5,11.96,12.8,13.96,16.86,21.84,26.8,28.48,35.44,48.0,97.0}-gg.in) \ + $(shell echo Rivet/EE{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg}-{2.2,2.6,3.0,3.2,4.6,4.8,3.63,4.03,4.5,9.46,10.00,10.52,10.52-sym,10.54,10.45,10.47}.in) \ + $(shell echo Rivet/EE-{Upsilon,Upsilon2,Upsilon4,JPsi,Psi2S,Tau,Phi,10.58-res,Lambdac,Omega,Xi0,Xic0,Xim}.in) \ $(shell echo Rivet/DIS{,-NoME,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg,-Merging}-{e--LowQ2,e+-LowQ2,e+-HighQ2}.in) \ $(shell echo Rivet/TVT{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg,-Merging}-{Run-I-Z,Run-I-W,Run-I-WZ,Run-II-Z-e,Run-II-Z-{,LowMass-,HighMass-}mu,Run-II-W}.in) \ $(shell echo Rivet/TVT{,-Dipole}-Run-II-{DiPhoton-GammaGamma,DiPhoton-GammaJet,PromptPhoton}.in) \ $(shell echo Rivet/TVT-Powheg-Run-II-{DiPhoton-GammaGamma,DiPhoton-GammaJet}.in) \ $(shell echo Rivet/TVT{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-{Run-II-Jets-{0..11},Run-I-Jets-{1..8}}.in ) \ $(shell echo Rivet/TVT{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-{630-Jets-{1..3},300-Jets-1,900-Jets-1}.in ) \ $(shell echo Rivet/TVT{,-Dipole}-{Run-I,Run-II,300,630,900}-UE.in) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-7-DiJets-{1..7}-{A,B,C}.in ) \ - $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-13-DiJets-{6..11}-A.in ) \ + $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-13-DiJets-{{1..11}-A,{6..11}-B}.in ) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-{7,8,13}-Jets-{0..10}.in ) \ $(shell echo Rivet/LHC{,-Dipole}-{900,2360,2760,7,8,13}-UE.in ) \ $(shell echo Rivet/LHC{,-Dipole}-{900,7,13}-UE-Long.in ) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-7-Charm-{1..5}.in) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-7-Bottom-{0..9}.in) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-7-Top-{L,SL}.in) \ $(shell echo Rivet/LHC{,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox,-Matchbox-Powheg,-Merging}-{8,13}-Top-{All,L,SL}.in) \ $(shell echo Rivet/Star{,-Dipole}-{UE,Jets-{1..4}}.in ) \ $(shell echo Rivet/SppS{,-Dipole}-{200,500,900,546}-UE.in ) \ $(shell echo Rivet/LHC{,-Matchbox,-Matchbox-Powheg,-Powheg,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-{W-{e,mu},13-Z-{e,mu},Z-HighMass{1,2}-e,{8,13}-W-mu,8-Z-Mass{1..4}-{e,mu},Z-{e,mu,mu-SOPHTY},Z-LowMass-{e,mu},Z-MedMass-e,WZ,WW-{emu,ll},ZZ-{ll,lv},{8,13}-WZ,8-ZZ-lv,8-WW-ll,Z-mu-Short}.in) \ $(shell echo Rivet/LHC{,-Dipole}-7-{W,Z}Gamma-{e,mu}.in) \ $(shell echo Rivet/LHC{,-Dipole}-8-ZGamma-{e,mu}.in) \ $(shell echo Rivet/LHC{,-Matchbox,-Matchbox-Powheg,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-{7-W-Jet-{1..3}-e,7-Z-Jet-{0..3}-e,7-Z-Jet-0-mu}.in) \ $(shell echo Rivet/LHC{-Matchbox,-Matchbox-Powheg,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-{Z-b,Z-bb,8-Z-b,8-Z-bb,W-b,8-Z-jj}.in) \ $(shell echo Rivet/LHC{,-Dipole}-{7,8,13}-PromptPhoton-{1..4}.in) Rivet/LHC-GammaGamma-7.in \ $(shell echo Rivet/LHC{,-Powheg}-{7,8}-{DiPhoton-GammaGamma,DiPhoton-GammaJet}.in) \ $(shell echo Rivet/LHC{,-Powheg,-Matchbox,-Matchbox-Powheg,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-{ggH,VBF,WH,ZH}.in) \ $(shell echo Rivet/LHC{,-Powheg,-Matchbox,-Matchbox-Powheg,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-8-{{ggH,VBF,WH,ZH}{,-GammaGamma},ggH-WW}.in) \ $(shell echo Rivet/LHC{,-Matchbox,-Matchbox-Powheg,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Merging}-ggHJet.in) # $(shell echo Rivet/ISR-{30,44,53,62}-UE.in ) $(shell echo Rivet/SppS-{53,63}-UE.in ) Rivet-GammaGamma: Rivet-GammaGamma/done touch $@ Rivet-GammaGamma/done: $(shell echo Rivet-GammaGamma-mumu-{3.5,4.5,5.5,6.5,7.5,9.0,12.5,17.5,30.0}.yoda ) rm -rf Rivet-GammaGamma python/merge-GammaGamma GammaGamma rivet-mkhtml -o Rivet-GammaGamma GammaGamma.yoda:Hw touch $@ -Rivet-LEP-Gamma: Rivet-LEP-Gamma/done +Rivet-EE-Gamma: Rivet-EE-Gamma/done touch $@ -Rivet-LEP-Gamma/done: $(shell echo Rivet-LEP-Gamma-Direct-mumu-{161,172,183,189,196,206}.yoda ) \ - $(shell echo Rivet-LEP-Gamma-Direct-tautau-{189,196,206}.yoda ) \ - $(shell echo Rivet-LEP-Gamma-{Direct,Single-Resolved,Double-Resolved}-Jets-{198,206}.yoda ) - rm -rf Rivet-LEP-Gamma - python/merge-LEP-Gamma LEP-Gamma - rivet-mkhtml -o Rivet-LEP-Gamma LEP-Gamma.yoda:Hw +Rivet-EE-Gamma/done: $(shell echo Rivet-EE-Gamma-Direct-mumu-{161,172,183,189,196,206}.yoda ) \ + $(shell echo Rivet-EE-Gamma-Direct-tautau-{189,196,206}.yoda ) \ + $(shell echo Rivet-EE-Gamma-{Direct,Single-Resolved,Double-Resolved}-Jets-{198,206}.yoda ) + rm -rf Rivet-EE-Gamma + python/merge-EE-Gamma EE-Gamma + rivet-mkhtml -o Rivet-EE-Gamma EE-Gamma.yoda:Hw touch $@ -Rivet-LEP : Rivet-LEP/done +Rivet-EE : Rivet-EE/done touch $@ -Rivet-LEP/done : $(shell echo Rivet{,-Powheg}-LEP-{9.4,12,13,14,17,27.6,29,30.2,30.7,30,31.3,34.8,43.6,45,50,52,55,56,57,60.8,60,61.4,66,76,10,12.8,22,26.8,35,41,44,48.0,82,85,91,93.0,130,133,136,161,172,177,183,189,192,196,197,200,202,206,91-nopi}.yoda) \ - $(shell echo Rivet-LEP-{10.5,11.96,12.8,13.96,16.86,21.84,26.8,28.48,35.44,48.0,97.0}-gg.yoda) - rm -rf Rivet-LEP - python/merge-LEP --with-gg LEP - python/merge-LEP Powheg-LEP - rivet-mkhtml -o Rivet-LEP LEP.yoda:Hw Powheg-LEP.yoda:Hw-Powheg +Rivet-EE/done : $(shell echo Rivet{,-Powheg}-EE-{7.7,9.4,12,13,14,14.8,17,27.6,29,30.2,30.7,30,31.3,34,34.8,43.6,45,50,52,53.3,55,56,57,58,59.5,60.8,60,61.4,66,76,10,12.8,21.5,22,25,26.8,34.5,35,36.2,41,42.1,42.6,44,48.0,82,85,91,93.0,130,133,136,161,172,177,183,189,192,196,197,200,202,205,206,207,91-nopi}.yoda) \ + $(shell echo Rivet-EE-{10.5,11.96,12.8,13.96,16.86,21.84,26.8,28.48,35.44,48.0,97.0}-gg.yoda) \ + $(shell echo Rivet-EE-{10.52,10.52-sym,2.2,2.6,3.0,3.2,4.6,4.8,3.63,4.03,4.5,9.46,10.00,10.54,10.45,10.47,Upsilon,Upsilon2,Upsilon4,Tau,Phi,10.58-res,10.58,Lambdac,Omega,Xi0,Xic0,Xim,JPsi,Psi2S}.yoda) + rm -rf Rivet-EE + python/merge-EE --with-gg EE + python/merge-EE Powheg-EE + rivet-mkhtml -o Rivet-EE EE.yoda:Hw Powheg-EE.yoda:Hw-Powheg + python/plot-EE Rivet-EE touch $@ - - - -Rivet-BFactory : Rivet-BFactory/done - touch $@ - -Rivet-BFactory/done: $(shell echo Rivet-BFactory-{10.52,10.52-sym,10.54,10.45,10.47,Upsilon,Upsilon2,Upsilon4,Tau,10.58-res,10.58}.yoda) - rm -rf Rivet-BFactory - python/merge-BFactory BFactory - rivet-mkhtml -o Rivet-BFactory BFactory.yoda:Hw - touch $@ - - - Rivet-DIS : Rivet-DIS/done touch $@ Rivet-DIS/done: $(shell echo Rivet{-DIS,-DIS-NoME,-Powheg-DIS}-{e--LowQ2,e+-LowQ2,e+-HighQ2}.yoda) rm -rf Rivet-DIS python/merge-DIS DIS python/merge-DIS Powheg-DIS python/merge-DIS DIS-NoME rivet-mkhtml -o Rivet-DIS DIS.yoda:Hw Powheg-DIS.yoda:Hw-Powheg DIS-NoME.yoda:Hw-NoME touch $@ Rivet-TVT-EW : Rivet-TVT-EW/done touch $@ Rivet-TVT-EW/done: $(shell echo Rivet{,-Powheg}-TVT-{Run-I-Z,Run-I-W,Run-I-WZ,Run-II-Z-{e,{,LowMass-,HighMass-}mu},Run-II-W}.yoda) rm -rf Rivet-TVT-EW python/merge-TVT-EW TVT python/merge-TVT-EW Powheg-TVT rivet-mkhtml -o Rivet-TVT-EW TVT-EW.yoda:Hw Powheg-TVT-EW.yoda:Hw-Powheg touch $@ Rivet-TVT-Photon : Rivet-TVT-Photon/done touch $@ Rivet-TVT-Photon/done: $(shell echo Rivet{,-Powheg}-TVT-Run-II-{DiPhoton-GammaGamma,DiPhoton-GammaJet}.yoda Rivet-TVT-Run-II-PromptPhoton.yoda) rm -rf Rivet-TVT-Photon python/merge-TVT-Photon TVT python/merge-TVT-Photon Powheg-TVT rivet-mkhtml -o Rivet-TVT-Photon TVT-Photon.yoda:Hw Powheg-TVT-Photon.yoda:Hw-Powheg touch $@ Rivet-TVT-Jets : Rivet-TVT-Jets/done touch $@ Rivet-TVT-Jets/done: $(shell echo Rivet-TVT-{Run-II-Jets-{0..11},Run-I-Jets-{1..8}}.yoda ) \ $(shell echo Rivet-TVT-{630-Jets-{1..3},300-Jets-1,900-Jets-1}.yoda ) \ $(shell echo Rivet-TVT-{Run-I,Run-II,300,630,900}-UE.yoda) rm -rf Rivet-TVT-Jets python/merge-TVT-Jets TVT rivet-mkhtml -o Rivet-TVT-Jets TVT-Jets.yoda:Hw touch $@ Rivet-Star : Rivet-Star/done touch $@ Rivet-Star/done : $(shell echo Rivet-Star-{UE,Jets-{1..4}}.yoda ) rm -rf Rivet-Star python/merge-Star Star rivet-mkhtml -o Rivet-Star Star.yoda:Hw touch $@ Rivet-SppS : Rivet-SppS/done touch $@ ## $(shell echo Rivet-ISR-{30,44,53,62}-UE.yoda ) \ ## {53,63,200,500,900,546} EHS-UE Rivet-SppS/done : $(shell echo Rivet-SppS-{200,500,900,546}-UE.yoda ) rm -rf Rivet-SppS python/merge-SppS SppS rivet-mkhtml -o Rivet-SppS SppS.yoda:Hw touch $@ Rivet-LHC-Jets : Rivet-LHC-Jets/done touch $@ Rivet-LHC-Jets/done : \ $(shell echo Rivet-LHC-7-DiJets-{1..7}-{A,B,C}.yoda ) \ - $(shell echo Rivet-LHC-13-DiJets-{6..11}-A.yoda ) \ + $(shell echo Rivet-LHC-13-DiJets-{{1..11}-A,{6..11}-B}.yoda ) \ $(shell echo Rivet-LHC-{7,8,13}-Jets-{0..10}.yoda ) \ $(shell echo Rivet-LHC-2760-Jets-{1..3}.yoda ) \ $(shell echo Rivet-LHC-{900,2360,2760,7,8,13}-UE.yoda ) \ $(shell echo Rivet-LHC-{900,7,13}-UE-Long.yoda ) \ $(shell echo Rivet-LHC-7-Charm-{1..5}.yoda ) \ $(shell echo Rivet-LHC-7-Bottom-{0..9}.yoda ) \ $(shell echo Rivet-LHC-{7,8,13}-Top-{L,SL}.yoda ) \ $(shell echo Rivet-LHC-{8,13}-Top-All.yoda ) rm -rf Rivet-LHC-Jets python/merge-LHC-Jets LHC rivet-mkhtml -o Rivet-LHC-Jets LHC-Jets.yoda:Hw touch $@ Rivet-LHC-EW : Rivet-LHC-EW/done touch $@ Rivet-LHC-EW/done: \ $(shell echo Rivet{,-Powheg}-LHC-{13-Z-{e,mu},{8,13}-W-mu,Z-HighMass{1,2}-e,8-Z-Mass{1..4}-{e,mu},W-{e,mu},Z-{e,mu,mu-SOPHTY},Z-LowMass-{e,mu},Z-MedMass-e,WZ,WW-{emu,ll},ZZ-{ll,lv},{8,13}-WZ,8-ZZ-lv,8-WW-ll,Z-mu-Short}.yoda) \ $(shell echo Rivet-LHC-{7-W-Jet-{1..3}-e,7-Z-Jet-{0..3}-e,7-Z-Jet-0-mu}.yoda) \ $(shell echo Rivet-LHC-7-{W,Z}Gamma-{e,mu}.yoda) \ $(shell echo Rivet-LHC-8-ZGamma-{e,mu}.yoda) rm -rf Rivet-LHC-EW; python/merge-LHC-EW LHC python/merge-LHC-EW Powheg-LHC rivet-mkhtml -o Rivet-LHC-EW LHC-EW.yoda:Hw Powheg-LHC-EW.yoda:Hw-Powheg \ Rivet-LHC-Z-mu-SOPHTY.yoda:Hw Rivet-Powheg-LHC-Z-mu-SOPHTY.yoda:Hw-Powheg touch $@ Rivet-LHC-Photon : Rivet-LHC-Photon/done touch $@ Rivet-LHC-Photon/done: \ $(shell echo Rivet-LHC-{7,8,13}-PromptPhoton-{1..4}.yoda) \ Rivet-LHC-GammaGamma-7.yoda \ $(shell echo Rivet{,-Powheg}-LHC-{7,8}-{DiPhoton-GammaGamma,DiPhoton-GammaJet}.yoda) rm -rf Rivet-LHC-Photon python/merge-LHC-Photon LHC python/merge-LHC-Photon Powheg-LHC rivet-mkhtml -o Rivet-LHC-Photon LHC-Photon.yoda:Hw Powheg-LHC-Photon.yoda:Hw-Powheg touch $@ Rivet-LHC-Higgs : Rivet-LHC-Higgs/done touch $@ Rivet-LHC-Higgs/done: \ $(shell echo Rivet{,-Powheg}-LHC-{ggH,VBF,WH,ZH}.yoda) \ $(shell echo Rivet{,-Powheg}-LHC-8-{{ggH,VBF,WH,ZH}{,-GammaGamma},ggH-WW}.yoda) \ Rivet-LHC-ggHJet.yoda yodamerge --add Rivet-Powheg-LHC-8-{ggH{-GammaGamma,-WW,},{VBF,ZH,WH}{,-GammaGamma}}.yoda -o Powheg-LHC-Higgs.yoda yodamerge --add Rivet-LHC-8-{ggH{-GammaGamma,-WW,},{VBF,ZH,WH}{,-GammaGamma}}.yoda -o LHC-Higgs.yoda rm -rf Rivet-LHC-Higgs rivet-mkhtml -o Rivet-LHC-Higgs Powheg-LHC-Higgs.yoda:Hw-Powheg LHC-Higgs.yoda:Hw\ Rivet-Powheg-LHC-ggH.yoda:gg-Powheg Rivet-LHC-ggH.yoda:gg Rivet-LHC-ggHJet.yoda:HJet \ Rivet-Powheg-LHC-VBF.yoda:VBF-Powheg Rivet-LHC-VBF.yoda:VBF Rivet-LHC-WH.yoda:WH Rivet-LHC-ZH.yoda:ZH \ Rivet-Powheg-LHC-WH.yoda:WH-Powheg Rivet-Powheg-LHC-ZH.yoda:ZH-Powheg touch $@ clean-local: - rm -f *.out *.log *.tex *.top *.run *.dump *.mult *.Bmult *.yoda Rivet/*.in + rm -f *.out *.log *.tex *.top *.run *.dump *.mult *.Bmult *.yoda Rivet/*.in anatohepmc.txt hepmctoana.txt rm -rf Rivet-* distclean-local: rm -rf .cache diff --git a/Tests/Rivet/BFactory/BFactory-10.45.in b/Tests/Rivet/BFactory/BFactory-10.45.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.45.in +++ /dev/null @@ -1,11 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.225 -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.225 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity - -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 diff --git a/Tests/Rivet/BFactory/BFactory-10.47.in b/Tests/Rivet/BFactory/BFactory-10.47.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.47.in +++ /dev/null @@ -1,10 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.235 -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.235 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity - -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319102 diff --git a/Tests/Rivet/BFactory/BFactory-10.52-sym.in b/Tests/Rivet/BFactory/BFactory-10.52-sym.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.52-sym.in +++ /dev/null @@ -1,11 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.26*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.26*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.50 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity - -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2004_S5809304 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2017_I1606201 diff --git a/Tests/Rivet/BFactory/BFactory-10.52.in b/Tests/Rivet/BFactory/BFactory-10.52.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.52.in +++ /dev/null @@ -1,10 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 7.91*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity - -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2013_I1216515 diff --git a/Tests/Rivet/BFactory/BFactory-10.54.in b/Tests/Rivet/BFactory/BFactory-10.54.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.54.in +++ /dev/null @@ -1,11 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 7.94*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S6895344 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1238276 \ No newline at end of file diff --git a/Tests/Rivet/BFactory/BFactory-10.58-res.in b/Tests/Rivet/BFactory/BFactory-10.58-res.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.58-res.in +++ /dev/null @@ -1,12 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2001_S4598261 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S6895344 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2003_I593379 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2017_I1512299 \ No newline at end of file diff --git a/Tests/Rivet/BFactory/BFactory-10.58.in b/Tests/Rivet/BFactory/BFactory-10.58.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-10.58.in +++ /dev/null @@ -1,9 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 diff --git a/Tests/Rivet/BFactory/BFactory-Tau.in b/Tests/Rivet/BFactory/BFactory-Tau.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-Tau.in +++ /dev/null @@ -1,18 +0,0 @@ -erase /Herwig/EventHandlers/EventHandler:PostSubProcessHandlers 0 -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.58299 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -# Matrix elements -set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEee2gZ2ll -set /Herwig/MatrixElements/MEee2gZ2ll:Allowed Tau -set /Herwig/Particles/pi0:Stable Stable -# Babar three pion -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S7266081 -# BELLE pipi -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2008_I786560 -# ALEPH spectral functions -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2014_I1267648 diff --git a/Tests/Rivet/BFactory/BFactory-Upsilon.in b/Tests/Rivet/BFactory/BFactory-Upsilon.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-Upsilon.in +++ /dev/null @@ -1,15 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 4.73*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 4.73*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.45 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -# set hard process -create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so -set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon -set /Herwig/MatrixElements/MEUpsilon:Coupling 0.0004151809 -set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 diff --git a/Tests/Rivet/BFactory/BFactory-Upsilon2.in b/Tests/Rivet/BFactory/BFactory-Upsilon2.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-Upsilon2.in +++ /dev/null @@ -1,13 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.0125*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.0125*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.02 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so -set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(2S) -set /Herwig/MatrixElements/MEUpsilon:Coupling 0.0004151809 -set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon -# BELLE charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 diff --git a/Tests/Rivet/BFactory/BFactory-Upsilon4.in b/Tests/Rivet/BFactory/BFactory-Upsilon4.in deleted file mode 100644 --- a/Tests/Rivet/BFactory/BFactory-Upsilon4.in +++ /dev/null @@ -1,22 +0,0 @@ -create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.29*GeV -set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.29*GeV -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5799 -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity -create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so -set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) -set /Herwig/MatrixElements/MEUpsilon:Coupling 0.0004151809 -set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon -# ARGUS pi,K, proton -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2653028 -# ARGUS K*, rho, omega -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 -# various semileptonic decays -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1116411 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2015_I1334693 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2011_I878990 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2013_I1238273 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2015_I1397632 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319102 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-198.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-198.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-198.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. +################################################## +# select the analyses +################################################## +# L3 jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 +# OPAL jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 \ No newline at end of file diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-206.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-Jets-206.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-161.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-161.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-161.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 161. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-172.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-172.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-172.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 172. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-183.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-183.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-183.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 183. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-189.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-189.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-189.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-196.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-196.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-196.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-206.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-mumu-206.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-189.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-189.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-189.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-196.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-196.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-196.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-206.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Direct-tautau-206.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-198.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-198.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-198.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. +################################################## +# select the analyses +################################################## +# L3 jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 +# OPAL jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-206.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Double-Resolved-Jets-206.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-198.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-198.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-198.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. +################################################## +# select the analyses +################################################## +# L3 jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 +# OPAL jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 diff --git a/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-206.in b/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE-Gamma/EE-Gamma-Single-Resolved-Jets-206.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# L3 mu+mu- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/EE/EE-10.00.in b/Tests/Rivet/EE/EE-10.00.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.00.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.0 +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.4 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# argus eta pi0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I268577 +# argus phi +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I262551 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I276860 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1988_I251097 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I262415 diff --git a/Tests/Rivet/EE/EE-10.45.in b/Tests/Rivet/EE/EE-10.45.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.45.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.225 +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.225 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 diff --git a/Tests/Rivet/EE/EE-10.47.in b/Tests/Rivet/EE/EE-10.47.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.47.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.235 +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.235 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319102 diff --git a/Tests/Rivet/EE/EE-10.5-gg.in b/Tests/Rivet/EE/EE-10.5-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.5-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 10.5 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-10.52-sym.in b/Tests/Rivet/EE/EE-10.52-sym.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.52-sym.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.26*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.26*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.50 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# CLEO charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2004_S5809304 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2000_I526554 +# CLEO baryon assymetry +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2001_I552541 +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2017_I1606201 diff --git a/Tests/Rivet/EE/EE-10.52.in b/Tests/Rivet/EE/EE-10.52.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.52.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 7.91*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2013_I1216515 diff --git a/Tests/Rivet/EE/EE-10.54.in b/Tests/Rivet/EE/EE-10.54.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.54.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 7.94*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S6895344 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1238276 \ No newline at end of file diff --git a/Tests/Rivet/EE/EE-10.58-res.in b/Tests/Rivet/EE/EE-10.58-res.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.58-res.in @@ -0,0 +1,13 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2001_S4598261 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S6895344 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2003_I593379 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2017_I1512299 diff --git a/Tests/Rivet/EE/EE-10.58.in b/Tests/Rivet/EE/EE-10.58.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.58.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 diff --git a/Tests/Rivet/EE/EE-10.in b/Tests/Rivet/EE/EE-10.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-10.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 10. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9. +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS diff --git a/Tests/Rivet/EE/EE-11.96-gg.in b/Tests/Rivet/EE/EE-11.96-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-11.96-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 11.96 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-12.8-gg.in b/Tests/Rivet/EE/EE-12.8-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-12.8-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-12.8.in b/Tests/Rivet/EE/EE-12.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-12.8.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-12.in b/Tests/Rivet/EE/EE-12.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-12.in @@ -0,0 +1,20 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I165122 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I153511 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I153656 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + diff --git a/Tests/Rivet/EE/EE-13.96-gg.in b/Tests/Rivet/EE/EE-13.96-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-13.96-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 13.96 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-13.in b/Tests/Rivet/EE/EE-13.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-13.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 13.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + diff --git a/Tests/Rivet/EE/EE-130.in b/Tests/Rivet/EE/EE-130.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-130.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 130. +################################################## +# select the analyses +################################################## +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-133.in b/Tests/Rivet/EE/EE-133.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-133.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 133. +################################################## +# select the analyses +################################################## +# OPAL event shapes and multiplicities at different energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 diff --git a/Tests/Rivet/EE/EE-136.in b/Tests/Rivet/EE/EE-136.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-136.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 136. +################################################## +# select the analyses +################################################## +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-14.8.in b/Tests/Rivet/EE/EE-14.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-14.8.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 14.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_I284251 diff --git a/Tests/Rivet/EE/EE-14.in b/Tests/Rivet/EE/EE-14.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-14.in @@ -0,0 +1,20 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 14. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1983_I181470 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1983_I191415 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1987_I248660 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1984_I202784 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I168232 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1985_I205119 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I279165 diff --git a/Tests/Rivet/EE/EE-16.86-gg.in b/Tests/Rivet/EE/EE-16.86-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-16.86-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 16.86 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-161.in b/Tests/Rivet/EE/EE-161.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-161.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 161. +################################################## +# select the analyses +################################################## +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-17.in b/Tests/Rivet/EE/EE-17.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-17.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 17. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + diff --git a/Tests/Rivet/EE/EE-172.in b/Tests/Rivet/EE/EE-172.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-172.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 172. +################################################## +# select the analyses +################################################## +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-177.in b/Tests/Rivet/EE/EE-177.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-177.in @@ -0,0 +1,13 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 177. +################################################## +# select the analyses +################################################## +# OPAL event shapes and multiplicities at different energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS diff --git a/Tests/Rivet/EE/EE-183.in b/Tests/Rivet/EE/EE-183.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-183.in @@ -0,0 +1,20 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 183. +################################################## +# select the analyses +################################################## +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 diff --git a/Tests/Rivet/EE/EE-189.in b/Tests/Rivet/EE/EE-189.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-189.in @@ -0,0 +1,18 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 + diff --git a/Tests/Rivet/EE/EE-192.in b/Tests/Rivet/EE/EE-192.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-192.in @@ -0,0 +1,15 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 192. +################################################## +# select the analyses +################################################## +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 + diff --git a/Tests/Rivet/EE/EE-196.in b/Tests/Rivet/EE/EE-196.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-196.in @@ -0,0 +1,19 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. +################################################## +# select the analyses +################################################## +# OPAL event shapes and multiplicities at different energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 + diff --git a/Tests/Rivet/EE/EE-197.in b/Tests/Rivet/EE/EE-197.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-197.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 197. +################################################## +# select the analyses +################################################## +# OPAL event shapes and multiplicities at different energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 +# OPAL from gluon paper +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-2.2.in b/Tests/Rivet/EE/EE-2.2.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-2.2.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 2.2 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-2.6.in b/Tests/Rivet/EE/EE-2.6.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-2.6.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 2.6 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-200.in b/Tests/Rivet/EE/EE-200.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-200.in @@ -0,0 +1,19 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 200. +################################################## +# select the analyses +################################################## +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 + diff --git a/Tests/Rivet/EE/EE-202.in b/Tests/Rivet/EE/EE-202.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-202.in @@ -0,0 +1,15 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 202. +################################################## +# select the analyses +################################################## +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# OPAL charged particles +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I595335 +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 + diff --git a/Tests/Rivet/EE/EE-205.in b/Tests/Rivet/EE/EE-205.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-205.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 205. +################################################## +# select the analyses +################################################## +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 diff --git a/Tests/Rivet/EE/EE-206.in b/Tests/Rivet/EE/EE-206.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-206.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. +################################################## +# select the analyses +################################################## +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 +# DELPHI b/c/light multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-207.in b/Tests/Rivet/EE/EE-207.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-207.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 207. +################################################## +# select the analyses +################################################## +# delphi event shapes for a wide energy range +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 diff --git a/Tests/Rivet/EE/EE-21.5.in b/Tests/Rivet/EE/EE-21.5.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-21.5.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 21.5 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_I284251 diff --git a/Tests/Rivet/EE/EE-21.84-gg.in b/Tests/Rivet/EE/EE-21.84-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-21.84-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 21.84 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-22.in b/Tests/Rivet/EE/EE-22.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-22.in @@ -0,0 +1,28 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 22. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 21*GeV +################################################## +# select the analyses +################################################## +# JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1982_I12010 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1983_I181470 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1983_I191415 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1987_I248660 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1984_I202784 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1985_I205119 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I279165 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + + diff --git a/Tests/Rivet/EE/EE-25.in b/Tests/Rivet/EE/EE-25.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-25.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 25. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 21*GeV +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 + diff --git a/Tests/Rivet/EE/EE-26.8-gg.in b/Tests/Rivet/EE/EE-26.8-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-26.8-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 26.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-26.8.in b/Tests/Rivet/EE/EE-26.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-26.8.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 26.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-27.6.in b/Tests/Rivet/EE/EE-27.6.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-27.6.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 27.6 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + diff --git a/Tests/Rivet/EE/EE-28.48-gg.in b/Tests/Rivet/EE/EE-28.48-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-28.48-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 28.48 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-29.in b/Tests/Rivet/EE/EE-29.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-29.in @@ -0,0 +1,24 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 29.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1986_I18502 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1988_I250824 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1987_I235694 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1985_I205868 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MAC_1985_I202924 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1992_I339573 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1984_I205869 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1986_I217416 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1990_I280958 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1988_I262143 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1985_I201482 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1984_I200105 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1988_I23360 diff --git a/Tests/Rivet/EE/EE-3.0.in b/Tests/Rivet/EE/EE-3.0.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-3.0.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 3.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-3.2.in b/Tests/Rivet/EE/EE-3.2.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-3.2.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 3.2 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-3.63.in b/Tests/Rivet/EE/EE-3.63.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-3.63.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 3.63 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 3.6 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1977_I118873 diff --git a/Tests/Rivet/EE/EE-30.2.in b/Tests/Rivet/EE/EE-30.2.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-30.2.in @@ -0,0 +1,15 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.2 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I165122 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 + diff --git a/Tests/Rivet/EE/EE-30.7.in b/Tests/Rivet/EE/EE-30.7.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-30.7.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.7 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 diff --git a/Tests/Rivet/EE/EE-30.in b/Tests/Rivet/EE/EE-30.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-30.in @@ -0,0 +1,17 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I153341 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I153511 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I153656 + diff --git a/Tests/Rivet/EE/EE-31.3.in b/Tests/Rivet/EE/EE-31.3.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-31.3.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 31.3 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1980_I143691 + diff --git a/Tests/Rivet/EE/EE-34.5.in b/Tests/Rivet/EE/EE-34.5.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-34.5.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 34.5 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_I284251 diff --git a/Tests/Rivet/EE/EE-34.8.in b/Tests/Rivet/EE/EE-34.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-34.8.in @@ -0,0 +1,17 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 34.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1984_I202785 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1986_I230950 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1985_I215869 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I279165 +# TASSO strange baryons +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I266893 diff --git a/Tests/Rivet/EE/EE-34.in b/Tests/Rivet/EE/EE-34.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-34.in @@ -0,0 +1,22 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 34. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# CELLO EEC +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1982_I12010 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1983_I191415 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1983_I181470 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I179022 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1984_I202784 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1981_I166363 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I168232 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1985_I205119 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1983_I192072 +# tasso pi, K and p spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I267755 diff --git a/Tests/Rivet/EE/EE-35.44-gg.in b/Tests/Rivet/EE/EE-35.44-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-35.44-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 35.44 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/EE/EE-35.in b/Tests/Rivet/EE/EE-35.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-35.in @@ -0,0 +1,28 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 35. +################################################## +# select the analyses +################################################## +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1987_I248660 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1990_I283026 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CELLO_1989_I276764 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1984_I203145 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1982_I177174 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_I284251 +## jade gamma,pi0 and eta spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1990_I282847 +## TASSO event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1988_I263859 diff --git a/Tests/Rivet/EE/EE-36.2.in b/Tests/Rivet/EE/EE-36.2.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-36.2.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 36.2 +################################################## +# select the analyses +################################################## +# TASSO D* +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I278856 diff --git a/Tests/Rivet/EE/EE-4.03.in b/Tests/Rivet/EE/EE-4.03.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-4.03.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 4.03 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 4.00 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1977_I118873 diff --git a/Tests/Rivet/EE/EE-4.5.in b/Tests/Rivet/EE/EE-4.5.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-4.5.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 4.5 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 4.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1977_I118873 diff --git a/Tests/Rivet/EE/EE-4.6.in b/Tests/Rivet/EE/EE-4.6.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-4.6.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 4.6 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-4.8.in b/Tests/Rivet/EE/EE-4.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-4.8.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 4.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESII_2004_I622224 diff --git a/Tests/Rivet/EE/EE-41.in b/Tests/Rivet/EE/EE-41.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-41.in @@ -0,0 +1,9 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 41.4 +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-42.1.in b/Tests/Rivet/EE/EE-42.1.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-42.1.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 42.1 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# TASSO strange baryons +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I266893 diff --git a/Tests/Rivet/EE/EE-42.6.in b/Tests/Rivet/EE/EE-42.6.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-42.6.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 42.6 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_I284251 diff --git a/Tests/Rivet/EE/EE-43.6.in b/Tests/Rivet/EE/EE-43.6.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-43.6.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 43.6 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1987_I248660 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I279165 + diff --git a/Tests/Rivet/EE/EE-44.in b/Tests/Rivet/EE/EE-44.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-44.in @@ -0,0 +1,19 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 44. +################################################## +# select the analyses +################################################## +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 +# tasso event shapes at various low energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 +# jade gamma,pi0 and eta spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1990_I282847 +# tasso pi, K and p spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I267755 + diff --git a/Tests/Rivet/EE/EE-45.in b/Tests/Rivet/EE/EE-45.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-45.in @@ -0,0 +1,10 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 45.0 +################################################## +# select the analyses +################################################## +# DELPHI event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 diff --git a/Tests/Rivet/EE/EE-48.0-gg.in b/Tests/Rivet/EE/EE-48.0-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-48.0-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 48.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-48.0.in b/Tests/Rivet/EE/EE-48.0.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-48.0.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 48.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-50.in b/Tests/Rivet/EE/EE-50.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-50.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 50. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-52.in b/Tests/Rivet/EE/EE-52.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-52.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 52. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-53.3.in b/Tests/Rivet/EE/EE-53.3.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-53.3.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 53.3 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# EEC +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TOPAZ_1989_I279575 diff --git a/Tests/Rivet/EE/EE-55.in b/Tests/Rivet/EE/EE-55.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-55.in @@ -0,0 +1,15 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 55. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# AMY charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# AMY event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I283337 diff --git a/Tests/Rivet/EE/EE-56.in b/Tests/Rivet/EE/EE-56.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-56.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 56. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-57.in b/Tests/Rivet/EE/EE-57.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-57.in @@ -0,0 +1,13 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 57. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# AMY charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 +# TOPAZ event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TOPAZ_1993_I361661 diff --git a/Tests/Rivet/EE/EE-58.in b/Tests/Rivet/EE/EE-58.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-58.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 58. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TOPAZ_1995_I381900 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1995_I406129 diff --git a/Tests/Rivet/EE/EE-59.5.in b/Tests/Rivet/EE/EE-59.5.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-59.5.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 59.5 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# EEC +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TOPAZ_1989_I279575 diff --git a/Tests/Rivet/EE/EE-60.8.in b/Tests/Rivet/EE/EE-60.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-60.8.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 60.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-60.in b/Tests/Rivet/EE/EE-60.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-60.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 60. +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-61.4.in b/Tests/Rivet/EE/EE-61.4.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-61.4.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 61.4 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV +################################################## +# select the analyses +################################################## +# tasso charged mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/EE/EE-66.in b/Tests/Rivet/EE/EE-66.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-66.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 66.0 +################################################## +# select the analyses +################################################## +# DELPHI event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-7.7.in b/Tests/Rivet/EE/EE-7.7.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-7.7.in @@ -0,0 +1,13 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 7.7 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 7.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 diff --git a/Tests/Rivet/EE/EE-76.in b/Tests/Rivet/EE/EE-76.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-76.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 76.0 +################################################## +# select the analyses +################################################## +# DELPHI event shapes +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 +# L3 event shapes etc for a wide range of CMS energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-82.in b/Tests/Rivet/EE/EE-82.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-82.in @@ -0,0 +1,9 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 82.3 +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-85.in b/Tests/Rivet/EE/EE-85.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-85.in @@ -0,0 +1,9 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 85.1 +################################################## +# select the analyses +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/EE/EE-9.4.in b/Tests/Rivet/EE/EE-9.4.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-9.4.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 9.4 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I165122 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I156315 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1983_I191161 + diff --git a/Tests/Rivet/EE/EE-9.46.in b/Tests/Rivet/EE/EE-9.46.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-9.46.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 4.73 +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 4.73 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.4 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity + +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1990_I278933 diff --git a/Tests/Rivet/EE/EE-91-nopi.in b/Tests/Rivet/EE/EE-91-nopi.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-91-nopi.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 91.2 +set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm +set /Herwig/Particles/pi0:Stable Stable +set /Herwig/Particles/eta:Stable Stable + +################################################## +# select the analyses +################################################## +# ALEPH photon analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1996_S3196992 +# OPAL photon analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1993_S2692198 diff --git a/Tests/Rivet/EE/EE-91.in b/Tests/Rivet/EE/EE-91.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-91.in @@ -0,0 +1,115 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 91.2 +################################################## +# select the analyses +################################################## +# Validated +################################################## +# ALEPH charged particle multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1991_S2435284 +# OPAL charged particle multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1992_I321190 +# DELPHI charged particle multiplicity +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1991_I301657 +# ALEPH main LEP I QCD summary paper +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1996_S3486095 +# ALEPH D* +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1999_S4193598 +# OPAL D* +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1995_I382219 +# OPAL charged hadron analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1994_S2927284 +# OPAL Delta++ analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1995_S3198391 +# OPAL J/Psi analysis analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1996_S3257789 +# ALEPH eta/omega analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2002_S4823664 +# OPAL K*0 analysis +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_S3608263 +# OPAL flavour specific charged multiplicities etc +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3780481 +# OPAL f_0,f_2 and phi production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3702294 +# OPAL gamma,pi0,eta,eta',rho+/-,a0+/- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3749908 +# OPAL K0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2000_S4418603 +# OPAL K* +/- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1993_I342766 +# SLD flavour specific charged multiplicities etc +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_1996_S3398250 +# SLD flavour specific charged multiplicities etc +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_1999_S3743934 +# SLD flavour specific charged multiplicities etc +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_2004_S5693039 +# OPAL event shapes and multiplicities at different energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 +# ALEPH jet and event shapes at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 +# OPAL/JADE jet rates at many energies +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 +# DELPHI strange baryon production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1995_S3137023 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2006_I719387 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_I524694 +# DELPHI f_0, rho_0 and f_2 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1999_S3960137 +# DELPHI K*0 and phi production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1996_I420528 +# DELPHI f'_2 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1996_I416741 +# DELPHI pi0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1996_I401100 +# DELPHI K- K*+/- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1995_I377487 +# DELPHI K+/-, p pbar +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1995_I394052 +# DELPHI Delta++ +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1995_I399737 +# DELPHI pi, K p, flavour seperated +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1998_I473409 +# OPAL strange baryon production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_S3396100 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_I421977 +# DELPHI tuning paper +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1996_S3430090 +# DELPHI b quark +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2011_I890503 +# ALEPH b quark +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2001_S4656318 +# SLD b quark +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_2002_S4869273 +# OPAL b quark +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I599181 +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS +# OPAL from gluon paper +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361:PROCESS=QQ +# L3 eta +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_1992_I336180 +# L3 jet rates +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 +# ALEPH pi+-, K+- and (p, anti-p) +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1995_I382179 +# L3 eta' and omega specta +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_1997_I427107 +# charged mult, different # of jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1992_I334948 +# charged mult, different rapidity regions +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1991_I324035 +# lambda, lambdabar correlations +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1993_I360638 +# delphi flavour sep charged +# lambda, lambdabar correlations +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1997_I428178 +################################################## +# unvalidated +################################################## +# OPAL 4 jet angles +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2001_S4553896 diff --git a/Tests/Rivet/EE/EE-93.0.in b/Tests/Rivet/EE/EE-93.0.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-93.0.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 93.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-97.0-gg.in b/Tests/Rivet/EE/EE-97.0-gg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-97.0-gg.in @@ -0,0 +1,11 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 97.0 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 +################################################## +# select the analyses +################################################## +# PDG hadron multiplicities and ratios +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/EE/EE-JPsi.in b/Tests/Rivet/EE/EE-JPsi.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-JPsi.in @@ -0,0 +1,21 @@ +# -*- ThePEG-repository -*- +# e+ e- -> J/Psi +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEJpsi HwMELepton.so +set /Herwig/MatrixElements/MEJpsi:VectorMeson /Herwig/Particles/Jpsi +set /Herwig/MatrixElements/MEJpsi:Coupling 11.43148 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEJpsi +set EventGenerator:EventHandler:LuminosityFunction:Energy 3.096916 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 0.2 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +do /Herwig/Particles/Jpsi:SelectDecayModes /Herwig/Particles/Jpsi/Jpsi->n0,nbar0; /Herwig/Particles/Jpsi/Jpsi->p+,pbar-; /Herwig/Particles/Jpsi/Jpsi->Sigma0,Sigmabar0; /Herwig/Particles/Jpsi/Jpsi->Lambda0,Lambdabar0; /Herwig/Particles/Jpsi/Jpsi->Sigma*-,Sigma*bar+; /Herwig/Particles/Jpsi/Jpsi->Sigma*0,Sigma*bar0; /Herwig/Particles/Jpsi/Jpsi->Sigma*+,Sigma*bar-; /Herwig/Particles/Jpsi/Jpsi->Xi-,Xibar+; /Herwig/Particles/Jpsi/Jpsi->Sigma*0,Sigma*bar0; /Herwig/Particles/Jpsi/Jpsi->Xi0,Xibar0; +# J/psi-> lambda anti-lambda and sigma anti-sigma +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2017_I1510563 +# J/psi -> p pbar and n nbar +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2012_I1113599 +# J/Psi -> xi- and Sigma*+/- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2016_I1422780 +# J/Psi -> xi0 and Sigma*0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2017_I1506414 +# J/psi-> lambda anti-lambda +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2019_I1691850 \ No newline at end of file diff --git a/Tests/Rivet/EE/EE-Lambdac.in b/Tests/Rivet/EE/EE-Lambdac.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Lambdac.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +decaymode Upsilon(4S)->Lambda_c+,Lambdabar_c-; 1. 1 /Herwig/Decays/DecayME0 +do /Herwig/Particles/Upsilon(4S):SelectDecayModes /Herwig/Particles/Upsilon(4S)/Upsilon(4S)->Lambda_c+,Lambdabar_c-; +# Xi decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 FOCUS_2006_I693639 diff --git a/Tests/Rivet/EE/EE-Omega.in b/Tests/Rivet/EE/EE-Omega.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Omega.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +decaymode Upsilon(4S)->Omega-,Omegabar+; 1. 1 /Herwig/Decays/DecayME0 +do /Herwig/Particles/Upsilon(4S):SelectDecayModes /Herwig/Particles/Upsilon(4S)/Upsilon(4S)->Omega-,Omegabar+; +# Omega decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HyperCP_2005_I677384 diff --git a/Tests/Rivet/EE/EE-Phi.in b/Tests/Rivet/EE/EE-Phi.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Phi.in @@ -0,0 +1,22 @@ +# -*- ThePEG-repository -*- +# e+ e- -> phi +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEPhi HwMELepton.so +set /Herwig/MatrixElements/MEPhi:VectorMeson /Herwig/Particles/phi +set /Herwig/MatrixElements/MEPhi:Coupling 13.60507 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEPhi +set EventGenerator:EventHandler:LuminosityFunction:Energy 1.019461 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 0.2 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +# phi -> eta pi0 gamma +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 KLOE_2009_I818106 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SND_2000_I525398 +# phi -> pi0 pi0 gamma +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 KLOE_2002_I585183 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SND_2000_I527094 +# KLOE phi -> pi0 dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 KLOE2_2016_I1416825 +# KLOE phi -> eta dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 KLOE2_2014_I1317236 +# phi -> pi+pi-pi0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SND_2001_I558279 diff --git a/Tests/Rivet/EE/EE-Psi2S.in b/Tests/Rivet/EE/EE-Psi2S.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Psi2S.in @@ -0,0 +1,19 @@ +# -*- ThePEG-repository -*- +# e+ e- -> psi(2S) +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEPsi2S HwMELepton.so +set /Herwig/MatrixElements/MEPsi2S:VectorMeson /Herwig/Particles/psi(2S) +set /Herwig/MatrixElements/MEPsi2S:Coupling 19.25684 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEPsi2S +set EventGenerator:EventHandler:LuminosityFunction:Energy 3.77 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 0.2 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +do /Herwig/Particles/psi(2S):SelectDecayModes /Herwig/Particles/psi(2S)/psi(2S)->n0,nbar0; /Herwig/Particles/psi(2S)/psi(2S)->p+,pbar-; /Herwig/Particles/psi(2S)/psi(2S)->Sigma0,Sigmabar0; /Herwig/Particles/psi(2S)/psi(2S)->Lambda0,Lambdabar0; /Herwig/Particles/psi(2S)/psi(2S)->Sigma*-,Sigma*bar+; /Herwig/Particles/psi(2S)/psi(2S)->Sigma*0,Sigma*bar0; /Herwig/Particles/psi(2S)/psi(2S)->Sigma*+,Sigma*bar-; /Herwig/Particles/psi(2S)/psi(2S)->Xi-,Xibar+; /Herwig/Particles/psi(2S)/psi(2S)->Xi0,Xibar0; /Herwig/Particles/psi(2S)/psi(2S)->Sigma*0,Sigma*bar0; +# psi(2S) -> lambda anti-lambda and sigma anti-sigma +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2017_I1510563 +# psi(2S) -> p pbar and n nbar +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2018_I1658762 +# psi(2S) -> xi- and Sigma+/- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2016_I1422780 +# psi(2S) -> xi0 and Sigma*0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2017_I1506414 diff --git a/Tests/Rivet/EE/EE-Tau.in b/Tests/Rivet/EE/EE-Tau.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Tau.in @@ -0,0 +1,30 @@ +# -*- ThePEG-repository -*- +erase /Herwig/EventHandlers/EventHandler:PostSubProcessHandlers 0 +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 3.5*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 8.*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.58299 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +# Matrix elements +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEee2gZ2ll +set /Herwig/MatrixElements/MEee2gZ2ll:Allowed Tau +set /Herwig/Particles/pi0:Stable Stable +# Babar three pion +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S7266081 +# BELLE pipi +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2008_I786560 +# ALEPH spectral functions +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2014_I1267648 +# BELLE Kpi +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2007_I753243 +# BELLE 3 charged hadrons +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2010_I841618 +# BABAR KK +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2018_I1679886 +# CLEO pi pi +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1999_I508944 +# MC dists +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_TAU_Decay + diff --git a/Tests/Rivet/EE/EE-Upsilon.in b/Tests/Rivet/EE/EE-Upsilon.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Upsilon.in @@ -0,0 +1,22 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 4.73015*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 4.73015*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.45 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +# set hard process +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon +set /Herwig/MatrixElements/MEUpsilon:Coupling 41.15810 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1990_I278933 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I262551 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I276860 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1988_I251097 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I262415 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1981_I165122 diff --git a/Tests/Rivet/EE/EE-Upsilon2.in b/Tests/Rivet/EE/EE-Upsilon2.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Upsilon2.in @@ -0,0 +1,17 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.01163*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.01163*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.02 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(2S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 62.72911 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +# BELLE charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2669951 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1990_I278933 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I262551 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1988_I251097 diff --git a/Tests/Rivet/EE/EE-Upsilon4.in b/Tests/Rivet/EE/EE-Upsilon4.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Upsilon4.in @@ -0,0 +1,50 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +# ARGUS pi,K, proton +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2653028 +# ARGUS K*, rho, omega +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_S2789213 +# various semileptonic decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1116411 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2015_I1334693 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2011_I878990 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2013_I1238273 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2015_I1397632 +# BELLE b->s gamma +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2015_I1330289 +# BES D -> K, pi semi-leptonic +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2015_I1391138 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2017_I1519425 +# eta/omega dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 A2_2017_I1486671 +# BES eta' dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2015_I1364494 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2018_I1641075 +# BES J/psi dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2018_I1697377 +# multiplicities +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_Upsilon_4S_HADRON_MULTIPLICITIES +# BES multiplicty in eta_c decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2019_I1724880 +# eta -> pi+pi-pi0 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 KLOE2_2016_I1416990 +# kaons in b decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1994_I354224 +# # MC analyses based on old internal ones +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_Meson_Meson_Leptons_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_OmegaPhia1_3Pion_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_D_Dalitz +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_Eta_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_Onium_PiPi_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_Semi_Leptonic_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319102 diff --git a/Tests/Rivet/EE/EE-Xi0.in b/Tests/Rivet/EE/EE-Xi0.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Xi0.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +decaymode Upsilon(4S)->Xi0,Xibar0; 1. 1 /Herwig/Decays/DecayME0 +do /Herwig/Particles/Upsilon(4S):SelectDecayModes /Herwig/Particles/Upsilon(4S)/Upsilon(4S)->Xi0,Xibar0; +# Xi decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 NA48_2010_I868871 diff --git a/Tests/Rivet/EE/EE-Xic0.in b/Tests/Rivet/EE/EE-Xic0.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Xic0.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +decaymode Upsilon(4S)->Xi_c0,Xi_cbar0; 1. 1 /Herwig/Decays/DecayME0 +do /Herwig/Particles/Upsilon(4S):SelectDecayModes /Herwig/Particles/Upsilon(4S)/Upsilon(4S)->Xi_c0,Xi_cbar0; +# Xi decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2000_I537236 diff --git a/Tests/Rivet/EE/EE-Xim.in b/Tests/Rivet/EE/EE-Xim.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Xim.in @@ -0,0 +1,16 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.2897*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.2897*GeV +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 10.5792 +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so +set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +decaymode Upsilon(4S)->Xi-,Xibar+; 1. 1 /Herwig/Decays/DecayME0 +do /Herwig/Particles/Upsilon(4S):SelectDecayModes /Herwig/Particles/Upsilon(4S)/Upsilon(4S)->Xi-,Xibar+; +# Xi decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 E756_2000_I530367 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-198.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-198.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-198.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. -################################################## -# select the analyses -################################################## -# L3 jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 -# OPAL jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 \ No newline at end of file diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-206.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-Jets-206.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-161.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-161.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-161.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 161. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-172.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-172.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-172.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 172. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-183.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-183.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-183.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 183. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-189.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-189.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-189.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-196.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-196.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-196.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-206.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-mumu-206.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-189.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-189.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-189.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-196.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-196.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-196.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-206.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Direct-tautau-206.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I645127 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-198.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-198.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-198.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. -################################################## -# select the analyses -################################################## -# L3 jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 -# OPAL jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-206.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Double-Resolved-Jets-206.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-198.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-198.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-198.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 198. -################################################## -# select the analyses -################################################## -# L3 jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I661114 -# OPAL jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I611415 diff --git a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-206.in b/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP-Gamma/LEP-Gamma-Single-Resolved-Jets-206.in +++ /dev/null @@ -1,10 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# L3 mu+mu- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2008_I754316 diff --git a/Tests/Rivet/LEP/LEP-10.5-gg.in b/Tests/Rivet/LEP/LEP-10.5-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-10.5-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 10.5 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-10.in b/Tests/Rivet/LEP/LEP-10.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-10.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 10. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9. -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS diff --git a/Tests/Rivet/LEP/LEP-11.96-gg.in b/Tests/Rivet/LEP/LEP-11.96-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-11.96-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 11.96 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-12.8-gg.in b/Tests/Rivet/LEP/LEP-12.8-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-12.8-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-12.8.in b/Tests/Rivet/LEP/LEP-12.8.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-12.8.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-12.in b/Tests/Rivet/LEP/LEP-12.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-12.in +++ /dev/null @@ -1,12 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 12.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 diff --git a/Tests/Rivet/LEP/LEP-13.96-gg.in b/Tests/Rivet/LEP/LEP-13.96-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-13.96-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 13.96 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-13.in b/Tests/Rivet/LEP/LEP-13.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-13.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 13.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-130.in b/Tests/Rivet/LEP/LEP-130.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-130.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 130. -################################################## -# select the analyses -################################################## -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-133.in b/Tests/Rivet/LEP/LEP-133.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-133.in +++ /dev/null @@ -1,13 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 133. -################################################## -# select the analyses -################################################## -# OPAL event shapes and multiplicities at different energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 diff --git a/Tests/Rivet/LEP/LEP-136.in b/Tests/Rivet/LEP/LEP-136.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-136.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 136. -################################################## -# select the analyses -################################################## -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-14.in b/Tests/Rivet/LEP/LEP-14.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-14.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 14. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso event shapes at various low energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 \ No newline at end of file diff --git a/Tests/Rivet/LEP/LEP-16.86-gg.in b/Tests/Rivet/LEP/LEP-16.86-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-16.86-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 16.86 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-161.in b/Tests/Rivet/LEP/LEP-161.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-161.in +++ /dev/null @@ -1,16 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 161. -################################################## -# select the analyses -################################################## -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-17.in b/Tests/Rivet/LEP/LEP-17.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-17.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 17. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-172.in b/Tests/Rivet/LEP/LEP-172.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-172.in +++ /dev/null @@ -1,16 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 172. -################################################## -# select the analyses -################################################## -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-177.in b/Tests/Rivet/LEP/LEP-177.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-177.in +++ /dev/null @@ -1,12 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 177. -################################################## -# select the analyses -################################################## -# OPAL event shapes and multiplicities at different energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS diff --git a/Tests/Rivet/LEP/LEP-183.in b/Tests/Rivet/LEP/LEP-183.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-183.in +++ /dev/null @@ -1,18 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 183. -################################################## -# select the analyses -################################################## -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-189.in b/Tests/Rivet/LEP/LEP-189.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-189.in +++ /dev/null @@ -1,15 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 189. -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-192.in b/Tests/Rivet/LEP/LEP-192.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-192.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 192. -################################################## -# select the analyses -################################################## -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 diff --git a/Tests/Rivet/LEP/LEP-196.in b/Tests/Rivet/LEP/LEP-196.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-196.in +++ /dev/null @@ -1,16 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 196. -################################################## -# select the analyses -################################################## -# OPAL event shapes and multiplicities at different energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-197.in b/Tests/Rivet/LEP/LEP-197.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-197.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 197. -################################################## -# select the analyses -################################################## -# OPAL event shapes and multiplicities at different energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 -# OPAL from gluon paper -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-200.in b/Tests/Rivet/LEP/LEP-200.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-200.in +++ /dev/null @@ -1,15 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 200. -################################################## -# select the analyses -################################################## -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-202.in b/Tests/Rivet/LEP/LEP-202.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-202.in +++ /dev/null @@ -1,9 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 202. -################################################## -# select the analyses -################################################## -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 diff --git a/Tests/Rivet/LEP/LEP-206.in b/Tests/Rivet/LEP/LEP-206.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-206.in +++ /dev/null @@ -1,16 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 206. -################################################## -# select the analyses -################################################## -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2002_S5361494 -# DELPHI b/c/light multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_S4328825 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-21.84-gg.in b/Tests/Rivet/LEP/LEP-21.84-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-21.84-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 21.84 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-22.in b/Tests/Rivet/LEP/LEP-22.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-22.in +++ /dev/null @@ -1,14 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 22. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 21*GeV -################################################## -# select the analyses -################################################## -# JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 -# tasso event shapes at various low energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 \ No newline at end of file diff --git a/Tests/Rivet/LEP/LEP-26.8-gg.in b/Tests/Rivet/LEP/LEP-26.8-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-26.8-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 26.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-26.8.in b/Tests/Rivet/LEP/LEP-26.8.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-26.8.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 26.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-27.6.in b/Tests/Rivet/LEP/LEP-27.6.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-27.6.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 27.6 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-28.48-gg.in b/Tests/Rivet/LEP/LEP-28.48-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-28.48-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 28.48 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-29.in b/Tests/Rivet/LEP/LEP-29.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-29.in +++ /dev/null @@ -1,12 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 29.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 HRS_1986_I18502 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TPC_1987_I235694 diff --git a/Tests/Rivet/LEP/LEP-30.2.in b/Tests/Rivet/LEP/LEP-30.2.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-30.2.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.2 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-30.7.in b/Tests/Rivet/LEP/LEP-30.7.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-30.7.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.7 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-30.in b/Tests/Rivet/LEP/LEP-30.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-30.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 30.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 diff --git a/Tests/Rivet/LEP/LEP-31.3.in b/Tests/Rivet/LEP/LEP-31.3.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-31.3.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 31.3 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-34.8.in b/Tests/Rivet/LEP/LEP-34.8.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-34.8.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 34.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 diff --git a/Tests/Rivet/LEP/LEP-35.44-gg.in b/Tests/Rivet/LEP/LEP-35.44-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-35.44-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 35.44 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361 diff --git a/Tests/Rivet/LEP/LEP-35.in b/Tests/Rivet/LEP/LEP-35.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-35.in +++ /dev/null @@ -1,17 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 35. -################################################## -# select the analyses -################################################## -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 -# tasso event shapes at various low energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1983_I190818 diff --git a/Tests/Rivet/LEP/LEP-41.in b/Tests/Rivet/LEP/LEP-41.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-41.in +++ /dev/null @@ -1,9 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 41.4 -################################################## -# select the analyses -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-43.6.in b/Tests/Rivet/LEP/LEP-43.6.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-43.6.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 43.6 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1989_I277658 diff --git a/Tests/Rivet/LEP/LEP-44.in b/Tests/Rivet/LEP/LEP-44.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-44.in +++ /dev/null @@ -1,13 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 44. -################################################## -# select the analyses -################################################## -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_1998_S3612880 -# tasso event shapes at various low energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 TASSO_1990_S2148048 diff --git a/Tests/Rivet/LEP/LEP-45.in b/Tests/Rivet/LEP/LEP-45.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-45.in +++ /dev/null @@ -1,9 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 45.0 -################################################## -# select the analyses -################################################## -# DELPHI event shapes -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 diff --git a/Tests/Rivet/LEP/LEP-48.0-gg.in b/Tests/Rivet/LEP/LEP-48.0-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-48.0-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 48.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-48.0.in b/Tests/Rivet/LEP/LEP-48.0.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-48.0.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 48.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-50.in b/Tests/Rivet/LEP/LEP-50.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-50.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 50. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-52.in b/Tests/Rivet/LEP/LEP-52.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-52.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 52. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-55.in b/Tests/Rivet/LEP/LEP-55.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-55.in +++ /dev/null @@ -1,13 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 55. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-56.in b/Tests/Rivet/LEP/LEP-56.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-56.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 56. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-57.in b/Tests/Rivet/LEP/LEP-57.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-57.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 57. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-60.8.in b/Tests/Rivet/LEP/LEP-60.8.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-60.8.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 60.8 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-60.in b/Tests/Rivet/LEP/LEP-60.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-60.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 60. -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-61.4.in b/Tests/Rivet/LEP/LEP-61.4.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-61.4.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 61.4 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 13.*GeV -################################################## -# select the analyses -################################################## -# tasso charged mult -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 AMY_1990_I295160 diff --git a/Tests/Rivet/LEP/LEP-66.in b/Tests/Rivet/LEP/LEP-66.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-66.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 66.0 -################################################## -# select the analyses -################################################## -# DELPHI event shapes -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-76.in b/Tests/Rivet/LEP/LEP-76.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-76.in +++ /dev/null @@ -1,12 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 76.0 -################################################## -# select the analyses -################################################## -# DELPHI event shapes -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2003_I620250 -# L3 event shapes etc for a wide range of CMS energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-82.in b/Tests/Rivet/LEP/LEP-82.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-82.in +++ /dev/null @@ -1,9 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 82.3 -################################################## -# select the analyses -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-85.in b/Tests/Rivet/LEP/LEP-85.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-85.in +++ /dev/null @@ -1,9 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 85.1 -################################################## -# select the analyses -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 diff --git a/Tests/Rivet/LEP/LEP-9.4.in b/Tests/Rivet/LEP/LEP-9.4.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-9.4.in +++ /dev/null @@ -1,11 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 9.4 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 -################################################## -# select the analyses -################################################## -# Validated -################################################## -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PLUTO_1980_I154270 diff --git a/Tests/Rivet/LEP/LEP-91-nopi.in b/Tests/Rivet/LEP/LEP-91-nopi.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-91-nopi.in +++ /dev/null @@ -1,15 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 91.2 -set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm -set /Herwig/Particles/pi0:Stable Stable -set /Herwig/Particles/eta:Stable Stable - -################################################## -# select the analyses -################################################## -# ALEPH photon analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1996_S3196992 -# OPAL photon analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1993_S2692198 diff --git a/Tests/Rivet/LEP/LEP-91.in b/Tests/Rivet/LEP/LEP-91.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-91.in +++ /dev/null @@ -1,89 +0,0 @@ -# -*- ThePEG-repository -*- -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 91.2 -################################################## -# select the analyses -################################################## -# Validated -################################################## -# ALEPH charged particle multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1991_S2435284 -# OPAL charged particle multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1992_I321190 -# DELPHI charged particle multiplicity -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1991_I301657 -# ALEPH main LEP I QCD summary paper -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1996_S3486095 -# ALEPH D* -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1999_S4193598 -# OPAL D* -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1995_I382219 -# OPAL charged hadron analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1994_S2927284 -# OPAL Delta++ analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1995_S3198391 -# OPAL J/Psi analysis analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1996_S3257789 -# ALEPH eta/omega analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2002_S4823664 -# OPAL K*0 analysis -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_S3608263 -# OPAL flavour specific charged multiplicities etc -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3780481 -# OPAL f_0,f_2 and phi production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3702294 -# OPAL gamma,pi0,eta,eta',rho+/-,a0+/- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1998_S3749908 -# OPAL K0 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2000_S4418603 -# OPAL K* +/- -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1993_I342766 -# SLD flavour specific charged multiplicities etc -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_1996_S3398250 -# SLD flavour specific charged multiplicities etc -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_1999_S3743934 -# SLD flavour specific charged multiplicities etc -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_2004_S5693039 -# OPAL event shapes and multiplicities at different energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_S6132243 -# ALEPH jet and event shapes at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2004_S5765862 -# OPAL/JADE jet rates at many energies -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 JADE_OPAL_2000_S4300807 -# DELPHI strange baryon production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1995_S3137023 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2000_I524694 -# DELPHI f_0, rho_0 and f_2 production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1999_S3960137 -# OPAL strange baryon production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_S3396100 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_1997_I421977 -# DELPHI tuning paper -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_1996_S3430090 -# DELPHI b quark -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DELPHI_2011_I890503 -# ALEPH b quark -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_2001_S4656318 -# SLD b quark -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 SLD_2002_S4869273 -# OPAL b quark -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2003_I599181 -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 PDG_HADRON_MULTIPLICITIES_RATIOS -# OPAL from gluon paper -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I631361:PROCESS=QQ -# L3 eta -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_1992_I336180 -# L3 jet rates -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 L3_2004_I652683 -# ALEPH pi+-, K+- and (p, anti-p) -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ALEPH_1995_I382179 -################################################## -# unvalidated -################################################## -# OPAL 4 jet angles -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2001_S4553896 diff --git a/Tests/Rivet/LEP/LEP-93.0.in b/Tests/Rivet/LEP/LEP-93.0.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-93.0.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 93.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LEP/LEP-97.0-gg.in b/Tests/Rivet/LEP/LEP-97.0-gg.in deleted file mode 100644 --- a/Tests/Rivet/LEP/LEP-97.0-gg.in +++ /dev/null @@ -1,10 +0,0 @@ -################################################## -# LEP physics parameters (override defaults) -################################################## -set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 97.0 -set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.99 -################################################## -# select the analyses -################################################## -# PDG hadron multiplicities and ratios -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 OPAL_2004_I648738 diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-1-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-1-A.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-1-A.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-10-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-10-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-10-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-10-A.in @@ -1,6 +1,6 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-10-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-10-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-10-B.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-11-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-11-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-11-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-11-A.in @@ -1,6 +1,5 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-11-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-11-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-11-B.in @@ -0,0 +1,5 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-2-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-2-A.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-2-A.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-3-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-3-A.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-3-A.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-4-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-4-A.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-4-A.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-5-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-5-A.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-5-A.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-6-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-6-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-6-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-6-A.in @@ -1,6 +1,6 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-6-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-6-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-6-B.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-7-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-7-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-7-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-7-A.in @@ -1,6 +1,6 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-7-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-7-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-7-B.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-8-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-8-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-8-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-8-A.in @@ -1,6 +1,6 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-8-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-8-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-8-B.in @@ -0,0 +1,6 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-9-A.in b/Tests/Rivet/LHC/LHC-13-DiJets-9-A.in --- a/Tests/Rivet/LHC/LHC-13-DiJets-9-A.in +++ b/Tests/Rivet/LHC/LHC-13-DiJets-9-A.in @@ -1,6 +1,5 @@ ################################################## # select the analyses ################################################## -# CMS High mass jets -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1663452 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2017_I1519995 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-DiJets-9-B.in b/Tests/Rivet/LHC/LHC-13-DiJets-9-B.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/LHC/LHC-13-DiJets-9-B.in @@ -0,0 +1,5 @@ +################################################## +# select the analyses +################################################## +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-0.in b/Tests/Rivet/LHC/LHC-13-Jets-0.in --- a/Tests/Rivet/LHC/LHC-13-Jets-0.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-0.in @@ -1,3 +1,5 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 \ No newline at end of file +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-1.in b/Tests/Rivet/LHC/LHC-13-Jets-1.in --- a/Tests/Rivet/LHC/LHC-13-Jets-1.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-1.in @@ -1,3 +1,5 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 \ No newline at end of file +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-10.in b/Tests/Rivet/LHC/LHC-13-Jets-10.in --- a/Tests/Rivet/LHC/LHC-13-Jets-10.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-10.in @@ -1,3 +1,5 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 \ No newline at end of file +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-2.in b/Tests/Rivet/LHC/LHC-13-Jets-2.in --- a/Tests/Rivet/LHC/LHC-13-Jets-2.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-2.in @@ -1,3 +1,5 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 \ No newline at end of file +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-3.in b/Tests/Rivet/LHC/LHC-13-Jets-3.in --- a/Tests/Rivet/LHC/LHC-13-Jets-3.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-3.in @@ -1,3 +1,5 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 \ No newline at end of file +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/LHC/LHC-13-Jets-4.in b/Tests/Rivet/LHC/LHC-13-Jets-4.in --- a/Tests/Rivet/LHC/LHC-13-Jets-4.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-4.in @@ -1,4 +1,7 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-Jets-5.in b/Tests/Rivet/LHC/LHC-13-Jets-5.in --- a/Tests/Rivet/LHC/LHC-13-Jets-5.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-5.in @@ -1,4 +1,7 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-Jets-6.in b/Tests/Rivet/LHC/LHC-13-Jets-6.in --- a/Tests/Rivet/LHC/LHC-13-Jets-6.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-6.in @@ -1,4 +1,7 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-Jets-7.in b/Tests/Rivet/LHC/LHC-13-Jets-7.in --- a/Tests/Rivet/LHC/LHC-13-Jets-7.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-7.in @@ -1,5 +1,8 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1711114 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-Jets-8.in b/Tests/Rivet/LHC/LHC-13-Jets-8.in --- a/Tests/Rivet/LHC/LHC-13-Jets-8.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-8.in @@ -1,4 +1,7 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 + diff --git a/Tests/Rivet/LHC/LHC-13-Jets-9.in b/Tests/Rivet/LHC/LHC-13-Jets-9.in --- a/Tests/Rivet/LHC/LHC-13-Jets-9.in +++ b/Tests/Rivet/LHC/LHC-13-Jets-9.in @@ -1,4 +1,6 @@ # CMS Jets insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2016_I1459051 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2016_CONF_2016_092 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CMS_2018_I1682495 +# ATLAS jets +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2018_I1634970 diff --git a/Tests/Rivet/Templates/DIS-Matchbox.in b/Tests/Rivet/Templates/DIS-Matchbox.in --- a/Tests/Rivet/Templates/DIS-Matchbox.in +++ b/Tests/Rivet/Templates/DIS-Matchbox.in @@ -1,55 +1,55 @@ # -*- ThePEG-repository -*- # # DO NOT EDIT - autogenerated by make_input_files.py # ################################################## ## Herwig/Matchbox example input file ################################################## ################################################## ## Collider type ################################################## read snippets/Matchbox.in read snippets/EPCollider.in ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/MatrixElements/Matchbox set Factory:OrderInAlphaS 0 set Factory:OrderInAlphaEW 2 set Factory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/LeptonQ2Scale ${shower} ${bscheme} -read Matchbox/MMHT2014.in +read Matchbox/CT14.in do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode # switch off initial state QED radiation set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF # create the Rivet analysis create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis read ${parameterFile} ## Select the process cd /Herwig/MatrixElements/Matchbox ${process} cd /Herwig/Generators set EventGenerator:MaxErrors 1000000 saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/DIS-Merging.in b/Tests/Rivet/Templates/DIS-Merging.in --- a/Tests/Rivet/Templates/DIS-Merging.in +++ b/Tests/Rivet/Templates/DIS-Merging.in @@ -1,65 +1,65 @@ # -*- ThePEG-repository -*- # # DO NOT EDIT - autogenerated by make_input_files.py # ################################################## ## Herwig/Matchbox example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/EPCollider.in read snippets/MonacoSampler.in ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings read Matchbox/MadGraph-OpenLoops.in set /Herwig/Merging/MergingFactory:OrderInAlphaS 0 set /Herwig/Merging/MergingFactory:OrderInAlphaEW 2 set /Herwig/Merging/MergingFactory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/LeptonQ2Scale ################################################## ## PDF and AlphaS choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in set /Herwig/Couplings/NLOAlphaS:input_alpha_s 0.118 read Merging/FactorCMWScheme.in # switch off initial state QED radiation set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF # create the Rivet analysis create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis read ${parameterFile} ## Select the process cd /Herwig/Merging/ set Merger:MergingScale 10.*GeV ${process} do /Herwig/Merging/MergingFactory:ProductionMode cd /Herwig/Generators set EventGenerator:MaxErrors 1000000 saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Gamma-Direct.in b/Tests/Rivet/Templates/EE-Gamma-Direct.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Gamma-Direct.in @@ -0,0 +1,46 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +# base parameters for LEP analyses +################################################## +read snippets/EECollider.in +################################################## +# Technical parameters for this run +################################################## +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 + +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF +set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF +################################################## +## Shower and scheme selection. +## Should be empty unless using the Dipole Shower. +################################################## +${shower} + +################################################## +# Create the Herwig analysis +################################################## +cd /Herwig/Generators +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis + +################################################## +# Use the q qbar matrix element +################################################## +# default e+e- > q qbar (5 flavours d,u,s,c,b) +${process} +set /Herwig/Shower/PartnerFinder:QEDPartner IIandFF + +read ${parameterFile} + +################################################## +# Save run for later usage with 'Herwig run' +################################################## +cd /Herwig/Generators +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Gamma-Double-Resolved.in b/Tests/Rivet/Templates/EE-Gamma-Double-Resolved.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Gamma-Double-Resolved.in @@ -0,0 +1,47 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +# base parameters for LEP analyses +################################################## +read snippets/EECollider.in +################################################## +# Technical parameters for this run +################################################## +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 + +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF +set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF +set /Herwig/Particles/gamma:PDF /Herwig/Partons/SaSPDF +################################################## +## Shower and scheme selection. +## Should be empty unless using the Dipole Shower. +################################################## +${shower} + +################################################## +# Create the Herwig analysis +################################################## +cd /Herwig/Generators +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis + +################################################## +# Use the q qbar matrix element +################################################## +# default e+e- > q qbar (5 flavours d,u,s,c,b) +${process} +set /Herwig/Shower/PartnerFinder:QEDPartner All + +read ${parameterFile} + +################################################## +# Save run for later usage with 'Herwig run' +################################################## +cd /Herwig/Generators +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Gamma-Single-Resolved.in b/Tests/Rivet/Templates/EE-Gamma-Single-Resolved.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Gamma-Single-Resolved.in @@ -0,0 +1,72 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +# base parameters for LEP analyses +################################################## +read snippets/EECollider.in +################################################## +# Technical parameters for this run +################################################## +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 + +################################################## +# Select the PDFs +################################################## +set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF +set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF +set /Herwig/Particles/gamma:PDF /Herwig/Partons/SaSPDF + + +DISABLEREADONLY +create Herwig::MultiPartonExtractor /Herwig/Partons/GGExtractor HwPartonExtractor.so +newdef /Herwig/Partons/GGExtractor:NoPDF /Herwig/Partons/NoPDF +insert /Herwig/Partons/GGExtractor:FirstPDFs 0 /Herwig/Partons/WWPDF +insert /Herwig/Partons/GGExtractor:FirstPDFs 1 /Herwig/Partons/SaSPDF +insert /Herwig/Partons/GGExtractor:SecondPDFs 0 /Herwig/Partons/WWPDF +insert /Herwig/Partons/GGExtractor:SecondPDFs 1 /Herwig/Partons/NoPDF + +create Herwig::MultiPartonExtractor /Herwig/Partons/GG2Extractor HwPartonExtractor.so +newdef /Herwig/Partons/GG2Extractor:NoPDF /Herwig/Partons/NoPDF +insert /Herwig/Partons/GG2Extractor:FirstPDFs 0 /Herwig/Partons/WWPDF +insert /Herwig/Partons/GG2Extractor:FirstPDFs 1 /Herwig/Partons/NoPDF +insert /Herwig/Partons/GG2Extractor:SecondPDFs 0 /Herwig/Partons/WWPDF +insert /Herwig/Partons/GG2Extractor:SecondPDFs 1 /Herwig/Partons/SaSPDF + + +set /Herwig/MatrixElements/SubProcess:PartonExtractor /Herwig/Partons/GGExtractor +cp /Herwig/MatrixElements/SubProcess /Herwig/MatrixElements/SubProcess2 +set /Herwig/MatrixElements/SubProcess2:PartonExtractor /Herwig/Partons/GG2Extractor + +insert /Herwig/Generators/EventGenerator:EventHandler:SubProcessHandlers 1 /Herwig/MatrixElements/SubProcess2 + + +################################################## +## Shower and scheme selection. +## Should be empty unless using the Dipole Shower. +################################################## +${shower} + +################################################## +# Create the Herwig analysis +################################################## +cd /Herwig/Generators +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis + +################################################## +# Use the q qbar matrix element +################################################## +# default e+e- > q qbar (5 flavours d,u,s,c,b) +${process} +set /Herwig/Shower/PartnerFinder:QEDPartner All + +read ${parameterFile} + +################################################## +# Save run for later usage with 'Herwig run' +################################################## +cd /Herwig/Generators +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Matchbox.in b/Tests/Rivet/Templates/EE-Matchbox.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Matchbox.in @@ -0,0 +1,61 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +## Collider type +################################################## +read snippets/Matchbox.in + +read snippets/EECollider.in +################################################## +## Process selection +################################################## +## Model assumptions +read Matchbox/StandardModelLike.in +read Matchbox/DiagonalCKM.in +## Set the order of the couplings +cd /Herwig/MatrixElements/Matchbox +set Factory:OrderInAlphaS 0 +set Factory:OrderInAlphaEW 2 + +################################################## +## Scale choice +## See the documentation for more options +################################################## +cd /Herwig/MatrixElements/Matchbox +set Factory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/SHatScale +################################################## +## Matching and shower selection +################################################## +${shower} +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +################################################## +# Create the Herwig analysis +################################################## +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis +################################################## +## Do not apply profile scales for LEP as hard +## scale coincides with kinematic limit +################################################## +set /Herwig/Shower/ShowerHandler:HardScaleProfile NULL +set /Herwig/DipoleShower/DipoleShowerHandler:HardScaleProfile NULL +################################################## +## Save the generator +################################################## +do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode + +## Select the process +cd /Herwig/MatrixElements/Matchbox +${process} + +read ${parameterFile} + +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Merging.in b/Tests/Rivet/Templates/EE-Merging.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Merging.in @@ -0,0 +1,67 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +## Collider type +################################################## +read snippets/DipoleMerging.in +read snippets/EECollider.in +read snippets/MonacoSampler.in +################################################## +## Process selection +################################################## +## Model assumptions +read Matchbox/StandardModelLike.in +read Matchbox/DiagonalCKM.in +## Set the order of the couplings +cd /Herwig/Merging/ +set MergingFactory:OrderInAlphaS 0 +set MergingFactory:OrderInAlphaEW 2 +################################################## +## Matrix element library selection +################################################## +read Matchbox/MadGraph-OpenLoops.in +################################################## +## Scale choice +## See the documentation for more options +################################################## +cd /Herwig/Merging/ +set MergingFactory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/SHatScale +################################################## +## PDF and AlphaS choice +################################################## +set /Herwig/Couplings/NLOAlphaS:input_alpha_s 0.118 +read Merging/FactorCMWScheme.in +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF +################################################## +# Create the Herwig analysis +################################################## +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis +################################################## +## Do not apply profile scales for LEP as hard +## scale coincides with kinematic limit +################################################## +set /Herwig/DipoleShower/DipoleShowerHandler:HardScaleProfile NULL + + +## Select the process +cd /Herwig/Merging/ +set Merger:MergingScale 5.*GeV +${process} + +read ${parameterFile} + +################################################## +## Save the generator +################################################## +do /Herwig/Merging/MergingFactory:ProductionMode + +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE-Powheg.in b/Tests/Rivet/Templates/EE-Powheg.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE-Powheg.in @@ -0,0 +1,40 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +# base parameters for LEP analyses +################################################## +read snippets/EECollider.in +################################################## +# Technical parameters for this run +################################################## +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 + +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF + +################################################## +# Create the Herwig analysis +################################################## +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis + +################################################## +# Use the NLO q qbar matrix element +################################################## +set /Herwig/Shower/ShowerHandler:HardEmission POWHEG +insert /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/PowhegMEee2gZ2qq +${process} + +read ${parameterFile} + +################################################## +# Save run for later usage with 'Herwig run' +################################################## +cd /Herwig/Generators +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/EE.in b/Tests/Rivet/Templates/EE.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/Templates/EE.in @@ -0,0 +1,48 @@ +# -*- ThePEG-repository -*- +# +# DO NOT EDIT - autogenerated by make_input_files.py +# +################################################## +# base parameters for LEP analyses +################################################## +read snippets/EECollider.in +################################################## +# Technical parameters for this run +################################################## +cd /Herwig/Generators +set EventGenerator:MaxErrors 1000000 + +################################################## +# Switch off ISR +################################################## +set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF +set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF + + +################################################## +## Shower and scheme selection. +## Should be empty unless using the Dipole Shower. +################################################## +${shower} + +################################################## +# Create the Herwig analysis +################################################## +cd /Herwig/Generators +create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so +insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis + +################################################## +# Use the q qbar matrix element +################################################## +# default e+e- > q qbar (5 flavours d,u,s,c,b) +${process} +set /Herwig/Shower/PartnerFinder:QEDPartner IIandFF + +read ${parameterFile} + +################################################## +# Save run for later usage with 'Herwig run' +################################################## +cd /Herwig/Generators +saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/Hadron-Matchbox.in b/Tests/Rivet/Templates/Hadron-Matchbox.in --- a/Tests/Rivet/Templates/Hadron-Matchbox.in +++ b/Tests/Rivet/Templates/Hadron-Matchbox.in @@ -1,50 +1,50 @@ # -*- ThePEG-repository -*- # # DO NOT EDIT - autogenerated by make_input_files.py # ################################################## ## Collider type ################################################## read snippets/Matchbox.in read snippets/PPCollider.in ################################################## ## Matrix element library selection ################################################## ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ${nlo} ################################################## ## Matching and shower selection ## Please also see flavour scheme settings ## towards the end of the input file. ################################################## ${shower} ################################################## ## PDF choice ################################################## ${bscheme} -read Matchbox/MMHT2014.in +read Matchbox/CT14.in ################################################## # Create the Herwig analysis ################################################## create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis set /Herwig/Analysis/RivetAnalysis:Debug No set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm ################################################## ## Save the generator ################################################## do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode ## Select the process cd /Herwig/MatrixElements/Matchbox ${process} read ${parameterFile} cd /Herwig/Generators set EventGenerator:MaxErrors 1000000 saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/Hadron-Merging.in b/Tests/Rivet/Templates/Hadron-Merging.in --- a/Tests/Rivet/Templates/Hadron-Merging.in +++ b/Tests/Rivet/Templates/Hadron-Merging.in @@ -1,50 +1,50 @@ # -*- ThePEG-repository -*- # # DO NOT EDIT - autogenerated by make_input_files.py # ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Matrix element library selection ################################################## ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in read Matchbox/MadGraph-OpenLoops.in ################################################## ## PDF and AlphaS choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in set /Herwig/Couplings/NLOAlphaS:input_alpha_s 0.118 read Merging/FactorCMWScheme.in ################################################## # Create the Herwig analysis ################################################## create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis set /Herwig/Analysis/RivetAnalysis:Debug No set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm ## Select the process cd /Herwig/Merging/ set Merger:MergingScale 15.*GeV ${process} read ${parameterFile} ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode cd /Herwig/Generators set EventGenerator:MaxErrors 1000000 saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Gamma-Direct.in b/Tests/Rivet/Templates/LEP-Gamma-Direct.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Gamma-Direct.in +++ /dev/null @@ -1,46 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -# base parameters for LEP analyses -################################################## -read snippets/EECollider.in -################################################## -# Technical parameters for this run -################################################## -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 - -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF -set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF -################################################## -## Shower and scheme selection. -## Should be empty unless using the Dipole Shower. -################################################## -${shower} - -################################################## -# Create the Herwig analysis -################################################## -cd /Herwig/Generators -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -################################################## -# Use the q qbar matrix element -################################################## -# default e+e- > q qbar (5 flavours d,u,s,c,b) -${process} -set /Herwig/Shower/PartnerFinder:QEDPartner IIandFF - -read ${parameterFile} - -################################################## -# Save run for later usage with 'Herwig run' -################################################## -cd /Herwig/Generators -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Gamma-Double-Resolved.in b/Tests/Rivet/Templates/LEP-Gamma-Double-Resolved.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Gamma-Double-Resolved.in +++ /dev/null @@ -1,47 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -# base parameters for LEP analyses -################################################## -read snippets/EECollider.in -################################################## -# Technical parameters for this run -################################################## -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 - -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF -set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF -set /Herwig/Particles/gamma:PDF /Herwig/Partons/SaSPDF -################################################## -## Shower and scheme selection. -## Should be empty unless using the Dipole Shower. -################################################## -${shower} - -################################################## -# Create the Herwig analysis -################################################## -cd /Herwig/Generators -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -################################################## -# Use the q qbar matrix element -################################################## -# default e+e- > q qbar (5 flavours d,u,s,c,b) -${process} -set /Herwig/Shower/PartnerFinder:QEDPartner All - -read ${parameterFile} - -################################################## -# Save run for later usage with 'Herwig run' -################################################## -cd /Herwig/Generators -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Gamma-Single-Resolved.in b/Tests/Rivet/Templates/LEP-Gamma-Single-Resolved.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Gamma-Single-Resolved.in +++ /dev/null @@ -1,72 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -# base parameters for LEP analyses -################################################## -read snippets/EECollider.in -################################################## -# Technical parameters for this run -################################################## -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 - -################################################## -# Select the PDFs -################################################## -set /Herwig/Particles/e+:PDF /Herwig/Partons/WWPDF -set /Herwig/Particles/e-:PDF /Herwig/Partons/WWPDF -set /Herwig/Particles/gamma:PDF /Herwig/Partons/SaSPDF - - -DISABLEREADONLY -create Herwig::MultiPartonExtractor /Herwig/Partons/GGExtractor HwPartonExtractor.so -newdef /Herwig/Partons/GGExtractor:NoPDF /Herwig/Partons/NoPDF -insert /Herwig/Partons/GGExtractor:FirstPDFs 0 /Herwig/Partons/WWPDF -insert /Herwig/Partons/GGExtractor:FirstPDFs 1 /Herwig/Partons/SaSPDF -insert /Herwig/Partons/GGExtractor:SecondPDFs 0 /Herwig/Partons/WWPDF -insert /Herwig/Partons/GGExtractor:SecondPDFs 1 /Herwig/Partons/NoPDF - -create Herwig::MultiPartonExtractor /Herwig/Partons/GG2Extractor HwPartonExtractor.so -newdef /Herwig/Partons/GG2Extractor:NoPDF /Herwig/Partons/NoPDF -insert /Herwig/Partons/GG2Extractor:FirstPDFs 0 /Herwig/Partons/WWPDF -insert /Herwig/Partons/GG2Extractor:FirstPDFs 1 /Herwig/Partons/NoPDF -insert /Herwig/Partons/GG2Extractor:SecondPDFs 0 /Herwig/Partons/WWPDF -insert /Herwig/Partons/GG2Extractor:SecondPDFs 1 /Herwig/Partons/SaSPDF - - -set /Herwig/MatrixElements/SubProcess:PartonExtractor /Herwig/Partons/GGExtractor -cp /Herwig/MatrixElements/SubProcess /Herwig/MatrixElements/SubProcess2 -set /Herwig/MatrixElements/SubProcess2:PartonExtractor /Herwig/Partons/GG2Extractor - -insert /Herwig/Generators/EventGenerator:EventHandler:SubProcessHandlers 1 /Herwig/MatrixElements/SubProcess2 - - -################################################## -## Shower and scheme selection. -## Should be empty unless using the Dipole Shower. -################################################## -${shower} - -################################################## -# Create the Herwig analysis -################################################## -cd /Herwig/Generators -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -################################################## -# Use the q qbar matrix element -################################################## -# default e+e- > q qbar (5 flavours d,u,s,c,b) -${process} -set /Herwig/Shower/PartnerFinder:QEDPartner All - -read ${parameterFile} - -################################################## -# Save run for later usage with 'Herwig run' -################################################## -cd /Herwig/Generators -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Matchbox.in b/Tests/Rivet/Templates/LEP-Matchbox.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Matchbox.in +++ /dev/null @@ -1,61 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -## Collider type -################################################## -read snippets/Matchbox.in - -read snippets/EECollider.in -################################################## -## Process selection -################################################## -## Model assumptions -read Matchbox/StandardModelLike.in -read Matchbox/DiagonalCKM.in -## Set the order of the couplings -cd /Herwig/MatrixElements/Matchbox -set Factory:OrderInAlphaS 0 -set Factory:OrderInAlphaEW 2 - -################################################## -## Scale choice -## See the documentation for more options -################################################## -cd /Herwig/MatrixElements/Matchbox -set Factory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/SHatScale -################################################## -## Matching and shower selection -################################################## -${shower} -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -################################################## -# Create the Herwig analysis -################################################## -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis -################################################## -## Do not apply profile scales for LEP as hard -## scale coincides with kinematic limit -################################################## -set /Herwig/Shower/ShowerHandler:HardScaleProfile NULL -set /Herwig/DipoleShower/DipoleShowerHandler:HardScaleProfile NULL -################################################## -## Save the generator -################################################## -do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode - -## Select the process -cd /Herwig/MatrixElements/Matchbox -${process} - -read ${parameterFile} - -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Merging.in b/Tests/Rivet/Templates/LEP-Merging.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Merging.in +++ /dev/null @@ -1,67 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -## Collider type -################################################## -read snippets/DipoleMerging.in -read snippets/EECollider.in -read snippets/MonacoSampler.in -################################################## -## Process selection -################################################## -## Model assumptions -read Matchbox/StandardModelLike.in -read Matchbox/DiagonalCKM.in -## Set the order of the couplings -cd /Herwig/Merging/ -set MergingFactory:OrderInAlphaS 0 -set MergingFactory:OrderInAlphaEW 2 -################################################## -## Matrix element library selection -################################################## -read Matchbox/MadGraph-OpenLoops.in -################################################## -## Scale choice -## See the documentation for more options -################################################## -cd /Herwig/Merging/ -set MergingFactory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/SHatScale -################################################## -## PDF and AlphaS choice -################################################## -set /Herwig/Couplings/NLOAlphaS:input_alpha_s 0.118 -read Merging/FactorCMWScheme.in -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF -################################################## -# Create the Herwig analysis -################################################## -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis -################################################## -## Do not apply profile scales for LEP as hard -## scale coincides with kinematic limit -################################################## -set /Herwig/DipoleShower/DipoleShowerHandler:HardScaleProfile NULL - - -## Select the process -cd /Herwig/Merging/ -set Merger:MergingScale 5.*GeV -${process} - -read ${parameterFile} - -################################################## -## Save the generator -################################################## -do /Herwig/Merging/MergingFactory:ProductionMode - -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP-Powheg.in b/Tests/Rivet/Templates/LEP-Powheg.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP-Powheg.in +++ /dev/null @@ -1,40 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -# base parameters for LEP analyses -################################################## -read snippets/EECollider.in -################################################## -# Technical parameters for this run -################################################## -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 - -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF - -################################################## -# Create the Herwig analysis -################################################## -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -################################################## -# Use the NLO q qbar matrix element -################################################## -set /Herwig/Shower/ShowerHandler:HardEmission POWHEG -insert /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/PowhegMEee2gZ2qq -${process} - -read ${parameterFile} - -################################################## -# Save run for later usage with 'Herwig run' -################################################## -cd /Herwig/Generators -saverun ${runname} EventGenerator diff --git a/Tests/Rivet/Templates/LEP.in b/Tests/Rivet/Templates/LEP.in deleted file mode 100644 --- a/Tests/Rivet/Templates/LEP.in +++ /dev/null @@ -1,48 +0,0 @@ -# -*- ThePEG-repository -*- -# -# DO NOT EDIT - autogenerated by make_input_files.py -# -################################################## -# base parameters for LEP analyses -################################################## -read snippets/EECollider.in -################################################## -# Technical parameters for this run -################################################## -cd /Herwig/Generators -set EventGenerator:MaxErrors 1000000 - -################################################## -# Switch off ISR -################################################## -set /Herwig/Particles/e-:PDF /Herwig/Partons/NoPDF -set /Herwig/Particles/e+:PDF /Herwig/Partons/NoPDF - - -################################################## -## Shower and scheme selection. -## Should be empty unless using the Dipole Shower. -################################################## -${shower} - -################################################## -# Create the Herwig analysis -################################################## -cd /Herwig/Generators -create ThePEG::RivetAnalysis /Herwig/Analysis/RivetAnalysis RivetAnalysis.so -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -################################################## -# Use the q qbar matrix element -################################################## -# default e+e- > q qbar (5 flavours d,u,s,c,b) -${process} -set /Herwig/Shower/PartnerFinder:QEDPartner IIandFF - -read ${parameterFile} - -################################################## -# Save run for later usage with 'Herwig run' -################################################## -cd /Herwig/Generators -saverun ${runname} EventGenerator diff --git a/Tests/python/make_input_files.py b/Tests/python/make_input_files.py --- a/Tests/python/make_input_files.py +++ b/Tests/python/make_input_files.py @@ -1,1927 +1,1938 @@ #! /usr/bin/env python import logging,sys,os from string import strip, Template import sys if sys.version_info[:3] < (2,4,0): print "rivet scripts require Python version >= 2.4.0... exiting" sys.exit(1) if __name__ == "__main__": import logging from optparse import OptionParser, OptionGroup parser = OptionParser(usage="%prog name [...]") simulation="" numberOfAddedProcesses=0 def addProcess(thefactory,theProcess,Oas,Oew,scale,mergedlegs,NLOprocesses): global numberOfAddedProcesses global simulation numberOfAddedProcesses+=1 res ="set "+thefactory+":OrderInAlphaS "+Oas+"\n" res+="set "+thefactory+":OrderInAlphaEW "+Oew+"\n" res+="do "+thefactory+":Process "+theProcess+" " if ( mergedlegs != 0 ): if simulation!="Merging": print "simulation is not Merging, trying to add merged legs." sys.exit(1) res+="[" for j in range(mergedlegs): res+=" j " res+="]" res+="\n" if (NLOprocesses!=0): if simulation!="Merging": print "simulation is not Merging, trying to add NLOProcesses." sys.exit(1) res+="set MergingFactory:NLOProcesses %s \n" % NLOprocesses if ( scale != "" ): res+="set "+thefactory+":ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/"+scale+"\n" return res def addLeptonPairCut(minmass,maxmass): return "set /Herwig/Cuts/LeptonPairMassCut:MinMass "+minmass+"*GeV\nset /Herwig/Cuts/LeptonPairMassCut:MaxMass "+maxmass+"*GeV\n" didaddfirstjet=False def addFirstJet(ptcut): global didaddfirstjet if(didaddfirstjet): logging.error("Can only add jetcut once.") sys.exit(1) res="set /Herwig/Cuts/Cuts:JetFinder /Herwig/Cuts/JetFinder\n" res+="insert /Herwig/Cuts/Cuts:MultiCuts 0 /Herwig/Cuts/JetCuts\n" res+="insert /Herwig/Cuts/JetCuts:JetRegions 0 /Herwig/Cuts/FirstJet\n" if(ptcut!=""): res+="set /Herwig/Cuts/FirstJet:PtMin "+ptcut+".*GeV\n" didaddfirstjet=True return res didaddsecondjet=False def addSecondJet(ptcut): global didaddsecondjet if(didaddsecondjet): logging.error("Can only add second jetcut once.") sys.exit(1) res="insert /Herwig/Cuts/JetCuts:JetRegions 0 /Herwig/Cuts/SecondJet\n" res+="set /Herwig/Cuts/SecondJet:PtMin "+ptcut+".*GeV\n" didaddsecondjet=True return res didaddjetpair=False def addJetPairCut(minmass): global didaddjetpair if(didaddjetpair): logging.error("Can only add second jetcut once.") sys.exit(1) res="""\ create ThePEG::JetPairRegion /Herwig/Cuts/JetPairMass JetCuts.so set /Herwig/Cuts/JetPairMass:FirstRegion /Herwig/Cuts/FirstJet set /Herwig/Cuts/JetPairMass:SecondRegion /Herwig/Cuts/SecondJet insert /Herwig/Cuts/JetCuts:JetPairRegions 0 /Herwig/Cuts/JetPairMass set /Herwig/Cuts/JetPairMass:MassMin {mm}.*GeV """.format(mm=minmass) didaddjetpair=True return res addedBRReweighter=False def addBRReweighter(): global addedBRReweighter if(addedBRReweighter): logging.error("Can only add BRReweighter once.") sys.exit(1) res="create Herwig::BranchingRatioReweighter /Herwig/Generators/BRReweighter\n" res+="insert /Herwig/Generators/EventGenerator:EventHandler:PostHadronizationHandlers 0 /Herwig/Generators/BRReweighter\n" addedBRReweighter=True return res def setHardProcessWidthToZero(list1): res="" for i in list1: res+="set /Herwig/Particles/"+i+":HardProcessWidth 0.\n" return res selecteddecaymode=False def selectDecayMode(particle,decaymodes): global selecteddecaymode res="do /Herwig/Particles/"+particle+":SelectDecayModes" for decay in decaymodes: res+=" /Herwig/Particles/"+particle+"/"+decay res+="\n" selecteddecaymode=True return res def jet_kt_cut(energy): return "set /Herwig/Cuts/JetKtCut:MinKT {E}*GeV\n".format(E=energy) def mhatmin_cut(energy): return "set /Herwig/Cuts/Cuts:MHatMin {E}*GeV\n".format(E=energy) def mhat_minm_maxm(e1,e2,e3): return """\ set /Herwig/Cuts/Cuts:MHatMin {e1}*GeV set /Herwig/Cuts/MassCut:MinM {e2}*GeV set /Herwig/Cuts/MassCut:MaxM {e3}*GeV """.format(**locals()) def collider_lumi(energy): return "set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy {E}*GeV\n".format(E=energy) def insert_ME(me,process=None,ifname='Process',subprocess="SubProcess"): result = "insert /Herwig/MatrixElements/{subprocess}:MatrixElements 0 /Herwig/MatrixElements/{me}\n".format(**locals()) if process is not None: result += "set /Herwig/MatrixElements/{me}:{ifname} {process}".format(**locals()) return result def particlegroup(name,*particles): result = ["do /Herwig/MatrixElements/Matchbox/Factory:StartParticleGroup {n}".format(n=name)] for p in particles: result.append( "insert /Herwig/MatrixElements/Matchbox/Factory:ParticleGroup 0 /Herwig/Particles/{p}".format(p=p) ) result.append("do /Herwig/MatrixElements/Matchbox/Factory:EndParticleGroup") return '\n'.join(result) # settings for four flavour scheme fourFlavour=""" read Matchbox/FourFlavourScheme.in {bjetgroup} set /Herwig/Cuts/MatchboxJetMatcher:Group bjet """.format(bjetgroup=particlegroup('bjet','b','bbar','c', 'cbar', 's','sbar','d','dbar','u','ubar','g')) ME_Upsilon = """\ create Herwig::MEee2VectorMeson /Herwig/MatrixElements/MEUpsilon HwMELepton.so set /Herwig/MatrixElements/MEUpsilon:VectorMeson /Herwig/Particles/Upsilon(4S) -set /Herwig/MatrixElements/MEUpsilon:Coupling 0.0004151809 +set /Herwig/MatrixElements/MEUpsilon:Coupling 96.72794 """ + insert_ME("MEUpsilon") (opts, args) = parser.parse_args() ## Check args if len(args) != 1: logging.error("Must specify at least input file") sys.exit(1) name = args[0] print name # select the template to load # collider KNOWN_COLLIDERS = [ "GammaGamma", - "LEP-Gamma", + "EE-Gamma", "BFactory", - "LEP", + "EE", "DIS", "TVT", "LHC-GammaGamma", "LHC", "ISR", "SppS", "Star", "EHS", ] collider = "" for cand_collider in KNOWN_COLLIDERS: if cand_collider in name: collider = cand_collider break del cand_collider assert collider have_hadronic_collider = collider in ["TVT","LHC","ISR","SppS","Star","EHS"] thefactory="Factory" parameters = { 'shower' : '', 'bscheme' : '', } # istart determines how many name parts need to be skipped istart = 1 # Dipole shower with Matchbox Powheg if "Dipole-Matchbox-Powheg" in name : istart = 4 simulation="Matchbox" parameters["shower"] = "read Matchbox/Powheg-DipoleShower.in\n" # Dipole shower with internal Powheg - Todo: Finish modifying template files. ''' elif "Dipole-Powheg" in name : istart = 3 simulation="Powheg" parameters["shower"] = "set /Herwig/EventHandlers/EventHandler:CascadeHandler /Herwig/DipoleShower/DipoleShowerHandler\nread snippets/Dipole_AutoTune_prel.in\n" ''' # Dipole shower with MCatNLO elif "Dipole-MCatNLO" in name : istart = 3 simulation="Matchbox" parameters["shower"] = "read Matchbox/MCatNLO-DipoleShower.in\n" # Dipole shower with Matchbox LO elif "Dipole-Matchbox-LO" in name : istart = 4 simulation="Matchbox" parameters["shower"] = "read Matchbox/LO-DipoleShower.in\n" # Dipole shower with internal LO elif "Dipole" in name : istart = 2 simulation="" parameters["shower"] = "set /Herwig/EventHandlers/EventHandler:CascadeHandler /Herwig/DipoleShower/DipoleShowerHandler\nread snippets/Dipole_AutoTune_prel.in\n" # AO shower with Matchbox Powheg elif "Matchbox-Powheg" in name : istart = 3 simulation="Matchbox" parameters["shower"] = "read Matchbox/Powheg-DefaultShower.in\n" # AO shower with MCatNLO elif "Matchbox" in name : istart = 2 simulation="Matchbox" parameters["shower"] = "read Matchbox/MCatNLO-DefaultShower.in\n" # AO shower with inernal Powheg elif "Powheg" in name : istart = 2 simulation="Powheg" # Dipole shower with merging elif "Merging" in name : istart = 2 simulation="Merging" thefactory="MergingFactory" # Flavour settings for Matchbox if simulation=="Matchbox" : parameters["bscheme"] = "read Matchbox/FiveFlavourScheme.in\n" if "Dipole" in parameters["shower"] : parameters["bscheme"] += "read Matchbox/FiveFlavourNoBMassScheme.in\n" - if collider not in ['DIS','LEP'] : + if collider not in ['DIS','EE'] : parameters["nlo"] = "read Matchbox/MadGraph-OpenLoops.in\n" # Flavour settings for dipole shower with internal ME if simulation=="" and "Dipole" in parameters["shower"] : parameters["bscheme"] = "read snippets/DipoleShowerFiveFlavours.in" # find the template if simulation=="" : if collider=="LHC-GammaGamma" : istart += 1 templateName="Hadron-Gamma.in" elif have_hadronic_collider : templateName="Hadron.in" - elif collider=="LEP-Gamma" : + elif collider=="EE-Gamma" : istart+=1 if("Direct" in name) : - templateName="LEP-Gamma-Direct.in" + templateName="EE-Gamma-Direct.in" elif("Single-Resolved" in name) : - templateName="LEP-Gamma-Single-Resolved.in" + templateName="EE-Gamma-Single-Resolved.in" elif("Double-Resolved" in name) : - templateName="LEP-Gamma-Double-Resolved.in" + templateName="EE-Gamma-Double-Resolved.in" else : - print "Unknown type of LEP-Gamma event ",name + print "Unknown type of EE-Gamma event ",name quit() elif collider=="GammaGamma" : templateName="GammaGamma.in" elif collider != "BFactory" : templateName= "%s.in" % collider else : - templateName= "LEP.in" + templateName= "EE.in" else : if have_hadronic_collider : templateName= "Hadron-%s.in" % simulation elif collider != "BFactory" : templateName= "%s-%s.in" % (collider,simulation) else : - templateName= "LEP-%s.in" % simulation + templateName= "EE-%s.in" % simulation # work out the name of the parameter file parameterName="-".join(name.split("-")[istart:]) del istart class StringBuilder(object): """ Avoid expensive string additions until the end by building up a list first. This helper class avoids rewriting all the += lower down to list operations. """ def __init__(self, init = None): self.lines = [] if init is None else [init] def __iadd__(self, line): self.lines.append(line) return self def __str__(self): return '\n'.join(self.lines) # work out the process and parameters process=StringBuilder() -# Bfactory -if(collider=="BFactory") : - if(simulation=="") : - if(parameterName=="10.58-res") : - process += ME_Upsilon - elif(parameterName=="10.58") : - process += ME_Upsilon - process += "set /Herwig/MatrixElements/MEee2gZ2qq:MaximumFlavour 4\n" - else : - process+=insert_ME("MEee2gZ2qq") - process+= "set /Herwig/MatrixElements/MEee2gZ2qq:MaximumFlavour 4\n" - elif(simulation=="Powheg") : - process = StringBuilder("set /Herwig/MatrixElements/PowhegMEee2gZ2qq:MaximumFlavour 4\n") - elif(simulation=="Matchbox" ) : - process = StringBuilder(addProcess(thefactory,"e- e+ -> u ubar","0","2","",0,0)) - process+=addProcess(thefactory,"e- e+ -> d dbar","0","2","",0,0) - process+=addProcess(thefactory,"e- e+ -> c cbar","0","2","",0,0) - process+=addProcess(thefactory,"e- e+ -> s sbar","0","2","",0,0) - elif(simulation=="Merging" ) : - logging.warning("BFactory not explicitly tested for %s " % simulation) - sys.exit(0) # DIS -elif(collider=="DIS") : +if(collider=="DIS") : if(simulation=="") : if "NoME" in parameterName : process = StringBuilder("set /Herwig/Shower/ShowerHandler:HardEmission None") parameterName=parameterName.replace("NoME-","") else : process = StringBuilder("") elif(simulation=="Powheg") : process = StringBuilder("") elif(simulation=="Matchbox" ) : if "e-" in parameterName : process = StringBuilder(addProcess(thefactory,"e- p -> e- j","0","2","",0,0)) else : process = StringBuilder(addProcess(thefactory,"e+ p -> e+ j","0","2","",0,0)) elif(simulation=="Merging" ) : if "e-" in parameterName : process = StringBuilder(addProcess(thefactory,"e- p -> e- j","0","2","",2,2)) else : process = StringBuilder(addProcess(thefactory,"e+ p -> e+ j","0","2","",2,2)) -# LEP -elif(collider=="LEP") : +# EE +elif(collider=="EE") : if(simulation=="") : if "gg" in parameterName : process = StringBuilder("create Herwig::MEee2Higgs2SM /Herwig/MatrixElements/MEee2Higgs2SM\n") process+=insert_ME("MEee2Higgs2SM","Gluon","Allowed") else : - process = StringBuilder(insert_ME("MEee2gZ2qq")) - if(parameterName=="10") : - process+="set /Herwig/MatrixElements/MEee2gZ2qq:MaximumFlavour 4" + if(parameterName=="10.58-res") : + process += ME_Upsilon + elif(parameterName=="10.58") : + process += ME_Upsilon + process += "set /Herwig/MatrixElements/MEee2gZ2qq:MaximumFlavour 4\n" + else : + process = StringBuilder(insert_ME("MEee2gZ2qq")) + try : + ecms = float(parameterName) + if(ecms<=10.1) : + process+= "set /Herwig/MatrixElements/MEee2gZ2qq:MaximumFlavour 4\n" + except : + pass elif(simulation=="Powheg") : process = StringBuilder() if(parameterName=="10") : - process = StringBuilder("set /Herwig/MatrixElements/PowhegMEee2gZ2qq:MaximumFlavour 4") + process = StringBuilder() + try : + ecms = float(parameterName) + if(ecms<=10.1) : + process+= "set /Herwig/MatrixElements/PowhegMEee2gZ2qq:MaximumFlavour 4\n" + except : + pass elif(simulation=="Matchbox" ) : - if(parameterName=="10") : - process = StringBuilder(addProcess(thefactory,"e- e+ -> u ubar","0","2","",0,0)) - process+=addProcess(thefactory,"e- e+ -> d dbar","0","2","",0,0) - process+=addProcess(thefactory,"e- e+ -> c cbar","0","2","",0,0) - process+=addProcess(thefactory,"e- e+ -> s sbar","0","2","",0,0) - else : + try : + ecms = float(parameterName) + if(ecms<=10.1) : + process = StringBuilder(addProcess(thefactory,"e- e+ -> u ubar","0","2","",0,0)) + process+=addProcess(thefactory,"e- e+ -> d dbar","0","2","",0,0) + process+=addProcess(thefactory,"e- e+ -> c cbar","0","2","",0,0) + process+=addProcess(thefactory,"e- e+ -> s sbar","0","2","",0,0) + else : + process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",0,0)) + except: process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",0,0)) - elif(simulation=="Merging" ) : - if(parameterName=="10") : - process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",2,2)) - process+="read Matchbox/FourFlavourScheme.in" - else : - process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",2,2)) -# LEP-Gamma -elif(collider=="LEP-Gamma") : + try : + ecms = float(parameterName) + if(ecms<=10.1) : + process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",2,2)) + process+="read Matchbox/FourFlavourScheme.in" + else : + process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",2,2)) + except: + process = StringBuilder(addProcess(thefactory,"e- e+ -> j j","0","2","",2,2)) +# EE-Gamma +elif(collider=="EE-Gamma") : if(simulation=="") : if("mumu" in parameterName) : process = StringBuilder(insert_ME("MEgg2ff","Muon")) process +="set /Herwig/Cuts/Cuts:MHatMin 3.\n" elif( "tautau" in parameterName) : process = StringBuilder(insert_ME("MEgg2ff","Tau")) process +="set /Herwig/Cuts/Cuts:MHatMin 3.\n" elif( "Jets" in parameterName) : if("Direct" in parameterName ) : process = StringBuilder(insert_ME("MEgg2ff","Quarks")) elif("Single-Resolved" in parameterName ) : process = StringBuilder(insert_ME("MEGammaP2Jets",None,"Process","SubProcess")) process+= insert_ME("MEGammaP2Jets",None,"Process","SubProcess2") else : process = StringBuilder(insert_ME("MEQCD2to2")) process+="insert /Herwig/Cuts/Cuts:OneCuts[0] /Herwig/Cuts/JetKtCut" process+="set /Herwig/Cuts/JetKtCut:MinKT 3." else : - print "process not supported for Gamma Gamma processes at LEP" + print "process not supported for Gamma Gamma processes at EE" quit() else : - print "Only internal matrix elements currently supported for Gamma Gamma processes at LEP" + print "Only internal matrix elements currently supported for Gamma Gamma processes at EE" quit() elif(collider=="GammaGamma") : if(simulation=="") : if("mumu" in parameterName) : process = StringBuilder(insert_ME("MEgg2ff")) process +="set /Herwig/MatrixElements/MEgg2ff:Process Muon\n" process +="set /Herwig/Cuts/Cuts:MHatMin 3.\n" else : - print "process not supported for Gamma Gamma processes at LEP" + print "process not supported for Gamma Gamma processes at EE" quit() else : - print "Only internal matrix elements currently supported for Gamma Gamma processes at LEP" + print "Only internal matrix elements currently supported for Gamma Gamma processes at EE" quit() # TVT elif(collider=="TVT") : process = StringBuilder("set /Herwig/Generators/EventGenerator:EventHandler:BeamB /Herwig/Particles/pbar-\n") if "Run-II" in parameterName : process+=collider_lumi(1960.0) elif "Run-I" in parameterName : process+=collider_lumi(1800.0) elif "900" in parameterName : process+=collider_lumi(900.0) elif "630" in parameterName : process+=collider_lumi(630.0) elif "300" in parameterName : process+=collider_lumi(300.0) if(simulation=="") : if "PromptPhoton" in parameterName : process+=insert_ME("MEGammaJet") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 15.\n" elif "DiPhoton-GammaGamma" in parameterName : process+=insert_ME("MEGammaGamma") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" parameterName=parameterName.replace("-GammaGamma","") elif "DiPhoton-GammaJet" in parameterName : process+=insert_ME("MEGammaJet") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" parameterName=parameterName.replace("-GammaJet","") elif "UE" in parameterName : if "Dipole" in parameters["shower"]: process+="read snippets/MB-DipoleShower.in\n" else: process+="read snippets/MB.in\n" process+="read snippets/Diffraction.in\n" process += "set /Herwig/Decays/DecayHandler:LifeTimeOption 0\n" process += "set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm\n" elif "Jets" in parameterName : process+=insert_ME("MEQCD2to2") process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "Run-II-Jets-10" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(500.) elif "Run-II-Jets-11" in parameterName: process+=jet_kt_cut( 30.)+mhatmin_cut(900.) elif "Run-I-Jets-1" in parameterName : process+=jet_kt_cut( 20.) elif "Run-I-Jets-2" in parameterName : process+=jet_kt_cut( 40.) elif "Run-I-Jets-3" in parameterName : process+=jet_kt_cut( 65.) elif "Run-I-Jets-4" in parameterName : process+=jet_kt_cut( 90.) elif "Run-I-Jets-5" in parameterName : process+=jet_kt_cut(160.) elif "Run-I-Jets-6" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(100.) elif "Run-I-Jets-7" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(400.) elif "Run-I-Jets-8" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(700.) elif "Run-II-Jets-0" in parameterName : process+=jet_kt_cut( 15.) elif "Run-II-Jets-1" in parameterName : process+=jet_kt_cut( 25.) elif "Run-II-Jets-2" in parameterName : process+=jet_kt_cut( 40.) elif "Run-II-Jets-3" in parameterName : process+=jet_kt_cut( 60.) elif "Run-II-Jets-4" in parameterName : process+=jet_kt_cut( 85.) elif "Run-II-Jets-5" in parameterName : process+=jet_kt_cut(110.) elif "Run-II-Jets-6" in parameterName : process+=jet_kt_cut(160.) elif "Run-II-Jets-7" in parameterName : process+=jet_kt_cut(250.) elif "Run-II-Jets-8" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(100.) elif "Run-II-Jets-9" in parameterName : process+=jet_kt_cut( 30.)+mhatmin_cut(300.) elif "900-Jets-1" in parameterName : process+=jet_kt_cut( 10.) elif "300-Jets-1" in parameterName : process+=jet_kt_cut( 6.) elif "630-Jets-1" in parameterName : process+=jet_kt_cut( 20.) elif "630-Jets-2" in parameterName : process+=jet_kt_cut( 40.) elif "630-Jets-3" in parameterName : process+=jet_kt_cut( 75.) elif "900-Jets-1" in parameterName : process+=jet_kt_cut( 10.) elif "Run-I-WZ" in parameterName : process+=insert_ME("MEqq2W2ff","Electron") process+=insert_ME("MEqq2gZ2ff","Electron") elif "Run-II-W" in parameterName or "Run-I-W" in parameterName : process+=insert_ME("MEqq2W2ff","Electron") elif "Run-II-Z-e" in parameterName or "Run-I-Z" in parameterName : process +=insert_ME("MEqq2gZ2ff","Electron") elif "Run-II-Z-LowMass-mu" in parameterName : process +=insert_ME("MEqq2gZ2ff","Muon") process+=addLeptonPairCut("25","70") elif "Run-II-Z-HighMass-mu" in parameterName : process +=insert_ME("MEqq2gZ2ff","Muon") process+=addLeptonPairCut("150","600") elif "Run-II-Z-mu" in parameterName : process +=insert_ME("MEqq2gZ2ff","Muon") elif(simulation=="Powheg") : if "Run-I-WZ" in parameterName : process+=insert_ME("PowhegMEqq2W2ff","Electron") process+=insert_ME("PowhegMEqq2gZ2ff","Electron") elif "Run-II-W" in parameterName or "Run-I-W" in parameterName : process+=insert_ME("PowhegMEqq2W2ff","Electron") elif "Run-II-Z-e" in parameterName or "Run-I-Z" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") elif "Run-II-Z-LowMass-mu" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") process+=addLeptonPairCut("25","70") elif "Run-II-Z-HighMass-mu" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") process+=addLeptonPairCut("150","600") elif "Run-II-Z-mu" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "DiPhoton-GammaGamma" in parameterName : process+=insert_ME("MEGammaGammaPowheg","GammaGamma") process+=insert_ME("MEGammaGamma","gg") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" process+=jet_kt_cut(5.) parameterName=parameterName.replace("-GammaGamma","") elif "DiPhoton-GammaJet" in parameterName : process+=insert_ME("MEGammaGammaPowheg","VJet") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" process+=jet_kt_cut(5.) parameterName=parameterName.replace("-GammaJet","") elif(simulation=="Matchbox" or simulation=="Merging" ) : if "Jets" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p -> j j","2","0","MaxJetPtScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p -> j j","2","0","MaxJetPtScale",1,0) process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "Run-II-Jets-10" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("500") elif "Run-II-Jets-11" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("900") elif "Run-II-Jets-12" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("300") elif "Run-I-Jets-1" in parameterName : process+=addFirstJet("20") elif "Run-I-Jets-2" in parameterName : process+=addFirstJet("40") elif "Run-I-Jets-3" in parameterName : process+=addFirstJet("65") elif "Run-I-Jets-4" in parameterName : process+=addFirstJet("90") elif "Run-I-Jets-5" in parameterName : process+=addFirstJet("160") elif "Run-I-Jets-6" in parameterName : process+=addFirstJet("30")+addSecondJet("25")+addJetPairCut("100") elif "Run-I-Jets-7" in parameterName : process+=addFirstJet("30")+addSecondJet("25")+addJetPairCut("400") elif "Run-I-Jets-8" in parameterName : process+=addFirstJet("30")+addSecondJet("25")+addJetPairCut("700") elif "Run-II-Jets-0" in parameterName : process+=addFirstJet("15") elif "Run-II-Jets-1" in parameterName : process+=addFirstJet("25") elif "Run-II-Jets-2" in parameterName : process+=addFirstJet("40") elif "Run-II-Jets-3" in parameterName : process+=addFirstJet("60") elif "Run-II-Jets-4" in parameterName : process+=addFirstJet("85") elif "Run-II-Jets-5" in parameterName : process+=addFirstJet("110") elif "Run-II-Jets-6" in parameterName : process+=addFirstJet("160") elif "Run-II-Jets-7" in parameterName : process+=addFirstJet("250") elif "Run-II-Jets-8" in parameterName : process+=addFirstJet("30")+addSecondJet("25")+addJetPairCut("100") elif "Run-II-Jets-9" in parameterName : process+=addFirstJet("30")+addSecondJet("25")+addJetPairCut("300") elif "900-Jets-1" in parameterName : process+=addFirstJet("10") elif "300-Jets-1" in parameterName : process+=addFirstJet("6") elif "630-Jets-1" in parameterName : process+=addFirstJet("20") elif "630-Jets-2" in parameterName : process+=addFirstJet("40") elif "630-Jets-3" in parameterName : process+=addFirstJet("75") elif "900-Jets-1" in parameterName : process+=addFirstJet("10") else : logging.error("Exit 00007") sys.exit(1) elif "Run-I-WZ" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar e+ e-","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p pbar e+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p pbar e- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('epm','e+','e-') process+=particlegroup('epmnu','e+','e-','nu_e','nu_ebar') process+=addProcess(thefactory,"p pbar epm epmnu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Run-II-W" in parameterName or "Run-I-W" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar e+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p pbar e- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('epm','e+','e-') process+=addProcess(thefactory,"p pbar epm nu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Run-II-Z-e" in parameterName or "Run-I-Z" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p pbar e+ e-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Run-II-Z-LowMass-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("25","70") elif "Run-II-Z-HighMass-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("150","600") elif "Run-II-Z-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p pbar mu+ mu-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") # Star elif(collider=="Star" ) : process = StringBuilder("set /Herwig/Decays/DecayHandler:LifeTimeOption 0\n") process+= "set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm\n" process+= "set /Herwig/Generators/EventGenerator:EventHandler:BeamB /Herwig/Particles/p+\n" process+= collider_lumi(200.0) process+= "set /Herwig/Cuts/Cuts:X2Min 0.01\n" if(simulation=="") : if "UE" in parameterName : if "Dipole" in parameters["shower"]: process+="read snippets/MB-DipoleShower.in\n" else: process+="read snippets/MB.in\n" process+="read snippets/Diffraction.in\n" else : process+=insert_ME("MEQCD2to2") process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "Jets-1" in parameterName : process+=jet_kt_cut(2.) elif "Jets-2" in parameterName : process+=jet_kt_cut(5.) elif "Jets-3" in parameterName : process+=jet_kt_cut(20.) elif "Jets-4" in parameterName : process+=jet_kt_cut(25.) else : logging.error("Star not supported for %s " % simulation) sys.exit(1) # ISR and SppS elif(collider=="ISR" or collider =="SppS" or collider == "EHS" ) : process = StringBuilder("set /Herwig/Decays/DecayHandler:LifeTimeOption 0\n") process+="set /Herwig/Decays/DecayHandler:MaxLifeTime 10*mm\n" if(collider=="SppS") : process = StringBuilder("set /Herwig/Generators/EventGenerator:EventHandler:BeamB /Herwig/Particles/pbar-\n") if "30" in parameterName : process+=collider_lumi( 30.4) elif "44" in parameterName : process+=collider_lumi( 44.4) elif "53" in parameterName : process+=collider_lumi( 53.0) elif "62" in parameterName : process+=collider_lumi( 62.2) elif "63" in parameterName : process+=collider_lumi( 63.0) elif "200" in parameterName : process+=collider_lumi(200.0) elif "500" in parameterName : process+=collider_lumi(500.0) elif "546" in parameterName : process+=collider_lumi(546.0) elif "900" in parameterName : process+=collider_lumi(900.0) if(simulation=="") : if "Dipole" in parameters["shower"]: process+="read snippets/MB-DipoleShower.in\n" else: process+="read snippets/MB.in\n" process+="read snippets/Diffraction.in\n" else : logging.error(" SppS and ISR not supported for %s " % simulation) sys.exit(1) # LHC elif(collider=="LHC") : if parameterName.startswith("7-") : process = StringBuilder(collider_lumi(7000.0)) elif parameterName.startswith("8-") : process = StringBuilder(collider_lumi(8000.0)) elif parameterName.startswith("13-") : process = StringBuilder(collider_lumi(13000.0)) elif parameterName.startswith("900") : process = StringBuilder(collider_lumi(900.0)) elif parameterName.startswith("2360") : process = StringBuilder(collider_lumi(2360.0)) elif parameterName.startswith("2760") : process = StringBuilder(collider_lumi(2760.0)) else : process = StringBuilder(collider_lumi(7000.0)) if(simulation=="") : if "VBF" in parameterName : process+=insert_ME("MEPP2HiggsVBF") if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) addedBRReweighter = True process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "ggHJet" in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) addedBRReweighter = True process+="set /Herwig/Particles/tau-:Stable Stable\n" process+=insert_ME("MEHiggsJet") process+=jet_kt_cut(20.) elif "ggH" in parameterName : process+=insert_ME("MEHiggs") process+=insert_ME("MEHiggsJet","qqbar") process+=jet_kt_cut(0.0) if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) addedBRReweighter = True process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "PromptPhoton" in parameterName : process+=insert_ME("MEGammaJet") if "PromptPhoton-1" in parameterName : process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" elif "PromptPhoton-2" in parameterName : process+="set /Herwig/Cuts/PhotonKtCut:MinKT 25.\n" elif "PromptPhoton-3" in parameterName : process+="set /Herwig/Cuts/PhotonKtCut:MinKT 80.\n" elif "PromptPhoton-4" in parameterName : process+="set /Herwig/Cuts/PhotonKtCut:MinKT 150.\n" elif "DiPhoton-GammaGamma" in parameterName : process+=insert_ME("MEGammaGamma") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" parameterName=parameterName.replace("-GammaGamma","") elif "DiPhoton-GammaJet" in parameterName : process+=insert_ME("MEGammaJet") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" parameterName=parameterName.replace("-GammaJet","") elif "8-WH" in parameterName : process+=insert_ME("MEPP2WH") process+=jet_kt_cut(0.0) if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-ZH" in parameterName : process+=insert_ME("MEPP2ZH") process+=jet_kt_cut(0.0) if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "WH" in parameterName : process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;"]) addedBRReweighter = True process+=insert_ME("MEPP2WH") process+=jet_kt_cut(0.0) elif "ZH" in parameterName : process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;"]) addedBRReweighter = True process+=insert_ME("MEPP2ZH") process+=jet_kt_cut(0.0) elif "UE" in parameterName : if "Dipole" in parameters["shower"]: process+="read snippets/MB-DipoleShower.in\n" else: process+="set /Herwig/Shower/ShowerHandler:IntrinsicPtGaussian 2.2*GeV\n" process+="read snippets/MB.in\n" process+="read snippets/Diffraction.in\n" if "Long" in parameterName : process += "set /Herwig/Decays/DecayHandler:MaxLifeTime 100*mm\n" elif "8-DiJets" in parameterName or "7-DiJets" in parameterName or "13-DiJets" in parameterName : process+=insert_ME("MEQCD2to2") process+="set MEQCD2to2:MaximumFlavour 5\n" process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "13-DiJets" not in parameterName : if "-A" in parameterName : process+=jet_kt_cut(45.) process+="set /Herwig/Cuts/JetKtCut:MinEta -3.\n" process+="set /Herwig/Cuts/JetKtCut:MaxEta 3.\n" elif "-B" in parameterName : process+=jet_kt_cut(20.) process+="set /Herwig/Cuts/JetKtCut:MinEta -2.7\n" process+="set /Herwig/Cuts/JetKtCut:MaxEta 2.7\n" elif "-C" in parameterName : process+=jet_kt_cut(20.) process+="set /Herwig/Cuts/JetKtCut:MinEta -4.8\n" process+="set /Herwig/Cuts/JetKtCut:MaxEta 4.8\n" else : if "-A" in parameterName : + process+=jet_kt_cut(60.) + process+="set /Herwig/Cuts/JetKtCut:MinEta -3.\n" + process+="set /Herwig/Cuts/JetKtCut:MaxEta 3.\n" + elif "-B" in parameterName : process+=jet_kt_cut(180.) process+="set /Herwig/Cuts/JetKtCut:MinEta -3.\n" process+="set /Herwig/Cuts/JetKtCut:MaxEta 3.\n" if "DiJets-1" in parameterName : process+=mhatmin_cut(90.) elif "DiJets-2" in parameterName : process+=mhatmin_cut(200.) elif "DiJets-3" in parameterName : process+=mhatmin_cut(450.) elif "DiJets-4" in parameterName : process+=mhatmin_cut(750.) elif "DiJets-5" in parameterName : process+=mhatmin_cut(950.) elif "DiJets-6" in parameterName : process+=mhatmin_cut(1550.) elif "DiJets-7" in parameterName : process+=mhatmin_cut(2150.) elif "DiJets-8" in parameterName : process+=mhatmin_cut(2750.) elif "DiJets-9" in parameterName : process+=mhatmin_cut(3750.) elif "DiJets-10" in parameterName : process+=mhatmin_cut(4750.) elif "DiJets-11" in parameterName : process+=mhatmin_cut(5750.) elif( "7-Jets" in parameterName or "8-Jets" in parameterName or "13-Jets" in parameterName or "2760-Jets" in parameterName ) : process+=insert_ME("MEQCD2to2") process+="set MEQCD2to2:MaximumFlavour 5\n" process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "Jets-10" in parameterName : process+=jet_kt_cut(1800.) elif "Jets-0" in parameterName : process+=jet_kt_cut(5.) elif "Jets-1" in parameterName : process+=jet_kt_cut(10.) elif "Jets-2" in parameterName : process+=jet_kt_cut(20.) elif "Jets-3" in parameterName : process+=jet_kt_cut(40.) elif "Jets-4" in parameterName : process+=jet_kt_cut(70.) elif "Jets-5" in parameterName : process+=jet_kt_cut(150.) elif "Jets-6" in parameterName : process+=jet_kt_cut(200.) elif "Jets-7" in parameterName : process+=jet_kt_cut(300.) elif "Jets-8" in parameterName : process+=jet_kt_cut(500.) elif "Jets-9" in parameterName : process+=jet_kt_cut(800.) elif( "7-Charm" in parameterName or "7-Bottom" in parameterName or "8-Bottom" in parameterName) : if("8-Bottom" in parameterName) : addBRReweighter() process+=selectDecayMode("Jpsi",["Jpsi->mu-,mu+;"]) if "Bottom" in parameterName : process+="cp MEHeavyQuark MEBottom\n" process+="set MEBottom:QuarkType Bottom\n" process+=insert_ME("MEBottom") else : process+="cp MEHeavyQuark MECharm\n" process+="set MECharm:QuarkType Charm\n" process+=insert_ME("MECharm") process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "-0" in parameterName : if "Bottom" in parameterName : process+="set MEBottom:Process Pair\n" process+=jet_kt_cut(0.) elif "-1" in parameterName : process+=jet_kt_cut(5.) elif "-2" in parameterName : process+=jet_kt_cut(15.) elif "-3" in parameterName : process+=jet_kt_cut(20.) elif "-4" in parameterName : process+=jet_kt_cut(50.) elif "-5" in parameterName : process+=jet_kt_cut(80.) elif "-6" in parameterName : process+=jet_kt_cut(110.) elif "-7" in parameterName : process+=jet_kt_cut(30.)+mhatmin_cut(90.) elif "-8" in parameterName : process+=jet_kt_cut(30.)+mhatmin_cut(340.) elif "-9" in parameterName : process+=jet_kt_cut(30.)+mhatmin_cut(500.) elif "Top-L" in parameterName : process+="set MEHeavyQuark:QuarkType Top\n" process+=insert_ME("MEHeavyQuark") process+=selectDecayMode("t",["t->nu_e,e+,b;", "t->nu_mu,mu+,b;"]) process+=addBRReweighter() elif "Top-SL" in parameterName : process+="set MEHeavyQuark:QuarkType Top\n" process+=insert_ME("MEHeavyQuark") process+="set /Herwig/Particles/t:Synchronized Not_synchronized\n" process+="set /Herwig/Particles/tbar:Synchronized Not_synchronized\n" process+=selectDecayMode("t",["t->nu_e,e+,b;","t->nu_mu,mu+,b;"]) process+=selectDecayMode("tbar",["tbar->b,bbar,cbar;", "tbar->bbar,cbar,d;", "tbar->bbar,cbar,s;", "tbar->bbar,s,ubar;", "tbar->bbar,ubar,d;"]) process+=addBRReweighter() elif "Top-All" in parameterName : process+="set MEHeavyQuark:QuarkType Top\n" process+=insert_ME("MEHeavyQuark") elif "WZ" in parameterName : process+=insert_ME("MEPP2VV","WZ") process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;"]) process+=selectDecayMode("W-",["W-->nu_ebar,e-;", "W-->nu_mubar,mu-;"]) process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;"]) addedBRReweighter = True elif "WW-emu" in parameterName : process+=insert_ME("MEPP2VV","WW") process+="set /Herwig/Particles/W+:Synchronized 0\n" process+="set /Herwig/Particles/W-:Synchronized 0\n" process+=selectDecayMode("W+",["W+->nu_e,e+;"]) process+=selectDecayMode("W-",["W-->nu_mubar,mu-;"]) addedBRReweighter = True elif "WW-ll" in parameterName : process+=insert_ME("MEPP2VV","WW") process+=selectDecayMode("W+",["W+->nu_e,e+;","W+->nu_mu,mu+;","W+->nu_tau,tau+;"]) addedBRReweighter = True elif "ZZ-ll" in parameterName : process+=insert_ME("MEPP2VV","ZZ") process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;"]) addedBRReweighter = True elif "ZZ-lv" in parameterName : process+=insert_ME("MEPP2VV","ZZ") process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;", "Z0->nu_e,nu_ebar;", "Z0->nu_mu,nu_mubar;", "Z0->nu_tau,nu_taubar;"]) addedBRReweighter = True elif "W-Z-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") process+=insert_ME("MEqq2W2ff","Electron") elif "W-Z-mu" in parameterName : process+=insert_ME("MEqq2gZ2ff","Muon") process+=insert_ME("MEqq2W2ff","Muon") elif "W-e" in parameterName : process+=insert_ME("MEqq2W2ff","Electron") elif "W-mu" in parameterName : process+=insert_ME("MEqq2W2ff","Muon") elif "Z-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") elif "Z-mu" in parameterName : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-LowMass-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") process+=mhat_minm_maxm(20,20,70) elif "Z-MedMass-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") process+=mhat_minm_maxm(40,40,130) elif "Z-LowMass-mu" in parameterName : process+=insert_ME("MEqq2gZ2ff","Muon") process+=mhat_minm_maxm(10,10,70) elif "Z-Mass1" in parameterName : process+=mhat_minm_maxm(10,10,35) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-Mass2" in parameterName : process+=mhat_minm_maxm(25,25,70) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-Mass3" in parameterName : process+=mhat_minm_maxm(60,60,120) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-Mass4" in parameterName : process+=mhat_minm_maxm(110,110,8000) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-HighMass1" in parameterName : process+=mhat_minm_maxm(116,116,400) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "Z-HighMass2" in parameterName : process+=mhat_minm_maxm(400,400,7000) if "-e" in parameterName : process+=insert_ME("MEqq2gZ2ff","Electron") else : process+=insert_ME("MEqq2gZ2ff","Muon") elif "W-Jet" in parameterName : process+=insert_ME("MEWJet","Electron","WDecay") if "W-Jet-1-e" in parameterName : process+="set /Herwig/Cuts/WBosonKtCut:MinKT 100.0*GeV\n" parameterName=parameterName.replace("W-Jet-1-e","W-Jet-e") elif "W-Jet-2-e" in parameterName : process+="set /Herwig/Cuts/WBosonKtCut:MinKT 190.0*GeV\n" parameterName=parameterName.replace("W-Jet-2-e","W-Jet-e") elif "W-Jet-3-e" in parameterName : process+="set /Herwig/Cuts/WBosonKtCut:MinKT 270.0*GeV\n" parameterName=parameterName.replace("W-Jet-3-e","W-Jet-e") elif "Z-Jet" in parameterName : if "-e" in parameterName : process+=insert_ME("MEZJet","Electron","ZDecay") if "Z-Jet-0-e" in parameterName : process+="set /Herwig/Cuts/ZBosonKtCut:MinKT 35.0*GeV\n" parameterName=parameterName.replace("Z-Jet-0-e","Z-Jet-e") elif "Z-Jet-1-e" in parameterName : process+="set /Herwig/Cuts/ZBosonKtCut:MinKT 100.0*GeV\n" parameterName=parameterName.replace("Z-Jet-1-e","Z-Jet-e") elif "Z-Jet-2-e" in parameterName : process+="set /Herwig/Cuts/ZBosonKtCut:MinKT 190.0*GeV\n" parameterName=parameterName.replace("Z-Jet-2-e","Z-Jet-e") elif "Z-Jet-3-e" in parameterName : process+="set /Herwig/Cuts/ZBosonKtCut:MinKT 270.0*GeV\n" parameterName=parameterName.replace("Z-Jet-3-e","Z-Jet-e") else : process+=insert_ME("MEZJet","Muon","ZDecay") process+="set /Herwig/Cuts/ZBosonKtCut:MinKT 35.0*GeV\n" parameterName=parameterName.replace("Z-Jet-0-mu","Z-Jet-mu") elif "WGamma" in parameterName : process+=insert_ME("MEPP2VGamma","1") process+="set MEPP2VGamma:MassOption 1" process+="set /Herwig/Cuts/PhotonKtCut:MinKT 10.\n" if "-e" in parameterName : process+=selectDecayMode("W+",["W+->nu_e,e+;"]) addedBRReweighter=True else : process+=selectDecayMode("W+",["W+->nu_mu,mu+;"]) addedBRReweighter=True elif "ZGamma" in parameterName : process+=insert_ME("MEPP2VGamma","2") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 10.\n" if "-e" in parameterName : process+=selectDecayMode("Z0",["Z0->e-,e+;"]) addedBRReweighter=True else : process+=selectDecayMode("Z0",["Z0->mu-,mu+;"]) addedBRReweighter=True else : logging.error(" Process %s not supported for internal matrix elements" % name) sys.exit(1) elif(simulation=="Powheg") : if "VBF" in parameterName : process+=insert_ME("PowhegMEPP2HiggsVBF") if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) addedBRReweighter = True process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "ggHJet" in parameterName : logging.error(" Process %s not supported for POWHEG matrix elements" % name) sys.exit(1) elif "ggH" in parameterName : process+=insert_ME("PowhegMEHiggs") if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) addedBRReweighter = True process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "8-WH" in parameterName : process+=insert_ME("PowhegMEPP2WH") process+=jet_kt_cut(0.0) if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "8-ZH" in parameterName : process+=insert_ME("PowhegMEPP2ZH") process+=jet_kt_cut(0.0) if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) addedBRReweighter = True elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) addedBRReweighter = True elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) addedBRReweighter = True elif "WH" in parameterName : process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;"]) addedBRReweighter = True process+=insert_ME("PowhegMEPP2WH") process+=jet_kt_cut(0.0) elif "ZH" in parameterName : process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;"]) addedBRReweighter = True process+=insert_ME("PowhegMEPP2ZH") process+=jet_kt_cut(0.0) elif "UE" in parameterName : logging.error(" Process %s not supported for powheg matrix elements" % name) sys.exit(1) elif "WZ" in parameterName : process+="create Herwig::HwDecayHandler /Herwig/NewPhysics/DecayHandler\n" process+="set /Herwig/NewPhysics/DecayHandler:NewStep No\n" process+="set /Herwig/Shower/ShowerHandler:SplitHardProcess No\n"; process+="set /Herwig/Decays/ZDecayer:PhotonGenerator NULL\n"; process+="set /Herwig/Decays/WDecayer:PhotonGenerator NULL\n"; process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 0 /Herwig/Particles/tau-\n" process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 1 /Herwig/Particles/tau+\n" process+="insert /Herwig/Generators/EventGenerator:EventHandler:PreCascadeHandlers 0 /Herwig/NewPhysics/DecayHandler\n" process+=insert_ME("PowhegMEPP2VV","WZ") process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;"]) process+=selectDecayMode("W-",["W-->nu_ebar,e-;", "W-->nu_mubar,mu-;"]) process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;"]) addedBRReweighter = True elif "WW-emu" in parameterName : process+="create Herwig::HwDecayHandler /Herwig/NewPhysics/DecayHandler\n" process+="set /Herwig/NewPhysics/DecayHandler:NewStep No\n" process+="set /Herwig/Shower/ShowerHandler:SplitHardProcess No\n"; process+="set /Herwig/Decays/ZDecayer:PhotonGenerator NULL\n"; process+="set /Herwig/Decays/WDecayer:PhotonGenerator NULL\n"; process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 0 /Herwig/Particles/tau-\n" process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 1 /Herwig/Particles/tau+\n" process+="insert /Herwig/Generators/EventGenerator:EventHandler:PreCascadeHandlers 0 /Herwig/NewPhysics/DecayHandler\n" process+=insert_ME("PowhegMEPP2VV","WW") process+="set /Herwig/Particles/W+:Synchronized 0\n" process+="set /Herwig/Particles/W-:Synchronized 0\n" process+=selectDecayMode("W+",["W+->nu_e,e+;"]) process+=selectDecayMode("W-",["W-->nu_mubar,mu-;"]) addedBRReweighter = True elif "WW-ll" in parameterName : process+="create Herwig::HwDecayHandler /Herwig/NewPhysics/DecayHandler\n" process+="set /Herwig/NewPhysics/DecayHandler:NewStep No\n" process+="set /Herwig/Shower/ShowerHandler:SplitHardProcess No\n"; process+="set /Herwig/Decays/ZDecayer:PhotonGenerator NULL\n"; process+="set /Herwig/Decays/WDecayer:PhotonGenerator NULL\n"; process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 0 /Herwig/Particles/tau-\n" process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 1 /Herwig/Particles/tau+\n" process+="insert /Herwig/Generators/EventGenerator:EventHandler:PreCascadeHandlers 0 /Herwig/NewPhysics/DecayHandler\n" process+=insert_ME("PowhegMEPP2VV","WW") process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;", "W+->nu_tau,tau+;"]) addedBRReweighter = True elif "ZZ-ll" in parameterName : process+="create Herwig::HwDecayHandler /Herwig/NewPhysics/DecayHandler\n" process+="set /Herwig/NewPhysics/DecayHandler:NewStep No\n" process+="set /Herwig/Shower/ShowerHandler:SplitHardProcess No\n"; process+="set /Herwig/Decays/ZDecayer:PhotonGenerator NULL\n"; process+="set /Herwig/Decays/WDecayer:PhotonGenerator NULL\n"; process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 0 /Herwig/Particles/tau-\n" process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 1 /Herwig/Particles/tau+\n" process+="insert /Herwig/Generators/EventGenerator:EventHandler:PreCascadeHandlers 0 /Herwig/NewPhysics/DecayHandler\n" process+=insert_ME("PowhegMEPP2VV","ZZ") process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;"]) addedBRReweighter = True elif "ZZ-lv" in parameterName : process+="create Herwig::HwDecayHandler /Herwig/NewPhysics/DecayHandler\n" process+="set /Herwig/NewPhysics/DecayHandler:NewStep No\n" process+="set /Herwig/Shower/ShowerHandler:SplitHardProcess No\n"; process+="set /Herwig/Decays/ZDecayer:PhotonGenerator NULL\n"; process+="set /Herwig/Decays/WDecayer:PhotonGenerator NULL\n"; process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 0 /Herwig/Particles/tau-\n" process+="insert /Herwig/NewPhysics/DecayHandler:Excluded 1 /Herwig/Particles/tau+\n" process+="insert /Herwig/Generators/EventGenerator:EventHandler:PreCascadeHandlers 0 /Herwig/NewPhysics/DecayHandler\n" process+=insert_ME("PowhegMEPP2VV","ZZ") process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;", "Z0->nu_e,nu_ebar;", "Z0->nu_mu,nu_mubar;", "Z0->nu_tau,nu_taubar;"]) addedBRReweighter = True elif "W-Z-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") process+=insert_ME("PowhegMEqq2W2ff","Electron") elif "W-Z-mu" in parameterName : process+=insert_ME("MEqq2gZ2ff","Muon") process+=insert_ME("MEqq2W2ff","Muon") elif "W-e" in parameterName : process+=insert_ME("PowhegMEqq2W2ff","Electron") elif "W-mu" in parameterName : process+=insert_ME("PowhegMEqq2W2ff","Muon") elif "Z-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") elif "Z-mu" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-LowMass-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") process+=mhat_minm_maxm(20,20,70) elif "Z-MedMass-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") process+=mhat_minm_maxm(40,40,130) elif "Z-LowMass-mu" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") process+=mhat_minm_maxm(10,10,70) elif "Z-Mass1" in parameterName : process+=mhat_minm_maxm(10,10,35) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-Mass2" in parameterName : process+=mhat_minm_maxm(25,25,70) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-Mass3" in parameterName : process+=mhat_minm_maxm(60,60,120) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-Mass4" in parameterName : process+=mhat_minm_maxm(110,110,8000) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-HighMass1" in parameterName : process+=mhat_minm_maxm(116,116,400) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "Z-HighMass2" in parameterName : process+=mhat_minm_maxm(400,400,7000) if "-e" in parameterName : process+=insert_ME("PowhegMEqq2gZ2ff","Electron") else : process+=insert_ME("PowhegMEqq2gZ2ff","Muon") elif "DiPhoton-GammaGamma" in parameterName : process+=insert_ME("MEGammaGammaPowheg","GammaGamma") process+=insert_ME("MEGammaGamma","gg") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" process+=jet_kt_cut(5.) parameterName=parameterName.replace("-GammaGamma","") elif "DiPhoton-GammaJet" in parameterName : process+=insert_ME("MEGammaGammaPowheg","VJet") process+="set /Herwig/Cuts/PhotonKtCut:MinKT 5.\n" process+=jet_kt_cut(5.) parameterName=parameterName.replace("-GammaJet","") else : logging.error(" Process %s not supported for internal POWHEG matrix elements" % name) sys.exit(1) elif( simulation=="Matchbox" or simulation=="Merging" ) : if "VBF" in parameterName : parameters["nlo"] = "read Matchbox/VBFNLO.in\n" if(simulation=="Merging"): process+="cd /Herwig/Merging/\n" process+="insert "+thefactory+":DiagramGenerator:RestrictLines 0 /Herwig/Particles/Z0\n" process+="insert "+thefactory+":DiagramGenerator:RestrictLines 0 /Herwig/Particles/W+\n" process+="insert "+thefactory+":DiagramGenerator:RestrictLines 0 /Herwig/Particles/W-\n" process+="insert "+thefactory+":DiagramGenerator:RestrictLines 0 /Herwig/Particles/gamma\n" process+="do "+thefactory+":DiagramGenerator:TimeLikeRange 0 0\n" if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p h0 j j","0","3","FixedScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p h0 j j","0","3","FixedScale",1,1) process+=setHardProcessWidthToZero(["h0"]) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 125.7\n" if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) process+=addBRReweighter() elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) process+=addBRReweighter() elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) process+=addBRReweighter() elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) process+=addBRReweighter() process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "ggHJet" in parameterName : if(simulation=="Merging"): logging.warning("ggHJet not explicitly tested for %s " % simulation) sys.exit(0) parameters["nlo"] = "read Matchbox/MadGraph-GoSam.in\nread Matchbox/HiggsEffective.in\n" process+=selectDecayMode("h0",["h0->tau-,tau+;"]) process+=addBRReweighter() process+="set /Herwig/Particles/tau-:Stable Stable\n" process+=setHardProcessWidthToZero(["h0"]) process+=addProcess(thefactory,"p p h0 j","3","1","FixedScale",0,0) process+=addFirstJet("20") process+="set "+thefactory+":ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/FixedScale\n" process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 125.7\n" elif "ggH" in parameterName : parameters["nlo"] = "read Matchbox/MadGraph-GoSam.in\nread Matchbox/HiggsEffective.in\n" if(simulation=="Merging"): process+= "cd /Herwig/MatrixElements/Matchbox/Amplitudes\nset OpenLoops:HiggsEff On\nset MadGraph:Model heft\n" process+="cd /Herwig/Merging/\n" process+=setHardProcessWidthToZero(["h0"]) if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p h0","2","1","FixedScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p h0","2","1","FixedScale",2,2) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 125.7\n" if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) process+=addBRReweighter() elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) process+=addBRReweighter() elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) process+=addBRReweighter() elif "8-" not in parameterName : process+=selectDecayMode("h0",["h0->tau-,tau+;"]) process+=addBRReweighter() process+="set /Herwig/Particles/tau-:Stable Stable\n" elif "8-WH" in parameterName : if(simulation=="Merging"): logging.warning("8-WH not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["h0","W+","W-"]) process+=addProcess(thefactory,"p p W+ h0","0","2","FixedScale",0,0) process+=addProcess(thefactory,"p p W- h0","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 125.7\n" if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) process+=addBRReweighter() elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) process+=addBRReweighter() elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) process+=addBRReweighter() elif "8-ZH" in parameterName : if(simulation=="Merging"): logging.warning("8-ZH not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["h0","Z0"]) process+=addProcess(thefactory,"p p Z0 h0","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 125.7\n" if "GammaGamma" in parameterName : process+=selectDecayMode("h0",["h0->gamma,gamma;"]) process+=addBRReweighter() elif "WW" in parameterName : process+=selectDecayMode("h0",["h0->W+,W-;"]) process+=addBRReweighter() elif "ZZ" in parameterName : process+=selectDecayMode("h0",["h0->Z0,Z0;"]) process+=addBRReweighter() elif "WH" in parameterName : if(simulation=="Merging"): logging.warning("WH not explicitly tested for %s " % simulation) sys.exit(0) process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=addBRReweighter() process+=setHardProcessWidthToZero(["h0"]) process+=addProcess(thefactory,"p p e+ nu h0","0","3","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p e- nu h0","0","3","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu+ nu h0","0","3","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu- nu h0","0","3","LeptonPairMassScale",0,0) process+=addLeptonPairCut("60","120") elif "ZH" in parameterName : if(simulation=="Merging"): logging.warning("ZH not explicitly tested for %s " % simulation) sys.exit(0) process+=selectDecayMode("h0",["h0->b,bbar;"]) process+=addBRReweighter() process+=setHardProcessWidthToZero(["h0"]) process+=addProcess(thefactory,"p p e+ e- h0","0","3","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu+ mu- h0","0","3","LeptonPairMassScale",0,0) process+=addLeptonPairCut("60","120") elif "UE" in parameterName : logging.error(" Process %s not supported for Matchbox matrix elements" % name) sys.exit(1) elif "8-DiJets" in parameterName or "7-DiJets" in parameterName or "13-DiJets" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p j j","2","0","MaxJetPtScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p j j","2","0","MaxJetPtScale",1,1) process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "13-DiJets" not in parameterName : if "-A" in parameterName : process+=addFirstJet("45") process+=addSecondJet("25") process+="set /Herwig/Cuts/FirstJet:YRange -3. 3.\n" process+="set /Herwig/Cuts/SecondJet:YRange -3. 3.\n" elif "-B" in parameterName : process+=addFirstJet("20") process+=addSecondJet("15") process+="set /Herwig/Cuts/FirstJet:YRange -2.7 2.7\n" process+="set /Herwig/Cuts/SecondJet:YRange -2.7 2.7\n" elif "-C" in parameterName : process+=addFirstJet("20") process+=addSecondJet("15") process+="set /Herwig/Cuts/FirstJet:YRange -4.8 4.8\n" process+="set /Herwig/Cuts/SecondJet:YRange -4.8 4.8\n" else : logging.error("Exit 00001") sys.exit(1) else : if "-A" in parameterName : - process+=addFirstJet("220") + process+= addFirstJet("75.") + process+=addSecondJet("60.") + process+="set /Herwig/Cuts/JetKtCut:MinEta -3.\n" + process+="set /Herwig/Cuts/JetKtCut:MaxEta 3.\n" + elif "-B" in parameterName : + process+= addFirstJet("220.") process+=addSecondJet("180.") process+="set /Herwig/Cuts/JetKtCut:MinEta -3.\n" process+="set /Herwig/Cuts/JetKtCut:MaxEta 3.\n" else : logging.error("Exit 00001") sys.exit(1) if "DiJets-1" in parameterName : process+=addJetPairCut("90") elif "DiJets-2" in parameterName : process+=addJetPairCut("200") elif "DiJets-3" in parameterName : process+=addJetPairCut("450") elif "DiJets-4" in parameterName : process+=addJetPairCut("750") elif "DiJets-5" in parameterName : process+=addJetPairCut("950") elif "DiJets-6" in parameterName : process+=addJetPairCut("1550") elif "DiJets-7" in parameterName : process+=addJetPairCut("2150") elif "DiJets-8" in parameterName : process+=addJetPairCut("2750") elif "DiJets-9" in parameterName : process+=mhatmin_cut(3750.) elif "DiJets-10" in parameterName : process+=mhatmin_cut(4750.) elif "DiJets-11" in parameterName : process+=mhatmin_cut(5750.) else : logging.error("Exit 00002") sys.exit(1) elif( "7-Jets" in parameterName or "8-Jets" in parameterName or "13-Jets" in parameterName or "2760-Jets" in parameterName ) : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p j j","2","0","MaxJetPtScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p j j","2","0","MaxJetPtScale",1,1) process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "Jets-10" in parameterName : process+=addFirstJet("1800") elif "Jets-0" in parameterName : process+=addFirstJet("5") elif "Jets-1" in parameterName : process+=addFirstJet("10") elif "Jets-2" in parameterName : process+=addFirstJet("20") elif "Jets-3" in parameterName : process+=addFirstJet("40") elif "Jets-4" in parameterName : process+=addFirstJet("70") elif "Jets-5" in parameterName : process+=addFirstJet("150") elif "Jets-6" in parameterName : process+=addFirstJet("200") elif "Jets-7" in parameterName : process+=addFirstJet("300") elif "Jets-8" in parameterName : process+=addFirstJet("500") elif "Jets-9" in parameterName : process+=addFirstJet("800") else : logging.error("Exit 00003") sys.exit(1) elif( "7-Charm" in parameterName or "7-Bottom" in parameterName or "8-Bottom" in parameterName) : parameters["bscheme"]=fourFlavour process+="set /Herwig/Particles/b:HardProcessMass 4.2*GeV\n" process+="set /Herwig/Particles/bbar:HardProcessMass 4.2*GeV\n" if("8-Bottom" in parameterName) : addBRReweighter() process+=selectDecayMode("Jpsi",["Jpsi->mu-,mu+;"]) if "Bottom" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p b bbar","2","0","MaxJetPtScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p b bbar","2","0","MaxJetPtScale",1,0) else: if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p c cbar","2","0","MaxJetPtScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p c cbar","2","0","MaxJetPtScale",1,0) process+="set /Herwig/UnderlyingEvent/MPIHandler:IdenticalToUE 0\n" if "-0" in parameterName : process+=addFirstJet("0") elif "-1" in parameterName : process+=addFirstJet("5") elif "-2" in parameterName : process+=addFirstJet("15") elif "-3" in parameterName : process+=addFirstJet("20") elif "-4" in parameterName : process+=addFirstJet("50") elif "-5" in parameterName : process+=addFirstJet("80") elif "-6" in parameterName : process+=addFirstJet("110") elif "-7" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("90") elif "-8" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("340") elif "-9" in parameterName : process+=addFirstJet("30") process+=addSecondJet("25") process+=addJetPairCut("500") else : logging.error("Exit 00004") sys.exit(1) elif "Top-L" in parameterName : process+=setHardProcessWidthToZero(["t","tbar"]) if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",2,2) process+=selectDecayMode("t",["t->nu_e,e+,b;", "t->nu_mu,mu+,b;"]) process+=addBRReweighter() elif "Top-SL" in parameterName : process+=setHardProcessWidthToZero(["t","tbar"]) if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",2,2) process+="set /Herwig/Particles/t:Synchronized Not_synchronized\n" process+="set /Herwig/Particles/tbar:Synchronized Not_synchronized\n" process+=selectDecayMode("t",["t->nu_e,e+,b;", "t->nu_mu,mu+,b;"]) process+=selectDecayMode("tbar",["tbar->b,bbar,cbar;", "tbar->bbar,cbar,d;", "tbar->bbar,cbar,s;", "tbar->bbar,s,ubar;", "tbar->bbar,ubar,d;"]) process+=addBRReweighter() elif "Top-All" in parameterName : process+=setHardProcessWidthToZero(["t","tbar"]) if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p t tbar","2","0","TopPairMTScale",2,2) elif "WZ" in parameterName : if(simulation=="Merging"): logging.warning("WZ not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["W+","W-","Z0"]) process+=addProcess(thefactory,"p p W+ Z0","0","2","FixedScale",0,0) process+=addProcess(thefactory,"p p W- Z0","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 171.6*GeV\n\n" process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;"]) process+=selectDecayMode("W-",["W-->nu_ebar,e-;", "W-->nu_mubar,mu-;"]) process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;"]) process+=addBRReweighter() process+=addLeptonPairCut("60","120") elif "WW-emu" in parameterName : if(simulation=="Merging"): logging.warning("WW-emu not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["W+","W-","Z0"]) process+=addProcess(thefactory,"p p W+ W-","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 160.8*GeV\n" process+="set /Herwig/Particles/W+:Synchronized 0\n" process+="set /Herwig/Particles/W-:Synchronized 0\n" process+=selectDecayMode("W+",["W+->nu_e,e+;"]) process+=selectDecayMode("W-",["W-->nu_mubar,mu-;"]) process+=addBRReweighter() parameters["bscheme"] = "read Matchbox/FourFlavourScheme.in\n" process+=addLeptonPairCut("60","120") elif "WW-ll" in parameterName : if(simulation=="Merging"): logging.warning("WW-ll not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["W+","W-","Z0"]) process+=addProcess(thefactory,"p p W+ W-","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 160.8*GeV\n" process+=selectDecayMode("W+",["W+->nu_e,e+;", "W+->nu_mu,mu+;", "W+->nu_tau,tau+;"]) process+=addBRReweighter() process+=addLeptonPairCut("60","120") parameters["bscheme"] = "read Matchbox/FourFlavourScheme.in\n" elif "ZZ-ll" in parameterName : if(simulation=="Merging"): logging.warning("ZZ-ll not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["W+","W-","Z0"]) process+=addProcess(thefactory,"p p Z0 Z0","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 182.2*GeV\n" process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;"]) process+=addBRReweighter() process+=addLeptonPairCut("60","120") elif "ZZ-lv" in parameterName : if(simulation=="Merging"): logging.warning("ZZ-lv not explicitly tested for %s " % simulation) sys.exit(0) process+=setHardProcessWidthToZero(["W+","W-","Z0"]) process+=addProcess(thefactory,"p p Z0 Z0","0","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 182.2*GeV\n" process+=selectDecayMode("Z0",["Z0->e-,e+;", "Z0->mu-,mu+;", "Z0->tau-,tau+;", "Z0->nu_e,nu_ebar;", "Z0->nu_mu,nu_mubar;", "Z0->nu_tau,nu_taubar;"]) process+=addBRReweighter() process+=addLeptonPairCut("60","120") elif "W-Z-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p e+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p e- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('epm','e+','e-') process+=particlegroup('epmnu','e+','e-','nu_e','nu_ebar') process+=addProcess(thefactory,"p p epm epmnu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "W-Z-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('mupm','mu+','mu-') process+=particlegroup('mupmnu','mu+','mu-','nu_mu','nu_mubar') process+=addProcess(thefactory,"p p mupm mupmnu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "W-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p e- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('epm','e+','e-') process+=addProcess(thefactory,"p p epm nu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "W-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ nu","0","2","LeptonPairMassScale",0,0) process+=addProcess(thefactory,"p p mu- nu","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=particlegroup('mupm','mu+','mu-') process+=addProcess(thefactory,"p p mupm nu","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Z-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Z-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("60","120") elif "Z-jj" in parameterName : if(simulation=="Merging"): logging.warning("Z-jj not explicitly tested for %s " % simulation) sys.exit(0) process+=addProcess(thefactory,"p p e+ e- j j","2","2","LeptonPairMassScale",0,0) process+=addFirstJet("40") process+=addSecondJet("30") process+=addLeptonPairCut("60","120") elif "Z-LowMass-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("20","70") elif "Z-MedMass-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("40","130") elif "Z-LowMass-mu" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) process+=addLeptonPairCut("10","70") elif "Z-Mass1" in parameterName : process+=addLeptonPairCut("10","35") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "Z-Mass2" in parameterName : process+=addLeptonPairCut("25","70") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "Z-Mass3" in parameterName : process+=addLeptonPairCut("60","120") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "Z-Mass4" in parameterName : process+=addLeptonPairCut("115","8000") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "Z-HighMass1" in parameterName : process+=addLeptonPairCut("116","400") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "Z-HighMass2" in parameterName : process+=addLeptonPairCut("400","7000") if "-e" in parameterName : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p e+ e-","0","2","LeptonPairMassScale",2,2) else : if(simulation=="Matchbox"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",0,0) elif(simulation=="Merging"): process+=addProcess(thefactory,"p p mu+ mu-","0","2","LeptonPairMassScale",2,2) elif "W-Jet" in parameterName : if(simulation=="Merging"): logging.warning("W-Jet not explicitly tested for %s " % simulation) sys.exit(0) process+=addProcess(thefactory,"p p e+ nu j","1","2","HTScale",0,0) process+=addProcess(thefactory,"p p e- nu j","1","2","HTScale",0,0) process+=addLeptonPairCut("60","120") if "W-Jet-1-e" in parameterName : process+=addFirstJet("100") parameterName=parameterName.replace("W-Jet-1-e","W-Jet-e") elif "W-Jet-2-e" in parameterName : process+=addFirstJet("190") parameterName=parameterName.replace("W-Jet-2-e","W-Jet-e") elif "W-Jet-3-e" in parameterName : process+=addFirstJet("270") parameterName=parameterName.replace("W-Jet-3-e","W-Jet-e") else : logging.error("Exit 00005") sys.exit(1) elif "Z-Jet" in parameterName : if(simulation=="Merging"): logging.warning("Z-Jet not explicitly tested for %s " % simulation) sys.exit(0) if "-e" in parameterName : process+=addProcess(thefactory,"p p e+ e- j","1","2","HTScale",0,0) if "Z-Jet-0-e" in parameterName : process+=addFirstJet("35") parameterName=parameterName.replace("Z-Jet-0-e","Z-Jet-e") elif "Z-Jet-1-e" in parameterName : process+=addFirstJet("100") parameterName=parameterName.replace("Z-Jet-1-e","Z-Jet-e") elif "Z-Jet-2-e" in parameterName : process+=addFirstJet("190") parameterName=parameterName.replace("Z-Jet-2-e","Z-Jet-e") elif "Z-Jet-3-e" in parameterName : process+=addFirstJet("270") parameterName=parameterName.replace("Z-Jet-3-e","Z-Jet-e") else : logging.error("Exit 00006") sys.exit(1) else : process+=addProcess(thefactory,"p p mu+ mu- j","1","2","HTScale",0,0) process+=addFirstJet("35") parameterName=parameterName.replace("Z-Jet-0-mu","Z-Jet-mu") process+=addLeptonPairCut("60","120") elif "Z-bb" in parameterName : if(simulation=="Merging"): logging.warning("Z-bb not explicitly tested for %s " % simulation) sys.exit(0) parameters["bscheme"]=fourFlavour process+="set /Herwig/Particles/b:HardProcessMass 4.2*GeV\nset /Herwig/Particles/bbar:HardProcessMass 4.2*GeV\n" process+=addProcess(thefactory,"p p e+ e- b bbar","2","2","FixedScale",0,0) process+=addLeptonPairCut("66","116") process+=addFirstJet("18") process+=addSecondJet("15") process+=addLeptonPairCut("60","120") elif "Z-b" in parameterName : if(simulation=="Merging"): logging.warning("Z-b not explicitly tested for %s " % simulation) sys.exit(0) process+=particlegroup('bjet','b','bbar') process+=addProcess(thefactory,"p p e+ e- bjet","1","2","FixedScale",0,0) process+="set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 91.2*GeV\n" process+=addLeptonPairCut("60","120") process+=addFirstJet("15") elif "W-b" in parameterName : if(simulation=="Merging"): logging.warning("W-b not explicitly tested for %s " % simulation) sys.exit(0) parameters["bscheme"]=fourFlavour process += "set /Herwig/Particles/b:HardProcessMass 4.2*GeV\nset /Herwig/Particles/bbar:HardProcessMass 4.2*GeV\n" process+=addProcess(thefactory,"p p e- nu b bbar","2","2","FixedScale",0,0) process+=addProcess(thefactory,"p p mu+ nu b bbar","2","2","FixedScale",0,0) process += "set /Herwig/MatrixElements/Matchbox/Scales/FixedScale:FixedScale 80.4*GeV\n" process+=addFirstJet("30") process+=addLeptonPairCut("60","120") else : logging.error(" Process %s not supported for Matchbox matrix elements" % name) sys.exit(1) # LHC-GammaGamma elif(collider=="LHC-GammaGamma" ) : if "-7-" in parameterName : process = StringBuilder(collider_lumi(7000.0)) elif "-8-" in parameterName : process = StringBuilder(collider_lumi(8000.0)) else : process = StringBuilder(collider_lumi(7000.0)) if(simulation=="") : if "7" in parameterName : process += insert_ME("MEgg2ff","Muon") else : logging.error(" Process %s not supported for default matrix elements" % name) sys.exit(1) else : logging.error("LHC-GammaGamma not supported for %s " % simulation) sys.exit(1) parameters['parameterFile'] = os.path.join(collider,"{c}-{pn}.in".format(c=collider, pn=parameterName)) parameters['runname'] = 'Rivet-%s' % name parameters['process'] = str(process) if have_hadronic_collider : if collider == "EHS" : parameters['collider'] = "PPCollider.in\nread snippets/FixedTarget-PP.in" else : parameters['collider'] = "PPCollider.in" #check if selecteddecaymode and addedBRReweighter is consistent if selecteddecaymode and not addedBRReweighter: logging.error("Decaymode was selected but no BRReweighter was added.") sys.exit(1) if addedBRReweighter and not selecteddecaymode: logging.error("BRReweighter was added but no Decaymode was selected.") sys.exit(1) # check that we only add one process if in merging mode: if numberOfAddedProcesses > 1 and simulation =="Merging": logging.error("In Merging only one process is allowed at the moment. See ticket #403.") sys.exit(1) # Check if a process was added for Merging or Matchbox: if numberOfAddedProcesses == 0 and (simulation =="Merging" or simulation =="Matchbox"): logging.error("No process was selected.") sys.exit(1) # get template and write the file with open(os.path.join("Rivet/Templates",templateName), 'r') as f: templateText = f.read() template = Template( templateText ) with open(os.path.join("Rivet",name+".in"), 'w') as f: f.write( template.substitute(parameters) ) diff --git a/Tests/python/merge-BFactory b/Tests/python/merge-BFactory deleted file mode 100755 --- a/Tests/python/merge-BFactory +++ /dev/null @@ -1,222 +0,0 @@ -#! /usr/bin/env python -import logging -import sys - -if sys.version_info[:3] < (2,4,0): - print "rivet scripts require Python version >= 2.4.0... exiting" - sys.exit(1) - -import os, yoda - -# ############################################# - -def fillAbove(desthisto, sourcehistosbysqrts): - for sqrts, h in sorted(sourcehistosbysqrts.iteritems()) : - for i in range(0,h.numPoints) : - if(h.points[i].x-0.01sqrts) : - desthisto.addPoint(h.points[i]) - -def merge(hpath): - global inhistos - global outhistos - try: - fillAbove(outhistos[hpath], inhistos[hpath]) - except: - logging.error("Unknown analysis object" + hpath) - sys.exit(1) - -def useOne(hpath, sqrts): - global inhistos - global outhistos - try: - outhistos[hpath] = inhistos[hpath][float(sqrts)] - except: - pass - -if __name__ == "__main__": - import logging - from optparse import OptionParser, OptionGroup - parser = OptionParser(usage="%prog name") - verbgroup = OptionGroup(parser, "Verbosity control") - verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", - default=logging.INFO, help="print debug (very verbose) messages") - verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", - default=logging.INFO, help="be very quiet") - parser.add_option_group(verbgroup) - (opts, args) = parser.parse_args() - logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") - - ## Check args - if len(args) < 1: - logging.error("Must specify at least the name of the files") - sys.exit(1) - -# ####################################### - -yodafiles=["-10.52","-10.52-sym","-10.54", - "-10.58-res","-10.58","-Upsilon", - "-Upsilon2","-Upsilon4","-10.45","-10.47","-Tau"] - -## Get histos -inhistos = {} -outhistos={} -weights = {} -for f in yodafiles: - file = "Rivet-%s%s.yoda" % (args[0], f) - if(file.find("10.45")>0) : - sqrts=10.45 - elif(file.find("10.47")>0) : - sqrts=10.47 - elif(file.find("10.52")>0) : - sqrts=10.52 - elif(file.find("10.54")>0) : - sqrts=10.54 - elif(file.find("10.58")>0) : - sqrts=10.58 - elif(file.find("Tau")>0) : - sqrts=10.58 - elif(file.find("Upsilon4")>0) : - sqrts=10.58 - elif(file.find("Upsilon2")>0) : - sqrts=10.02 - elif(file.find("Upsilon")>0) : - sqrts=9.46 - if not os.access(file, os.R_OK): - if(file.find("Upsilon")>=0 or file.find("Tau")>=0) : continue - logging.error("%s can not be read" % file) - continue - try: - aos = yoda.read(file) - except: - logging.error("%s can not be parsed as yoda" % file) - continue - ## Get histos from this YODA file - for aopath, ao in aos.iteritems() : - if("RAW" in aopath) :continue - # jet shapes - if(aopath.find("6265367")>0 or aopath.find("6895344")>0 or - aopath.find("6181155")>0 or aopath.find("2789213")>0 or - aopath.find("2669951")>0) : - if not inhistos.has_key(aopath): - inhistos[aopath] = {} - tmpE = inhistos[aopath] - sqrttemp=sqrts - if(aopath.find("2669951")>0 and aopath.find("d01")>0 and - sqrts==10.45) : - sqrts=9.9 - - if not tmpE.has_key(sqrts): - tmpE[sqrts] = ao - else: - raise Exception("A set with sqrts = %s already exists" % ( sqrts)) - sqrts=sqrttemp - else : - if("ARGUS_1992_I319102" in aopath) : - if("d02" in aopath and sqrts==10.47) : - outhistos[aopath] = ao - elif("d03"in aopath and sqrts==10.58) : - outhistos[aopath] = ao - else: - outhistos[aopath] = ao - -## Make empty output histos if needed -for hpath,hsets in inhistos.iteritems(): - if( hpath.find("2669951")>0) : - if(type(hsets.values()[0])==yoda.core.Scatter2D) : - outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].path,hsets.values()[0].title) - else : - outhistos[hpath] = hsets.values()[0] - -# BELLE -useOne("/BELLE_2006_S6265367/d01-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y03","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y04","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y05","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y06","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y07","10.52") -useOne("/BELLE_2006_S6265367/d01-x01-y08","10.52") -useOne("/BELLE_2006_S6265367/d02-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d02-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d03-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d03-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d04-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d04-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d05-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d05-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d06-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d06-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d07-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d07-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d08-x01-y01","10.52") -useOne("/BELLE_2006_S6265367/d08-x01-y02","10.52") -useOne("/BELLE_2006_S6265367/d09-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d09-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d10-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d10-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d11-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d11-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d12-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d12-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d13-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d13-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d14-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d14-x01-y02","10.58") -useOne("/BELLE_2006_S6265367/d15-x01-y01","10.58") -useOne("/BELLE_2006_S6265367/d15-x01-y02","10.58") -# BABAR -useOne("/BABAR_2007_S6895344/d01-x01-y01","10.54") -useOne("/BABAR_2007_S6895344/d02-x01-y01","10.54") -useOne("/BABAR_2007_S6895344/d03-x01-y01","10.58") -useOne("/BABAR_2007_S6895344/d04-x01-y01","10.58") -# BABAR -useOne("/BABAR_2005_S6181155/d01-x01-y01","10.58") -useOne("/BABAR_2005_S6181155/d02-x01-y01","10.58") -useOne("/BABAR_2005_S6181155/d02-x01-y02","10.54") -useOne("/BABAR_2005_S6181155/d03-x01-y01","10.54") -useOne("/BABAR_2005_S6181155/d04-x01-y01","10.58") -useOne("/BABAR_2005_S6181155/d05-x01-y01","10.58") -useOne("/BABAR_2005_S6181155/d05-x01-y02","10.54") -# ARGUS -useOne("/ARGUS_1993_S2789213/d01-x01-y01","10.45") -useOne("/ARGUS_1993_S2789213/d01-x01-y02","10.45") -useOne("/ARGUS_1993_S2789213/d01-x01-y03","10.45") -useOne("/ARGUS_1993_S2789213/d01-x01-y04","10.45") -useOne("/ARGUS_1993_S2789213/d01-x01-y05","10.45") -useOne("/ARGUS_1993_S2789213/d02-x01-y01", "9.46") -useOne("/ARGUS_1993_S2789213/d02-x01-y02", "9.46") -useOne("/ARGUS_1993_S2789213/d02-x01-y03", "9.46") -useOne("/ARGUS_1993_S2789213/d02-x01-y04", "9.46") -useOne("/ARGUS_1993_S2789213/d02-x01-y05", "9.46") -useOne("/ARGUS_1993_S2789213/d03-x01-y01","10.58") -useOne("/ARGUS_1993_S2789213/d03-x01-y02","10.58") -useOne("/ARGUS_1993_S2789213/d03-x01-y03","10.58") -useOne("/ARGUS_1993_S2789213/d03-x01-y04","10.58") -useOne("/ARGUS_1993_S2789213/d03-x01-y05","10.58") -useOne("/ARGUS_1993_S2789213/d04-x01-y01","10.45") -useOne("/ARGUS_1993_S2789213/d05-x01-y01", "9.46") -useOne("/ARGUS_1993_S2789213/d06-x01-y01","10.58") -useOne("/ARGUS_1993_S2789213/d07-x01-y01","10.45") -useOne("/ARGUS_1993_S2789213/d08-x01-y01", "9.46") -useOne("/ARGUS_1993_S2789213/d09-x01-y01","10.58") -useOne("/ARGUS_1993_S2789213/d10-x01-y01","10.45") -useOne("/ARGUS_1993_S2789213/d11-x01-y01", "9.46") -useOne("/ARGUS_1993_S2789213/d12-x01-y01","10.58") -useOne("/ARGUS_1993_S2789213/d13-x01-y01","10.45") -useOne("/ARGUS_1993_S2789213/d14-x01-y01", "9.46") -useOne("/ARGUS_1993_S2789213/d15-x01-y01","10.58") - -if("/ARGUS_1993_S2669951/d04-x01-y01" in outhistos) : - useOne("/ARGUS_1993_S2669951/d02-x01-y01","10.45") - useOne("/ARGUS_1993_S2669951/d03-x01-y01","9.46") - useOne("/ARGUS_1993_S2669951/d04-x01-y01","10.02") - merge("/ARGUS_1993_S2669951/d01-x01-y01") - merge("/ARGUS_1993_S2669951/d01-x01-y02") - merge("/ARGUS_1993_S2669951/d05-x01-y01") - -# Choose output file -name = args[0]+".yoda" -# output the yoda file -yoda.writeYODA(outhistos,name) -sys.exit(0) diff --git a/Tests/python/merge-EE b/Tests/python/merge-EE new file mode 100755 --- /dev/null +++ b/Tests/python/merge-EE @@ -0,0 +1,1185 @@ +#! /usr/bin/env python +# import lighthisto +import logging +import sys + +if sys.version_info[:3] < (2,4,0): + print "rivet scripts require Python version >= 2.4.0... exiting" + sys.exit(1) + +import os, yoda, copy + +# # ############################################# + +def fillAbove(desthisto, sourcehistosbysqrts): + if type(desthisto) is yoda.core.Scatter2D : + for sqrts,h in sorted(sourcehistosbysqrts.iteritems()) : + if(sqrts=="U1") : + sqrts2=9.46 + elif sqrts=="U2" : + sqrts2=10.02 + elif sqrts=="U4" : + sqrts2=10.58 + else : + sqrts2=float(sqrts) + if("ARGUS_1989_I276860" in desthisto.path and sqrts2==10.00) : sqrts2=9.98 + step = 0.001 + if("TASSO_1980_I143691" in desthisto.path) : step=0.3 + for i in range(0,h.numPoints) : + xmin = min(h.points[i].xMin,h.points[i].x-step) + xmax = max(h.points[i].xMax,h.points[i].x+step) + if(sqrts2>=xmin and sqrts2<=xmax) : + desthisto.addPoint(h.points[i]) + + elif(type(desthisto)==yoda.core.Profile1D) : + for sqrts, h in sorted(sourcehistosbysqrts.iteritems()) : + step = 0.001 + for i in range(0,h.numBins) : + try : + xmin = min(h.bins[i].xMin,h.bins[i].xMid-step) + xmax = max(h.bins[i].xMax,h.bins[i].xMid+step) + if(sqrts>=xmin and sqrts<=xmax) : + desthisto.bins[i] += h.bins[i] + break + except: + print 'exception' + quit() + else : + logging.error("Unknown analysis object" + desthisto.path) + sys.exit(1) + +def merge(hpath): + global inhistos + global outhistos + try: + fillAbove(outhistos[hpath], inhistos[hpath]) + except: + pass + +def useOne(hpath, sqrts): + global inhistos + global outhistos + try: + outhistos[hpath] = inhistos[hpath][float(sqrts)] + except: + try: + outhistos[hpath] = inhistos[hpath][sqrts] + except: + pass + +def average(hpath, sqrts1,sqrts2): + global inhistos + global outhistos + outhistos[hpath] = inhistos[hpath][float(sqrts1)]+inhistos[hpath][float(sqrts2)] + outhistos[hpath].path=hpath + outhistos[hpath].scaleW(0.5) + +if __name__ == "__main__": + import logging + from optparse import OptionParser, OptionGroup + parser = OptionParser(usage="%prog name") + verbgroup = OptionGroup(parser, "Verbosity control") + verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", + default=logging.INFO, help="print debug (very verbose) messages") + verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", + default=logging.INFO, help="be very quiet") + parser.add_option_group(verbgroup) + parser.add_option("--with-gg", + action='store_true' , + dest="gg", + default=False, + help="Include gg analyese") + parser.add_option("--without-gg", + action='store_false', + dest="gg", + default=False, + help="Don\'t include gg analyses") + (opts, args) = parser.parse_args() + logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") + ## Check args + if len(args) < 1: + logging.error("Must specify at least the name of the files") + sys.exit(1) + +####################################### + +yodafiles=["130","133","136","177","192", + "196","202","205","206","207","91" ,"91-nopi" ,\ + "161","183","197","35" ,"36.2","172",\ + "189","200","44","14","14.8","21.5","22","25","10",\ + "12.8","26.8","48.0","93.0",\ + "12","13","17","27.6","29","30.2","34.5",\ + "30.7","30","31.3","34","34.8","43.6","50","52","53.3",\ + "55","56","57","58","59.5","60.8","60","61.4","7.7", + "9.4","45","66","76","41","42.6","82","85"] +# add gg if needed +if(opts.gg) : + yodafiles += ["10.5-gg","12.8-gg","16.86-gg","26.8-gg",\ + "35.44-gg","97.0-gg","11.96-gg","13.96-gg",\ + "21.84-gg","28.48-gg","48.0-gg"] + +yodafiles += ["2.2","2.6","3.0","3.2","4.6","4.8","3.63","4.03","4.5","9.46","10.00","10.52","10.52-sym","10.54", + "10.58-res","10.58","Upsilon", + "Upsilon2","Upsilon4","10.45","10.47","Tau","Phi", + "Lambdac","Omega","Xi0","Xic0","Xim","JPsi","Psi2S"] +## Get histos +inhistos = {} +outhistos={} +for f in yodafiles: + file = "Rivet-%s-%s.yoda" % (args[0], f) + if(file.find("Tau")>0) : + sqrts=10.58 + elif(file.find("Upsilon4")>0) : + sqrts="U4" + elif(file.find("Upsilon2")>0) : + sqrts="U2" + elif(file.find("Upsilon")>0) : + sqrts="U1" + elif(file.find("Phi")>0) : + sqrts="phi" + elif(file.find("JPsi")>0) : + sqrts="psi" + elif(file.find("Psi2S")>0) : + sqrts="psi2s" + elif(file.find("Lambdac")>0 or file.find("Xic0")>0 or + file.find("Omega")>0 or file.find("Xi0")>0 or + file.find("Xim")>0) : + sqrts="baryon" + else : + sqrts=float(f.split("-")[0]) + + if not os.access(file, os.R_OK): + logging.error("%s cannot be read" % file) + continue + try: + aos = yoda.read(file) + except: + logging.error("%s cannot be parsed as yoda" % file) + continue + ## Get histos from this YODA file + for aopath, ao in aos.iteritems() : + if("RAW" in aopath) :continue + # plots which neede merging/selecting + if(aopath.find("4300807")>0 or aopath.find("6132243")>0 or + aopath.find("5765862")>0 or aopath.find("3612880")>0 or + aopath.find("4328825")>0 or aopath.find("5361494")>0 or + aopath.find("2148048")>0 or aopath.find("295160" )>0 or + aopath.find("190818" )>0 or aopath.find("154270" )>0 or + aopath.find("277658" )>0 or aopath.find("143691" )>0 or + aopath.find("6265367")>0 or aopath.find("6895344")>0 or + aopath.find("6181155")>0 or aopath.find("2789213")>0 or + aopath.find("2669951")>0 or aopath.find("278933" )>0 or + aopath.find("276860" )>0 or aopath.find("251097" )>0 or + aopath.find("262551" )>0 or aopath.find("262415" )>0 or + aopath.find("165122" )>0 or aopath.find("118873" )>0 or + aopath.find("177174" )>0 or aopath.find("284251" )>0 or + aopath.find("191161" )>0 or aopath.find("1422780")>0 or + (aopath.find("MULTIPLICITIES")>0 and aopath.find("Upsilon_4S")<0)) : + if not inhistos.has_key(aopath): + inhistos[aopath] = {} + tmpE = inhistos[aopath] + sqrttemp=sqrts + if(aopath.find("2669951")>0 and aopath.find("d01")>0 and + sqrts==10.45) : + sqrts=9.9 + if not tmpE.has_key(sqrts): + tmpE[sqrts] = ao + else: + raise Exception("A set with sqrts = %s already exists" % ( sqrts)) + sqrts=sqrttemp + elif(aopath.find("OPAL_2004_I648738")>=0) : + if(file.find("gg")>=0) : + if(aopath.find("y03")>=0) : + outhistos[aopath] = ao + else : + if(aopath.find("y03")<0) : + outhistos[aopath] = ao + else : + if("ARGUS_1992_I319102" in aopath) : + if("d02" in aopath and sqrts==10.47) : + outhistos[aopath] = ao + elif("d03"in aopath and sqrts=="U4") : + outhistos[aopath] = ao + else: + outhistos[aopath] = ao + +# ## Make empty output histos if needed +for hpath,hsets in inhistos.iteritems(): + if( hpath.find("4300807")>0 or hpath.find("6132243")>0 or + hpath.find("5765862")>0 or hpath.find("295160" )>0 or + hpath.find("4328825")>0 or hpath.find("5361494")>0 or + hpath.find("190818" )>0 or hpath.find("154270" )>0 or + hpath.find("277658" )>0 or hpath.find("2669951")>0 or + hpath.find("276860" )>0 or hpath.find("165122" )>0 or + hpath.find("118873" )>0 or hpath.find("143691" )>0 or + hpath.find("284251" )>0 or hpath.find("191161" )>0 or + hpath.find("1422780")>0) : + if(hpath=="/PLUTO_1981_I165122/d01-x01-y01" or + hpath=="/PLUTO_1981_I165122/d03-x01-y01" ) : continue + if(type(hsets.values()[0])==yoda.core.Scatter2D) : + outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].path, + hsets.values()[0].title) + elif(type(hsets.values()[0])==yoda.core.Profile1D) : + outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].path, + hsets.values()[0].title) + for i in range(0,hsets.values()[0].numBins) : + outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, + hsets.values()[0].bins[i].xMax) + elif(type(hsets.values()[0])==yoda.core.Histo1D) : + outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].path, + hsets.values()[0].title) + for i in range(0,hsets.values()[0].numBins) : + outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, + hsets.values()[0].bins[i].xMax) + else : + logging.error("Histogram %s is of unknown type" % hpath) + sys.exit(1) + +# tasso +useOne("/TASSO_1990_S2148048/d06-x01-y01","14") +useOne("/TASSO_1990_S2148048/d07-x01-y01","14") +useOne("/TASSO_1990_S2148048/d08-x01-y01","14") +useOne("/TASSO_1990_S2148048/d06-x01-y02","22") +useOne("/TASSO_1990_S2148048/d07-x01-y02","22") +useOne("/TASSO_1990_S2148048/d08-x01-y02","22") +useOne("/TASSO_1990_S2148048/d06-x01-y03","35") +useOne("/TASSO_1990_S2148048/d07-x01-y03","35") +useOne("/TASSO_1990_S2148048/d08-x01-y03","35") +useOne("/TASSO_1990_S2148048/d06-x01-y04","44") +useOne("/TASSO_1990_S2148048/d07-x01-y04","44") +useOne("/TASSO_1990_S2148048/d08-x01-y04","44") +# jade +useOne("/JADE_1998_S3612880/d02-x01-y01","44") +useOne("/JADE_1998_S3612880/d03-x01-y01","44") +useOne("/JADE_1998_S3612880/d04-x01-y01","44") +useOne("/JADE_1998_S3612880/d05-x01-y01","44") +useOne("/JADE_1998_S3612880/d06-x01-y01","35") +useOne("/JADE_1998_S3612880/d07-x01-y01","35") +useOne("/JADE_1998_S3612880/d08-x01-y01","35") +useOne("/JADE_1998_S3612880/d09-x01-y01","35") +useOne("/JADE_1998_S3612880/d10-x01-y01","44") +useOne("/JADE_1998_S3612880/d11-x01-y01","35") +useOne("/JADE_1998_S3612880/d12-x01-y01","22") +# opal/jade +useOne("/JADE_OPAL_2000_S4300807/d07-x01-y01","35") +useOne("/JADE_OPAL_2000_S4300807/d07-x01-y02","35") +useOne("/JADE_OPAL_2000_S4300807/d07-x01-y03","35") +useOne("/JADE_OPAL_2000_S4300807/d07-x01-y04","35") +useOne("/JADE_OPAL_2000_S4300807/d07-x01-y05","35") +useOne("/JADE_OPAL_2000_S4300807/d08-x01-y01","44") +useOne("/JADE_OPAL_2000_S4300807/d08-x01-y02","44") +useOne("/JADE_OPAL_2000_S4300807/d08-x01-y03","44") +useOne("/JADE_OPAL_2000_S4300807/d08-x01-y04","44") +useOne("/JADE_OPAL_2000_S4300807/d08-x01-y05","44") +useOne("/JADE_OPAL_2000_S4300807/d09-x01-y01","91") +useOne("/JADE_OPAL_2000_S4300807/d09-x01-y02","91") +useOne("/JADE_OPAL_2000_S4300807/d09-x01-y03","91") +useOne("/JADE_OPAL_2000_S4300807/d09-x01-y04","91") +useOne("/JADE_OPAL_2000_S4300807/d09-x01-y05","91") +useOne("/JADE_OPAL_2000_S4300807/d10-x01-y01","133") +useOne("/JADE_OPAL_2000_S4300807/d10-x01-y02","133") +useOne("/JADE_OPAL_2000_S4300807/d10-x01-y03","133") +useOne("/JADE_OPAL_2000_S4300807/d10-x01-y04","133") +useOne("/JADE_OPAL_2000_S4300807/d10-x01-y05","133") +useOne("/JADE_OPAL_2000_S4300807/d11-x01-y01","161") +useOne("/JADE_OPAL_2000_S4300807/d11-x01-y02","161") +useOne("/JADE_OPAL_2000_S4300807/d11-x01-y03","161") +useOne("/JADE_OPAL_2000_S4300807/d11-x01-y04","161") +useOne("/JADE_OPAL_2000_S4300807/d11-x01-y05","161") +useOne("/JADE_OPAL_2000_S4300807/d12-x01-y01","172") +useOne("/JADE_OPAL_2000_S4300807/d12-x01-y02","172") +useOne("/JADE_OPAL_2000_S4300807/d12-x01-y03","172") +useOne("/JADE_OPAL_2000_S4300807/d12-x01-y04","172") +useOne("/JADE_OPAL_2000_S4300807/d12-x01-y05","172") +useOne("/JADE_OPAL_2000_S4300807/d13-x01-y01","183") +useOne("/JADE_OPAL_2000_S4300807/d13-x01-y02","183") +useOne("/JADE_OPAL_2000_S4300807/d13-x01-y03","183") +useOne("/JADE_OPAL_2000_S4300807/d13-x01-y04","183") +useOne("/JADE_OPAL_2000_S4300807/d13-x01-y05","183") +useOne("/JADE_OPAL_2000_S4300807/d14-x01-y01","189") +useOne("/JADE_OPAL_2000_S4300807/d14-x01-y02","189") +useOne("/JADE_OPAL_2000_S4300807/d14-x01-y03","189") +useOne("/JADE_OPAL_2000_S4300807/d14-x01-y04","189") +useOne("/JADE_OPAL_2000_S4300807/d14-x01-y05","189") +useOne("/JADE_OPAL_2000_S4300807/d16-x01-y01","35") +useOne("/JADE_OPAL_2000_S4300807/d16-x01-y02","35") +useOne("/JADE_OPAL_2000_S4300807/d16-x01-y03","35") +useOne("/JADE_OPAL_2000_S4300807/d16-x01-y04","35") +useOne("/JADE_OPAL_2000_S4300807/d16-x01-y05","35") +useOne("/JADE_OPAL_2000_S4300807/d17-x01-y01","44") +useOne("/JADE_OPAL_2000_S4300807/d17-x01-y02","44") +useOne("/JADE_OPAL_2000_S4300807/d17-x01-y03","44") +useOne("/JADE_OPAL_2000_S4300807/d17-x01-y04","44") +useOne("/JADE_OPAL_2000_S4300807/d17-x01-y05","44") +useOne("/JADE_OPAL_2000_S4300807/d18-x01-y01","91") +useOne("/JADE_OPAL_2000_S4300807/d18-x01-y02","91") +useOne("/JADE_OPAL_2000_S4300807/d18-x01-y03","91") +useOne("/JADE_OPAL_2000_S4300807/d18-x01-y04","91") +useOne("/JADE_OPAL_2000_S4300807/d18-x01-y05","91") +useOne("/JADE_OPAL_2000_S4300807/d19-x01-y01","133") +useOne("/JADE_OPAL_2000_S4300807/d19-x01-y02","133") +useOne("/JADE_OPAL_2000_S4300807/d19-x01-y03","133") +useOne("/JADE_OPAL_2000_S4300807/d19-x01-y04","133") +useOne("/JADE_OPAL_2000_S4300807/d19-x01-y05","133") +useOne("/JADE_OPAL_2000_S4300807/d20-x01-y01","161") +useOne("/JADE_OPAL_2000_S4300807/d20-x01-y02","161") +useOne("/JADE_OPAL_2000_S4300807/d20-x01-y03","161") +useOne("/JADE_OPAL_2000_S4300807/d20-x01-y04","161") +useOne("/JADE_OPAL_2000_S4300807/d20-x01-y05","161") +useOne("/JADE_OPAL_2000_S4300807/d21-x01-y01","172") +useOne("/JADE_OPAL_2000_S4300807/d21-x01-y02","172") +useOne("/JADE_OPAL_2000_S4300807/d21-x01-y03","172") +useOne("/JADE_OPAL_2000_S4300807/d21-x01-y04","172") +useOne("/JADE_OPAL_2000_S4300807/d21-x01-y05","172") +useOne("/JADE_OPAL_2000_S4300807/d22-x01-y01","183") +useOne("/JADE_OPAL_2000_S4300807/d22-x01-y02","183") +useOne("/JADE_OPAL_2000_S4300807/d22-x01-y03","183") +useOne("/JADE_OPAL_2000_S4300807/d22-x01-y04","183") +useOne("/JADE_OPAL_2000_S4300807/d22-x01-y05","183") +useOne("/JADE_OPAL_2000_S4300807/d23-x01-y01","189") +useOne("/JADE_OPAL_2000_S4300807/d23-x01-y02","189") +useOne("/JADE_OPAL_2000_S4300807/d23-x01-y03","189") +useOne("/JADE_OPAL_2000_S4300807/d23-x01-y04","189") +useOne("/JADE_OPAL_2000_S4300807/d23-x01-y05","189") +useOne("/JADE_OPAL_2000_S4300807/d24-x01-y01","35") +useOne("/JADE_OPAL_2000_S4300807/d24-x01-y02","35") +useOne("/JADE_OPAL_2000_S4300807/d24-x01-y03","35") +useOne("/JADE_OPAL_2000_S4300807/d24-x01-y04","35") +useOne("/JADE_OPAL_2000_S4300807/d25-x01-y01","44") +useOne("/JADE_OPAL_2000_S4300807/d25-x01-y02","44") +useOne("/JADE_OPAL_2000_S4300807/d25-x01-y03","44") +useOne("/JADE_OPAL_2000_S4300807/d25-x01-y04","44") +useOne("/JADE_OPAL_2000_S4300807/d26-x01-y01","91") +useOne("/JADE_OPAL_2000_S4300807/d26-x01-y02","91") +useOne("/JADE_OPAL_2000_S4300807/d26-x01-y03","91") +useOne("/JADE_OPAL_2000_S4300807/d26-x01-y04","91") +useOne("/JADE_OPAL_2000_S4300807/d27-x01-y01","133") +useOne("/JADE_OPAL_2000_S4300807/d27-x01-y02","133") +useOne("/JADE_OPAL_2000_S4300807/d27-x01-y03","133") +useOne("/JADE_OPAL_2000_S4300807/d27-x01-y04","133") +useOne("/JADE_OPAL_2000_S4300807/d28-x01-y01","161") +useOne("/JADE_OPAL_2000_S4300807/d28-x01-y02","161") +useOne("/JADE_OPAL_2000_S4300807/d28-x01-y03","161") +useOne("/JADE_OPAL_2000_S4300807/d28-x01-y04","161") +useOne("/JADE_OPAL_2000_S4300807/d29-x01-y01","172") +useOne("/JADE_OPAL_2000_S4300807/d29-x01-y02","172") +useOne("/JADE_OPAL_2000_S4300807/d29-x01-y03","172") +useOne("/JADE_OPAL_2000_S4300807/d29-x01-y04","172") +useOne("/JADE_OPAL_2000_S4300807/d30-x01-y01","183") +useOne("/JADE_OPAL_2000_S4300807/d30-x01-y02","183") +useOne("/JADE_OPAL_2000_S4300807/d30-x01-y03","183") +useOne("/JADE_OPAL_2000_S4300807/d30-x01-y04","183") +useOne("/JADE_OPAL_2000_S4300807/d31-x01-y01","189") +useOne("/JADE_OPAL_2000_S4300807/d31-x01-y02","189") +useOne("/JADE_OPAL_2000_S4300807/d31-x01-y03","189") +useOne("/JADE_OPAL_2000_S4300807/d31-x01-y04","189") + +useOne("/OPAL_2004_S6132243/d01-x01-y01","91") +useOne("/OPAL_2004_S6132243/d01-x01-y02","133") +useOne("/OPAL_2004_S6132243/d01-x01-y03","177") +useOne("/OPAL_2004_S6132243/d01-x01-y04","197") +useOne("/OPAL_2004_S6132243/d02-x01-y01","91") +useOne("/OPAL_2004_S6132243/d02-x01-y02","133") +useOne("/OPAL_2004_S6132243/d02-x01-y03","177") +useOne("/OPAL_2004_S6132243/d02-x01-y04","197") +useOne("/OPAL_2004_S6132243/d03-x01-y01","91") +useOne("/OPAL_2004_S6132243/d03-x01-y02","133") +useOne("/OPAL_2004_S6132243/d03-x01-y03","177") +useOne("/OPAL_2004_S6132243/d03-x01-y04","197") +useOne("/OPAL_2004_S6132243/d04-x01-y01","91") +useOne("/OPAL_2004_S6132243/d04-x01-y02","133") +useOne("/OPAL_2004_S6132243/d04-x01-y03","177") +useOne("/OPAL_2004_S6132243/d04-x01-y04","197") +useOne("/OPAL_2004_S6132243/d05-x01-y01","91") +useOne("/OPAL_2004_S6132243/d05-x01-y02","133") +useOne("/OPAL_2004_S6132243/d05-x01-y03","177") +useOne("/OPAL_2004_S6132243/d05-x01-y04","197") +useOne("/OPAL_2004_S6132243/d06-x01-y01","91") +useOne("/OPAL_2004_S6132243/d06-x01-y02","133") +useOne("/OPAL_2004_S6132243/d06-x01-y03","177") +useOne("/OPAL_2004_S6132243/d06-x01-y04","197") +useOne("/OPAL_2004_S6132243/d07-x01-y01","91") +useOne("/OPAL_2004_S6132243/d07-x01-y02","133") +useOne("/OPAL_2004_S6132243/d07-x01-y03","177") +useOne("/OPAL_2004_S6132243/d07-x01-y04","197") +useOne("/OPAL_2004_S6132243/d08-x01-y01","91") +useOne("/OPAL_2004_S6132243/d08-x01-y02","133") +useOne("/OPAL_2004_S6132243/d08-x01-y03","177") +useOne("/OPAL_2004_S6132243/d08-x01-y04","197") +useOne("/OPAL_2004_S6132243/d09-x01-y01","91") +useOne("/OPAL_2004_S6132243/d09-x01-y02","133") +useOne("/OPAL_2004_S6132243/d09-x01-y03","177") +useOne("/OPAL_2004_S6132243/d09-x01-y04","197") +useOne("/OPAL_2004_S6132243/d10-x01-y01","91") +useOne("/OPAL_2004_S6132243/d10-x01-y02","133") +useOne("/OPAL_2004_S6132243/d10-x01-y03","177") +useOne("/OPAL_2004_S6132243/d10-x01-y04","197") +useOne("/OPAL_2004_S6132243/d11-x01-y01","91") +useOne("/OPAL_2004_S6132243/d11-x01-y02","133") +useOne("/OPAL_2004_S6132243/d11-x01-y03","177") +useOne("/OPAL_2004_S6132243/d11-x01-y04","197") +useOne("/OPAL_2004_S6132243/d12-x01-y01","91") +useOne("/OPAL_2004_S6132243/d12-x01-y02","133") +useOne("/OPAL_2004_S6132243/d12-x01-y03","177") +useOne("/OPAL_2004_S6132243/d12-x01-y04","197") +useOne("/OPAL_2004_S6132243/d13-x01-y01","91") +useOne("/OPAL_2004_S6132243/d13-x01-y02","133") +useOne("/OPAL_2004_S6132243/d13-x01-y03","177") +useOne("/OPAL_2004_S6132243/d13-x01-y04","197") +useOne("/OPAL_2004_S6132243/d14-x01-y01","91") +useOne("/OPAL_2004_S6132243/d14-x01-y02","133") +useOne("/OPAL_2004_S6132243/d14-x01-y03","177") +useOne("/OPAL_2004_S6132243/d14-x01-y04","197") +useOne("/OPAL_2004_S6132243/d15-x01-y01","91") +useOne("/OPAL_2004_S6132243/d15-x01-y02","133") +useOne("/OPAL_2004_S6132243/d15-x01-y03","177") +useOne("/OPAL_2004_S6132243/d15-x01-y04","197") +useOne("/OPAL_2004_S6132243/d16-x01-y01","91") +useOne("/OPAL_2004_S6132243/d16-x01-y02","133") +useOne("/OPAL_2004_S6132243/d16-x01-y03","177") +useOne("/OPAL_2004_S6132243/d16-x01-y04","197") +useOne("/OPAL_2004_S6132243/d17-x01-y01","91") +useOne("/OPAL_2004_S6132243/d17-x01-y02","133") +useOne("/OPAL_2004_S6132243/d17-x01-y03","177") +useOne("/OPAL_2004_S6132243/d17-x01-y04","197") +useOne("/OPAL_2004_S6132243/d18-x01-y01","91") +useOne("/OPAL_2004_S6132243/d18-x01-y02","133") +useOne("/OPAL_2004_S6132243/d18-x01-y03","177") +useOne("/OPAL_2004_S6132243/d18-x01-y04","197") +useOne("/OPAL_2004_S6132243/d19-x01-y01","91") +useOne("/OPAL_2004_S6132243/d19-x01-y02","133") +useOne("/OPAL_2004_S6132243/d19-x01-y03","177") +useOne("/OPAL_2004_S6132243/d19-x01-y04","197") +useOne("/OPAL_2004_S6132243/d20-x01-y01","91") +useOne("/OPAL_2004_S6132243/d20-x01-y02","133") +useOne("/OPAL_2004_S6132243/d20-x01-y03","177") +useOne("/OPAL_2004_S6132243/d20-x01-y04","197") +useOne("/OPAL_2004_S6132243/d21-x01-y01","91") +useOne("/OPAL_2004_S6132243/d21-x01-y02","133") +useOne("/OPAL_2004_S6132243/d21-x01-y03","177") +useOne("/OPAL_2004_S6132243/d21-x01-y04","197") +useOne("/OPAL_2004_S6132243/d22-x01-y01","91") +useOne("/OPAL_2004_S6132243/d22-x01-y02","133") +useOne("/OPAL_2004_S6132243/d22-x01-y03","177") +useOne("/OPAL_2004_S6132243/d22-x01-y04","197") +useOne("/OPAL_2004_S6132243/d23-x01-y01","91") +useOne("/OPAL_2004_S6132243/d23-x01-y02","133") +useOne("/OPAL_2004_S6132243/d23-x01-y03","177") +useOne("/OPAL_2004_S6132243/d23-x01-y04","197") +useOne("/OPAL_2004_S6132243/d24-x01-y01","91") +useOne("/OPAL_2004_S6132243/d24-x01-y02","133") +useOne("/OPAL_2004_S6132243/d24-x01-y03","177") +useOne("/OPAL_2004_S6132243/d24-x01-y04","197") +useOne("/OPAL_2004_S6132243/d25-x01-y01","91") +useOne("/OPAL_2004_S6132243/d25-x01-y02","133") +useOne("/OPAL_2004_S6132243/d25-x01-y03","177") +useOne("/OPAL_2004_S6132243/d25-x01-y04","197") +useOne("/OPAL_2004_S6132243/d26-x01-y01","91") +useOne("/OPAL_2004_S6132243/d26-x01-y02","133") +useOne("/OPAL_2004_S6132243/d26-x01-y03","177") +useOne("/OPAL_2004_S6132243/d26-x01-y04","197") + +merge( "/OPAL_2002_S5361494/d01-x01-y01") +merge( "/OPAL_2002_S5361494/d01-x01-y02") +merge( "/OPAL_2002_S5361494/d01-x01-y03") +merge( "/OPAL_2002_S5361494/d01-x01-y04") +merge("/DELPHI_2000_S4328825/d01-x01-y01") +merge("/DELPHI_2000_S4328825/d01-x01-y02") +merge("/DELPHI_2000_S4328825/d01-x01-y03") +merge("/DELPHI_2000_S4328825/d01-x01-y04") +merge("/ALEPH_2004_S5765862/d01-x01-y01") +useOne("/ALEPH_2004_S5765862/d02-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d03-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d04-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d05-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d06-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d07-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d08-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d09-x01-y01","206") + +useOne("/ALEPH_2004_S5765862/d11-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d12-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d13-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d14-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d15-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d16-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d17-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d18-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d19-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d20-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d21-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d22-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d23-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d24-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d25-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d26-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d27-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d28-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d29-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d30-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d31-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d32-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d33-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d34-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d35-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d36-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d37-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d38-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d39-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d40-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d41-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d42-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d43-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d44-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d45-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d46-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d47-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d48-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d49-x01-y01","196") +useOne("/ALEPH_2004_S5765862/d50-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d51-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d54-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d55-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d56-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d57-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d58-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d59-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d60-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d61-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d62-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d63-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d64-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d65-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d66-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d67-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d68-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d69-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d70-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d71-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d72-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d73-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d74-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d75-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d76-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d77-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d78-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d79-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d80-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d81-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d82-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d83-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d84-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d85-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d86-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d87-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d88-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d89-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d90-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d91-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d92-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d93-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d94-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d95-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d96-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d97-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d98-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d99-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d100-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d101-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d102-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d103-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d104-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d105-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d106-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d107-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d108-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d109-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d110-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d111-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d112-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d113-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d114-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d115-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d116-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d117-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d118-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d119-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d120-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d121-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d122-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d123-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d124-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d125-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d126-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d127-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d128-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d129-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d130-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d131-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d132-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d133-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d134-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d135-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d136-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d137-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d138-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d139-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d140-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d141-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d142-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d143-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d144-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d145-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d146-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d147-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d148-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d149-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d150-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d151-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d152-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d153-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d154-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d155-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d156-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d157-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d158-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d159-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d160-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d161-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d162-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d163-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d164-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d165-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d166-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d167-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d168-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d169-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d170-x01-y01","189") + +useOne("/ALEPH_2004_S5765862/d172-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d173-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d174-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d175-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d176-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d177-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d178-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d179-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d180-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d181-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d182-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d183-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d184-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d185-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d186-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d187-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d188-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d189-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d190-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d191-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d192-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d193-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d194-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d195-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d196-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d197-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d198-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d199-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d200-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d201-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d202-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d203-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d204-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d205-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d206-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d207-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d208-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d209-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d210-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d211-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d212-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d213-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d214-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d215-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d216-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d217-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d218-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d219-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d220-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d221-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d222-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d223-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d224-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d225-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d226-x01-y01","206") +useOne("/ALEPH_2004_S5765862/d227-x01-y01","91") +useOne("/ALEPH_2004_S5765862/d228-x01-y01","133") +useOne("/ALEPH_2004_S5765862/d229-x01-y01","161") +useOne("/ALEPH_2004_S5765862/d230-x01-y01","172") +useOne("/ALEPH_2004_S5765862/d231-x01-y01","183") +useOne("/ALEPH_2004_S5765862/d232-x01-y01","189") +useOne("/ALEPH_2004_S5765862/d233-x01-y01","200") +useOne("/ALEPH_2004_S5765862/d234-x01-y01","206") + +# hadron multiplicities +useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d17-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d22-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d23-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d25-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d40-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d45-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d49-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d53-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES/d54-x01-y01","10") + +useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d22-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d33-x01-y01","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d34-x01-y01","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y02","35") + +useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d10-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d11-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d12-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d14-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d16-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d17-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d23-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d24-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d25-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d26-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d27-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d28-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d29-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d30-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d32-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d34-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d35-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d36-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d37-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d40-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d41-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d42-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d43-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d45-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d49-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d52-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d54-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y04","177") + +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y01","10" ) +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d53-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y01","10") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d33-x01-y01","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y01","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y02","35") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d10-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d11-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d12-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d14-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d16-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d24-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d26-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d27-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d28-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d29-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d30-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d32-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d35-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d36-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d37-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d41-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d42-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d43-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y03","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d52-x01-y01","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y02","91") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y04","177") +useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y04","177") +# AMY analysis +useOne("/AMY_1990_I295160/d01-x01-y01","50") +useOne("/AMY_1990_I295160/d01-x01-y02","52") +useOne("/AMY_1990_I295160/d01-x01-y03","55") +useOne("/AMY_1990_I295160/d01-x01-y04","56") +useOne("/AMY_1990_I295160/d01-x01-y05","57") +useOne("/AMY_1990_I295160/d01-x01-y06","60") +useOne("/AMY_1990_I295160/d01-x01-y07","60.8") +useOne("/AMY_1990_I295160/d01-x01-y08","61.4") +useOne("/AMY_1990_I295160/d01-x01-y09","57") +useOne("/AMY_1990_I295160/d02-x02-y01","57") +merge("/AMY_1990_I295160/d02-x01-y01") +merge("/JADE_1983_I190818/d01-x01-y01") +merge("/PLUTO_1980_I154270/d01-x01-y01") + +merge("/TASSO_1989_I277658/d02-x01-y01") +useOne("/TASSO_1989_I277658/d05-x01-y01","14") +useOne("/TASSO_1989_I277658/d05-x01-y02","22") +useOne("/TASSO_1989_I277658/d05-x01-y03","34.8") +useOne("/TASSO_1989_I277658/d05-x01-y04","43.6") + +# BELLE +useOne("/BELLE_2006_S6265367/d01-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y03","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y04","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y05","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y06","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y07","10.52") +useOne("/BELLE_2006_S6265367/d01-x01-y08","10.52") +useOne("/BELLE_2006_S6265367/d02-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d02-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d03-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d03-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d04-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d04-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d05-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d05-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d06-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d06-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d07-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d07-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d08-x01-y01","10.52") +useOne("/BELLE_2006_S6265367/d08-x01-y02","10.52") +useOne("/BELLE_2006_S6265367/d09-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d09-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d10-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d10-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d11-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d11-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d12-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d12-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d13-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d13-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d14-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d14-x01-y02","U4") +useOne("/BELLE_2006_S6265367/d15-x01-y01","U4") +useOne("/BELLE_2006_S6265367/d15-x01-y02","U4") +# BABAR +useOne("/BABAR_2007_S6895344/d01-x01-y01","10.54") +useOne("/BABAR_2007_S6895344/d02-x01-y01","10.54") +useOne("/BABAR_2007_S6895344/d03-x01-y01","10.58") +useOne("/BABAR_2007_S6895344/d04-x01-y01","10.58") +# BABAR +useOne("/BABAR_2005_S6181155/d01-x01-y01","10.58") +useOne("/BABAR_2005_S6181155/d02-x01-y01","10.58") +useOne("/BABAR_2005_S6181155/d02-x01-y02","10.54") +useOne("/BABAR_2005_S6181155/d03-x01-y01","10.54") +useOne("/BABAR_2005_S6181155/d04-x01-y01","10.58") +useOne("/BABAR_2005_S6181155/d05-x01-y01","10.58") +useOne("/BABAR_2005_S6181155/d05-x01-y02","10.54") +# ARGUS +useOne("/ARGUS_1993_S2789213/d01-x01-y01","10.45") +useOne("/ARGUS_1993_S2789213/d01-x01-y02","10.45") +useOne("/ARGUS_1993_S2789213/d01-x01-y03","10.45") +useOne("/ARGUS_1993_S2789213/d01-x01-y04","10.45") +useOne("/ARGUS_1993_S2789213/d01-x01-y05","10.45") +useOne("/ARGUS_1993_S2789213/d02-x01-y01", "U1") +useOne("/ARGUS_1993_S2789213/d02-x01-y02", "U1") +useOne("/ARGUS_1993_S2789213/d02-x01-y03", "U1") +useOne("/ARGUS_1993_S2789213/d02-x01-y04", "U1") +useOne("/ARGUS_1993_S2789213/d02-x01-y05", "U1") +useOne("/ARGUS_1993_S2789213/d03-x01-y01","U4") +useOne("/ARGUS_1993_S2789213/d03-x01-y02","U4") +useOne("/ARGUS_1993_S2789213/d03-x01-y03","U4") +useOne("/ARGUS_1993_S2789213/d03-x01-y04","U4") +useOne("/ARGUS_1993_S2789213/d03-x01-y05","U4") +useOne("/ARGUS_1993_S2789213/d04-x01-y01","10.45") +useOne("/ARGUS_1993_S2789213/d05-x01-y01", "U1") +useOne("/ARGUS_1993_S2789213/d06-x01-y01","U4") +useOne("/ARGUS_1993_S2789213/d07-x01-y01","10.45") +useOne("/ARGUS_1993_S2789213/d08-x01-y01", "U1") +useOne("/ARGUS_1993_S2789213/d09-x01-y01","U4") +useOne("/ARGUS_1993_S2789213/d10-x01-y01","10.45") +useOne("/ARGUS_1993_S2789213/d11-x01-y01", "U1") +useOne("/ARGUS_1993_S2789213/d12-x01-y01","U4") +useOne("/ARGUS_1993_S2789213/d13-x01-y01","10.45") +useOne("/ARGUS_1993_S2789213/d14-x01-y01", "U1") +useOne("/ARGUS_1993_S2789213/d15-x01-y01","U4") + +if("/ARGUS_1993_S2669951/d04-x01-y01" in outhistos) : + useOne("/ARGUS_1993_S2669951/d02-x01-y01","10.45") + useOne("/ARGUS_1993_S2669951/d03-x01-y01","U1") + useOne("/ARGUS_1993_S2669951/d04-x01-y01","U2") + merge("/ARGUS_1993_S2669951/d01-x01-y01") + merge("/ARGUS_1993_S2669951/d01-x01-y02") + merge("/ARGUS_1993_S2669951/d05-x01-y01") + +useOne("/ARGUS_1990_I278933/d01-x01-y01","9.46") +useOne("/ARGUS_1990_I278933/d01-x01-y02","U1") +useOne("/ARGUS_1990_I278933/d01-x01-y03","U2") +useOne("/ARGUS_1990_I278933/d02-x01-y01","9.46") +useOne("/ARGUS_1990_I278933/d02-x01-y02","U1") +useOne("/ARGUS_1990_I278933/d02-x01-y03","U2") +useOne("/ARGUS_1990_I278933/d03-x01-y01","9.46") +useOne("/ARGUS_1990_I278933/d03-x01-y02","9.46") +useOne("/ARGUS_1990_I278933/d04-x01-y01","U1") +useOne("/ARGUS_1990_I278933/d04-x01-y02","U2") +useOne("/ARGUS_1990_I278933/d05-x01-y01","9.46") +useOne("/ARGUS_1990_I278933/d05-x01-y02","9.46") +useOne("/ARGUS_1990_I278933/d06-x01-y01","U1") +useOne("/ARGUS_1990_I278933/d06-x01-y02","U2") + +useOne("/ARGUS_1989_I262551/d01-x01-y01","10.00") +useOne("/ARGUS_1989_I262551/d02-x01-y01","U1") +useOne("/ARGUS_1989_I262551/d02-x01-y02","U2") +useOne("/ARGUS_1989_I262551/d03-x01-y01","U1") +useOne("/ARGUS_1989_I262551/d04-x01-y01","U2") + +merge("/ARGUS_1989_I276860/d01-x01-y01") +merge("/ARGUS_1989_I276860/d01-x01-y02") +merge("/ARGUS_1989_I276860/d02-x01-y01") +merge("/ARGUS_1989_I276860/d03-x01-y01") +merge("/ARGUS_1989_I276860/d04-x01-y01") +merge("/ARGUS_1989_I276860/d04-x01-y02") +for i in range(5,13) : + useOne("/ARGUS_1989_I276860/d%02d-x01-y01" %i,"U1") + useOne("/ARGUS_1989_I276860/d%02d-x01-y02" %i,"10.00") + +for i in range(1,8) : + useOne("/ARGUS_1988_I251097/d01-x01-y%02d" %i,"U1") + useOne("/ARGUS_1988_I251097/d02-x01-y%02d" %i,"10.00") +useOne("/ARGUS_1988_I251097/d03-x01-y01","U1") +useOne("/ARGUS_1988_I251097/d04-x01-y01","U2") +useOne("/ARGUS_1988_I251097/d05-x01-y01","10.00") +useOne("/ARGUS_1988_I251097/d06-x01-y01","10.00") +useOne("/ARGUS_1988_I251097/d07-x01-y01","U1") +useOne("/ARGUS_1988_I251097/d08-x01-y01","U2") +useOne("/ARGUS_1988_I251097/d09-x01-y01","10.00") + +useOne("/ARGUS_1989_I262415/d03-x01-y01","U1") +useOne("/ARGUS_1989_I262415/d04-x01-y01","10.00") + +merge("/PLUTO_1981_I165122/d01-x01-y01") +merge("/PLUTO_1981_I165122/d02-x01-y01") +useOne("/PLUTO_1981_I165122/d06-x01-y01","U1") +useOne("/PLUTO_1981_I165122/d04-x01-y01","30.2") +useOne("/PLUTO_1981_I165122/d05-x01-y01","9.4") +useOne("/PLUTO_1977_I118873/d02-x01-y01","3.63") +useOne("/PLUTO_1977_I118873/d03-x01-y01","4.03") +useOne("/PLUTO_1977_I118873/d04-x01-y01","4.5") + + +useOne("/TASSO_1982_I177174/d01-x01-y01","14.") +useOne("/TASSO_1982_I177174/d01-x01-y02","22.") +useOne("/TASSO_1982_I177174/d01-x01-y03","34.") +for i in range(2,4) : + useOne("/TASSO_1982_I177174/d0%s-x01-y01" %i ,"12.") + useOne("/TASSO_1982_I177174/d0%s-x01-y02" %i ,"14.") + useOne("/TASSO_1982_I177174/d0%s-x01-y03" %i ,"22.") + useOne("/TASSO_1982_I177174/d0%s-x01-y04" %i ,"25.") + useOne("/TASSO_1982_I177174/d0%s-x01-y05" %i ,"30.") + useOne("/TASSO_1982_I177174/d0%s-x01-y06" %i ,"34.") + useOne("/TASSO_1982_I177174/d0%s-x01-y07" %i ,"35.") + +merge("/TASSO_1980_I143691/d01-x01-y01") +useOne("/TASSO_1980_I143691/d02-x01-y01","13.") +useOne("/TASSO_1980_I143691/d05-x01-y01","13.") +if("/TASSO_1980_I143691/d03-x01-y01" in inhistos) : + average("/TASSO_1980_I143691/d03-x01-y01","17.","22.") + average("/TASSO_1980_I143691/d06-x01-y01","17.","22.") +useOne("/TASSO_1980_I143691/d04-x01-y01","30.2") +useOne("/TASSO_1980_I143691/d07-x01-y01","30.2") + +useOne("/TASSO_1990_I284251/d01-x01-y01","42.6") +useOne("/TASSO_1990_I284251/d01-x01-y02","35.") +useOne("/TASSO_1990_I284251/d01-x01-y03","34.5") +useOne("/TASSO_1990_I284251/d02-x01-y01","14.8") +useOne("/TASSO_1990_I284251/d03-x01-y01","21.5") +merge("/TASSO_1990_I284251/d04-x01-y01") +useOne("/TASSO_1990_I284251/d05-x01-y01","42.6") +useOne("/TASSO_1990_I284251/d05-x01-y02","42.6") +useOne("/TASSO_1990_I284251/d05-x01-y03","35") +useOne("/TASSO_1990_I284251/d05-x01-y04","35") +useOne("/TASSO_1990_I284251/d06-x01-y01","14.8") +useOne("/TASSO_1990_I284251/d06-x01-y02","14.8") +useOne("/TASSO_1990_I284251/d07-x01-y01","21.5") +useOne("/TASSO_1990_I284251/d07-x01-y02","21.5") +useOne("/TASSO_1990_I284251/d08-x01-y01","42.6") +useOne("/TASSO_1990_I284251/d08-x01-y02","35.") +useOne("/TASSO_1990_I284251/d08-x01-y03","34.5") +merge("/TASSO_1990_I284251/d09-x01-y01") +useOne("/TASSO_1990_I284251/d10-x01-y01","35") +useOne("/TASSO_1990_I284251/d10-x01-y02","35") + +# BES xi analysis +useOne("/BESIII_2016_I1422780/d02-x01-y01","psi") +useOne("/BESIII_2016_I1422780/d02-x01-y02","psi") +useOne("/BESIII_2016_I1422780/d02-x01-y03","psi") +useOne("/BESIII_2016_I1422780/d02-x01-y04","psi2s") +useOne("/BESIII_2016_I1422780/d02-x01-y05","psi2s") +useOne("/BESIII_2016_I1422780/d02-x01-y06","psi2s") +if ( "/BESIII_2016_I1422780/d01-x01-y03" in inhistos and + "psi" in inhistos["/BESIII_2016_I1422780/d01-x01-y03"]) : + for point in inhistos["/BESIII_2016_I1422780/d01-x01-y03"]["psi"].points: + outhistos["/BESIII_2016_I1422780/d01-x01-y03"].addPoint(point) +if ( "/BESIII_2016_I1422780/d01-x01-y03" in inhistos and + "psi2s" in inhistos["/BESIII_2016_I1422780/d01-x01-y03"]) : + for point in inhistos["/BESIII_2016_I1422780/d01-x01-y03"]["psi2s"].points: + outhistos["/BESIII_2016_I1422780/d01-x01-y03"].addPoint(point) + +# pluto analysis +for id in range(1,3) : + for iy in range(1,5) : + merge("/PLUTO_1983_I191161/d0%s-x01-y0%s" % (id,iy)) + +# Choose output file +name = args[0]+".yoda" +# output the yoda file +yoda.writeYODA(outhistos,name) +sys.exit(0) diff --git a/Tests/python/merge-EE-Gamma b/Tests/python/merge-EE-Gamma new file mode 100755 --- /dev/null +++ b/Tests/python/merge-EE-Gamma @@ -0,0 +1,136 @@ +#! /usr/bin/env python +import logging,sys +import os, yoda, copy + +if sys.version_info[:3] < (2,4,0): + print "rivet scripts require Python version >= 2.4.0... exiting" + sys.exit(1) + + +############################################# + +def fillAbove(desthisto, sourcehistosbysqrts): + if type(desthisto) is yoda.core.Scatter2D : + for sqrts in sorted(sourcehistosbysqrts.keys()) : + h=sourcehistosbysqrts[sqrts] + for i in range(0,h.numPoints) : + if sqrts==h.points[i].x : + desthisto.addPoint(h.points[i]) + + elif(type(desthisto)==yoda.core.Profile1D) : + for sqrts, h in sorted(sourcehistosbysqrts.iteritems()) : + for i in range(0,h.numBins) : + if(sqrts>=h.bins[i].xMin and \ + sqrts<=h.bins[i].xMax) : + desthisto.bins[i] += h.bins[i] + break + else : + logging.error("Unknown analysis object" + desthisto.path) + sys.exit(1) + +def merge(hpath): + global inhistos + global outhistos + try: + fillAbove(outhistos[hpath], inhistos[hpath]) + except: + pass + +def useOne(hpath, sqrts): + global inhistos + global outhistos + try: + outhistos[hpath] = inhistos[hpath][float(sqrts)] + except: + pass + +if __name__ == "__main__": + import logging + from optparse import OptionParser, OptionGroup + parser = OptionParser(usage="%prog name") + verbgroup = OptionGroup(parser, "Verbosity control") + verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", + default=logging.INFO, help="print debug (very verbose) messages") + verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", + default=logging.INFO, help="be very quiet") + parser.add_option_group(verbgroup) + (opts, args) = parser.parse_args() + logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") + ## Check args + if len(args) < 1: + logging.error("Must specify at least the name of the files") + sys.exit(1) + +####################################### + +yodafiles=["-Direct-mumu-161","-Direct-mumu-172","-Direct-mumu-183", + "-Direct-mumu-189","-Direct-mumu-196","-Direct-mumu-206", + "-Direct-tautau-189","-Direct-tautau-196","-Direct-tautau-206", + "-Direct-Jets-198","-Single-Resolved-Jets-198","-Double-Resolved-Jets-198", + "-Direct-Jets-206","-Single-Resolved-Jets-206","-Double-Resolved-Jets-206",] + +# Get histos +inhistos = {} +outhistos = {} +for f in yodafiles: + file = "Rivet-%s%s.yoda" % (args[0], f) + sqrts=float(f.split("-")[-1].replace(".yoda","")) + if not os.access(file, os.R_OK): + logging.error("%s cannot be read" % file) + continue + try: + aos = yoda.read(file) + except: + logging.error("%s cannot be parsed as yoda" % file) + continue + ## Get histos from this YODA file + for aopath, ao in aos.iteritems() : + if("RAW" in aopath or "_XSEC" in aopath or "_EVTCOUNT" in aopath ) :continue + # merge of different energy values + if("L3_2004_I645127" in aopath) : + if(("d01" in aopath and "mu" in file) or + ("d02" in aopath and "tau" in file)) : + if not inhistos.has_key(aopath): + inhistos[aopath] = {} + if not inhistos[aopath].has_key(sqrts): + inhistos[aopath][sqrts] = ao + else: + raise Exception("A set with sqrts = %s already exists" % ( sqrts)) + else : + if(aopath in outhistos) : + outhistos[aopath] += ao + else : + outhistos[aopath] = ao +## Make empty output histos if needed +for hpath,hsets in inhistos.iteritems(): + if("L3_2004_I645127" in hpath ) : + if(type(hsets.values()[0])==yoda.core.Scatter2D) : + outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].path, + hsets.values()[0].title) + elif(type(hsets.values()[0])==yoda.core.Profile1D) : + outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].path, + hsets.values()[0].title) + for i in range(0,hsets.values()[0].numBins) : + outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, + hsets.values()[0].bins[i].xMax) + elif(type(hsets.values()[0])==yoda.core.Histo1D) : + outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].path, + hsets.values()[0].title) + for i in range(0,hsets.values()[0].numBins) : + outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, + hsets.values()[0].bins[i].xMax) + else : + logging.error("Histogram %s is of unknown type" % hpath) + sys.exit(1) + +merge("/L3_2004_I645127/d01-x01-y01") +merge("/L3_2004_I645127/d01-x01-y02") +merge("/L3_2004_I645127/d02-x01-y01") + + +# Choose output file +name = args[0]+".yoda" +# output the yoda file +print "Write yoda to ",name +yoda.writeYODA(outhistos,name) +sys.exit(0) diff --git a/Tests/python/merge-LEP b/Tests/python/merge-LEP deleted file mode 100755 --- a/Tests/python/merge-LEP +++ /dev/null @@ -1,900 +0,0 @@ -#! /usr/bin/env python -# import lighthisto -import logging -import sys - -if sys.version_info[:3] < (2,4,0): - print "rivet scripts require Python version >= 2.4.0... exiting" - sys.exit(1) - -import os, yoda, copy - -# # ############################################# - -def fillAbove(desthisto, sourcehistosbysqrts): - if type(desthisto) is yoda.core.Scatter2D : - for sqrts in sorted(sourcehistosbysqrts.keys()) : - h=sourcehistosbysqrts[sqrts] - for i in range(0,h.numPoints) : - if sqrts==h.points[i].x : - desthisto.addPoint(h.points[i]) - - elif(type(desthisto)==yoda.core.Profile1D) : - for sqrts, h in sorted(sourcehistosbysqrts.iteritems()) : - for i in range(0,h.numBins) : - if(sqrts>=h.bins[i].xMin and \ - sqrts<=h.bins[i].xMax) : - desthisto.bins[i] += h.bins[i] - break - else : - logging.error("Unknown analysis object" + desthisto.path) - sys.exit(1) - -def merge(hpath): - global inhistos - global outhistos - try: - fillAbove(outhistos[hpath], inhistos[hpath]) - except: - pass - -def useOne(hpath, sqrts): - global inhistos - global outhistos - try: - outhistos[hpath] = inhistos[hpath][float(sqrts)] - except: - pass - -if __name__ == "__main__": - import logging - from optparse import OptionParser, OptionGroup - parser = OptionParser(usage="%prog name") - verbgroup = OptionGroup(parser, "Verbosity control") - verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", - default=logging.INFO, help="print debug (very verbose) messages") - verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", - default=logging.INFO, help="be very quiet") - parser.add_option_group(verbgroup) - parser.add_option("--with-gg", - action='store_true' , - dest="gg", - default=False, - help="Include gg analyese") - parser.add_option("--without-gg", - action='store_false', - dest="gg", - default=False, - help="Don\'t include gg analyses") - (opts, args) = parser.parse_args() - logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") - ## Check args - if len(args) < 1: - logging.error("Must specify at least the name of the files") - sys.exit(1) - -####################################### - -yodafiles=["-130","-133","-136","-177","-192", - "-196","-202","-206","-91" ,"-91-nopi" ,\ - "-161","-183","-197","-35" ,"-172",\ - "-189","-200","-44","-14","-22","-10",\ - "-12.8","-26.8","-48.0","-93.0",\ - "-12","-13","-17","-27.6","-29","-30.2",\ - "-30.7","-30","-31.3","-34.8","-43.6","-50","-52",\ - "-55","-56","-57","-60.8","-60","-61.4","-9.4","-45","-66","-76","-41","-82","-85"] -# add gg if needed -if(opts.gg) : - yodafiles += ["-10.5-gg","-12.8-gg","-16.86-gg","-26.8-gg",\ - "-35.44-gg","-97.0-gg","-11.96-gg","-13.96-gg",\ - "-21.84-gg","-28.48-gg","-48.0-gg"] -## Get histos -inhistos = {} -outhistos={} -for f in yodafiles: - file = "Rivet-%s%s.yoda" % (args[0], f) - sqrts=float(f.split("-")[1].replace(".yoda","")) - if not os.access(file, os.R_OK): - logging.error("%s cannot be read" % file) - continue - try: - aos = yoda.read(file) - except: - logging.error("%s cannot be parsed as yoda" % file) - continue - ## Get histos from this YODA file - for aopath, ao in aos.iteritems() : - if("RAW" in aopath) :continue - # jet shapes - if(aopath.find("4300807")>0 or aopath.find("6132243")>0 or - aopath.find("5765862")>0 or aopath.find("3612880")>0 or - aopath.find("4328825")>0 or aopath.find("5361494")>0 or - aopath.find("2148048")>0 or aopath.find("295160")>0 or - aopath.find("190818" )>0 or aopath.find("154270")>0 or - aopath.find("277658")>0 or - aopath.find("MULTIPLICITIES")>0) : - if not inhistos.has_key(aopath): - inhistos[aopath] = {} - if not inhistos[aopath].has_key(sqrts): - inhistos[aopath][sqrts] = ao - else: - raise Exception("A set with sqrts = %s already exists" % ( sqrts)) - elif(aopath.find("OPAL_2004_I648738")>=0) : - if(file.find("gg")>=0) : - if(aopath.find("y03")>=0) : - outhistos[aopath] = ao - else : - if(aopath.find("y03")<0) : - outhistos[aopath] = ao - else : - outhistos[aopath] = ao - -# ## Make empty output histos if needed -for hpath,hsets in inhistos.iteritems(): - if( hpath.find("4300807")>0 or hpath.find("6132243")>0 or - hpath.find("5765862")>0 or hpath.find("295160")>0 or - hpath.find("4328825")>0 or hpath.find("5361494")>0 or - hpath.find("190818")>0 or hpath.find("154270")>0 or - hpath.find("277658")>0) : - if(type(hsets.values()[0])==yoda.core.Scatter2D) : - outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].path, - hsets.values()[0].title) - elif(type(hsets.values()[0])==yoda.core.Profile1D) : - outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].path, - hsets.values()[0].title) - for i in range(0,hsets.values()[0].numBins) : - outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, - hsets.values()[0].bins[i].xMax) - elif(type(hsets.values()[0])==yoda.core.Histo1D) : - outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].path, - hsets.values()[0].title) - for i in range(0,hsets.values()[0].numBins) : - outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, - hsets.values()[0].bins[i].xMax) - else : - logging.error("Histogram %s is of unknown type" % hpath) - sys.exit(1) - -# tasso -useOne("/TASSO_1990_S2148048/d06-x01-y01","14") -useOne("/TASSO_1990_S2148048/d07-x01-y01","14") -useOne("/TASSO_1990_S2148048/d08-x01-y01","14") -useOne("/TASSO_1990_S2148048/d06-x01-y02","22") -useOne("/TASSO_1990_S2148048/d07-x01-y02","22") -useOne("/TASSO_1990_S2148048/d08-x01-y02","22") -useOne("/TASSO_1990_S2148048/d06-x01-y03","35") -useOne("/TASSO_1990_S2148048/d07-x01-y03","35") -useOne("/TASSO_1990_S2148048/d08-x01-y03","35") -useOne("/TASSO_1990_S2148048/d06-x01-y04","44") -useOne("/TASSO_1990_S2148048/d07-x01-y04","44") -useOne("/TASSO_1990_S2148048/d08-x01-y04","44") -# jade -useOne("/JADE_1998_S3612880/d02-x01-y01","44") -useOne("/JADE_1998_S3612880/d03-x01-y01","44") -useOne("/JADE_1998_S3612880/d04-x01-y01","44") -useOne("/JADE_1998_S3612880/d05-x01-y01","44") -useOne("/JADE_1998_S3612880/d06-x01-y01","35") -useOne("/JADE_1998_S3612880/d07-x01-y01","35") -useOne("/JADE_1998_S3612880/d08-x01-y01","35") -useOne("/JADE_1998_S3612880/d09-x01-y01","35") -useOne("/JADE_1998_S3612880/d10-x01-y01","44") -useOne("/JADE_1998_S3612880/d11-x01-y01","35") -useOne("/JADE_1998_S3612880/d12-x01-y01","22") -# opal/jade -useOne("/JADE_OPAL_2000_S4300807/d07-x01-y01","35") -useOne("/JADE_OPAL_2000_S4300807/d07-x01-y02","35") -useOne("/JADE_OPAL_2000_S4300807/d07-x01-y03","35") -useOne("/JADE_OPAL_2000_S4300807/d07-x01-y04","35") -useOne("/JADE_OPAL_2000_S4300807/d07-x01-y05","35") -useOne("/JADE_OPAL_2000_S4300807/d08-x01-y01","44") -useOne("/JADE_OPAL_2000_S4300807/d08-x01-y02","44") -useOne("/JADE_OPAL_2000_S4300807/d08-x01-y03","44") -useOne("/JADE_OPAL_2000_S4300807/d08-x01-y04","44") -useOne("/JADE_OPAL_2000_S4300807/d08-x01-y05","44") -useOne("/JADE_OPAL_2000_S4300807/d09-x01-y01","91") -useOne("/JADE_OPAL_2000_S4300807/d09-x01-y02","91") -useOne("/JADE_OPAL_2000_S4300807/d09-x01-y03","91") -useOne("/JADE_OPAL_2000_S4300807/d09-x01-y04","91") -useOne("/JADE_OPAL_2000_S4300807/d09-x01-y05","91") -useOne("/JADE_OPAL_2000_S4300807/d10-x01-y01","133") -useOne("/JADE_OPAL_2000_S4300807/d10-x01-y02","133") -useOne("/JADE_OPAL_2000_S4300807/d10-x01-y03","133") -useOne("/JADE_OPAL_2000_S4300807/d10-x01-y04","133") -useOne("/JADE_OPAL_2000_S4300807/d10-x01-y05","133") -useOne("/JADE_OPAL_2000_S4300807/d11-x01-y01","161") -useOne("/JADE_OPAL_2000_S4300807/d11-x01-y02","161") -useOne("/JADE_OPAL_2000_S4300807/d11-x01-y03","161") -useOne("/JADE_OPAL_2000_S4300807/d11-x01-y04","161") -useOne("/JADE_OPAL_2000_S4300807/d11-x01-y05","161") -useOne("/JADE_OPAL_2000_S4300807/d12-x01-y01","172") -useOne("/JADE_OPAL_2000_S4300807/d12-x01-y02","172") -useOne("/JADE_OPAL_2000_S4300807/d12-x01-y03","172") -useOne("/JADE_OPAL_2000_S4300807/d12-x01-y04","172") -useOne("/JADE_OPAL_2000_S4300807/d12-x01-y05","172") -useOne("/JADE_OPAL_2000_S4300807/d13-x01-y01","183") -useOne("/JADE_OPAL_2000_S4300807/d13-x01-y02","183") -useOne("/JADE_OPAL_2000_S4300807/d13-x01-y03","183") -useOne("/JADE_OPAL_2000_S4300807/d13-x01-y04","183") -useOne("/JADE_OPAL_2000_S4300807/d13-x01-y05","183") -useOne("/JADE_OPAL_2000_S4300807/d14-x01-y01","189") -useOne("/JADE_OPAL_2000_S4300807/d14-x01-y02","189") -useOne("/JADE_OPAL_2000_S4300807/d14-x01-y03","189") -useOne("/JADE_OPAL_2000_S4300807/d14-x01-y04","189") -useOne("/JADE_OPAL_2000_S4300807/d14-x01-y05","189") -useOne("/JADE_OPAL_2000_S4300807/d16-x01-y01","35") -useOne("/JADE_OPAL_2000_S4300807/d16-x01-y02","35") -useOne("/JADE_OPAL_2000_S4300807/d16-x01-y03","35") -useOne("/JADE_OPAL_2000_S4300807/d16-x01-y04","35") -useOne("/JADE_OPAL_2000_S4300807/d16-x01-y05","35") -useOne("/JADE_OPAL_2000_S4300807/d17-x01-y01","44") -useOne("/JADE_OPAL_2000_S4300807/d17-x01-y02","44") -useOne("/JADE_OPAL_2000_S4300807/d17-x01-y03","44") -useOne("/JADE_OPAL_2000_S4300807/d17-x01-y04","44") -useOne("/JADE_OPAL_2000_S4300807/d17-x01-y05","44") -useOne("/JADE_OPAL_2000_S4300807/d18-x01-y01","91") -useOne("/JADE_OPAL_2000_S4300807/d18-x01-y02","91") -useOne("/JADE_OPAL_2000_S4300807/d18-x01-y03","91") -useOne("/JADE_OPAL_2000_S4300807/d18-x01-y04","91") -useOne("/JADE_OPAL_2000_S4300807/d18-x01-y05","91") -useOne("/JADE_OPAL_2000_S4300807/d19-x01-y01","133") -useOne("/JADE_OPAL_2000_S4300807/d19-x01-y02","133") -useOne("/JADE_OPAL_2000_S4300807/d19-x01-y03","133") -useOne("/JADE_OPAL_2000_S4300807/d19-x01-y04","133") -useOne("/JADE_OPAL_2000_S4300807/d19-x01-y05","133") -useOne("/JADE_OPAL_2000_S4300807/d20-x01-y01","161") -useOne("/JADE_OPAL_2000_S4300807/d20-x01-y02","161") -useOne("/JADE_OPAL_2000_S4300807/d20-x01-y03","161") -useOne("/JADE_OPAL_2000_S4300807/d20-x01-y04","161") -useOne("/JADE_OPAL_2000_S4300807/d20-x01-y05","161") -useOne("/JADE_OPAL_2000_S4300807/d21-x01-y01","172") -useOne("/JADE_OPAL_2000_S4300807/d21-x01-y02","172") -useOne("/JADE_OPAL_2000_S4300807/d21-x01-y03","172") -useOne("/JADE_OPAL_2000_S4300807/d21-x01-y04","172") -useOne("/JADE_OPAL_2000_S4300807/d21-x01-y05","172") -useOne("/JADE_OPAL_2000_S4300807/d22-x01-y01","183") -useOne("/JADE_OPAL_2000_S4300807/d22-x01-y02","183") -useOne("/JADE_OPAL_2000_S4300807/d22-x01-y03","183") -useOne("/JADE_OPAL_2000_S4300807/d22-x01-y04","183") -useOne("/JADE_OPAL_2000_S4300807/d22-x01-y05","183") -useOne("/JADE_OPAL_2000_S4300807/d23-x01-y01","189") -useOne("/JADE_OPAL_2000_S4300807/d23-x01-y02","189") -useOne("/JADE_OPAL_2000_S4300807/d23-x01-y03","189") -useOne("/JADE_OPAL_2000_S4300807/d23-x01-y04","189") -useOne("/JADE_OPAL_2000_S4300807/d23-x01-y05","189") -useOne("/JADE_OPAL_2000_S4300807/d24-x01-y01","35") -useOne("/JADE_OPAL_2000_S4300807/d24-x01-y02","35") -useOne("/JADE_OPAL_2000_S4300807/d24-x01-y03","35") -useOne("/JADE_OPAL_2000_S4300807/d24-x01-y04","35") -useOne("/JADE_OPAL_2000_S4300807/d25-x01-y01","44") -useOne("/JADE_OPAL_2000_S4300807/d25-x01-y02","44") -useOne("/JADE_OPAL_2000_S4300807/d25-x01-y03","44") -useOne("/JADE_OPAL_2000_S4300807/d25-x01-y04","44") -useOne("/JADE_OPAL_2000_S4300807/d26-x01-y01","91") -useOne("/JADE_OPAL_2000_S4300807/d26-x01-y02","91") -useOne("/JADE_OPAL_2000_S4300807/d26-x01-y03","91") -useOne("/JADE_OPAL_2000_S4300807/d26-x01-y04","91") -useOne("/JADE_OPAL_2000_S4300807/d27-x01-y01","133") -useOne("/JADE_OPAL_2000_S4300807/d27-x01-y02","133") -useOne("/JADE_OPAL_2000_S4300807/d27-x01-y03","133") -useOne("/JADE_OPAL_2000_S4300807/d27-x01-y04","133") -useOne("/JADE_OPAL_2000_S4300807/d28-x01-y01","161") -useOne("/JADE_OPAL_2000_S4300807/d28-x01-y02","161") -useOne("/JADE_OPAL_2000_S4300807/d28-x01-y03","161") -useOne("/JADE_OPAL_2000_S4300807/d28-x01-y04","161") -useOne("/JADE_OPAL_2000_S4300807/d29-x01-y01","172") -useOne("/JADE_OPAL_2000_S4300807/d29-x01-y02","172") -useOne("/JADE_OPAL_2000_S4300807/d29-x01-y03","172") -useOne("/JADE_OPAL_2000_S4300807/d29-x01-y04","172") -useOne("/JADE_OPAL_2000_S4300807/d30-x01-y01","183") -useOne("/JADE_OPAL_2000_S4300807/d30-x01-y02","183") -useOne("/JADE_OPAL_2000_S4300807/d30-x01-y03","183") -useOne("/JADE_OPAL_2000_S4300807/d30-x01-y04","183") -useOne("/JADE_OPAL_2000_S4300807/d31-x01-y01","189") -useOne("/JADE_OPAL_2000_S4300807/d31-x01-y02","189") -useOne("/JADE_OPAL_2000_S4300807/d31-x01-y03","189") -useOne("/JADE_OPAL_2000_S4300807/d31-x01-y04","189") - -useOne("/OPAL_2004_S6132243/d01-x01-y01","91") -useOne("/OPAL_2004_S6132243/d01-x01-y02","133") -useOne("/OPAL_2004_S6132243/d01-x01-y03","177") -useOne("/OPAL_2004_S6132243/d01-x01-y04","197") -useOne("/OPAL_2004_S6132243/d02-x01-y01","91") -useOne("/OPAL_2004_S6132243/d02-x01-y02","133") -useOne("/OPAL_2004_S6132243/d02-x01-y03","177") -useOne("/OPAL_2004_S6132243/d02-x01-y04","197") -useOne("/OPAL_2004_S6132243/d03-x01-y01","91") -useOne("/OPAL_2004_S6132243/d03-x01-y02","133") -useOne("/OPAL_2004_S6132243/d03-x01-y03","177") -useOne("/OPAL_2004_S6132243/d03-x01-y04","197") -useOne("/OPAL_2004_S6132243/d04-x01-y01","91") -useOne("/OPAL_2004_S6132243/d04-x01-y02","133") -useOne("/OPAL_2004_S6132243/d04-x01-y03","177") -useOne("/OPAL_2004_S6132243/d04-x01-y04","197") -useOne("/OPAL_2004_S6132243/d05-x01-y01","91") -useOne("/OPAL_2004_S6132243/d05-x01-y02","133") -useOne("/OPAL_2004_S6132243/d05-x01-y03","177") -useOne("/OPAL_2004_S6132243/d05-x01-y04","197") -useOne("/OPAL_2004_S6132243/d06-x01-y01","91") -useOne("/OPAL_2004_S6132243/d06-x01-y02","133") -useOne("/OPAL_2004_S6132243/d06-x01-y03","177") -useOne("/OPAL_2004_S6132243/d06-x01-y04","197") -useOne("/OPAL_2004_S6132243/d07-x01-y01","91") -useOne("/OPAL_2004_S6132243/d07-x01-y02","133") -useOne("/OPAL_2004_S6132243/d07-x01-y03","177") -useOne("/OPAL_2004_S6132243/d07-x01-y04","197") -useOne("/OPAL_2004_S6132243/d08-x01-y01","91") -useOne("/OPAL_2004_S6132243/d08-x01-y02","133") -useOne("/OPAL_2004_S6132243/d08-x01-y03","177") -useOne("/OPAL_2004_S6132243/d08-x01-y04","197") -useOne("/OPAL_2004_S6132243/d09-x01-y01","91") -useOne("/OPAL_2004_S6132243/d09-x01-y02","133") -useOne("/OPAL_2004_S6132243/d09-x01-y03","177") -useOne("/OPAL_2004_S6132243/d09-x01-y04","197") -useOne("/OPAL_2004_S6132243/d10-x01-y01","91") -useOne("/OPAL_2004_S6132243/d10-x01-y02","133") -useOne("/OPAL_2004_S6132243/d10-x01-y03","177") -useOne("/OPAL_2004_S6132243/d10-x01-y04","197") -useOne("/OPAL_2004_S6132243/d11-x01-y01","91") -useOne("/OPAL_2004_S6132243/d11-x01-y02","133") -useOne("/OPAL_2004_S6132243/d11-x01-y03","177") -useOne("/OPAL_2004_S6132243/d11-x01-y04","197") -useOne("/OPAL_2004_S6132243/d12-x01-y01","91") -useOne("/OPAL_2004_S6132243/d12-x01-y02","133") -useOne("/OPAL_2004_S6132243/d12-x01-y03","177") -useOne("/OPAL_2004_S6132243/d12-x01-y04","197") -useOne("/OPAL_2004_S6132243/d13-x01-y01","91") -useOne("/OPAL_2004_S6132243/d13-x01-y02","133") -useOne("/OPAL_2004_S6132243/d13-x01-y03","177") -useOne("/OPAL_2004_S6132243/d13-x01-y04","197") -useOne("/OPAL_2004_S6132243/d14-x01-y01","91") -useOne("/OPAL_2004_S6132243/d14-x01-y02","133") -useOne("/OPAL_2004_S6132243/d14-x01-y03","177") -useOne("/OPAL_2004_S6132243/d14-x01-y04","197") -useOne("/OPAL_2004_S6132243/d15-x01-y01","91") -useOne("/OPAL_2004_S6132243/d15-x01-y02","133") -useOne("/OPAL_2004_S6132243/d15-x01-y03","177") -useOne("/OPAL_2004_S6132243/d15-x01-y04","197") -useOne("/OPAL_2004_S6132243/d16-x01-y01","91") -useOne("/OPAL_2004_S6132243/d16-x01-y02","133") -useOne("/OPAL_2004_S6132243/d16-x01-y03","177") -useOne("/OPAL_2004_S6132243/d16-x01-y04","197") -useOne("/OPAL_2004_S6132243/d17-x01-y01","91") -useOne("/OPAL_2004_S6132243/d17-x01-y02","133") -useOne("/OPAL_2004_S6132243/d17-x01-y03","177") -useOne("/OPAL_2004_S6132243/d17-x01-y04","197") -useOne("/OPAL_2004_S6132243/d18-x01-y01","91") -useOne("/OPAL_2004_S6132243/d18-x01-y02","133") -useOne("/OPAL_2004_S6132243/d18-x01-y03","177") -useOne("/OPAL_2004_S6132243/d18-x01-y04","197") -useOne("/OPAL_2004_S6132243/d19-x01-y01","91") -useOne("/OPAL_2004_S6132243/d19-x01-y02","133") -useOne("/OPAL_2004_S6132243/d19-x01-y03","177") -useOne("/OPAL_2004_S6132243/d19-x01-y04","197") -useOne("/OPAL_2004_S6132243/d20-x01-y01","91") -useOne("/OPAL_2004_S6132243/d20-x01-y02","133") -useOne("/OPAL_2004_S6132243/d20-x01-y03","177") -useOne("/OPAL_2004_S6132243/d20-x01-y04","197") -useOne("/OPAL_2004_S6132243/d21-x01-y01","91") -useOne("/OPAL_2004_S6132243/d21-x01-y02","133") -useOne("/OPAL_2004_S6132243/d21-x01-y03","177") -useOne("/OPAL_2004_S6132243/d21-x01-y04","197") -useOne("/OPAL_2004_S6132243/d22-x01-y01","91") -useOne("/OPAL_2004_S6132243/d22-x01-y02","133") -useOne("/OPAL_2004_S6132243/d22-x01-y03","177") -useOne("/OPAL_2004_S6132243/d22-x01-y04","197") -useOne("/OPAL_2004_S6132243/d23-x01-y01","91") -useOne("/OPAL_2004_S6132243/d23-x01-y02","133") -useOne("/OPAL_2004_S6132243/d23-x01-y03","177") -useOne("/OPAL_2004_S6132243/d23-x01-y04","197") -useOne("/OPAL_2004_S6132243/d24-x01-y01","91") -useOne("/OPAL_2004_S6132243/d24-x01-y02","133") -useOne("/OPAL_2004_S6132243/d24-x01-y03","177") -useOne("/OPAL_2004_S6132243/d24-x01-y04","197") -useOne("/OPAL_2004_S6132243/d25-x01-y01","91") -useOne("/OPAL_2004_S6132243/d25-x01-y02","133") -useOne("/OPAL_2004_S6132243/d25-x01-y03","177") -useOne("/OPAL_2004_S6132243/d25-x01-y04","197") -useOne("/OPAL_2004_S6132243/d26-x01-y01","91") -useOne("/OPAL_2004_S6132243/d26-x01-y02","133") -useOne("/OPAL_2004_S6132243/d26-x01-y03","177") -useOne("/OPAL_2004_S6132243/d26-x01-y04","197") - -merge( "/OPAL_2002_S5361494/d01-x01-y01") -merge( "/OPAL_2002_S5361494/d01-x01-y02") -merge( "/OPAL_2002_S5361494/d01-x01-y03") -merge( "/OPAL_2002_S5361494/d01-x01-y04") -merge("/DELPHI_2000_S4328825/d01-x01-y01") -merge("/DELPHI_2000_S4328825/d01-x01-y02") -merge("/DELPHI_2000_S4328825/d01-x01-y03") -merge("/DELPHI_2000_S4328825/d01-x01-y04") -merge("/ALEPH_2004_S5765862/d01-x01-y01") -useOne("/ALEPH_2004_S5765862/d02-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d03-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d04-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d05-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d06-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d07-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d08-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d09-x01-y01","206") - -useOne("/ALEPH_2004_S5765862/d11-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d12-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d13-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d14-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d15-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d16-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d17-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d18-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d19-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d20-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d21-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d22-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d23-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d24-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d25-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d26-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d27-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d28-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d29-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d30-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d31-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d32-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d33-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d34-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d35-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d36-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d37-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d38-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d39-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d40-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d41-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d42-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d43-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d44-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d45-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d46-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d47-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d48-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d49-x01-y01","196") -useOne("/ALEPH_2004_S5765862/d50-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d51-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d54-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d55-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d56-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d57-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d58-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d59-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d60-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d61-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d62-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d63-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d64-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d65-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d66-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d67-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d68-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d69-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d70-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d71-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d72-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d73-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d74-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d75-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d76-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d77-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d78-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d79-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d80-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d81-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d82-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d83-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d84-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d85-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d86-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d87-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d88-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d89-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d90-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d91-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d92-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d93-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d94-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d95-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d96-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d97-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d98-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d99-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d100-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d101-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d102-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d103-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d104-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d105-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d106-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d107-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d108-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d109-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d110-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d111-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d112-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d113-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d114-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d115-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d116-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d117-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d118-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d119-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d120-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d121-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d122-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d123-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d124-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d125-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d126-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d127-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d128-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d129-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d130-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d131-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d132-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d133-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d134-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d135-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d136-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d137-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d138-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d139-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d140-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d141-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d142-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d143-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d144-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d145-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d146-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d147-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d148-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d149-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d150-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d151-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d152-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d153-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d154-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d155-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d156-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d157-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d158-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d159-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d160-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d161-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d162-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d163-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d164-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d165-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d166-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d167-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d168-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d169-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d170-x01-y01","189") - -useOne("/ALEPH_2004_S5765862/d172-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d173-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d174-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d175-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d176-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d177-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d178-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d179-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d180-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d181-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d182-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d183-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d184-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d185-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d186-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d187-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d188-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d189-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d190-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d191-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d192-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d193-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d194-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d195-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d196-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d197-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d198-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d199-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d200-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d201-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d202-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d203-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d204-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d205-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d206-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d207-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d208-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d209-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d210-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d211-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d212-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d213-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d214-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d215-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d216-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d217-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d218-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d219-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d220-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d221-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d222-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d223-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d224-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d225-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d226-x01-y01","206") -useOne("/ALEPH_2004_S5765862/d227-x01-y01","91") -useOne("/ALEPH_2004_S5765862/d228-x01-y01","133") -useOne("/ALEPH_2004_S5765862/d229-x01-y01","161") -useOne("/ALEPH_2004_S5765862/d230-x01-y01","172") -useOne("/ALEPH_2004_S5765862/d231-x01-y01","183") -useOne("/ALEPH_2004_S5765862/d232-x01-y01","189") -useOne("/ALEPH_2004_S5765862/d233-x01-y01","200") -useOne("/ALEPH_2004_S5765862/d234-x01-y01","206") - -# hadron multiplicities -useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d17-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d22-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d23-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d25-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d40-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d45-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d49-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d53-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES/d54-x01-y01","10") - -useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d22-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d33-x01-y01","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d34-x01-y01","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y02","35") - -useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d02-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d05-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d06-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d07-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d08-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d09-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d10-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d11-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d12-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d13-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d14-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d15-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d16-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d17-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d18-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d19-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d20-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d21-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d23-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d24-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d25-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d26-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d27-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d28-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d29-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d30-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d31-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d32-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d34-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d35-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d36-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d37-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d40-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d41-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d42-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d43-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d44-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d45-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d46-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d47-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d48-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d49-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d50-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d51-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d52-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d54-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES/d01-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES/d03-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES/d04-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES/d38-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES/d39-x01-y04","177") - -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y01","10" ) -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d53-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y01","10") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d33-x01-y01","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y01","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y02","35") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d10-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d11-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d12-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d14-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d16-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d24-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d26-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d27-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d28-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d29-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d30-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d32-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d35-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d36-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d37-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d41-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d42-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d43-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y03","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d52-x01-y01","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y02","91") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y04","177") -useOne("/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y04","177") -# AMY analysis -useOne("/AMY_1990_I295160/d01-x01-y01","50") -useOne("/AMY_1990_I295160/d01-x01-y02","52") -useOne("/AMY_1990_I295160/d01-x01-y03","55") -useOne("/AMY_1990_I295160/d01-x01-y04","56") -useOne("/AMY_1990_I295160/d01-x01-y05","57") -useOne("/AMY_1990_I295160/d01-x01-y06","60") -useOne("/AMY_1990_I295160/d01-x01-y07","60.8") -useOne("/AMY_1990_I295160/d01-x01-y08","61.4") -useOne("/AMY_1990_I295160/d01-x01-y09","57") -useOne("/AMY_1990_I295160/d02-x02-y01","57") -merge("/AMY_1990_I295160/d02-x01-y01") -merge("/JADE_1983_I190818/d01-x01-y01") -merge("/PLUTO_1980_I154270/d01-x01-y01") - -merge("/TASSO_1989_I277658/d02-x01-y01") -useOne("/TASSO_1989_I277658/d05-x01-y01","14") -useOne("/TASSO_1989_I277658/d05-x01-y02","22") -useOne("/TASSO_1989_I277658/d05-x01-y03","34.8") -useOne("/TASSO_1989_I277658/d05-x01-y04","43.6") -# Choose output file -name = args[0]+".yoda" -# output the yoda file -# print "Write yoda to ",name -yoda.writeYODA(outhistos,name) -sys.exit(0) diff --git a/Tests/python/merge-LEP-Gamma b/Tests/python/merge-LEP-Gamma deleted file mode 100755 --- a/Tests/python/merge-LEP-Gamma +++ /dev/null @@ -1,136 +0,0 @@ -#! /usr/bin/env python -import logging,sys -import os, yoda, copy - -if sys.version_info[:3] < (2,4,0): - print "rivet scripts require Python version >= 2.4.0... exiting" - sys.exit(1) - - -############################################# - -def fillAbove(desthisto, sourcehistosbysqrts): - if type(desthisto) is yoda.core.Scatter2D : - for sqrts in sorted(sourcehistosbysqrts.keys()) : - h=sourcehistosbysqrts[sqrts] - for i in range(0,h.numPoints) : - if sqrts==h.points[i].x : - desthisto.addPoint(h.points[i]) - - elif(type(desthisto)==yoda.core.Profile1D) : - for sqrts, h in sorted(sourcehistosbysqrts.iteritems()) : - for i in range(0,h.numBins) : - if(sqrts>=h.bins[i].xMin and \ - sqrts<=h.bins[i].xMax) : - desthisto.bins[i] += h.bins[i] - break - else : - logging.error("Unknown analysis object" + desthisto.path) - sys.exit(1) - -def merge(hpath): - global inhistos - global outhistos - try: - fillAbove(outhistos[hpath], inhistos[hpath]) - except: - pass - -def useOne(hpath, sqrts): - global inhistos - global outhistos - try: - outhistos[hpath] = inhistos[hpath][float(sqrts)] - except: - pass - -if __name__ == "__main__": - import logging - from optparse import OptionParser, OptionGroup - parser = OptionParser(usage="%prog name") - verbgroup = OptionGroup(parser, "Verbosity control") - verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", - default=logging.INFO, help="print debug (very verbose) messages") - verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", - default=logging.INFO, help="be very quiet") - parser.add_option_group(verbgroup) - (opts, args) = parser.parse_args() - logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") - ## Check args - if len(args) < 1: - logging.error("Must specify at least the name of the files") - sys.exit(1) - -####################################### - -yodafiles=["-Direct-mumu-161","-Direct-mumu-172","-Direct-mumu-183", - "-Direct-mumu-189","-Direct-mumu-196","-Direct-mumu-206", - "-Direct-tautau-189","-Direct-tautau-196","-Direct-tautau-206", - "-Direct-Jets-198","-Single-Resolved-Jets-198","-Double-Resolved-Jets-198", - "-Direct-Jets-206","-Single-Resolved-Jets-206","-Double-Resolved-Jets-206",] - -# Get histos -inhistos = {} -outhistos = {} -for f in yodafiles: - file = "Rivet-%s%s.yoda" % (args[0], f) - sqrts=float(f.split("-")[-1].replace(".yoda","")) - if not os.access(file, os.R_OK): - logging.error("%s cannot be read" % file) - continue - try: - aos = yoda.read(file) - except: - logging.error("%s cannot be parsed as yoda" % file) - continue - ## Get histos from this YODA file - for aopath, ao in aos.iteritems() : - if("RAW" in aopath or "_XSEC" in aopath or "_EVTCOUNT" in aopath ) :continue - # merge of different energy values - if("L3_2004_I645127" in aopath) : - if(("d01" in aopath and "mu" in file) or - ("d02" in aopath and "tau" in file)) : - if not inhistos.has_key(aopath): - inhistos[aopath] = {} - if not inhistos[aopath].has_key(sqrts): - inhistos[aopath][sqrts] = ao - else: - raise Exception("A set with sqrts = %s already exists" % ( sqrts)) - else : - if(aopath in outhistos) : - outhistos[aopath] += ao - else : - outhistos[aopath] = ao -## Make empty output histos if needed -for hpath,hsets in inhistos.iteritems(): - if("L3_2004_I645127" in hpath ) : - if(type(hsets.values()[0])==yoda.core.Scatter2D) : - outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].path, - hsets.values()[0].title) - elif(type(hsets.values()[0])==yoda.core.Profile1D) : - outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].path, - hsets.values()[0].title) - for i in range(0,hsets.values()[0].numBins) : - outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, - hsets.values()[0].bins[i].xMax) - elif(type(hsets.values()[0])==yoda.core.Histo1D) : - outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].path, - hsets.values()[0].title) - for i in range(0,hsets.values()[0].numBins) : - outhistos[hpath].addBin(hsets.values()[0].bins[i].xMin, - hsets.values()[0].bins[i].xMax) - else : - logging.error("Histogram %s is of unknown type" % hpath) - sys.exit(1) - -merge("/L3_2004_I645127/d01-x01-y01") -merge("/L3_2004_I645127/d01-x01-y02") -merge("/L3_2004_I645127/d02-x01-y01") - - -# Choose output file -name = args[0]+".yoda" -# output the yoda file -print "Write yoda to ",name -yoda.writeYODA(outhistos,name) -sys.exit(0) diff --git a/Tests/python/merge-LHC-Jets b/Tests/python/merge-LHC-Jets --- a/Tests/python/merge-LHC-Jets +++ b/Tests/python/merge-LHC-Jets @@ -1,1629 +1,1628 @@ #! /usr/bin/env python import logging import sys import math if sys.version_info[:3] < (2,4,0): print "rivet scripts require Python version >= 2.4.0... exiting" sys.exit(1) import os, yoda # ############################################# def rescale(path,scale) : if(path not in outhistos) : return outhistos[path].scaleW(scale) def fillAbove(scale,desthisto, sourcehistosbyptmin) : pthigh= 1e100 ptlow =-1e100 for pt, h in sorted(sourcehistosbyptmin.iteritems(),reverse=True): ptlow=pt if(type(desthisto)==yoda.core.Scatter2D) : for i in range(0,h.numPoints) : xMin = h.points[i].x-h.points[i].xErrs.minus if( xMin*scale >= ptlow and xMin*scale < pthigh ) : desthisto.addPoint(h.points[i]) elif(type(desthisto)==yoda.core.Profile1D) : for i in range(0,h.numBins) : if(h.bins[i].xMin*scale >= ptlow and h.bins[i].xMin*scale < pthigh ) : desthisto.bins[i] += h.bins[i] elif(type(desthisto)==yoda.core.Histo1D) : for i in range(0,h.numBins) : if(h.bins[i].xMin*scale >= ptlow and h.bins[i].xMin*scale < pthigh ) : desthisto.bins[i] += h.bins[i] elif(type(desthisto)==yoda.core.Counter) : desthisto += h else : logging.error("Can't merge %s, unknown type" % desthisto.path) sys.exit(1) pthigh=pt def mergeByPt(hpath, sqrts, scale=1.) : global inhistos_pt global outhistos try: fillAbove(scale,outhistos[hpath], inhistos_pt[hpath][float(sqrts)]) except: pass def mergeByMass(hpath, sqrts, scale=1.): global inhistos_mass global outhistos try: fillAbove(scale,outhistos[hpath], inhistos_mass[hpath][float(sqrts)]) except: pass def useOnePt(hpath, sqrts, ptmin): global inhistos_pt global outhistos try: ## Find best pT_min match ptmins = inhistos_pt[hpath][float(sqrts)].keys() closest_ptmin = None for ptm in ptmins: if closest_ptmin is None or \ abs(ptm-float(ptmin)) < abs(closest_ptmin-float(ptmin)): closest_ptmin = ptm if closest_ptmin != float(ptmin): logging.warning("Inexact match for requested pTmin=%s: " % ptmin + \ "using pTmin=%e instead" % closest_ptmin) outhistos[hpath] = inhistos_pt[hpath][float(sqrts)][closest_ptmin] except: pass def useOneMass(hpath, sqrts, ptmin): global inhistos_pt global outhistos try: ## Find best pT_min match ptmins = inhistos_mass[hpath][float(sqrts)].keys() closest_ptmin = None for ptm in ptmins: if closest_ptmin is None or \ abs(ptm-float(ptmin)) < abs(closest_ptmin-float(ptmin)): closest_ptmin = ptm if closest_ptmin != float(ptmin): logging.warning("Inexact match for requested mass=%s: " % ptmin + \ "using mass=%e instead" % closest_ptmin) outhistos[hpath] = inhistos_mass[hpath][float(sqrts)][closest_ptmin] except: pass # ####################################### if __name__ == "__main__": import logging from optparse import OptionParser, OptionGroup parser = OptionParser(usage="%prog name") verbgroup = OptionGroup(parser, "Verbosity control") parser.add_option("--with-ue", action='store_true' , dest="ue", default=True, help="Include UE analyses") parser.add_option("--without-ue", action='store_false', dest="ue", default=True, help="Don\'t include UE analyses") verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", default=logging.INFO, help="print debug (very verbose) messages") verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", default=logging.INFO, help="be very quiet") parser.add_option_group(verbgroup) (opts, args) = parser.parse_args() logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") (opts, args) = parser.parse_args() ## Check args if len(args) < 1: logging.error("Must specify at least the name of the files") sys.exit(1) yodafiles=["-7-Bottom-0.yoda","-7-Bottom-1.yoda","-7-Bottom-2.yoda", "-7-Bottom-3.yoda","-7-Bottom-4.yoda","-7-Bottom-5.yoda","-7-Bottom-6.yoda", "-7-Charm-1.yoda","-7-Charm-2.yoda", "-7-Charm-3.yoda","-7-Charm-4.yoda","-7-Charm-5.yoda", "-7-Top-SL.yoda","-7-Top-L.yoda", "-8-Top-SL.yoda","-8-Top-L.yoda","-8-Top-All.yoda", "-13-Top-L.yoda","-13-Top-SL.yoda","-13-Top-All.yoda"] for i in range(1,11) : for j in [7,8,13] : yodafiles.append("-%1.1i-Jets-%1.1i.yoda" % (j,i)) for i in range(1,3) : yodafiles.append("-2760-Jets-%1.1i.yoda" % i) if(opts.ue) : yodafiles += ["-7-Jets-0.yoda" ,"-8-Jets-0.yoda" , "-900-UE.yoda" ,"-2360-UE.yoda" , "-2760-UE.yoda" ,"-7-UE.yoda" , "-900-UE-Long.yoda" ,"-8-UE.yoda" , "-7-UE-Long.yoda","-13-UE.yoda","-13-UE-Long.yoda"] ## Get histos inhistos_pt = {} inhistos_mass = {} outhistos={} weights = {} for f in yodafiles: file='Rivet-'+args[0]+f ptmin=0. sqrts=7000 # CMS energy if(file.find("-900-")>0) : sqrts=900 elif(file.find("-2360-")>0) : sqrts=2360 elif(file.find("-2760-")>0) : sqrts=2760 elif(file.find("-7-")>=0) : sqrts=7000 elif(file.find("-8-")>=0) : sqrts=8000 elif(file.find("-13-")>0) : sqrts=13000 # pT min if(file.find("UE")>0) : ptmin=0. elif(file.find("Jets-0")>0) : ptmin=4. elif(file.find("Jets-10")>0) : ptmin=1900. elif(file.find("Jets-1")>0) : if( not opts.ue) : ptmin = 10. else : ptmin = 20. elif(file.find("Jets-2")>0) : ptmin=40. elif(file.find("Jets-3")>0) : ptmin=80. elif(file.find("Jets-4")>0) : ptmin=110. elif(file.find("Jets-5")>0) : ptmin=210. elif(file.find("Jets-6")>0) : ptmin=260. elif(file.find("Jets-7")>0) : ptmin=400. elif(file.find("Jets-8")>0) : ptmin=600. elif(file.find("Jets-9")>0) : ptmin=900. elif(file.find("Bottom-0")>0) : ptmin=0. elif(file.find("Bottom-1")>0 or file.find("Charm-1")>0) : ptmin=10. elif(file.find("Bottom-2")>0 or file.find("Charm-2")>0) : ptmin=20. elif(file.find("Bottom-3")>0 or file.find("Charm-3")>0) : ptmin=30. elif(file.find("Bottom-4")>0 or file.find("Charm-4")>0) : ptmin=70. elif(file.find("Bottom-5")>0 or file.find("Charm-5")>0) : ptmin=100. elif(file.find("Bottom-6")>0 or file.find("Charm-6")>0) : ptmin=130. elif(file.find("Top-SL.yoda")>0 or file.find("Top-L.yoda")>0 or \ file.find("Top-All.yoda")>0): ptmin=0. if not os.access(file, os.R_OK): logging.error("%s can not be read" % file) continue try: aos = yoda.read(file) except: logging.error("%s can not be parsed as YODA" % file) continue ## Get histos from this YODA file for aopath, ao in aos.iteritems() : if("RAW" in aopath) :continue if(aopath.find("S8924791")>0 or aopath.find("S8971293")>0 or aopath.find("S8817804")>0 or aopath.find("I1082936")>0 or aopath.find("S8994773")>0 or aopath.find("S8918562")>0 or aopath.find("S8624100")>0 or aopath.find("S8625980")>0 or aopath.find("S8894728")>0 or aopath.find("S8957746")>0 or aopath.find("S9126244")>0 or aopath.find("S9120041")>0 or aopath.find("S8950903")>0 or aopath.find("S9086218")>0 or aopath.find("S9088458")>0 or aopath.find("I919017" )>0 or aopath.find("I926145" )>0 or aopath.find("S8941262")>0 or aopath.find("S8973270")>0 or aopath.find("I1118269")>0 or aopath.find("I1188891")>0 or aopath.find("I1082009")>0 or aopath.find("I1087342")>0 or aopath.find("S9035664")>0 or aopath.find("I1125575")>0 or aopath.find("I1094564")>0 or aopath.find("I930220" )>0 or aopath.find("I1224539")>0 or aopath.find("I1273574")>0 or aopath.find("I1261026")>0 or aopath.find("I1307243")>0 or aopath.find("I1325553")>0 or aopath.find("I1298810")>0 or aopath.find("I1298811")>0 or aopath.find("I1208923")>0 or aopath.find("I1305624")>0 or aopath.find("I1419070")>0 or aopath.find("I1394679")>0 or aopath.find("I929691" )>0 or aopath.find("I1393758")>0 or aopath.find("I1459051")>0 or aopath.find("I1487277")>0 or aopath.find("I1421646")>0 or aopath.find("I1111014")>0 or aopath.find("I1605749")>0 or aopath.find("I1682495")>0 or aopath.find("I1609253")>0 or aopath.find("1385107" )>0 or aopath.find("I1486238")>0 or aopath.find("1634970" )>0 or aopath.find("ATLAS_2016_CONF_2016_092")>0 or aopath.find("CMS_2012_PAS_QCD_11_010")>0) : if not inhistos_pt.has_key(aopath): inhistos_pt[aopath] = {} tmpE = inhistos_pt[aopath] if not tmpE.has_key(sqrts): tmpE[sqrts] = {} if not tmpE[sqrts].has_key(ptmin): tmpE[sqrts][ptmin] = ao else: tmpE[sqrts][ptmin] += ao #raise Exception("A set with ptmin = %s already exists" % ( ptmin)) else : if(aopath.find("I1243871")>0) : if(aopath.find("x01")>0 and file.find("-7-Top-L.yoda")>0 ) : outhistos[aopath] = ao elif(aopath.find("x02")>0 and file.find("-7-Top-SL.yoda")>0 ) : outhistos[aopath] = ao elif(aopath.find("1467230")>0 or aopath.find("1419652")>0) : if(aopath.find("y01")>0 and file.find("Long")>0 ) : outhistos[aopath] = ao elif(aopath.find("y02")>0 and file.find("Long")<0 ) : outhistos[aopath] = ao elif("CMS_2017_I1471287" in aopath) : if("CMS_2017_I1471287/d" in aopath) : outhistos[aopath] = ao elif("ATLAS_2018_I1705857" in aopath ) : ihist = int(aopath.split("/d")[1].split("-")[0]) if "-SL" in file : if ihist in [9,10,11,12,19,20,21,22,23,24,25,26,33,34,35,36,37,38,45,46,47,48,49,50] : outhistos[aopath] = ao elif "-L" in file : if ihist in [3,4,5,6,7,8,13,14,15,16,17,18,27,28,29,30,31,32,39,40,41,42,43,44] : outhistos[aopath] = ao if ihist in [1,2] : if aopath not in outhistos : outhistos[aopath] = ao else : temp = yoda.core.Histo1D(ao.path, ao.title) for i in range(0,ao.numBins) : temp.addBin(ao.bins[i].xMin,ao.bins[i].xMax) if("-SL" in file) : temp.bins[0] += outhistos[aopath].bins[0] temp.bins[1] += outhistos[aopath].bins[1] temp.bins[2] += ao.bins[2] temp.bins[3] += ao.bins[3] temp.bins[2] += ao.bins[2] temp.bins[3] += ao.bins[3] else : temp.bins[0] += ao.bins[0] temp.bins[1] += ao.bins[1] temp.bins[2] += outhistos[aopath].bins[2] temp.bins[3] += outhistos[aopath].bins[3] temp.bins[2] += outhistos[aopath].bins[2] temp.bins[3] += outhistos[aopath].bins[3] outhistos[aopath] = temp else : outhistos[aopath] = ao yodafiles=["-7-Bottom-7.yoda","-7-Bottom-8.yoda","-7-Bottom-9.yoda"] for i in range(1,8) : yodafiles.append("-7-DiJets-%1.1i-A.yoda" % i) yodafiles.append("-7-DiJets-%1.1i-B.yoda" % i) yodafiles.append("-7-DiJets-%1.1i-C.yoda" % i) +for i in range(1,12) : + yodafiles.append("-13-DiJets-%1.1i-A.yoda" % i) for i in range(6,12) : - yodafiles.append("-13-DiJets-%1.1i-A.yoda" % i) + yodafiles.append("-13-DiJets-%1.1i-B.yoda" % i) for f in yodafiles: file='Rivet-'+args[0]+f if "-7-Jets" in file or "-7-DiJets" in file : sqrts = 7000 elif "-13-Jets" in file or "-13-DiJets" in file : sqrts = 13000 if(file.find("-DiJets-2")>0) : mass=250 elif(file.find("-DiJets-3")>0) : mass=500 elif(file.find("-DiJets-4")>0) : mass=800 elif(file.find("-DiJets-5")>0) : mass=1000 elif(file.find("-DiJets-6")>0) : mass=1600 elif(file.find("-DiJets-7")>0) : mass=2200 elif(file.find("-DiJets-8")>0) : mass=2800 elif(file.find("-DiJets-9")>0) : mass=3900 elif(file.find("-DiJets-10")>0) : mass=4900 elif(file.find("-DiJets-11")>0) : mass=5900 elif(file.find("-DiJets-1")>0) : mass=100 elif(file.find("-Bottom-7")>0) : mass=110 elif(file.find("-Bottom-8")>0) : mass=370 elif(file.find("-Bottom-9")>0) : mass=550 elif(file.find("-Jets-1")>0) : mass=0 if not os.access(file, os.R_OK): logging.error("%s can not be read" % file) continue try: aos = yoda.read(file) except: logging.error("%s can not be parsed as YODA" % file) continue ## Get histos from this YODA file for aopath, ao in aos.iteritems() : if("RAW" in aopath) :continue - if(aopath.find("8817804")>0 or - aopath.find("8968497")>0 or - aopath.find("1082936")>0 or - aopath.find("I930220")>0 or - aopath.find("1261026")>0 or - aopath.find("1090423")>0 or - aopath.find("1268975")>0 or - aopath.find("1519995") >0 or + if(aopath.find("8817804")>0 or aopath.find("8968497")>0 or + aopath.find("1082936")>0 or aopath.find("I930220")>0 or + aopath.find("1261026")>0 or aopath.find("1090423")>0 or + aopath.find("1268975")>0 or aopath.find("1519995") >0 or aopath.find("1663452") >0 or + aopath.find("1634970" )>0 or aopath.find("CMS_2013_I1208923")>0) : if not inhistos_mass.has_key(aopath): inhistos_mass[aopath] = {} tmpE = inhistos_mass[aopath] if not tmpE.has_key(sqrts): tmpE[sqrts] = {} tmpP = tmpE[sqrts] if not tmpP.has_key(mass): tmpP[mass] = ao else: print aopath print sqrts,mass,file raise Exception("A set with mass = %s already exists" % ( mass)) ## Make empty output histos if needed for hpath,hsets in inhistos_pt.iteritems(): if( hpath.find("8924791")>0 or hpath.find("8971293")>0 or hpath.find("8817804")>0 or hpath.find("8968497")>0 or (hpath.find("9120041")>0 and (hpath.find("d01")>0 or hpath.find("d02")>0)) or hpath.find("9126244")>0 or hpath.find("926145") >0 or hpath.find("9086218")>0 or hpath.find("1082936")>0 or hpath.find("8941262")>0 or hpath.find("1118269")>0 or hpath.find("1087342")>0 or hpath.find("1188891")>0 or hpath.find("919017")>0 or hpath.find("9035664")>0 or hpath.find("1125575")>0 or hpath.find("1094564")>0 or hpath.find("I930220")>0 or hpath.find("S9088458")>0 or hpath.find("I1273574")>0 or hpath.find("I1261026")>0 or hpath.find("I1090423")>0 or hpath.find("QCD_11_010")>0 or hpath.find("1298811" )>0 or hpath.find("I1325553" )>0 or hpath.find("I1298810" )>0 or hpath.find("1307243" )>0 or hpath.find("I1419070")>0 or hpath.find("I1394679")>0 or hpath.find("I1487277")>0 or hpath.find("CMS_2013_I1208923")>0 or hpath.find("1393758")>0 or hpath.find("ATLAS_2016_CONF_2016_092")>0 or hpath.find("1111014")>0 or hpath.find("1385107")>0 or hpath.find("I1486238") or - hpath.find("1459051")>0 or - hpath.find("1634970")>0 : + hpath.find("1459051")>0 or hpath.find("1634970")>0) : if(type(hsets.values()[0].values()[0])==yoda.core.Counter) : outhistos[hpath] = yoda.core.Counter(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) elif(type(hsets.values()[0].values()[0])==yoda.core.Scatter2D) : outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) elif(type(hsets.values()[0].values()[0])==yoda.core.Profile1D) : outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) for i in range(0,hsets.values()[0].values()[0].numBins) : outhistos[hpath].addBin(hsets.values()[0].values()[0].bins[i].xMin, hsets.values()[0].values()[0].bins[i].xMax) elif(type(hsets.values()[0].values()[0])==yoda.core.Histo1D) : outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) for i in range(0,hsets.values()[0].values()[0].numBins) : outhistos[hpath].addBin(hsets.values()[0].values()[0].bins[i].xMin, hsets.values()[0].values()[0].bins[i].xMax) else : logging.error("Histogram %s is of unknown type" % hpath) sys.exit(1) ## Make empty output histos if needed for hpath,hsets in inhistos_mass.iteritems(): - if(hpath.find("1268975")>0) : + if(hpath.find("1268975")>0 or + hpath.find("1634970")>0) : if(type(hsets.values()[0].values()[0])==yoda.core.Counter) : outhistos[hpath] = yoda.core.Counter(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) elif(type(hsets.values()[0].values()[0])==yoda.core.Scatter2D) : outhistos[hpath] = yoda.core.Scatter2D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) elif(type(hsets.values()[0].values()[0])==yoda.core.Profile1D) : outhistos[hpath] = yoda.core.Profile1D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) for i in range(0,hsets.values()[0].values()[0].numBins) : outhistos[hpath].addBin(hsets.values()[0].values()[0].bins[i].xMin, hsets.values()[0].values()[0].bins[i].xMax) elif(type(hsets.values()[0].values()[0])==yoda.core.Histo1D) : outhistos[hpath] = yoda.core.Histo1D(hsets.values()[0].values()[0].path, hsets.values()[0].values()[0].title) for i in range(0,hsets.values()[0].values()[0].numBins) : outhistos[hpath].addBin(hsets.values()[0].values()[0].bins[i].xMin, hsets.values()[0].values()[0].bins[i].xMax) else : logging.error("Histogram %s is of unknown type" % hpath) sys.exit(1) logging.info("Processing CMS_2011_S8957746") useOnePt("/CMS_2011_S8957746/d01-x01-y01", "7000", "80" ) useOnePt("/CMS_2011_S8957746/d02-x01-y01", "7000", "80" ) useOnePt("/CMS_2011_S8957746/d03-x01-y01", "7000", "110" ) useOnePt("/CMS_2011_S8957746/d04-x01-y01", "7000", "110" ) useOnePt("/CMS_2011_S8957746/d05-x01-y01", "7000", "210" ) useOnePt("/CMS_2011_S8957746/d06-x01-y01", "7000", "210" ) logging.info("Processing ATLAS_2010_S8894728") useOnePt("/ATLAS_2010_S8894728/d01-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d01-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d01-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d02-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d02-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d02-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d03-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d03-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d03-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d04-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d04-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d04-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d05-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d06-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d07-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d08-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d09-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d09-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d09-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d10-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d10-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d10-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d11-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d11-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d11-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d12-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d12-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d12-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d13-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d13-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d13-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d13-x01-y04", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d14-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d14-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d14-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d14-x01-y04", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d15-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d15-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d15-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d15-x01-y04", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d16-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d16-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d16-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d16-x01-y04", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d17-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d17-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d17-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d18-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d18-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d18-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d19-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d19-x01-y02", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d19-x01-y03", "900", "0" ) useOnePt("/ATLAS_2010_S8894728/d20-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d20-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d20-x01-y03", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d21-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8894728/d22-x01-y01", "7000", "0" ) logging.info("Processing ATLAS_2011_S8994773") useOnePt("/ATLAS_2011_S8994773/d01-x01-y01", "900", "0" ) useOnePt("/ATLAS_2011_S8994773/d02-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2011_S8994773/d03-x01-y01", "900", "0" ) useOnePt("/ATLAS_2011_S8994773/d04-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2011_S8994773/d13-x01-y01", "900", "0" ) useOnePt("/ATLAS_2011_S8994773/d13-x01-y02", "900", "0" ) useOnePt("/ATLAS_2011_S8994773/d13-x01-y03", "900", "0" ) useOnePt("/ATLAS_2011_S8994773/d14-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2011_S8994773/d14-x01-y02", "7000", "0" ) useOnePt("/ATLAS_2011_S8994773/d14-x01-y03", "7000", "0" ) logging.info("Processing ALICE_2010_S8624100") useOnePt("/ALICE_2010_S8624100/d11-x01-y01", "900", "0" ) useOnePt("/ALICE_2010_S8624100/d12-x01-y01", "900", "0" ) useOnePt("/ALICE_2010_S8624100/d13-x01-y01", "900", "0" ) useOnePt("/ALICE_2010_S8624100/d17-x01-y01","2360", "0" ) useOnePt("/ALICE_2010_S8624100/d18-x01-y01","2360", "0" ) useOnePt("/ALICE_2010_S8624100/d19-x01-y01","2360", "0" ) logging.info("Processing ALICE_2010_S8625980") useOnePt("/ALICE_2010_S8625980/d03-x01-y01", "7000", "0" ) useOnePt("/ALICE_2010_S8625980/d04-x01-y01", "900", "0" ) useOnePt("/ALICE_2010_S8625980/d05-x01-y01", "2360", "0" ) useOnePt("/ALICE_2010_S8625980/d06-x01-y01", "7000", "0" ) logging.info("Processing ATLAS_2010_S8918562") useOnePt("/ATLAS_2010_S8918562/d01-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d02-x01-y01", "2360", "0" ) useOnePt("/ATLAS_2010_S8918562/d03-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d04-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d05-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d06-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d07-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d08-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d09-x01-y01", "2360", "0" ) useOnePt("/ATLAS_2010_S8918562/d10-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d11-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d12-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d13-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d14-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d15-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d16-x01-y01", "2360", "0" ) useOnePt("/ATLAS_2010_S8918562/d17-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d18-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d19-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d20-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d21-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d22-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d23-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d24-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d25-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d26-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d27-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d28-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d29-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d30-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d31-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d32-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d33-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d34-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d35-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d36-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d37-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2010_S8918562/d38-x01-y01", "900", "0" ) useOnePt("/ATLAS_2010_S8918562/d39-x01-y01", "7000", "0" ) logging.info("Processing ATLAS_2011_S8971293") useOnePt("/ATLAS_2011_S8971293/d01-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y03", "7000", "210" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y04", "7000", "260" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y05", "7000", "260" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y06", "7000", "400" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y07", "7000", "400" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y08", "7000", "600" ) useOnePt("/ATLAS_2011_S8971293/d01-x01-y09", "7000", "600" ) logging.info("Processing ATLAS_2011_S8924791") if( not opts.ue) : useOnePt("/ATLAS_2011_S8924791/d01-x01-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x01-y02", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x02-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x02-y02", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x03-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x03-y02", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x04-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x04-y02", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x05-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x05-y02", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x06-y01", "7000", "10" ) useOnePt("/ATLAS_2011_S8924791/d01-x06-y02", "7000", "10" ) else : useOnePt("/ATLAS_2011_S8924791/d01-x01-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x01-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x02-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x02-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x03-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x03-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x04-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x04-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x05-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x05-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x06-y01", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d01-x06-y02", "7000", "20" ) useOnePt("/ATLAS_2011_S8924791/d02-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x02-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x02-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x03-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x03-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x04-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x04-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x05-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x05-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x06-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d02-x06-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x02-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x02-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x03-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x03-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x04-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x04-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x05-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x05-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x06-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d03-x06-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S8924791/d04-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x01-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x02-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x02-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x03-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x03-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x04-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x04-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x05-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x05-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x06-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d04-x06-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S8924791/d05-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x02-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x02-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x03-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x03-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x04-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x04-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x05-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x05-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x06-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d05-x06-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x02-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x02-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x03-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x03-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x04-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x04-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x05-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x05-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x06-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d06-x06-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S8924791/d07-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x02-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x02-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x03-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x03-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x04-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x04-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x05-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x05-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x06-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d07-x06-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S8924791/d08-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x01-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x02-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x02-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x03-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x03-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x04-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x04-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x05-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x05-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x06-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d08-x06-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x01-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x02-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x02-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x03-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x03-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x04-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x04-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x05-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x05-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x06-y01", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d09-x06-y02", "7000", "260" ) useOnePt("/ATLAS_2011_S8924791/d10-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x01-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x02-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x02-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x03-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x03-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x04-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x04-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x05-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x05-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x06-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d10-x06-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x01-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x02-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x02-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x03-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x03-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x04-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x04-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x05-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x05-y02", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x06-y01", "7000", "400" ) useOnePt("/ATLAS_2011_S8924791/d11-x06-y02", "7000", "400" ) logging.info("Processing ATLAS_2010_S8817804") mergeByPt("/ATLAS_2010_S8817804/d01-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d02-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d03-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d04-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d05-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d06-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d07-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d08-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d09-x01-y01", "7000") mergeByPt("/ATLAS_2010_S8817804/d10-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d11-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d12-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d13-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d14-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d15-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d16-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d17-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d18-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d19-x01-y01", "7000") mergeByMass("/ATLAS_2010_S8817804/d20-x01-y01", "7000") useOneMass("/ATLAS_2010_S8817804/d21-x01-y01", "7000", "250" ) useOneMass("/ATLAS_2010_S8817804/d22-x01-y01", "7000", "250" ) useOneMass("/ATLAS_2010_S8817804/d23-x01-y01", "7000", "650" ) useOneMass("/ATLAS_2010_S8817804/d24-x01-y01", "7000", "250" ) useOneMass("/ATLAS_2010_S8817804/d25-x01-y01", "7000", "250" ) useOneMass("/ATLAS_2010_S8817804/d26-x01-y01", "7000", "650" ) logging.info("Processing ATLAS_2011_I930220") mergeByPt("/ATLAS_2011_I930220/d01-x01-y01", "7000" ) mergeByPt("/ATLAS_2011_I930220/d02-x01-y01", "7000" ) mergeByPt("/ATLAS_2011_I930220/d03-x01-y01", "7000" ) mergeByPt("/ATLAS_2011_I930220/d04-x01-y01", "7000" ) mergeByPt("/ATLAS_2011_I930220/d05-x01-y01", "7000" ) mergeByPt("/ATLAS_2011_I930220/d06-x01-y01", "7000" ) mergeByMass("/ATLAS_2011_I930220/d07-x01-y01", "7000") useOneMass("/ATLAS_2011_I930220/d08-x01-y01", "7000", "110" ) useOneMass("/ATLAS_2011_I930220/d09-x01-y01", "7000", "110" ) useOneMass("/ATLAS_2011_I930220/d10-x01-y01", "7000", "370" ) logging.info("Processing ATLAS_2012_I1082936") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y02", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y03", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y04", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y05", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y06", "7000") mergeByPt("/ATLAS_2012_I1082936/d01-x01-y07", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y02", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y03", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y04", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y05", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y06", "7000") mergeByPt("/ATLAS_2012_I1082936/d02-x01-y07", "7000") mergeByMass("/ATLAS_2012_I1082936/d03-x01-y01", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y02", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y03", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y04", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y05", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y06", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y07", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y08", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d03-x01-y09", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y01", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y02", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y03", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y04", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y05", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y06", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y07", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y08", "7000", 1000.) mergeByMass("/ATLAS_2012_I1082936/d04-x01-y09", "7000", 1000.) logging.info("Processing CMS_2011_S8968497") useOneMass("/CMS_2011_S8968497/d01-x01-y01", "7000", "1700" ) useOneMass("/CMS_2011_S8968497/d02-x01-y01", "7000", "1700" ) useOneMass("/CMS_2011_S8968497/d03-x01-y01", "7000", "1100" ) useOneMass("/CMS_2011_S8968497/d04-x01-y01", "7000", "1100" ) useOneMass("/CMS_2011_S8968497/d05-x01-y01", "7000", "650" ) useOneMass("/CMS_2011_S8968497/d06-x01-y01", "7000", "650" ) useOneMass("/CMS_2011_S8968497/d07-x01-y01", "7000", "250" ) useOneMass("/CMS_2011_S8968497/d08-x01-y01", "7000", "250" ) useOneMass("/CMS_2011_S8968497/d09-x01-y01", "7000", "250" ) logging.info("Processing ATLAS_2011_S9126244") mergeByPt("/ATLAS_2011_S9126244/d01-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d01-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d02-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d02-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d03-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d03-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d04-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d04-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d05-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d05-x01-y02", "7000") useOnePt("/ATLAS_2011_S9126244/d06-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d06-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d07-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d07-x01-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d08-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d08-x01-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d09-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d09-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d10-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d10-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d11-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d11-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d12-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d12-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d13-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d13-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d14-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d14-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d15-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d15-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d16-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d16-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d17-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d17-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d18-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d18-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d19-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d20-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d21-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d22-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d23-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d24-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d25-x01-y01", "7000", "210" ) mergeByPt("/ATLAS_2011_S9126244/d26-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d26-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d27-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d27-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d28-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d28-x01-y02", "7000") mergeByPt("/ATLAS_2011_S9126244/d29-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9126244/d29-x01-y02", "7000") useOnePt("/ATLAS_2011_S9126244/d30-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d31-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d32-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d33-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d34-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d35-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d36-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d37-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d37-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2011_S9126244/d38-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d38-x01-y02", "7000", "80" ) useOnePt("/ATLAS_2011_S9126244/d39-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d39-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d40-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d40-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d41-x01-y01", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d41-x01-y02", "7000", "110" ) useOnePt("/ATLAS_2011_S9126244/d42-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d42-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d43-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2011_S9126244/d43-x01-y02", "7000", "210" ) # CMS_2011_S9120041 UE analysis logging.info("Processing CMS_2011_S9120041") mergeByPt("/CMS_2011_S9120041/d01-x01-y01", "7000") mergeByPt("/CMS_2011_S9120041/d02-x01-y01", "7000") if(opts.ue) : useOnePt("/CMS_2011_S9120041/d03-x01-y01", "900", "0" ) useOnePt("/CMS_2011_S9120041/d04-x01-y01", "900", "0" ) useOnePt("/CMS_2011_S9120041/d05-x01-y01", "7000", "0" ) useOnePt("/CMS_2011_S9120041/d06-x01-y01", "7000", "0" ) useOnePt("/CMS_2011_S9120041/d07-x01-y01", "7000", "0" ) useOnePt("/CMS_2011_S9120041/d11-x01-y01", "900", "0" ) useOnePt("/CMS_2011_S9120041/d12-x01-y01", "900", "0" ) useOnePt("/CMS_2011_S9120041/d13-x01-y01", "900", "0" ) useOnePt("/CMS_2011_S9120041/d08-x01-y01", "7000", "20" ) useOnePt("/CMS_2011_S9120041/d09-x01-y01", "7000", "20" ) useOnePt("/CMS_2011_S9120041/d10-x01-y01", "7000", "20" ) else : useOnePt("/CMS_2011_S9120041/d08-x01-y01", "7000", "10" ) useOnePt("/CMS_2011_S9120041/d09-x01-y01", "7000", "10" ) useOnePt("/CMS_2011_S9120041/d10-x01-y01", "7000", "10" ) # CMS dijet decorrelation logging.info("Processing CMS_2011_S8950903") useOnePt("/CMS_2011_S8950903/d01-x01-y01", "7000", "80" ) useOnePt("/CMS_2011_S8950903/d02-x01-y01", "7000", "110" ) useOnePt("/CMS_2011_S8950903/d03-x01-y01", "7000", "110" ) useOnePt("/CMS_2011_S8950903/d04-x01-y01", "7000", "210" ) useOnePt("/CMS_2011_S8950903/d05-x01-y01", "7000", "260" ) # CMS jet cross section logging.info("Processing CMS_2011_S9086218") mergeByPt("/CMS_2011_S9086218/d01-x01-y01", "7000") mergeByPt("/CMS_2011_S9086218/d02-x01-y01", "7000") mergeByPt("/CMS_2011_S9086218/d03-x01-y01", "7000") mergeByPt("/CMS_2011_S9086218/d04-x01-y01", "7000") mergeByPt("/CMS_2011_S9086218/d05-x01-y01", "7000") mergeByPt("/CMS_2011_S9086218/d06-x01-y01", "7000") # CMS 2/3 jet cross section ratio logging.info("Processing CMS_2011_S9086218") mergeByPt("/CMS_2011_S9088458/d01-x01-y01", "7000",500.) # ATLAS track jet logging.info("Processing ATLAS_2011_I919017") for d in range(1,3) : for y in range(1,5) : mergeByPt("/ATLAS_2011_I919017/d0%s-x01-y0%s" % (d,y), "7000") if( opts.ue) : for x in range(2,6) : for y in ["01","02","06","07","11","12","16","17","21","22"] : useOnePt("/ATLAS_2011_I919017/d0%s-x0%s-y%s" % (d,x,y), "7000", "0" ) for y in ["03","04","08","09","13","14","18","19","23","24"] : useOnePt("/ATLAS_2011_I919017/d0%s-x0%s-y%s" % (d,x,y), "7000", "4" ) for y in range(5,30,5) : useOnePt("/ATLAS_2011_I919017/d0%s-x%02d-y%02d" % (d,x,y) , "7000", "20" ) else : for x in range(2,6) : for y in range(5,30,5) : useOnePt("/ATLAS_2011_I919017/d0%s-x%02d-y%02d" % (d,x,y) , "7000", "10" ) logging.info("Processing ATLAS_2011_I926145") mergeByPt("/ATLAS_2011_I926145/d01-x01-y01", "7000",1.5) mergeByPt("/ATLAS_2011_I926145/d02-x01-y01", "7000",1.5) mergeByPt("/ATLAS_2011_I926145/d03-x01-y01", "7000",1.5) logging.info("Processing CMS_2011_S8941262") useOnePt("/CMS_2011_S8941262/d01-x01-y01", "7000", "10" ) useOnePt("/CMS_2011_S8941262/d03-x01-y01", "7000", "10" ) mergeByPt("/CMS_2011_S8941262/d02-x01-y01", "7000",1.5) logging.info("Processing CMS_2011_S8973270") useOnePt("/CMS_2011_S8973270/d01-x01-y01", "7000", "70" ) useOnePt("/CMS_2011_S8973270/d02-x01-y01", "7000", "100" ) useOnePt("/CMS_2011_S8973270/d03-x01-y01", "7000", "130" ) useOnePt("/CMS_2011_S8973270/d04-x01-y01", "7000", "70" ) useOnePt("/CMS_2011_S8973270/d05-x01-y01", "7000", "100" ) useOnePt("/CMS_2011_S8973270/d06-x01-y01", "7000", "130" ) logging.info("Processing ATLAS_2012_I1082009") useOnePt("/ATLAS_2012_I1082009/d08-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2012_I1082009/d09-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2012_I1082009/d10-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2012_I1082009/d11-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2012_I1082009/d12-x01-y01", "7000", "80" ) useOnePt("/ATLAS_2012_I1082009/d13-x01-y01", "7000", "40" ) logging.info("Processing ATLAS_2012_I1118269") mergeByPt("/ATLAS_2012_I1118269/d01-x01-y01", "7000") useOnePt("/ATLAS_2012_I1118269/d02-x01-y01", "7000", "10" ) logging.info("Processing ATLAS_2012_I1188891") mergeByPt("/ATLAS_2012_I1188891/d01-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1188891/d02-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1188891/d03-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1188891/d04-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1188891/d05-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1188891/d06-x01-y01", "7000") logging.info("Processing CMS_2012_I1087342") mergeByPt("/CMS_2012_I1087342/d01-x01-y01", "7000") mergeByPt("/CMS_2012_I1087342/d02-x01-y01", "7000") mergeByPt("/CMS_2012_I1087342/d03-x01-y01", "7000") logging.info("Processing CMS_2012_PAS_QCD_11_010") mergeByPt("/CMS_2012_PAS_QCD_11_010/d01-x01-y01", "7000") mergeByPt("/CMS_2012_PAS_QCD_11_010/d02-x01-y01", "7000") mergeByPt("/CMS_2012_PAS_QCD_11_010/d03-x01-y01", "7000") mergeByPt("/CMS_2012_PAS_QCD_11_010/d04-x01-y01", "7000") logging.info("Processing ATLAS_2011_S9035664") mergeByPt("/ATLAS_2011_S9035664/d11-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d12-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d13-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d14-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d15-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d16-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d17-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d18-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d20-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d21-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d22-x01-y01", "7000") mergeByPt("/ATLAS_2011_S9035664/d23-x01-y01", "7000") logging.info("Processing ATLAS_2012_I1125575") mergeByPt("/ATLAS_2012_I1125575/d01-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x01-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x02-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x02-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x03-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x03-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x04-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x04-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x05-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d01-x05-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x01-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x02-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x02-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x03-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x03-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x04-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x04-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x05-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d02-x05-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x01-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x01-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x02-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x02-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x03-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x03-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x04-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x04-y02", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x05-y01", "7000") mergeByPt("/ATLAS_2012_I1125575/d03-x05-y02", "7000") for d in range(4,7) : for x in range(1,6) : if(opts.ue) : for y in range(1,9) : useOnePt("/ATLAS_2012_I1125575/d0%s-x0%s-y0%s" % (d,x,y), "7000", "0" ) for y in ["09","10","11","12","13","14","15","16"] : useOnePt("/ATLAS_2012_I1125575/d0%s-x0%s-y%s" % (d,x,y), "7000", "0" ) for y in range(17,19) : useOnePt("/ATLAS_2012_I1125575/d0%s-x0%s-y%s" % (d,x,y), "7000", "20" ) else : for y in range(17,19) : useOnePt("/ATLAS_2012_I1125575/d0%s-x0%s-y%s" % (d,x,y), "7000", "10" ) for y in range(19,21) : useOnePt("/ATLAS_2012_I1125575/d0%s-x0%s-y%s" % (d,x,y), "7000", "40" ) # ATLAS_2012_I1094564 useOnePt("/ATLAS_2012_I1094564/d01-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d02-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d03-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d04-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d05-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d06-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d07-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d08-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d09-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d10-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d11-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d12-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d13-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d14-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d15-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d16-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d17-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d18-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d19-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d20-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d21-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d22-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d23-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d24-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d25-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d26-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d27-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d28-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d29-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d30-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d31-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d32-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d33-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2012_I1094564/d34-x01-y01", "7000", "260" ) useOnePt("/ATLAS_2012_I1094564/d35-x01-y01", "7000", "400" ) useOnePt("/ATLAS_2012_I1094564/d36-x01-y01", "7000", "400" ) logging.info("Processing CMS_2013_I1224539_DIJET") useOnePt("/CMS_2013_I1224539_DIJET/d01-x01-y01", "7000", "210" ) useOnePt("/CMS_2013_I1224539_DIJET/d02-x01-y01", "7000", "260" ) useOnePt("/CMS_2013_I1224539_DIJET/d03-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d04-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d05-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d06-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d07-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d08-x01-y01", "7000", "210" ) useOnePt("/CMS_2013_I1224539_DIJET/d09-x01-y01", "7000", "260" ) useOnePt("/CMS_2013_I1224539_DIJET/d10-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d11-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d12-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d13-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d14-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d15-x01-y01", "7000", "210" ) useOnePt("/CMS_2013_I1224539_DIJET/d16-x01-y01", "7000", "260" ) useOnePt("/CMS_2013_I1224539_DIJET/d17-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d18-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d19-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d20-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d21-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d22-x01-y01", "7000", "210" ) useOnePt("/CMS_2013_I1224539_DIJET/d23-x01-y01", "7000", "260" ) useOnePt("/CMS_2013_I1224539_DIJET/d24-x01-y01", "7000", "400" ) useOnePt("/CMS_2013_I1224539_DIJET/d25-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d26-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d27-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1224539_DIJET/d28-x01-y01", "7000", "600" ) useOnePt("/CMS_2013_I1273574/d01-x01-y01", "7000", "80" ) mergeByPt("/CMS_2013_I1273574/d02-x01-y01", "7000",1.) useOnePt("/CMS_2013_I1273574/d03-x01-y01", "7000", "80" ) useOnePt("/CMS_2013_I1273574/d04-x01-y01", "7000", "80" ) useOnePt("/CMS_2013_I1273574/d05-x01-y01", "7000", "80" ) useOnePt("/CMS_2013_I1273574/d06-x01-y01", "7000", "80" ) mergeByPt("/CMS_2013_I1273574/d07-x01-y01", "7000",1.) useOnePt("/CMS_2013_I1273574/d08-x01-y01", "7000", "80" ) mergeByPt("/CMS_2013_I1273574/d09-x01-y01", "7000",1.) useOnePt("/CMS_2013_I1273574/d10-x01-y01", "7000", "80" ) mergeByPt("/CMS_2013_I1273574/d11-x01-y01", "7000",1.) useOnePt("/CMS_2013_I1261026/d01-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d02-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d03-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d04-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d05-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d06-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d07-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d08-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d09-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d10-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d11-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d12-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d13-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d14-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d15-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d16-x01-y01", "7000", "0" ) useOnePt("/CMS_2013_I1261026/d17-x01-y01", "7000", "0" ) logging.info("Processing CMS_2012_I1090423") useOneMass("/CMS_2012_I1090423/d01-x01-y01", "7000", "2900" ) useOneMass("/CMS_2012_I1090423/d02-x01-y01", "7000", "2300" ) useOneMass("/CMS_2012_I1090423/d03-x01-y01", "7000", "1700" ) useOneMass("/CMS_2012_I1090423/d04-x01-y01", "7000", "1100" ) useOneMass("/CMS_2012_I1090423/d05-x01-y01", "7000", "1100" ) useOneMass("/CMS_2012_I1090423/d06-x01-y01", "7000", "650" ) useOneMass("/CMS_2012_I1090423/d07-x01-y01", "7000", "650" ) useOneMass("/CMS_2012_I1090423/d08-x01-y01", "7000", "250" ) useOneMass("/CMS_2012_I1090423/d09-x01-y01", "7000", "250" ) logging.info("Processing ATLAS_2014_I1298811") mergeByPt("/ATLAS_2014_I1298811/d01-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d01-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d02-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d02-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d03-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d03-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d04-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d04-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d05-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d05-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d06-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d06-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d07-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d07-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d08-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d08-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d09-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d09-x01-y02", "7000") mergeByPt("/ATLAS_2014_I1298811/d10-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1298811/d10-x01-y02", "7000") useOnePt("/ATLAS_2014_I1298811/d11-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2014_I1298811/d12-x01-y01", "7000", "0" ) useOnePt("/ATLAS_2014_I1298811/d13-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d13-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d14-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d14-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d15-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d15-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d25-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d25-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d26-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d26-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d27-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d27-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d16-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d16-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d17-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d17-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d18-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d18-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d28-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d28-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d29-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d29-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d30-x01-y01", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d30-x01-y02", "7000", "4" ) useOnePt("/ATLAS_2014_I1298811/d19-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d19-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d20-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d20-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d21-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d21-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d31-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d31-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d32-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d32-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d33-x01-y01", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d33-x01-y02", "7000", "40" ) useOnePt("/ATLAS_2014_I1298811/d22-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d22-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d23-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d23-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d24-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d24-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d34-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d34-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d35-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d35-x01-y02", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d36-x01-y01", "7000", "210" ) useOnePt("/ATLAS_2014_I1298811/d36-x01-y02", "7000", "210" ) logging.info("Processing ATLAS_2014_I1268975") mergeByMass("/ATLAS_2014_I1268975/d01-x01-y01", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d01-x01-y02", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d01-x01-y03", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d01-x01-y04", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d01-x01-y05", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d01-x01-y06", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y01", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y02", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y03", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y04", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y05", "7000", 1000.) mergeByMass("/ATLAS_2014_I1268975/d02-x01-y06", "7000", 1000.) logging.info("Processing ATLAS_2014_I1307243") useOnePt( "/ATLAS_2014_I1307243/d01-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d02-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d03-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d04-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d05-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d06-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d07-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d08-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d09-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d10-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d11-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d12-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d13-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d14-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d15-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d16-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d17-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d18-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d19-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d20-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d21-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d22-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d23-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d24-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d25-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d26-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d27-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d28-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d29-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d30-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d31-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d32-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d33-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d34-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d35-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d36-x01-y01", "7000", "80" ) useOnePt( "/ATLAS_2014_I1307243/d37-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d38-x01-y01", "7000") useOnePt( "/ATLAS_2014_I1307243/d39-x01-y01", "7000", "80" ) mergeByPt("/ATLAS_2014_I1307243/d40-x01-y01", "7000") logging.info("Processing ATLAS_2014_I1325553") mergeByPt("/ATLAS_2014_I1325553/d01-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d02-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d03-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d04-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d05-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d06-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d07-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d08-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d09-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d10-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d11-x01-y01", "7000") mergeByPt("/ATLAS_2014_I1325553/d12-x01-y01", "7000") logging.info("Processing ATLAS_2016_I1419070") for i in range(1,13) : if(i<10) : mergeByPt("/ATLAS_2016_I1419070/d0%s-x01-y01" % i, "8000") else : mergeByPt("/ATLAS_2016_I1419070/d%s-x01-y01" % i, "8000") # remake differences and sums for ihist in range(1,4) : if not ("/ATLAS_2016_I1419070/d0%s-x01-y01" % ihist) in outhistos : continue h1 = outhistos["/ATLAS_2016_I1419070/d0%s-x01-y01" % ihist ] h2 = outhistos["/ATLAS_2016_I1419070/d0%s-x01-y01" % (ihist+3)] sstring = "/ATLAS_2016_I1419070/d%s-x01-y01" % (9+ihist) dstring = "/ATLAS_2016_I1419070/d0%s-x01-y01" % (6+ihist) hdiff = yoda.Scatter2D(dstring,dstring) hsum = yoda.Scatter2D(sstring,sstring) outhistos[dstring]= hdiff outhistos[sstring]= hsum for nbin in range(0,h2.numBins) : bsum = h1.bins[nbin]+h2.bins[nbin] try: ydiff = h2.bins[nbin].mean-h1.bins[nbin].mean except: ydiff = 0 try: ysum = bsum.mean bstderr = bsum.stdErr except: ysum = 0 bstderr = 0 try: yerr = math.sqrt(h1.bins[nbin].stdErr**2+h2.bins[nbin].stdErr**2) except: yerr = 0 x = h1.bins[nbin].xMid xerr = 0.5*h1.bins[nbin].xWidth hdiff.addPoint(x,ydiff,xerr,yerr) hsum.addPoint(x,ysum ,xerr,bstderr) logging.info("Processing ATLAS_2015_I1394679") for i in range(1,5) : mergeByPt("/ATLAS_2015_I1394679/d0%s-x01-y01" % i, "8000") for i in range(5,11) : if(i<10) : useOnePt( "/ATLAS_2015_I1394679/d0%s-x01-y01" % i, "8000", "110" ) else : useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % i, "8000", "110" ) for i in range(0,4) : useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (11+4*i), "8000", "110" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (12+4*i), "8000", "260" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (13+4*i), "8000", "600" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (14+4*i), "8000", "900" ) for i in range(0,5) : useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (27+4*i), "8000", "110" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (28+4*i), "8000", "260" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (29+4*i), "8000", "400" ) useOnePt( "/ATLAS_2015_I1394679/d%s-x01-y01" % (30+4*i), "8000", "400" ) logging.info("Processing CMS_2013_I1208923") for i in range(1,6) : mergeByPt ("/CMS_2013_I1208923/d01-x01-y0%s" % i, "7000") mergeByMass("/CMS_2013_I1208923/d02-x01-y0%s" % i, "7000", 1.) logging.info("Processing CMS_2014_I1298810") for i in range(1,19) : if(i<10) : mergeByPt("/CMS_2014_I1298810/d0"+str(i)+"-x01-y01", "7000") else : mergeByPt("/CMS_2014_I1298810/d"+str(i)+"-x01-y01", "7000") logging.info("Processing CMS_2014_I1305624") for x in range(1,6) : useOnePt( "/CMS_2014_I1305624/d01-x%02d-y01" % x, "7000", "110" ) useOnePt( "/CMS_2014_I1305624/d01-x%02d-y02" % x, "7000", "110" ) useOnePt( "/CMS_2014_I1305624/d01-x%02d-y03" % x, "7000", "260" ) useOnePt( "/CMS_2014_I1305624/d01-x%02d-y04" % x, "7000", "260" ) useOnePt( "/CMS_2014_I1305624/d01-x%02d-y05" % x, "7000", "400" ) logging.info("Processing ATLAS_2011_I929691") for x in range(0,3) : useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 1), "7000", "20" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 2), "7000", "40" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 3), "7000", "40" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 4), "7000", "80" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 5), "7000", "110" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 6), "7000", "110" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 7), "7000", "210" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 8), "7000", "260" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+ 9), "7000", "260" ) useOnePt( "/ATLAS_2011_I929691/d%02d-x01-y01" % (10*x+10), "7000", "400" ) logging.info("Processing ATLAS_2015_I1393758") for i in range(1,13) : mergeByPt("/ATLAS_2015_I1393758/d%02d-x01-y01" % i, "8000") logging.info("Processing CMS_2016_I1459051") for i in range(1,15) : mergeByPt("/CMS_2016_I1459051/d%02d-x01-y01" % i, "13000") logging.info("Processing ATLAS_2016_CONF_2016_092") for i in range(1,7) : mergeByPt("/ATLAS_2016_CONF_2016_092/d%02d-x01-y01" % i, "13000") logging.info("Processing ATLAS_2017_I1609253") useOnePt( "/ATLAS_2017_I1609253/d01-x01-y01", "8000", "260" ) useOnePt( "/ATLAS_2017_I1609253/d02-x01-y01", "8000", "260" ) useOnePt( "/ATLAS_2017_I1609253/d03-x01-y01", "8000", "260" ) useOnePt( "/ATLAS_2017_I1609253/d04-x01-y01", "8000", "260" ) useOnePt( "/ATLAS_2017_I1609253/d05-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d06-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d07-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d08-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d09-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d10-x01-y01", "8000", "400" ) useOnePt( "/ATLAS_2017_I1609253/d11-x01-y01", "8000", "600" ) useOnePt( "/ATLAS_2017_I1609253/d12-x01-y01", "8000", "600" ) logging.info("Processing CMS_2016_I1487277") mergeByPt("/CMS_2016_I1487277/d01-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d02-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d03-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d04-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d05-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d06-x01-y01", "8000") mergeByPt("/CMS_2016_I1487277/d07-x01-y01", "8000") logging.info("Processing CMS_2016_I1421646") useOnePt( "/CMS_2016_I1421646/d01-x01-y01", "8000", "210" ) useOnePt( "/CMS_2016_I1421646/d02-x01-y01", "8000", "260" ) useOnePt( "/CMS_2016_I1421646/d03-x01-y01", "8000", "400" ) useOnePt( "/CMS_2016_I1421646/d04-x01-y01", "8000", "400" ) useOnePt( "/CMS_2016_I1421646/d05-x01-y01", "8000", "600" ) useOnePt( "/CMS_2016_I1421646/d06-x01-y01", "8000", "900" ) useOnePt( "/CMS_2016_I1421646/d07-x01-y01", "8000", "900" ) logging.info("Processing CMS_2017_I1605749") for i in [1,2,3,4,5,6,7,8,9,10,13,16] : useOnePt("/CMS_2017_I1605749/d%02d-x01-y01" % i, "8000", "400" ) for i in [11,14,17]: useOnePt("/CMS_2017_I1605749/d%02d-x01-y01" % i, "8000", "600" ) for i in [12,15,18]: useOnePt("/CMS_2017_I1605749/d%02d-x01-y01" % i, "8000", "900" ) def CMS_2012_I1111014_name(i,j) : if(i+j<100) : return "/CMS_2012_I1111014/d%02d-x01-y01" % (i+j) else : return "/CMS_2012_I1111014/d%03d-x01-y01" % (i+j) logging.info("Processing CMS_2012_I1111014") for j in [0,22,44,66,87,106]: for i in [1,2,3] : useOnePt(CMS_2012_I1111014_name(i,j), "7000", "20" ) for i in [4,5,6,7]: useOnePt(CMS_2012_I1111014_name(i,j), "7000", "40" ) for i in [8,9,10]: useOnePt(CMS_2012_I1111014_name(i,j), "7000", "80" ) for i in [11,12,13,14,15,16]: useOnePt(CMS_2012_I1111014_name(i,j), "7000", "110" ) for i in [17,18]: useOnePt(CMS_2012_I1111014_name(i,j), "7000", "210" ) useOnePt(CMS_2012_I1111014_name(19,j), "7000", "260" ) if(j<87) : for i in [20,21]: useOnePt(CMS_2012_I1111014_name(i,j), "7000", "400" ) if(j<66) : useOnePt(CMS_2012_I1111014_name(22,j), "7000", "600" ) for i in [126,127,128] : for j in [1,2] : mergeByPt("/CMS_2012_I1111014/d%03d-x01-y%02d" % (i,j), "7000") logging.info("Processing CMS_2018_I1682495") for i in [0,1,2,3] : useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 1), "13000", "110" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 2), "13000", "260" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 3), "13000", "260" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 4), "13000", "400" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 5), "13000", "400" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 6), "13000", "600" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 7), "13000", "600" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 8), "13000", "900" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+ 9), "13000", "900" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+10), "13000", "900" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+11), "13000", "900" ) useOnePt("/CMS_2018_I1682495/d%02d-x01-y01" % (12*i+12), "13000", "900" ) logging.info("Processing CMS_2015_I1385107") for i in range(1,9) : mergeByPt("/CMS_2015_I1385107/d%02d-x01-y01" % i, "2760") logging.info("Processing CMS_2018_I1663452") useOneMass("/CMS_2018_I1663452/d01-x01-y01", "13000", "5900" ) useOneMass("/CMS_2018_I1663452/d02-x01-y01", "13000", "4900" ) useOneMass("/CMS_2018_I1663452/d03-x01-y01", "13000", "3900" ) useOneMass("/CMS_2018_I1663452/d04-x01-y01", "13000", "3900" ) useOneMass("/CMS_2018_I1663452/d05-x01-y01", "13000", "2800" ) useOneMass("/CMS_2018_I1663452/d06-x01-y01", "13000", "2800" ) useOneMass("/CMS_2018_I1663452/d07-x01-y01", "13000", "2200" ) logging.info("Processing CMS_2017_I1519995") useOneMass("/CMS_2017_I1519995/d01-x01-y01", "13000", "3900" ) useOneMass("/CMS_2017_I1519995/d02-x01-y01", "13000", "3900" ) useOneMass("/CMS_2017_I1519995/d03-x01-y01", "13000", "2800" ) useOneMass("/CMS_2017_I1519995/d04-x01-y01", "13000", "2800" ) useOneMass("/CMS_2017_I1519995/d05-x01-y01", "13000", "2200" ) useOneMass("/CMS_2017_I1519995/d06-x01-y01", "13000", "1600" ) logging.info("Processing CMS_2016_I1486238") for i in [1,5,9,10,12,13,14,16,17] : useOnePt("/CMS_2016_I1486238/d%02d-x01-y01" % i, "7000", "20" ) mergeByPt("/CMS_2016_I1486238/d11-x01-y01", "7000") mergeByPt("/CMS_2016_I1486238/d15-x01-y01", "7000") logging.info("Processing ATLAS_2018_I1634970") for i in range(1,7) : mergeByPt("/ATLAS_2018_I1634970/d%02d-x01-y01"%i, "13000") for i in range(7,13) : mergeByMass("/ATLAS_2018_I1634970/d%02d-x01-y01"%i, "13000", 1.) # rescaling for semi-leptonic top decays (we only simulate 1 charge combination) for i in range(96,116,2) : rescale("/ATLAS_2018_I1656578/d%s-x01-y01" % i,2.) for i in range(15,29,2) : rescale("/ATLAS_2017_I1614149/d%s-x01-y01" % i,2.) for i in range(1,23,2) : rescale("/ATLAS_2015_I1404878/d%02d-x01-y01" % i,2.) rescale("/ATLAS_2015_I1397637/d01-x01-y01",2.) for i in range(1,22,1) : rescale("/ATLAS_2015_I1345452/d%02d-x01-y01" % i,2.) for i in range(1,10,1) : rescale("/ATLAS_2014_I1304688/d%02d-x01-y01" % i,2.) for i in range(1,82) : rescale("/CMS_2018_I1663958/d%02d-x01-y01" % i,2.) for i in range(169,173,1) : rescale("/CMS_2018_I1663958/d%02d-x01-y01" % i,2.) for i in range(8,15) : rescale("/CMS_2018_I1662081/d%02d-x01-y01" % i,2.) for i in range(1,41) : rescale("/CMS_2016_I1491950/d%02d-x02-y01" % i,2.) for i in range(1,13) : rescale("/CMS_2016_I1454211/d%02d-x01-y01" % i,2.) rescale("/CMS_2017_I1518399/d01-x01-y01",2.) # Choose output file name = args[0]+"-Jets.yoda" yoda.writeYODA(outhistos,name) sys.exit(0) diff --git a/Tests/python/plot-EE b/Tests/python/plot-EE new file mode 100755 --- /dev/null +++ b/Tests/python/plot-EE @@ -0,0 +1,3596 @@ +#! /usr/bin/env python +import glob,os,sys + +if __name__ == "__main__": + import logging + from optparse import OptionParser, OptionGroup + parser = OptionParser(usage="%prog name") + verbgroup = OptionGroup(parser, "Verbosity control") + verbgroup.add_option("-v", "--verbose", action="store_const", const=logging.DEBUG, dest="LOGLEVEL", + default=logging.INFO, help="print debug (very verbose) messages") + verbgroup.add_option("-q", "--quiet", action="store_const", const=logging.WARNING, dest="LOGLEVEL", + default=logging.INFO, help="be very quiet") + parser.add_option_group(verbgroup) + parser.add_option("--with-gg", + action='store_true' , + dest="gg", + default=False, + help="Include gg analyese") + parser.add_option("--without-gg", + action='store_false', + dest="gg", + default=False, + help="Don\'t include gg analyses") + (opts, args) = parser.parse_args() + logging.basicConfig(level=opts.LOGLEVEL, format="%(message)s") + ## Check args + if len(args) < 1: + logging.error("Must specify at least the name of the files") + sys.exit(1) + +directory=args[0] + +header=""" + +{title} + + + + +

{title}

""" + + +analyses={ "HadronDecays" : { }, + "TauDecays" : { "2pi" : {}, + "Kpi" : {}, + "KK" : {}, + "lnu" : {}, + "Keta" : {}, + "3pi" : {}, + "Kpipi" : {}, + "KKpi" : {}, + "2pieta" : {}, + "2pigamma" : {}, + "3K" : {}, + "4pi" : {}, + "5pi" : {},}, + "Charged" : {"TotalChargedMult" : { 0 : {}, 1 : {}, 4 : {}, 5 : {}, 51 : {}, 41 : {} , "C" : {} }, + "ChargedSpectrum" : { 0 : { "x" : {}, "p" : {}, "xi" : {}}, + 1 : { "x" : {}, "p" : {}, "xi" : {}}, + 2 : { "x" : {}, "p" : {}, "xi" : {}}, + 4 : { "x" : {}, "p" : {}, "xi" : {}}, + 5 : { "x" : {}, "p" : {}, "xi" : {}}, + 21 : { "x" : {}, "p" : {}, "xi" : {}}, + "C" : { "x" : {}, "p" : {}, "xi" : {}}}, + "ChargedRapidityThrust" : { }, + "ChargedpTInThrust" : { }, + "ChargedpTOutThrust" : { }, + "ChargedpTThrust" : { }, + "ChargedpTvsxpThrust" : { }, + "ChargedpTOutvsxpThrust" : { }, + "ChargedxFThrust" : { }, + "ChargedRapiditySphericity" : { }, + "ChargedpTInSphericity" : { }, + "ChargedpTOutSphericity" : { }, + "ChargedpLSphericity" : { }, + "ChargedpTSphericity" : { }, + "ChargedpT2Sphericity" : { }, + "ChargedFlowSphericity" : { }, + "ChargedEnergyFlowSphericity" : { }, + "ChargedAveragepT2inSphericity" : { }, + "ChargedAveragepT2outSphericity" : { }, + "ChargedAveragepTThrust" : { }, + "ChargedAveragepT2Thrust" : { }, + "ChargedSumpTThrust" : { }, + "ChargedSumpT2Thrust" : { }, + "ChargedAveragepTSphericity" : { }, + "ChargedAveragepT2Sphericity" : { }, + "ChargedSumpTSphericity" : { }, + "ChargedSumpT2Sphericity" : { }, + "DistChargedMult" : {0 : {}, 1 : {}, 2 : {}, 4 : {}, 5 : {} , 21 : {}, "C" :{}}}, + "IdentifiedParticle" : { 22 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 111 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 211 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 221 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 331 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 223 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 333 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 321 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 311 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 313 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 323 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 2212 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 413 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 423 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3122 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3212 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 2224 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3312 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3222 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + "3224B" : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 431 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 433 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3112 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3224 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3114 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3324 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3124 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 443 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 9010221 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 9000211 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 225 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 335 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 113 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 213 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 421 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 411 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 425 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 511 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4122 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 3334 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4332 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4132 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4112 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4114 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4124 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 14122 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + "321/2212" : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}}, + "IdentifiedParticleFlavour" : {111 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 211 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 321 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 311 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 313 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 333 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 2212 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 3122 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + 413 : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } }, + "321/2212" : { 1 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 4 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 5 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 41 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} }, + 51 : {"x" : {}, "xi" : {}, "p" : {}, "Ratio" : {}, "Other" : {} } },}, + "MultiplicityFlavour" : {111 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 211 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 321 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 2212 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 413 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 3122 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 313 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 333 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + 311 : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + "321/2212" : { 1 : {}, 4 : {}, 5 : {}, 41 : {}, 51 : {} }, + }, + "Multiplicity" : { 22: {}, 111 : {}, 211 : {}, 221 : {}, 331 : {}, 113 : {},9010221 : {},9000211 : {}, 213 : {}, + 223 : {}, 333 : {}, 321 : {}, 311 : {}, 411 : {}, 421 : {}, 431 : {}, 521 : {}, "511B" : {}, 531 : {}, 511 : {}, + 313 : {}, 323 : {}, 2212 : {}, 413 : {}, 423 : {}, 433 : {}, 513 : {}, 515 : {}, + 3122 : {}, 3312 : {}, 3212 : {}, 3112 : {}, 3114 : {}, 3324: {}, 3334 : {}, "321/2212" : {}, 4132 : {}, + 443 : {}, 100443 : {}, 553 : {}, 20223 : {}, 20333 : {}, 20443 : {}, 225 :{}, 335 : {}, 20431 : {}, 435 : {}, 315 : {}, 325 : {}, + 3222 : {}, 2224 : {}, 3224 : {}, 3114 : {}, 4122 : {}, 5122 :{}, 3124 :{}, 4222 : {}, "3222B" : {}, "3224B" : {}, + }, + "EventShapes" : { "T" : {}, "S" : {}, "D" : {}, "O" : {}, "Minor" : {}, "Major" : {}, + "y12_dur" : {}, "y23_dur" : {}, "y34_dur" : {}, "y45_dur" : {}, "y56_dur" : {}, + "y12_jade" : {}, "y23_jade" : {}, "y34_jade" : {}, "y45_jade" : {}, "y56_jade" : {}, + "HeavyJetMass" : {} , "JetMassDifference" : {} , + "LightJetMass" : {}, "TotalJetMass" : {} , "EEC" : {}, "AEEC" : {} , + "P" : {}, "A" : {} , "Qx" : {}, "Q21" : {}, "BW" : {}, "BT" : {}, "BN" : {}, + "Bdiff" : {}, "C" : {}, + "1jet_dur" : {}, "2jet_dur" : {}, "3jet_dur" : {}, "4jet_dur" : {}, "5jet_dur" : {}, "6jet_dur" : {}, + "1jet_jade" : {}, "2jet_jade" : {}, "3jet_jade" : {}, "4jet_jade" : {}, "5jet_jade" : {}, "6jet_jade" : {}, + "Moment_T":{}, "Moment_H":{},"Moment_C":{},"Moment_S":{},"Moment_L":{},"Moment_y":{},"Moment_BW":{}, + "Moment_BN":{},"Moment_BT":{},"Moment_O":{},"Moment_M":{},"Moment_m":{},}, + "FourJet" : {"BZ" : {}, "KSW" : {}, "NR" : {}, "alpha34" : {} }, + "EventShapesFlavour" : { "T" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "S" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "D" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "O" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "Minor" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "Major" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "y12" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"y23" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"y34" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"y45" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"y56" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "HeavyJetMass" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}} , "JetMassDifference" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}} , + "LightJetMass" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "TotalJetMass" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}} , "EEC" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "AEEC" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}} , + "P" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "A" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}} , "BW" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "BT" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "BN" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "Bdiff" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, "C" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}}, + "1jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"2jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"3jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"4jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"5jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},"6jet" : { 1 : {}, 2 : {}, 4 : {}, 5 : {}},}, + + "QED" : {}, +} +particleNames = { + 22 : "$\\gamma$", + 111 : "$\\pi^0$", 211 : "$\\pi^\\pm$", 221 : "$\\eta$", 331 : "$\\eta^\\prime$", + 113 : "$\\rho^0$", 213 : "$\\rho^\\pm$", 223 : "$\\omega$", 333 : "$\\phi$", + 115 : "$a_2^0$", 215 : "$a_2^\pm$", 225 : "$f_2$", 335 : "$f^\\prime_2$", + 20223 : "$f_1$", 20333 : "$f^\\prime_1$", 20113 : "$a^0_1$", 20213 : "$a^\\pm_1$", + 9010221 : "$f_0(980)$", 9000211 : "$a^\\pm_0(980)$", + + 311 : "$K^0,\\bar{K}^0$", 321 : "$K^\\pm$", 313 : "$K^{*0},\\bar{K}^{*0}$", 323 : "$K^{*\\pm}$", + 315 : "$K^0_2,\\bar{K}^0_2$", 325 : "$K^\\pm_2$", + 411 : "$D^\\pm$", 421 : "$D^0,\\bar{D}^0$", 413: "$D^{*\\pm}$", 415 : "$D^\\pm_2$", 425 : "$D^0_2, \\bar{D}^0_2$", 423: "$D^{*0},\\bar{D}^{*0}$", + 431 : "$D_s^\\pm$", 435 : "$D^\\pm_{s2}$", 20431 : "$D^\\pm_{s1}$", 433 : "$D_s^{*\\pm}$", + + 511 : "$B^0,\\bar{B}^0$", "511B" : "$B^0,\\bar{B}^0, B^\\pm$", + 521 : "$B^\\pm$", 531 : "$B^0_s,\\bar{B}^0_s$", 513 : "$B^*$",515 : "$B^{**}$", + + 443 : "$J/\\psi$" , 100443 : "$\\psi(2S)$", 553 : "$\Upsilon(1S)$", 20443 : "$\\chi_{c1}(1P)$", + 441 : "$\\eta_c$", 100553 : "$\Upsilon(2S)$", 300553 : "$\Upsilon(4S)$", 445 : "$\\chi_{c2}(1P)$", + 30443 : "$\\psi(3770)$", + 2212 : "$p,\\bar{p}$", 2224 : "$\\Delta^{++},\\bar{\\Delta}^{--}$", + + 3122 : "$\\Lambda^0,\\bar{\\Lambda}^0$", + 3222 : "$\\Sigma^+,\\bar{\Sigma}^-$", "3222B" : "$\\Sigma^\\pm,\\bar{\Sigma}^\\pm$", + 3212 : "$\\Sigma^0,\\bar{\Sigma}^0$", 3112 : "$\\Sigma^-,\\bar{\Sigma}^+$", + 3224 : "$\\Sigma^{*+},\\bar{\Sigma}^{*-}$", "3224B" : "$\\Sigma^{*\\pm},\\bar{\Sigma}^{*\\pm}$", + 3214 : "$\\Sigma^{*0},\\bar{\Sigma}^{*0}$", 3114 : "$\\Sigma^{*-},\\bar{\Sigma}^{*+}$", + 3322 : "$\\Xi^0,\\bar{\\Xi}^0$", 3312 : "$\\Xi^-,\\bar{\\Xi}^+$", 3324 : "$\\Xi^{*0},\\bar{\\Xi}^{*0}$", 3314 : "$\\Xi^{*-},\\bar{\\Xi}^{*+}$", + 3334 : "$\\Omega^-,\\bar{\\Omega}^+$", 3124 : "$\\Lambda^0(1520),\\bar{\\Lambda}^0(1520)$", + + 4122 : "$\\Lambda_c^+,\\bar{\\Lambda}^+_c$", 4222 : "$\\Sigma_c^{++}, \\Sigma_c^{0}, \\bar{\\Sigma}_c^{++}, \\bar{\\Sigma}_c^{0}$", + + 5122 : "$\\Lambda_b^0,\\bar{\\Lambda}^0_b$", 14122 : "$\\Lambda_c(2595)^+,\\bar{\\Lambda}(2595)_c^+$", + 4124 : "$\\Lambda_c(2625)^+,\\bar{\\Lambda}(2595)_c^+$", 4112 : "$\\Sigma_c^0,\\bar{\\Sigma}_c^0$", 4114 : "$\\Sigma_c^{*0},\\bar{\\Sigma}_c^{*0}$", + 4332 : "$\\Omega_c^0,\\bar{\\Omega}_c^0$", 4132 : "$\\Xi_c^0,\\bar{\\Xi}_c^0$", + "321/2212" : "$K^\\pm,p,\\bar{p}$" + } +# hadron species +mLight = [211,111,221,331,213,113,223,333,225,335,20213,20113,20223,20333,9010221, 9000111, 9000211] +mStrange = [311,321,313,323,315,325] +mCharm = [411,421,413,423,425,431,433,435,20431] +mBottom = [511,"511B",521,531,513,515] +mccbar = [441,443,100443,20443,30443] +mbbbar = [553,100553,300553] +bLight = [2212,2224] +bStrange = [3122,3222,"3222B",3212,3112,3114,3224,"3224B",3312,3322,3324,3334,3124] +bCharm = [4122,4112,4222,4114,4332,4132,14122,4124] +bBottom = [5122] +# hadron decays +modes = {} +# neutral pion +analyses["HadronDecays"][111] = { "Modes" : {"$\\pi^0\\to\\gamma e^+e^-$" : {} } } +analyses["HadronDecays"][111]["Modes"]["$\\pi^0\\to\\gamma e^+e^-$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h2_111p_22p_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_111p_22p_11_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_111p_22p_11_mff"] +# eta +analyses["HadronDecays"][221] = { "Modes" : {"$\\eta\\to\\pi^0\\pi^0\\pi^0$" : {}, + "$\\eta\\to\\pi^+\\pi^-\\pi^0$" : {}, + "$\\eta\\to\\gamma e^+e^-$" : {}, + "$\\eta\\to\\gamma \\pi^+\\pi^-$" : {}, + "$\\eta\\to\\gamma\\gamma\\pi^0$" : {} } } +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\pi^0\\pi^0\\pi^0$"]["MC" ] = ["/MC_Eta_Decay/dpi0pi0_0"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\pi^+\\pi^-\\pi^0$"]["MC" ] = ["/MC_Eta_Decay/dpi0pim_0","/MC_Eta_Decay/dpi0pip_0", + "/MC_Eta_Decay/dpippim_0"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\pi^+\\pi^-\\pi^0$"]["data"] = ["/KLOE2_2016_I1416990/d01-x01-y01","/KLOE2_2016_I1416990/d02-x01-y01", + "/KLOE2_2016_I1416990/d02-x01-y02","/KLOE2_2016_I1416990/d02-x01-y03", + "/KLOE2_2016_I1416990/d02-x01-y04","/KLOE2_2016_I1416990/d02-x01-y05", + "/KLOE2_2016_I1416990/d02-x01-y06","/KLOE2_2016_I1416990/d02-x01-y07", + "/KLOE2_2016_I1416990/d02-x01-y08","/KLOE2_2016_I1416990/d02-x01-y09", + "/KLOE2_2016_I1416990/d02-x01-y10","/KLOE2_2016_I1416990/d02-x01-y11", + "/KLOE2_2016_I1416990/d02-x01-y12","/KLOE2_2016_I1416990/d02-x01-y13", + "/KLOE2_2016_I1416990/d02-x01-y14","/KLOE2_2016_I1416990/d02-x01-y15", + "/KLOE2_2016_I1416990/d02-x01-y16","/KLOE2_2016_I1416990/d02-x01-y17"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\gamma e^+e^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_11_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_11_mff"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\gamma e^+e^-$"]["data"] = ["/A2_2017_I1486671/d01-x01-y01"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\gamma \\pi^+\\pi^-$"]["MC" ] = ["/MC_Eta_Decay/mpimgamma_0","/MC_Eta_Decay/mpipgamma_0", + "/MC_Eta_Decay/mpippim_0" ,"/MC_Eta_Decay/photonenergy_0"] +analyses["HadronDecays"][221]["Modes"]["$\\eta\\to\\gamma\\gamma\\pi^0$" ]["MC" ] = ["/MC_Eta_Decay/mgammagamma_0","/MC_Eta_Decay/mpi0gamma_0"] +# eta' +analyses["HadronDecays"][331] = { "Modes" : {"$\\eta^\\prime\\to\\pi^0\\pi^0\\pi^0$" : {}, + "$\\eta^\\prime\\to\\pi^+\\pi^-\\pi^0$" : {}, + "$\\eta^\\prime\\to\\eta\\pi^0\\pi^0$" : {}, + "$\\eta^\\prime\\to\\eta\\pi^+\\pi^-$" : {}, + "$\\eta^\\prime\\to\\gamma e^+e^-$" : {}, + "$\\eta^\\prime\\to\\gamma \\mu^+\\mu^-$" : {}, + "$\\eta^\\prime\\to\\gamma \\pi^+\\pi^-$" : {}, + "$\\eta^\\prime\\to\\gamma\\gamma\\pi^0$" : {} } } +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma e^+e^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_11_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_11_mff"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma e^+e^-$"]["data"] = ["/BESIII_2015_I1364494/d01-x01-y03"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma \\mu^+\\mu^-$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_13_mff", + "/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_13_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_331p_22p_13_mVf"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\pi^+\\pi^-\\pi^0$"]["MC"] = ["/MC_Eta_Decay/dpi0pim_1","/MC_Eta_Decay/dpippim_1", + "/MC_Eta_Decay/dpi0pip_1"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma \\pi^+\\pi^-$"]["MC" ] =["/MC_Eta_Decay/mpimgamma_1","/MC_Eta_Decay/mpipgamma_1", + "/MC_Eta_Decay/mpippim_1","/MC_Eta_Decay/photonenergy_1"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma \\pi^+\\pi^-$"]["data"] = ["/BESIII_2018_I1641075/d01-x01-y05"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\gamma\\gamma\\pi^0$"]["MC" ] = ["/MC_Eta_Decay/mgammagamma_1","/MC_Eta_Decay/mpi0gamma_1"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\pi^0\\pi^0\\pi^0$"]["MC" ] = ["/MC_Eta_Decay/dpi0pi0_1"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\eta\\pi^0\\pi^0$"]["MC" ] = ["/MC_Eta_Decay/dpi0eta","/MC_Eta_Decay/dpi0pi0_2"] +analyses["HadronDecays"][331]["Modes"]["$\\eta^\\prime\\to\\eta\\pi^+\\pi^-$"]["MC" ] = ["/MC_Eta_Decay/dpimeta","/MC_Eta_Decay/dpipeta", + "/MC_Eta_Decay/dpippim_2"] +# omega +analyses["HadronDecays"][223] = { "Modes" : {"$\\omega\\to\\pi^+\\pi^-\\pi^0$" : {}, + "$\\omega\\to e^+e^-\\pi^0$" : {}, + "$\\omega\\to \\mu^+\\mu^-\\pi^0$" : {},}} +analyses["HadronDecays"][223]["Modes"]["$\\omega\\to\\pi^+\\pi^-\\pi^0$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz_1","/MC_OmegaPhia1_3Pion_Decay/m0_1", + "/MC_OmegaPhia1_3Pion_Decay/mminus_1","/MC_OmegaPhia1_3Pion_Decay/mplus_1", + "/MC_OmegaPhia1_3Pion_Decay/xhist_1","/MC_OmegaPhia1_3Pion_Decay/yhist_1"] +analyses["HadronDecays"][223]["Modes"]["$\\omega\\to e^+e^-\\pi^0$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_223p_111p_11_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_223p_111p_11_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_223p_111p_11_mff"] +analyses["HadronDecays"][223]["Modes"]["$\\omega\\to \\mu^+\\mu^-\\pi^0$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_223p_111p_13_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_223p_111p_13_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_223p_111p_13_mff"] +analyses["HadronDecays"][223]["Modes"]["$\\omega\\to e^+e^-\\pi^0$"]["data"] = ["/A2_2017_I1486671/d02-x01-y01"] +# phi +analyses["HadronDecays"][333] = { "Modes" : {"$\\phi\\to\\pi^+\\pi^-\\pi^0$" : {}, + "$\\phi\\to e^+e^-\\pi^0$" : {}, + "$\\phi\\to e^+e^-\\eta$" : {}, + "$\\phi\\to \\mu^+\\mu-\\gamma$" : {}, + "$\\phi\\to \\pi^0\\pi^0\\gamma$" : {}, + "$\\phi\\to \\eta\\pi^0\\gamma$" : {},}} +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to\\pi^+\\pi^-\\pi^0$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz_2","/MC_OmegaPhia1_3Pion_Decay/m0_2", + "/MC_OmegaPhia1_3Pion_Decay/mminus_2","/MC_OmegaPhia1_3Pion_Decay/mplus_2", + "/MC_OmegaPhia1_3Pion_Decay/xhist_2","/MC_OmegaPhia1_3Pion_Decay/yhist_2"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to\\pi^+\\pi^-\\pi^0$"]["data"] = ["/SND_2001_I558279/d01-x01-y01","/SND_2001_I558279/d02-x01-y01"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to e^+e^-\\pi^0$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_333p_111p_11_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_333p_111p_11_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_333p_111p_11_mff"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to e^+e^-\\pi^0$"]["data"] = ["/KLOE2_2016_I1416825/d01-x01-y01"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to e^+e^-\\eta$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_333p_221p_11_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_333p_221p_11_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_333p_221p_11_mff"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to e^+e^-\\eta$"]["data"] = ["/KLOE2_2014_I1317236/d01-x01-y01"] + +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to \\pi^0\\pi^0\\gamma$"]["data"] = ["/KLOE_2002_I585183/d01-x01-y01","/SND_2000_I525398/d01-x01-y01"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to \\eta\\pi^0\\gamma$" ]["data"] = ["/KLOE_2009_I818106/d01-x01-y01","/SND_2000_I527094/d01-x01-y01"] +analyses["HadronDecays"][333]["Modes"]["$\\phi\\to \\mu^+\\mu-\\gamma$"]["MC"]=["/MC_Meson_Meson_Leptons_Decay/h2_333p_22p_13_mff","/MC_Meson_Meson_Leptons_Decay/h2_333p_22p_13_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_333p_22p_13_mVf"] +# a_1+ +analyses["HadronDecays"][20213] = { "Modes" : { "$a_1^+\\to\\pi^+\\pi^0\\pi^0$" : {}, + "$a_1^+\\to\\pi^+\\pi^-\\pi^+$" : {},}} +analyses["HadronDecays"][20213]["Modes"]["$a_1^+\\to\\pi^+\\pi^0\\pi^0$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz1","/MC_OmegaPhia1_3Pion_Decay/hist1A", + "/MC_OmegaPhia1_3Pion_Decay/hist1B"] +analyses["HadronDecays"][20213]["Modes"]["$a_1^+\\to\\pi^+\\pi^-\\pi^+$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz3","/MC_OmegaPhia1_3Pion_Decay/hist3A", + "/MC_OmegaPhia1_3Pion_Decay/hist3B"] +# a_10 +analyses["HadronDecays"][20113] = { "Modes" : { "$a_1^0\\to\\pi^0\\pi^0\\pi^0$" : {}, + "$a_1^0\\to\\pi^+\\pi^-\\pi^0$" : {},}} +analyses["HadronDecays"][20113]["Modes"]["$a_1^0\\to\\pi^0\\pi^0\\pi^0$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz0","/MC_OmegaPhia1_3Pion_Decay/hist0"] +analyses["HadronDecays"][20113]["Modes"]["$a_1^0\\to\\pi^+\\pi^-\\pi^0$"]["MC"] = ["/MC_OmegaPhia1_3Pion_Decay/dalitz2","/MC_OmegaPhia1_3Pion_Decay/hist2A", + "/MC_OmegaPhia1_3Pion_Decay/hist2B" ,"/MC_OmegaPhia1_3Pion_Decay/hist2C"] +# charm decays +# D+ +analyses["HadronDecays"][411] = { "Modes" : { "$D^+\\to\\bar{K}^0e^+\\nu_e$" : {}, + "$D^+\\to\\pi^0e^+\\nu_e$" : {}, + "$D^+\\to \\bar{K}_1(1270)^0e^+\\nu_e$" : {}, + "$D^+\\to\\bar{K}^0\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\pi^0\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to \\bar{K}_1(1270)^0\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\eta e^+\\nu_e$" : {}, + "$D^+\\to\\eta\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\eta^\\prime e^+\\nu_e$" : {}, + "$D^+\\to\\eta^\\prime\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\rho^0 e^+\\nu_e$" : {}, + "$D^+\\to\\rho^0\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\omega e^+\\nu_e$" : {}, + "$D^+\\to\\omega\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\bar{K}^{*0}e^+\\nu_e$" : {}, + "$D^+\\to\\bar{K}^{*0}\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to\\bar{K}_2^{*0}e^+\\nu_e$" : {}, + "$D^+\\to\\bar{K}_2^{*0}\\mu^+\\nu_\\mu$" : {}, + "$D^+\\to K^-\\pi^+\\pi^+$" : {}, + "$D^+\\to K^+\\pi^-\\pi^+$" : {}, + "$D^+\\to\\bar{K}^0\\pi^+\\pi^0$" : {}, + }} +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^0e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_311m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_311m_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^0e^+\\nu_e$" ]["data"] = ["/BESIII_2017_I1519425/d01-x01-y01"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_111p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_111p_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0e^+\\nu_e$" ]["data"] = ["/BESIII_2017_I1519425/d02-x01-y01"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to \\bar{K}_1(1270)^0e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_10313m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_10313m_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_311p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_311p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_111p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_111p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to \\bar{K}_1(1270)^0\\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_10313p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_10313p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to K^-\\pi^+\\pi^+$" ]["MC" ] = ["/MC_D_Dalitz/dalitz3","/MC_D_Dalitz/h_Kpiall3", + "/MC_D_Dalitz/h_Kpihigh3","/MC_D_Dalitz/h_Kpilow3", + "/MC_D_Dalitz/h_pipi3"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to K^+\\pi^-\\pi^+$" ]["MC" ] = ["/MC_D_Dalitz/dalitz5","/MC_D_Dalitz/h_kppim5", + "/MC_D_Dalitz/h_kppip5","/MC_D_Dalitz/h_pippim5",] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^0\\pi^+\\pi^0$" ]["MC" ] = ["/MC_D_Dalitz/dalitz4","/MC_D_Dalitz/h_Kpi04", + "/MC_D_Dalitz/h_Kpip4","/MC_D_Dalitz/h_pipi4"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_221p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_221p_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_221p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_221p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta^\\prime e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_331p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_331p_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta^\\prime\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_331p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_331p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\rho^0 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_113p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_113p_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\rho^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_113p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_113p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\omega e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_223p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_223p_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\omega\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_223p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_223p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^{*0}e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_313m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_313m_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^{*0}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_313p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_313p_13p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}_2^{*0}e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_315m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_315m_11m_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}_2^{*0}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411m_315p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_315p_13p_scale"] +# D^0 +analyses["HadronDecays"][421] ={ "Modes" : { "$D^0\\to K^-e^+\\nu_e$" : {}, + "$D^0\\to K^-\\mu^+\\nu_\\mu$" : {}, + "$D^0\\to K^{*-}e^+\\nu_e$" : {}, + "$D^0\\to K^{*-}\\mu^+\\nu_\\mu$" : {}, + "$D^0\\to K^{*-}_2e^+\\nu_e$" : {}, + "$D^0\\to K^{*-}_2\\mu^+\\nu_\\mu$" : {}, + "$D^0\\to K_1(1270)^{-}e^+\\nu_e$" : {}, + "$D^0\\to K_1(1270)^{-}\\mu^+\\nu_\\mu$": {}, + "$D^0\\to \\pi^-e^+\\nu_e$" : {}, + "$D^0\\to \\pi^-\\mu^+\\nu_\\mu$" : {}, + "$D^0\\to \\rho^-e^+\\nu_e$" : {}, + "$D^0\\to \\rho^-\\mu^+\\nu_\\mu$" : {}, + "$D^0\\to K^-\\pi^+\\pi^0$" : {}, + "$D^0\\to \\bar{K}^0\\pi^+\\pi^-$" : {}, + }} +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_323m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_323m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_323p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_323p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}_2e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_325m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_325m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}_2\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_325p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_325p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K_1(1270)^{-}e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_10323m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_10323m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K_1(1270)^{-}\\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_10323p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_10323p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^-e^+\\nu_e$" ]["data"] = ["/BESIII_2015_I1391138/d01-x01-y03"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^-e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_321m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_321m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_321p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_321p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\pi^-e^+\\nu_e$" ]["data"] = ["/BABAR_2015_I1334693/d01-x01-y01", + "/BESIII_2015_I1391138/d02-x01-y03"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\pi^-e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_211m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_211m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\pi^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_211p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_211p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\rho^-e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_213m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_213m_11m_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\rho^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421m_213p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_213p_13p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^-\\pi^+\\pi^0$" ]["MC" ] = ["/MC_D_Dalitz/dalitz2","/MC_D_Dalitz/h_minus2", + "/MC_D_Dalitz/h_neutral2","/MC_D_Dalitz/h_pipi2"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\bar{K}^0\\pi^+\\pi^-$" ]["MC" ] = ["/MC_D_Dalitz/dalitz1","/MC_D_Dalitz/h_minus1", + "/MC_D_Dalitz/h_pipi1","/MC_D_Dalitz/h_plus1"] +analyses["HadronDecays"][431] = { "Modes" : { "$D_s^+\\to \\eta e^+\\nu_e$" : {}, + "$D_s^+\\to \\eta \\mu^+\\nu_\\mu$" : {}, + "$D_s^+\\to \\eta^\\prime e^+\\nu_e$" : {}, + "$D_s^+\\to \\eta^\\prime \\mu^+\\nu_\\mu$" : {}, + "$D_s^+\\to \\phi e^+\\nu_e$" : {}, + "$D_s^+\\to \\phi \\mu^+\\nu_\\mu$" : {}, + "$D_s^+\\to K^0 e^+\\nu_e$" : {}, + "$D_s^+\\to K^0 \\mu^+\\nu_\\mu$" : {}, + "$D_s^+\\to K^{*0} e^+\\nu_e$" : {}, + "$D_s^+\\to K^{*0} \\mu^+\\nu_\\mu$" : {}, + "$D_s^+\\to K^+\\pi^-\\pi^+$" : {}, + }} +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_221p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_221p_11m_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431m_221p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_221p_13p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta^\\prime e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_331p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_331p_11m_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta^\\prime \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431m_331p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_331p_13p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\phi e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_333p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_333p_11m_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\phi \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431m_333p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_333p_13p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^0 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_311m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_311m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431p_311p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_311p_11m_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431m_311p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_311p_13p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^{*0} e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_313p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_313p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431p_313m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_313m_11m_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^{*0} \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431m_313p_13p_scale", + "/MC_Semi_Leptonic_Decay/h_431m_313p_13p_energy"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^+\\pi^-\\pi^+$" ]["MC" ] = ["/MC_D_Dalitz/dalitz6","/MC_D_Dalitz/h_kppim6", + "/MC_D_Dalitz/h_kppip6","/MC_D_Dalitz/h_pippim6"] +analyses["HadronDecays"][511]={ "Spectrum" : {}, + "Modes" : { "$B^0\\to\\pi^- e^+\\nu_e$" : {}, + "$B^0\\to\\pi^- \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to\\rho^- e^+\\nu_e$" : {}, + "$B^0\\to\\rho^- \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^- e^+\\nu_e$" : {}, + "$B^0\\to D^- \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^{*-} e^+\\nu_e$" : {}, + "$B^0\\to D^{*-} \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^{*-}_2 e^+\\nu_e$" : {}, + "$B^0\\to D^{*-}_2 \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^{*-}_0(2400) e^+\\nu_e$" : {}, + "$B^0\\to D^{*-}_0(2400) \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^{-}_1(2430) e^+\\nu_e$" : {}, + "$B^0\\to D^{-}_1(2430) \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to D^{-}_1(2420) e^+\\nu_e$" : {}, + "$B^0\\to D^{-}_1(2420) \\mu^+\\nu_\\mu$" : {}, + "$B^0\\to K^{*0} e^+e^-$" : {}, + "$B^0\\to K^{*0} \\mu^+\\mu^-$" : {}, + "$B^0\\to K^0 e^+e^-$" : {}, + "$B^0\\to K^0 \\mu^+\\mu^-$" : {}, + "$B\\to X_s\\gamma$" : {},}} +analyses["HadronDecays"][521]={"Modes" : { "$B^+\\to\\pi^0 e^+\\nu_e$" : {}, + "$B^+\\to\\pi^0 \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\omega e^+\\nu_e$" : {}, + "$B^+\\to\\omega \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\rho^0 e^+\\nu_e$" : {}, + "$B^+\\to\\rho^0 \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\eta^\\prime e^+\\nu_e$" : {}, + "$B^+\\to\\eta^\\prime \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\eta e^+\\nu_e$" : {}, + "$B^+\\to\\eta \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\bar{D}^0 e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^0 \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\bar{D}^{*0} e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^{*0} \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\bar{D}^{*0}_2 e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^{*0}_2 \\mu^+\\nu_\\mu$": {}, + "$B^+\\to\\bar{D}^{*0}_0(2400) e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^{*0}_0(2400) \\mu^+\\nu_\\mu$": {}, + "$B^+\\to\\bar{D}^{0}_1(2430) e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^{0}_1(2430) \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to\\bar{D}^{0}_1(2420) e^+\\nu_e$" : {}, + "$B^+\\to\\bar{D}^{0}_1(2420) \\mu^+\\nu_\\mu$" : {}, + "$B^+\\to K^{*+} e^+e^-$" : {}, + "$B^+\\to K^{*+} \\mu^+\\mu^-$" : {}, + "$B^+\\to K^- e^+e^-$" : {}, + "$B^+\\to K^- \\mu^+\\mu^-$" : {},} +} + + +analyses["HadronDecays"][511]["Spectrum"][311] = ["/ARGUS_1994_I354224/d01-x01-y01"] + +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\pi^0 e^+\\nu_e$" ]["data"] = ["/BELLE_2013_I1238273/d02-x01-y01"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\pi^0 e^+\\nu_e$" ]["MC"] = ["/MC_Semi_Leptonic_Decay/h_521p_111p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_111p_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\pi^0 \\mu^+\\nu_\\mu$" ]["MC"] = ["/MC_Semi_Leptonic_Decay/h_521m_111p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_111p_13p_scale"] + + +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\pi^- e^+\\nu_e$" ]["data"] = ["/BELLE_2011_I878990/d01-x01-y01","/BELLE_2013_I1238273/d01-x01-y01"] +#analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\pi^- \\mu^+\\nu_\\mu$" ]["data"] = [] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\pi^- e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_211m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_211m_11m_scale",] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\pi^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_211p_13p_scale", + "/MC_Semi_Leptonic_Decay/h_511m_211p_13p_energy"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\rho^- e^+\\nu_e$" ]["data"] = ["/BELLE_2013_I1238273/d03-x01-y01"] +#analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\rho^- \\mu^+\\nu_\\mu$" ]["data"] = [] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\rho^- e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_213m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_213m_11m_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\rho^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_213p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_213p_13p_scale",] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\omega e^+\\nu_e$" ]["data"] = ["/BELLE_2013_I1238273/d05-x01-y01","/BABAR_2013_I1116411/d01-x01-y01"] +#analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\omega \\mu^+\\nu_\\mu$" ]["data"] = [] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\omega e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_223p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_223p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\omega \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_223p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_223p_11m_scale",] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\rho^0 e^+\\nu_e$" ]["data"] = ["/BELLE_2013_I1238273/d04-x01-y01"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\rho^0 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_113p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_113p_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\rho^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_113p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_113p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^- e^+\\nu_e$" ]["data"] = ["/BELLE_2015_I1397632/d01-x01-y01"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^- \\mu^+\\nu_\\mu$" ]["data"] = ["/BELLE_2015_I1397632/d01-x01-y02"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^- e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_411m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_411m_11m_scale",] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_411p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_411p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-} e^+\\nu_e$" ]["data"] = ["/BELLE_2017_I1512299/d01-x01-y01","/BELLE_2017_I1512299/d02-x01-y01", + "/BELLE_2017_I1512299/d03-x01-y01","/BELLE_2017_I1512299/d04-x01-y01",] +#analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-} \\mu^+\\nu_\\mu$" ]["data"] = [] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-} e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_413m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_413m_11m_scale",] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-} \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_413p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_413p_13p_scale",] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_2 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_415m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_415m_11m_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_2 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_415p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_415p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta^\\prime e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_331p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_331p_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta^\\prime \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_331p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_331p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_221p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_221p_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_221p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_221p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^0 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_421m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_421m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_421p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_421p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^0 e^+\\nu_e$" ]["data"] = ["/BELLE_2015_I1397632/d02-x01-y01"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^0 \\mu^+\\nu_\\mu$" ]["data"] = ["/BELLE_2015_I1397632/d02-x01-y02"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0} e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_423m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_423m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0} \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_423p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_423p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_2 e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_425m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_425m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_2 \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_425p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_425p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_0(2400) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_10421m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_10421m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_0(2400) \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_10421p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_10421p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2430) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_20423m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_20423m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2430) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_20423p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_20423p_13p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2420) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_10423m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_10423m_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2420) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_10423p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_10423p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_0(2400) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_10411m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_10411m_11m_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_0(2400) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_10411p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_10411p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2430) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_20413m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_20413m_11m_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2430) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_20413p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_20413p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2420) e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_10413m_11m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_10413m_11m_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2420) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511m_10413p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_10413p_13p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to K^{*0} e^+e^-$" ]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_11_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_11_mff"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to K^{*0} \\mu^+\\mu^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_13_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_13_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_511p_313p_13_mff"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to K^0 e^+e^-$" ]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h_511p_311p_11_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_511p_311p_11_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_511p_311p_11_mff", + "/MC_Meson_Meson_Leptons_Decay/h_511m_311m_11_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_511m_311m_11_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_511m_311m_11_mff"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to K^0 \\mu^+\\mu^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h_511m_311m_13_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_511m_311m_13_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_511m_311m_13_mff"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to K^{*+} e^+e^-$" ]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_521m_323m_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_521m_323m_11_mff", + "/MC_Meson_Meson_Leptons_Decay/h2_521m_323m_11_mVfbar"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to K^{*+} \\mu^+\\mu^-$"]["MC" ] = [] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to K^- e^+e^-$" ]["MC" ] = [] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to K^- \\mu^+\\mu^-$" ]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h_521m_321m_13_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_521m_321m_13_mff", + "/MC_Meson_Meson_Leptons_Decay/h_521m_321m_13_mPf"] +analyses["HadronDecays"][511]["Modes"]["$B\\to X_s\\gamma$"]["data"]=["/BELLE_2015_I1330289/d01-x01-y02"] +# charmonium +analyses["HadronDecays"][443] = { "Modes" : { "$J/\\psi\\to\\eta e^+e^-$" : {}, + "$J/\\psi\\to\\gamma e^+e^-$" : {}, + "$J/\\psi\\to p\\bar{p}$" : {}, + "$J/\\psi\\to n\\bar{n}$" : {}, + "$J/\\psi\\to \\Sigma^{*-}\\bar\\Sigma^{*+}$" : {}, + "$J/\\psi\\to \\Sigma^{*0}\\bar\\Sigma^{*0}$" : {}, + "$J/\\psi\\to \\Sigma^{*+}\\bar\\Sigma^{*-}$" : {}, + "$J/\\psi\\to \\Xi^{-}\\bar\\Xi^{+}$" : {}, + "$J/\\psi\\to \\Xi^{0}\\bar\\Xi^{0}$" : {}, + "$J/\\psi\\to \\Lambda^{0}\\bar\\Lambda^{0}$" : {}, + "$J/\\psi\\to \\Sigma^{0}\\bar\\Sigma^{0}$" : {}, +}} + +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to\\eta e^+e^-$" ]["data"] = ["/BESIII_2018_I1697377/d01-x01-y01"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to\\gamma e^+e^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_11_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_11_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_11_mff"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to p\\bar{p}$" ]["data"] = ["/BESIII_2012_I1113599/d01-x01-y01"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to p\\bar{p}$" ]["MC"] = ["/BESIII_2012_I1113599/ctheta_p"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to n\\bar{n}$" ]["data"] = ["/BESIII_2012_I1113599/d01-x01-y02"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to n\\bar{n}$" ]["MC"] = ["/BESIII_2012_I1113599/ctheta_n"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Sigma^{*-}\\bar\\Sigma^{*+}$"]["data"] = ["/BESIII_2016_I1422780/d02-x01-y02","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Sigma^{*0}\\bar\\Sigma^{*0}$"]["data"] = ["/BESIII_2017_I1506414/d01-x01-y01","/BESIII_2017_I1506414/d02-x01-y01"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Sigma^{*+}\\bar\\Sigma^{*-}$"]["data"] = ["/BESIII_2016_I1422780/d02-x01-y03","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Xi^{-}\\bar\\Xi^{+}$" ]["data"] = ["/BESIII_2016_I1422780/d02-x01-y01","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Xi^{0}\\bar\\Xi^{0}$" ]["data"] = ["/BESIII_2017_I1506414/d01-x01-y02","/BESIII_2017_I1506414/d02-x02-y01"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Lambda^{0}\\bar\\Lambda^{0}$"]["data"] = ["/BESIII_2017_I1510563/d01-x01-y01","/BESIII_2017_I1510563/d02-x01-y01", + "/BESIII_2019_I1691850/d01-x01-y01","/BESIII_2019_I1691850/d01-x02-y01", + "/BESIII_2019_I1691850/d01-x03-y01","/BESIII_2019_I1691850/d01-x04-y01", + "/BESIII_2019_I1691850/d01-x05-y01",] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Lambda^{0}\\bar\\Lambda^{0}$"]["MC" ] = ["/BESIII_2019_I1691850/T1_n","/BESIII_2019_I1691850/T1_p", + "/BESIII_2019_I1691850/T2_n","/BESIII_2019_I1691850/T2_p", + "/BESIII_2019_I1691850/T3_n","/BESIII_2019_I1691850/T3_p", + "/BESIII_2019_I1691850/T4_n","/BESIII_2019_I1691850/T4_p", + "/BESIII_2019_I1691850/T5_n","/BESIII_2019_I1691850/T5_p", + "/BESIII_2019_I1691850/mu_n","/BESIII_2019_I1691850/mu_p", + "/BESIII_2019_I1691850/cThetaL",] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Sigma^{0}\\bar\\Sigma^{0}$" ]["data"] = ["/BESIII_2017_I1510563/d01-x01-y03","/BESIII_2017_I1510563/d02-x02-y01"] + +# eta_c +analyses["HadronDecays"][441] = {"DistChargedMult" : {}} + +analyses["HadronDecays"][441]["DistChargedMult"]["data"] = ["/BESIII_2019_I1724880/d01-x01-y01"] +# psi(3770) +analyses["HadronDecays"][30443] = { "Modes" : { "$\\psi(3770)\\to J/\\psi\\pi^0\\pi^0$" : {}, + "$\\psi(3770)\\to J/\\psi\\pi^+\\pi^-$" : {},}} +analyses["HadronDecays"][30443]["Modes"]["$\\psi(3770)\\to J/\\psi\\pi^0\\pi^0$"]["MC" ] = ["/MC_Onium_PiPi_Decay/h_30443_443_mpi0pi0","/MC_Onium_PiPi_Decay/h_30443_443_hpi0pi0"] +analyses["HadronDecays"][30443]["Modes"]["$\\psi(3770)\\to J/\\psi\\pi^+\\pi^-$"]["MC" ] = ["/MC_Onium_PiPi_Decay/h_30443_443_hpippim","/MC_Onium_PiPi_Decay/h_30443_443_mpippim"] + +# psi(2S) +analyses["HadronDecays"][100443] = { "Modes" : { "$\\psi(2S)\\to p\\bar{p}$" : {}, + "$\\psi(2S)\\to n\\bar{n}$" : {}, + "$\\psi(2S)\\to \\Sigma^{*-}\\bar\\Sigma^{*+}$" : {}, + "$\\psi(2S)\\to \\Sigma^{*0}\\bar\\Sigma^{*0}$" : {}, + "$\\psi(2S)\\to \\Sigma^{*+}\\bar\\Sigma^{*-}$" : {}, + "$\\psi(2S)\\to \\Xi^{-}\\bar\\Xi^{+}$" : {}, + "$\\psi(2S)\\to \\Xi^{0}\\bar\\Xi^{0}$" : {}, + "$\\psi(2S)\\to \\Lambda^{0}\\bar\\Lambda^{0}$" : {}, + "$\\psi(2S)\\to \\Sigma^{0}\\bar\\Sigma^{0}$" : {}, }} +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to p\\bar{p}$" ]["data"] = ["/BESIII_2018_I1658762/d01-x01-y01"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to p\\bar{p}$" ]["MC"] = ["/BESIII_2018_I1658762/ctheta_p"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to n\\bar{n}$" ]["data"] = ["/BESIII_2018_I1658762/d01-x01-y02"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to n\\bar{n}$" ]["MC"] = ["/BESIII_2018_I1658762/ctheta_n"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Sigma^{*-}\\bar\\Sigma^{*+}$"]["data"] = ["/BESIII_2016_I1422780/d02-x01-y05","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Sigma^{*0}\\bar\\Sigma^{*0}$"]["data"] = ["/BESIII_2017_I1506414/d01-x01-y03","/BESIII_2017_I1506414/d02-x03-y01"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Sigma^{*+}\\bar\\Sigma^{*-}$"]["data"] = ["/BESIII_2016_I1422780/d02-x01-y06","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Xi^{-}\\bar\\Xi^{+}$" ]["data"] = ["/BESIII_2016_I1422780/d02-x01-y04","/BESIII_2016_I1422780/d01-x01-y03"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Xi^{0}\\bar\\Xi^{0}$" ]["data"] = ["/BESIII_2017_I1506414/d01-x01-y04","/BESIII_2017_I1506414/d02-x04-y01"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Lambda^{0}\\bar\\Lambda^{0}$"]["data"] = ["/BESIII_2017_I1510563/d01-x01-y02","/BESIII_2017_I1510563/d02-x03-y01"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Sigma^{0}\\bar\\Sigma^{0}$" ]["data"] = ["/BESIII_2017_I1510563/d01-x01-y04","/BESIII_2017_I1510563/d02-x04-y01"] +# bottomonium +# upsilon(1s) +analyses["HadronDecays"][553] = { "Mult" : {}, "Spectrum" : {} } +analyses["HadronDecays"][553]["Mult"][3122 ] = ["/ARGUS_1988_I251097/d01-x01-y01"] +analyses["HadronDecays"][553]["Mult"][3312 ] = ["/ARGUS_1988_I251097/d01-x01-y02"] +analyses["HadronDecays"][553]["Mult"][3212 ] = ["/ARGUS_1988_I251097/d01-x01-y03"] +analyses["HadronDecays"][553]["Mult"][3114 ] = ["/ARGUS_1988_I251097/d01-x01-y04"] +analyses["HadronDecays"][553]["Mult"][3224 ] = ["/ARGUS_1988_I251097/d01-x01-y05"] +analyses["HadronDecays"][553]["Mult"][3324 ] = ["/ARGUS_1988_I251097/d01-x01-y06"] +analyses["HadronDecays"][553]["Mult"][3334 ] = ["/ARGUS_1988_I251097/d01-x01-y07"] +analyses["HadronDecays"][553]["Mult"][333 ] = ["/ARGUS_1989_I262551/d03-x01-y01","/ARGUS_1993_S2789213/d02-x01-y05"] +analyses["HadronDecays"][553]["Mult"][211 ] = ["/ARGUS_1989_I276860/d01-x01-y01","/ARGUS_1989_I276860/d01-x01-y02"] +analyses["HadronDecays"][553]["Mult"][311 ] = ["/ARGUS_1989_I276860/d02-x01-y01"] +analyses["HadronDecays"][553]["Mult"][321 ] = ["/ARGUS_1989_I276860/d03-x01-y01"] +analyses["HadronDecays"][553]["Mult"][2212 ] = ["/ARGUS_1989_I276860/d04-x01-y01","/ARGUS_1989_I276860/d04-x01-y02"] +analyses["HadronDecays"][553]["Mult"][111 ] = ["/ARGUS_1990_I278933/d01-x01-y02"] +analyses["HadronDecays"][553]["Mult"][221 ] = ["/ARGUS_1990_I278933/d02-x01-y02"] +analyses["HadronDecays"][553]["Mult"][331 ] = ["/ARGUS_1993_S2669951/d01-x01-y01","/ARGUS_1993_S2669951/d01-x01-y02"] +analyses["HadronDecays"][553]["Mult"][113 ] = ["/ARGUS_1993_S2789213/d02-x01-y02"] +analyses["HadronDecays"][553]["Mult"][223 ] = ["/ARGUS_1993_S2789213/d02-x01-y01"] +analyses["HadronDecays"][553]["Mult"][313 ] = ["/ARGUS_1993_S2789213/d02-x01-y03"] +analyses["HadronDecays"][553]["Mult"][323 ] = ["/ARGUS_1993_S2789213/d02-x01-y04"] +analyses["HadronDecays"][553]["Mult"][9010221] = ["/ARGUS_1993_S2669951/d05-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][3122] = ["/ARGUS_1988_I251097/d03-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][3312] = ["/ARGUS_1988_I251097/d07-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][3124] = ["/ARGUS_1989_I262415/d03-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][333 ] = ["/ARGUS_1989_I262551/d02-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][211 ] = ["/ARGUS_1989_I276860/d05-x01-y01","/ARGUS_1989_I276860/d09-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][321 ] = ["/ARGUS_1989_I276860/d06-x01-y01","/ARGUS_1989_I276860/d10-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][311 ] = ["/ARGUS_1989_I276860/d07-x01-y01","/ARGUS_1989_I276860/d11-x01-y01", + "/PLUTO_1981_I165122/d06-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][2212] = ["/ARGUS_1989_I276860/d08-x01-y01","/ARGUS_1989_I276860/d12-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][111 ] = ["/ARGUS_1990_I278933/d04-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][221 ] = ["/ARGUS_1990_I278933/d06-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][9010221] = ["/ARGUS_1993_S2669951/d03-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][323] = ["/ARGUS_1993_S2789213/d05-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][313] = ["/ARGUS_1993_S2789213/d08-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][113] = ["/ARGUS_1993_S2789213/d11-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][223] = ["/ARGUS_1993_S2789213/d14-x01-y01"] +# upsion(2s) +analyses["HadronDecays"][100553] = { "Mult" : {}, "Spectrum" : {}, + "Modes" : { "$\\Upsilon(2S)\\to J/\\psi\\pi^0\\pi^0$" : {}, + "$\\Upsilon(2S)\\to J/\\psi\\pi^+\\pi^-$" : {}, + "$\\Upsilon(2S)\\to \\Upsilon(1S))\\pi^0\\pi^0$" : {}, + "$\\Upsilon(2S)\\to \\Upsilon(1S)\\pi^+\\pi^-$" : {},}} +analyses["HadronDecays"][100553]["Mult"][111]= ["/ARGUS_1990_I278933/d01-x01-y03"] +analyses["HadronDecays"][100553]["Mult"][221]= ["/ARGUS_1990_I278933/d02-x01-y03"] +analyses["HadronDecays"][100553]["Mult"][333]= ["/ARGUS_1989_I262551/d04-x01-y01"] +analyses["HadronDecays"][100553]["Spectrum"][3122] = ["/ARGUS_1988_I251097/d04-x01-y01"] +analyses["HadronDecays"][100553]["Spectrum"][3312] = ["/ARGUS_1988_I251097/d08-x01-y01"] +analyses["HadronDecays"][100553]["Spectrum"][333 ] = ["/ARGUS_1989_I262551/d02-x01-y02"] +analyses["HadronDecays"][100553]["Spectrum"][111 ] = ["/ARGUS_1990_I278933/d04-x01-y02"] +analyses["HadronDecays"][100553]["Spectrum"][221 ] = ["/ARGUS_1990_I278933/d06-x01-y02"] +analyses["HadronDecays"][100553]["Spectrum"][9010221] = ["/ARGUS_1993_S2669951/d04-x01-y01"] +analyses["HadronDecays"][100553]["Modes"]["$\\Upsilon(2S)\\to J/\\psi\\pi^0\\pi^0$"]["MC"] = ["/MC_Onium_PiPi_Decay/h_100443_443_hpi0pi0", + "/MC_Onium_PiPi_Decay/h_100443_443_mpi0pi0"] +analyses["HadronDecays"][100553]["Modes"]["$\\Upsilon(2S)\\to J/\\psi\\pi^+\\pi^-$"]["MC"] = ["/MC_Onium_PiPi_Decay/h_100443_443_hpippim", + "/MC_Onium_PiPi_Decay/h_100443_443_mpippim"] +analyses["HadronDecays"][100553]["Modes"]["$\\Upsilon(2S)\\to \\Upsilon(1S))\\pi^0\\pi^0$"]["MC"] = ["/MC_Onium_PiPi_Decay/h_100553_553_mpi0pi0", + "/MC_Onium_PiPi_Decay/h_100553_553_hpi0pi0"] +analyses["HadronDecays"][100553]["Modes"]["$\\Upsilon(2S)\\to \\Upsilon(1S)\\pi^+\\pi^-$" ]["MC"] = ["/MC_Onium_PiPi_Decay/h_100553_553_mpippim", + "/MC_Onium_PiPi_Decay/h_100553_553_hpippim"] + +# upsilon(4s) +analyses["HadronDecays"][300553] = { "Mult" : {}, "Spectrum" : {}, "DistChargedMult" : {}, + "Modes" : {"$\\Upsilon(4S)\\to\\Upsilon(1S)\\pi^0\\pi^0$" : {}, + "$\\Upsilon(4S)\\to\\Upsilon(1S)\\pi^+\\pi^-$" : {}, + "$\\Upsilon(4S)\\to J/\\psi\\pi^0\\pi^0$" : {}, + "$\\Upsilon(4S)\\to J/\\psi\\pi^+\\pi^-$" : {},}} +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(1S)\\pi^0\\pi^0$"]["MC"]=["/MC_Onium_PiPi_Decay/h_300553_100553_hpi0pi0", + "/MC_Onium_PiPi_Decay/h_300553_100553_mpi0pi0"] +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(1S)\\pi^+\\pi^-$"]["MC"]=["/MC_Onium_PiPi_Decay/h_300553_100553_hpippim", + "/MC_Onium_PiPi_Decay/h_300553_100553_mpippim"] +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to J/\\psi\\pi^0\\pi^0$" ]["MC"]=["/MC_Onium_PiPi_Decay/h_300553_553_hpi0pi0", + "/MC_Onium_PiPi_Decay/h_300553_553_mpi0pi0"] +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to J/\\psi\\pi^+\\pi^-$" ]["MC"]=["/MC_Onium_PiPi_Decay/h_300553_553_mpippim", + "/MC_Onium_PiPi_Decay/h_300553_553_hpippim"] +analyses["HadronDecays"][300553]["DistChargedMult"]["data"] = ["/ARGUS_1992_I319102/d03-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 211 ] = ["/ARGUS_1993_S2653028/d07-x01-y01","/ARGUS_1993_S2653028/d08-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d87-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 321 ] = ["/ARGUS_1993_S2653028/d09-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d60-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d61-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d62-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 2212] = ["/ARGUS_1993_S2653028/d10-x01-y01","/ARGUS_1993_S2653028/d11-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d110-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 223 ] = ["/ARGUS_1993_S2789213/d03-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 113 ] = ["/ARGUS_1993_S2789213/d03-x01-y02", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d90-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 313 ] = ["/ARGUS_1993_S2789213/d03-x01-y03", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d65-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 323 ] = ["/ARGUS_1993_S2789213/d03-x01-y04", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d64-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 333 ] = ["/ARGUS_1993_S2789213/d03-x01-y05", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d92-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 111 ] = ["/BELLE_2001_S4598261/d02-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d88-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 4222] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d104-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 4112] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d106-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 4122] = ["/BABAR_2007_S6895344/d04-x01-y01", + "/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d96-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 3122] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d113-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 3312] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d116-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 411 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d29-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 421 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d30-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 413 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d31-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 423 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d32-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 431 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d33-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 433 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d34-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 443 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d48-x01-y01", + "/BABAR_2003_I593379/d01-x01-y01","/BABAR_2003_I593379/d01-x01-y02"] +analyses["HadronDecays"][300553]["Mult"][100443 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d50-x01-y01", + "/BABAR_2003_I593379/d01-x01-y07"] +analyses["HadronDecays"][300553]["Mult"][ 20443 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d51-x01-y01", + "/BABAR_2003_I593379/d01-x01-y03","/BABAR_2003_I593379/d01-x01-y04"] +analyses["HadronDecays"][300553]["Mult"][ 445 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d53-x01-y01", + "/BABAR_2003_I593379/d01-x01-y05","/BABAR_2003_I593379/d01-x01-y06"] +analyses["HadronDecays"][300553]["Mult"][ 311 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d63-x01-y01"] +analyses["HadronDecays"][300553]["Mult"][ 221 ] = ["/PDG_Upsilon_4S_HADRON_MULTIPLICITIES/d89-x01-y01"] + +analyses["HadronDecays"][300553]["Spectrum"][111 ] = ["/BELLE_2001_S4598261/d01-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][211 ] = ["/ARGUS_1993_S2653028/d01-x01-y01","/ARGUS_1993_S2653028/d02-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][321 ] = ["/ARGUS_1993_S2653028/d03-x01-y01","/ARGUS_1993_S2653028/d06-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][2212 ] = ["/ARGUS_1993_S2653028/d04-x01-y01","/ARGUS_1993_S2653028/d05-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][113 ] = ["/ARGUS_1993_S2789213/d12-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][4122 ] = ["/BABAR_2007_S6895344/d03-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][4132 ] = ["/BABAR_2005_S6181155/d01-x01-y01","/BABAR_2005_S6181155/d02-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][323 ] = ["/ARGUS_1993_S2789213/d06-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][313 ] = ["/ARGUS_1993_S2789213/d09-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][443 ] = ["/BABAR_2003_I593379/d06-x01-y01","/BABAR_2003_I593379/d10-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][20443 ] = ["/BABAR_2003_I593379/d07-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][445 ] = ["/BABAR_2003_I593379/d07-x01-y02"] +analyses["HadronDecays"][300553]["Spectrum"][100443] = ["/BABAR_2003_I593379/d08-x01-y01"] +# +analyses["HadronDecays"][3312] = { "Modes" : { "$\\Xi^-\\to\\Lambda^0\\pi^-$" : {} } } +analyses["HadronDecays"][3312]["Modes"]["$\\Xi^-\\to\\Lambda^0\\pi^-$"]["data"] = ["/E756_2000_I530367/d01-x01-y01","/E756_2000_I530367/d01-x01-y02"] +analyses["HadronDecays"][3312]["Modes"]["$\\Xi^-\\to\\Lambda^0\\pi^-$"]["MC" ] = ["/E756_2000_I530367/cthetaP","/E756_2000_I530367/cthetaM"] +analyses["HadronDecays"][3322] = { "Modes" : { "$\\Xi^0\\to\\Lambda^0\\pi^0$" : {}, "$\\Xi^0\\to\\Sigma^0\\gamma$" : {}, + "$\\Xi^0\\to\\Lambda^0\\gamma$" : {} } } +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Lambda^0\\pi^0$"]["data"] = ["/NA48_2010_I868871/d01-x01-y01"] +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Lambda^0\\pi^0$"]["MC" ] = ["/NA48_2010_I868871/ctheta_pi0"] +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Lambda^0\\gamma$"]["data"] = ["/NA48_2010_I868871/d02-x01-y01"] +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Lambda^0\\gamma$"]["MC" ] = ["/NA48_2010_I868871/ctheta_gamma"] +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Sigma^0\\gamma$"]["data"] = ["/NA48_2010_I868871/d03-x01-y01"] +analyses["HadronDecays"][3322]["Modes"]["$\\Xi^0\\to\\Sigma^0\\gamma$"]["MC" ] = ["/NA48_2010_I868871/ctheta_Sigma_0" ,"/NA48_2010_I868871/ctheta_Sigma_1" , + "/NA48_2010_I868871/ctheta_Sigma_2" ,"/NA48_2010_I868871/ctheta_Sigma_3" , + "/NA48_2010_I868871/ctheta_Sigma_4" ,"/NA48_2010_I868871/ctheta_Sigma_5" , + "/NA48_2010_I868871/ctheta_Sigma_6" ,"/NA48_2010_I868871/ctheta_Sigma_7" , + "/NA48_2010_I868871/ctheta_Sigma_8" ,"/NA48_2010_I868871/ctheta_Sigma_9" , + "/NA48_2010_I868871/ctheta_Sigma_10","/NA48_2010_I868871/ctheta_Sigma_11", + "/NA48_2010_I868871/ctheta_Sigma_12","/NA48_2010_I868871/ctheta_Sigma_13", + "/NA48_2010_I868871/ctheta_Sigma_14","/NA48_2010_I868871/ctheta_Sigma_15", + "/NA48_2010_I868871/ctheta_Sigma_16","/NA48_2010_I868871/ctheta_Sigma_17", + "/NA48_2010_I868871/ctheta_Sigma_18","/NA48_2010_I868871/ctheta_Sigma_19"] + +analyses["HadronDecays"][3334] = { "Modes" : { "$\\Omega^-\\to\\Lambda^0K^-$" : {} } } +analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Lambda^0K^-$"]["data"] = ["/HyperCP_2005_I677384/d01-x01-y01","/HyperCP_2005_I677384/d01-x01-y02", + "/HyperCP_2005_I677384/d01-x01-y03"] +analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Lambda^0K^-$"]["MC" ] = ["/HyperCP_2005_I677384/cthetaM","/HyperCP_2005_I677384/cthetaP", + "/HyperCP_2005_I677384/cthetaAll"] + +analyses["HadronDecays"][4132] = { "Modes" : { "$\\Xi^0_c\\to\\Xi^-\\pi^+$" : {} } } +analyses["HadronDecays"][4132]["Modes"]["$\\Xi^0_c\\to\\Xi^-\\pi^+$"]["data"] = ["/CLEO_2000_I537236/d01-x01-y01"] +analyses["HadronDecays"][4132]["Modes"]["$\\Xi^0_c\\to\\Xi^-\\pi^+$"]["MC" ] = ["/CLEO_2000_I537236/ctheta"] + +analyses["HadronDecays"][4122] = { "Modes" : { "$\\Lambda^+_c\\to\\Lambda^0\\pi^+$" : {} } } +analyses["HadronDecays"][4122]["Modes"]["$\\Lambda^+_c\\to\\Lambda^0\\pi^+$"]["data"] = ["/FOCUS_2006_I693639/d01-x01-y01"] +analyses["HadronDecays"][4122]["Modes"]["$\\Lambda^+_c\\to\\Lambda^0\\pi^+$"]["MC" ] = ["/FOCUS_2006_I693639/ctheta"] + +# charged multiplicity (total) +analyses["Charged"]["TotalChargedMult"][0][12.0 ] = ["/JADE_1983_I190818/d01-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][14.0 ] = ["/TASSO_1989_I277658/d02-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][21.65] = ["/PLUTO_1980_I154270/d01-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][22.0 ] = ["/TASSO_1980_I143691/d01-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][29.0 ] = ["/TPC_1987_I235694/d05-x01-y04","/HRS_1986_I18502/d03-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][50.0 ] = ["/AMY_1990_I295160/d02-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][55.7 ] = ["/AMY_1990_I295160/d02-x02-y01"] +analyses["Charged"]["TotalChargedMult"][0][91.2 ] = ["/ALEPH_1991_S2435284/d02-x01-y01","/OPAL_1992_I321190/d05-x01-y01", + "/DELPHI_1991_I301657/d04-x01-y01","/ALEPH_2004_S5765862/d01-x01-y01", + "/DELPHI_1996_S3430090/d35-x01-y01","/DELPHI_1998_I473409/d01-x01-y01", + "/OPAL_1998_S3780481/d09-x01-y04","/ALEPH_1996_S3486095/d19-x01-y01"] +# light quark events +analyses["Charged"]["TotalChargedMult"][1][29.0 ] = ["/TPC_1987_I235694/d04-x01-y04"] +analyses["Charged"]["TotalChargedMult"][1][91.2 ] = ["/OPAL_2002_S5361494/d01-x01-y03","/OPAL_1998_S3780481/d09-x01-y01", + "/DELPHI_1998_I473409/d03-x01-y01","/SLD_2004_S5693039/d08-x02-y01", + "/SLD_1996_S3398250/d03-x01-y01"] +analyses["Charged"]["TotalChargedMult"][1 ][195.0] = ["/DELPHI_2000_S4328825/d01-x01-y03"] + +# charm events +analyses["Charged"]["TotalChargedMult"][4][29.0 ] = ["/TPC_1987_I235694/d03-x01-y04"] +analyses["Charged"]["TotalChargedMult"][4][91.2 ] = ["/OPAL_2002_S5361494/d01-x01-y02","/OPAL_1998_S3780481/d09-x01-y02", + "/SLD_2004_S5693039/d08-x02-y02","/SLD_1996_S3398250/d02-x01-y01"] +analyses["Charged"]["TotalChargedMult"][4 ][195.0] = ["/DELPHI_2000_S4328825/d01-x01-y02"] +# bottom events +analyses["Charged"]["TotalChargedMult"][5][29.0 ] = ["/TPC_1987_I235694/d02-x01-y04"] +analyses["Charged"]["TotalChargedMult"][5][91.2 ] = ["/OPAL_2002_S5361494/d01-x01-y01","/OPAL_1998_S3780481/d09-x01-y03", + "/DELPHI_1998_I473409/d02-x01-y01","/SLD_2004_S5693039/d08-x02-y03", + "/SLD_1996_S3398250/d01-x01-y01"] +analyses["Charged"]["TotalChargedMult"][5 ][195.0] = ["/DELPHI_2000_S4328825/d01-x01-y01"] +# difference charm-light +analyses["Charged"]["TotalChargedMult"][41][91.2 ] = ["/SLD_2004_S5693039/d08-x03-y02","/SLD_1996_S3398250/d04-x01-y01"] +# difference bottom-light +analyses["Charged"]["TotalChargedMult"][51][91.2 ] = ["/OPAL_2002_S5361494/d01-x01-y04","/SLD_2004_S5693039/d08-x03-y03", + "/SLD_1996_S3398250/d05-x01-y01"] +analyses["Charged"]["TotalChargedMult"][51][195.0] = ["/DELPHI_2000_S4328825/d01-x01-y04"] +# with cuts +analyses["Charged"]["TotalChargedMult"]["C"][91.2] = ["\ALEPH_1996_S3486095/d20-x01-y01","\ALEPH_1996_S3486095/d21-x01-y01", + "\ALEPH_1996_S3486095/d22-x01-y01","\ALEPH_1996_S3486095/d23-x01-y01"] +# charged multiplicity (dist) +analyses["Charged"]["DistChargedMult"][0][10.47] = ["/ARGUS_1992_I319102/d02-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][14.0] = ["/TASSO_1989_I277658/d05-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][22.0] = ["/TASSO_1989_I277658/d05-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][29.0] = ["/HRS_1986_I18502/d01-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][34.8] = ["/TASSO_1989_I277658/d05-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][35.0] = ["/TASSO_1988_I263859/d06-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][43.6] = ["/TASSO_1989_I277658/d05-x01-y04"] +analyses["Charged"]["DistChargedMult"][0][50.0] = ["/AMY_1990_I295160/d01-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][52.0] = ["/AMY_1990_I295160/d01-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][55.0] = ["/AMY_1990_I295160/d01-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][56.0] = ["/AMY_1990_I295160/d01-x01-y04"] +analyses["Charged"]["DistChargedMult"][0][57.0] = ["/AMY_1990_I295160/d01-x01-y05"] +analyses["Charged"]["DistChargedMult"][0][60.0] = ["/AMY_1990_I295160/d01-x01-y06"] +analyses["Charged"]["DistChargedMult"][0][60.8] = ["/AMY_1990_I295160/d01-x01-y07"] +analyses["Charged"]["DistChargedMult"][0][61.4] = ["/AMY_1990_I295160/d01-x01-y08"] +analyses["Charged"]["DistChargedMult"][0][55.7] = ["/AMY_1990_I295160/d01-x01-y09"] +analyses["Charged"]["DistChargedMult"][0][91.2] = ["/ALEPH_1991_S2435284/d01-x01-y01","/OPAL_1992_I321190/d01-x01-y01", + "/DELPHI_1991_I301657/d02-x01-y01","/L3_2004_I652683/d59-x01-y01", + "/ALEPH_1996_S3486095/d18-x01-y01"] +analyses["Charged"]["DistChargedMult"][2][91.2] = ["/L3_2004_I652683/d59-x01-y02"] +analyses["Charged"]["DistChargedMult"][5][91.2] = ["/L3_2004_I652683/d59-x01-y03"] + +analyses["Charged"]["DistChargedMult"][0][130.1]=["/L3_2004_I652683/d60-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][136.3]=["/L3_2004_I652683/d60-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][161.3]=["/L3_2004_I652683/d60-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][172.3]=["/L3_2004_I652683/d61-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][182.8]=["/L3_2004_I652683/d61-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][188.6]=["/L3_2004_I652683/d61-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][194.4]=["/L3_2004_I652683/d62-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][200.2]=["/L3_2004_I652683/d62-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][206.2]=["/L3_2004_I652683/d62-x01-y03"] + + +analyses["Charged"]["DistChargedMult"]["C"][91.2]=["/DELPHI_1991_I324035/d01-x01-y01","/DELPHI_1991_I324035/d02-x01-y01", + "/DELPHI_1991_I324035/d03-x01-y01","/DELPHI_1991_I324035/d04-x01-y01", + "/DELPHI_1991_I324035/d05-x01-y01","/DELPHI_1991_I324035/d06-x01-y01", + "/DELPHI_1991_I324035/d07-x01-y01","/DELPHI_1991_I324035/d08-x01-y01", + "/DELPHI_1991_I324035/d09-x01-y01","/DELPHI_1991_I324035/d10-x01-y01", + "/DELPHI_1991_I324035/d11-x01-y01","/DELPHI_1991_I324035/d12-x01-y01", + "/DELPHI_1991_I324035/d13-x01-y01", + "/DELPHI_1992_I334948/d01-x01-y01","/DELPHI_1992_I334948/d01-x01-y02", + "/DELPHI_1992_I334948/d01-x01-y03","/DELPHI_1992_I334948/d02-x01-y01", + "/DELPHI_1992_I334948/d02-x01-y02","/DELPHI_1992_I334948/d02-x01-y03", + "/DELPHI_1992_I334948/d03-x01-y01","/DELPHI_1992_I334948/d03-x01-y02", + "/DELPHI_1992_I334948/d03-x01-y03",] + +analyses["Charged"]["DistChargedMult"][21][ 5.25] = ["/OPAL_2004_I631361/d01-x01-y01"] +analyses["Charged"]["DistChargedMult"][21][ 5.98] = ["/OPAL_2004_I631361/d01-x01-y02"] +analyses["Charged"]["DistChargedMult"][21][ 6.98] = ["/OPAL_2004_I631361/d01-x01-y03"] +analyses["Charged"]["DistChargedMult"][21][ 8.43] = ["/OPAL_2004_I631361/d02-x01-y01"] +analyses["Charged"]["DistChargedMult"][21][10.92] = ["/OPAL_2004_I631361/d02-x01-y02"] +analyses["Charged"]["DistChargedMult"][21][14.24] = ["/OPAL_2004_I631361/d03-x01-y01"] +analyses["Charged"]["DistChargedMult"][21][17.72] = ["/OPAL_2004_I631361/d03-x01-y02"] + +# charged particle spectra +# xi +analyses["Charged"]["ChargedSpectrum"][0]["xi"][2.2 ] = ["/BESII_2004_I622224/d01-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][2.6 ] = ["/BESII_2004_I622224/d02-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][3.0 ] = ["/BESII_2004_I622224/d03-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][3.2 ] = ["/BESII_2004_I622224/d04-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][4.6 ] = ["/BESII_2004_I622224/d05-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][4.8 ] = ["/BESII_2004_I622224/d06-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][12.0 ] = ["/TASSO_1980_I153511/d05-x01-y01","/TASSO_1982_I177174/d02-x01-y01", + "/TASSO_1982_I177174/d03-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][58.0 ] = ["/TOPAZ_1995_I381900/d01-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][91.2 ] = ["/ALEPH_1996_S3486095/d17-x01-y01","/DELPHI_1996_S3430090/d08-x01-y01", + "/L3_2004_I652683/d65-x01-y01","/OPAL_1998_S3780481/d08-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][130.1] = ["/L3_2004_I652683/d66-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][133.0] = ["/ALEPH_2004_S5765862/d11-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][136.3] = ["/L3_2004_I652683/d66-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][161.0] = ["/ALEPH_2004_S5765862/d12-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][161.3] = ["/L3_2004_I652683/d66-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][172.0] = ["/ALEPH_2004_S5765862/d13-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][172.3] = ["/L3_2004_I652683/d67-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][182.8] = ["/L3_2004_I652683/d67-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][183.0] = ["/DELPHI_2003_I620250/d32-x01-y01","/ALEPH_2004_S5765862/d14-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][188.6] = ["/L3_2004_I652683/d67-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][189.0] = ["/ALEPH_2004_S5765862/d15-x01-y01","/DELPHI_2003_I620250/d32-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][192.0] = ["/DELPHI_2003_I620250/d32-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][194.4] = ["/L3_2004_I652683/d68-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][200.2] = ["/L3_2004_I652683/d68-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][206.2] = ["/L3_2004_I652683/d68-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][196.0] = ["/DELPHI_2003_I620250/d32-x01-y04","/ALEPH_2004_S5765862/d16-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][200.0] = ["/DELPHI_2003_I620250/d33-x01-y01","/ALEPH_2004_S5765862/d17-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][200.5] = ["/OPAL_2003_I595335/d05-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][202.0] = ["/DELPHI_2003_I620250/d33-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][205.0] = ["/DELPHI_2003_I620250/d33-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][206.0] = ["/ALEPH_2004_S5765862/d18-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["xi"][207.0] = ["/DELPHI_2003_I620250/d33-x01-y04"] + + +# x +analyses["Charged"]["ChargedSpectrum"][0]["x" ][13.0 ] = ["/TASSO_1980_I143691/d05-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][14.0 ] = ["/TASSO_1982_I177174/d01-x01-y01","/TASSO_1982_I177174/d02-x01-y02", + "/TASSO_1982_I177174/d03-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][19.5 ] = ["/TASSO_1980_I143691/d06-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][22.0 ] = ["/TASSO_1982_I177174/d01-x01-y02","/TASSO_1982_I177174/d02-x01-y03", + "/TASSO_1982_I177174/d03-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][25.0 ] = ["/TASSO_1982_I177174/d02-x01-y04","/TASSO_1982_I177174/d03-x01-y04"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][29.0 ] = ["/TPC_1988_I262143/d01-x01-y04" ,"/HRS_1985_I201482/d10-x01-y01", + "/HRS_1985_I201482/d12-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][30.0 ] = ["/TASSO_1982_I177174/d02-x01-y05","/TASSO_1982_I177174/d03-x01-y05", + "/TASSO_1980_I143691/d07-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][30.8 ] = ["/TASSO_1980_I153511/d06-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][33.0 ] = ["/TASSO_1982_I177174/d01-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][34.0 ] = ["/TASSO_1982_I177174/d02-x01-y06","/TASSO_1982_I177174/d03-x01-y06"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][35.0 ] = ["/TASSO_1982_I177174/d02-x01-y07","/TASSO_1982_I177174/d03-x01-y07", + "/TASSO_1988_I263859/d10-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][55.2 ] = ["/AMY_1990_I283337/d02-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][91.2 ] = ["/DELPHI_1998_I473409/d16-x01-y01","/DELPHI_1998_I473409/d17-x01-y01", + "/ALEPH_1996_S3486095/d09-x01-y01","/OPAL_1998_S3780481/d04-x01-y01", + "/SLD_2004_S5693039/d01-x01-y01","/SLD_1999_S3743934/d04-x01-y01", + "/DELPHI_1996_S3430090/d07-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][133.0] = ["/ALEPH_2004_S5765862/d02-x01-y01","/ALEPH_2004_S5765862/d19-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][161.0] = ["/ALEPH_2004_S5765862/d03-x01-y01","/ALEPH_2004_S5765862/d20-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][172.0] = ["/ALEPH_2004_S5765862/d04-x01-y01","/ALEPH_2004_S5765862/d21-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][183.0] = ["/ALEPH_2004_S5765862/d05-x01-y01","/ALEPH_2004_S5765862/d22-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][189.0] = ["/ALEPH_2004_S5765862/d06-x01-y01","/ALEPH_2004_S5765862/d23-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][196.0] = ["/ALEPH_2004_S5765862/d07-x01-y01","/ALEPH_2004_S5765862/d24-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][200.0] = ["/ALEPH_2004_S5765862/d08-x01-y01","/ALEPH_2004_S5765862/d25-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][200.5] = ["/OPAL_2003_I595335/d04-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][206.0] = ["/ALEPH_2004_S5765862/d09-x01-y01","/ALEPH_2004_S5765862/d26-x01-y01"] +# with cuts +analyses["Charged"]["ChargedSpectrum"]["C"]["x" ][29.0 ] = ["/HRS_1985_I201482/d11-x01-y01","/HRS_1985_I201482/d13-x01-y01", + "/HRS_1985_I201482/d14-x01-y01","/HRS_1985_I201482/d15-x01-y01"] +# flavour separated +analyses["Charged"]["ChargedSpectrum"][1]["x" ][91.2] = ["/DELPHI_1998_I473409/d32-x01-y01","/DELPHI_1998_I473409/d33-x01-y01", + "/DELPHI_1997_I428178/d01-x01-y03","/OPAL_1998_S3780481/d01-x01-y01", + "/SLD_2004_S5693039/d08-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][1]["xi"][91.2] = ["/OPAL_1998_S3780481/d05-x01-y01"] + +analyses["Charged"]["ChargedSpectrum"][2]["x" ][13.0 ] = ["/OPAL_2004_I648738/d06-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["x" ][28.0 ] = ["/OPAL_2004_I648738/d07-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["x" ][49.0 ] = ["/OPAL_2004_I648738/d08-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["x" ][100.0] = ["/OPAL_2004_I648738/d09-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["x" ][91.2 ] = ["/OPAL_2004_I648738/d10-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["x" ][196.0] = ["/OPAL_2004_I648738/d11-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][2]["xi"][91.2 ] = ["/L3_2004_I652683/d65-x01-y02"] + +analyses["Charged"]["ChargedSpectrum"][4]["x" ][91.2 ] = ["/DELPHI_1997_I428178/d01-x01-y02","/OPAL_1998_S3780481/d02-x01-y01", + "/SLD_2004_S5693039/d08-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][4]["xi"][91.2 ] = ["/OPAL_1998_S3780481/d06-x01-y01"] + +analyses["Charged"]["ChargedSpectrum"][5]["x" ][13.0 ] = ["/OPAL_2004_I648738/d06-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][5]["x" ][28.0 ] = ["/OPAL_2004_I648738/d07-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][5]["x" ][49.0 ] = ["/OPAL_2004_I648738/d08-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][5]["x" ][100.0] = ["/OPAL_2004_I648738/d09-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][5]["x" ][91.2 ] = ["/DELPHI_1998_I473409/d24-x01-y01","/DELPHI_1998_I473409/d25-x01-y01", + "/DELPHI_1997_I428178/d01-x01-y01","/OPAL_1998_S3780481/d03-x01-y01", + "/SLD_2004_S5693039/d08-x01-y03","/OPAL_2004_I648738/d10-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][5]["xi"][91.2 ] = ["/OPAL_1998_S3780481/d07-x01-y01","/L3_2004_I652683/d65-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][5]["x" ][196.0] = ["/OPAL_2004_I648738/d11-x01-y02"] +# gluons +analyses["Charged"]["ChargedSpectrum"][21]["x"][ 6.5 ] = ["/OPAL_2004_I648738/d06-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][21]["x"][14.0 ] = ["/OPAL_2004_I648738/d07-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][21]["x"][14.24] = ["/OPAL_2004_I631361/d05-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][21]["x"][17.72] = ["/OPAL_2004_I631361/d05-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][21]["x"][24.5 ] = ["/OPAL_2004_I648738/d08-x01-y03"] +analyses["Charged"]["ChargedSpectrum"][21]["x"][50.0 ] = ["/OPAL_2004_I648738/d09-x01-y03"] +# rapidity w.r.t thrust +analyses["Charged"]["ChargedRapidityThrust"][13.0 ] = ["/TASSO_1980_I143691/d02-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][19.5 ] = ["/TASSO_1980_I143691/d03-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][29.0 ] = ["/HRS_1985_I201482/d19-x01-y01","/HRS_1985_I201482/d20-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][30.0 ] = ["/TASSO_1980_I143691/d04-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][55.2 ] = ["/AMY_1990_I283337/d01-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][91.2 ] = ["/DELPHI_1996_S3430090/d05-x01-y01","/ALEPH_1996_S3486095/d10-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][133.0] = ["/ALEPH_2004_S5765862/d36-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][161.0] = ["/ALEPH_2004_S5765862/d37-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][172.0] = ["/ALEPH_2004_S5765862/d38-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][183.0] = ["/DELPHI_2003_I620250/d30-x01-y01","/ALEPH_2004_S5765862/d39-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][189.0] = ["/DELPHI_2003_I620250/d30-x01-y02","/ALEPH_2004_S5765862/d40-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][192.0] = ["/DELPHI_2003_I620250/d30-x01-y03"] +analyses["Charged"]["ChargedRapidityThrust"][196.0] = ["/DELPHI_2003_I620250/d30-x01-y04","/ALEPH_2004_S5765862/d41-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][200.0] = ["/DELPHI_2003_I620250/d31-x01-y01","/ALEPH_2004_S5765862/d42-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][200.5] = ["/OPAL_2003_I595335/d03-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][202.0] = ["/DELPHI_2003_I620250/d31-x01-y02"] +analyses["Charged"]["ChargedRapidityThrust"][205.0] = ["/DELPHI_2003_I620250/d31-x01-y03"] +analyses["Charged"]["ChargedRapidityThrust"][206.0] = ["/ALEPH_2004_S5765862/d43-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][207.0] = ["/DELPHI_2003_I620250/d31-x01-y04"] +# pt in w.r.t thrust +analyses["Charged"]["ChargedpTInThrust" ][91.2 ] = ["/DELPHI_1996_S3430090/d01-x01-y01","/ALEPH_1996_S3486095/d11-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][133.0] = ["/ALEPH_2004_S5765862/d27-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][161.0] = ["/ALEPH_2004_S5765862/d28-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][172.0] = ["/ALEPH_2004_S5765862/d29-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][183.0] = ["/DELPHI_2003_I620250/d34-x01-y01","/ALEPH_2004_S5765862/d30-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][189.0] = ["/DELPHI_2003_I620250/d34-x01-y02","/ALEPH_2004_S5765862/d31-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][192.0] = ["/DELPHI_2003_I620250/d34-x01-y03"] +analyses["Charged"]["ChargedpTInThrust" ][196.0] = ["/DELPHI_2003_I620250/d34-x01-y04","/ALEPH_2004_S5765862/d32-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][200.0] = ["/DELPHI_2003_I620250/d35-x01-y01","/ALEPH_2004_S5765862/d33-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][200.5] = ["/OPAL_2003_I595335/d01-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][202.0] = ["/DELPHI_2003_I620250/d35-x01-y02"] +analyses["Charged"]["ChargedpTInThrust" ][205.0] = ["/DELPHI_2003_I620250/d35-x01-y03"] +analyses["Charged"]["ChargedpTInThrust" ][206.0] = ["/ALEPH_2004_S5765862/d34-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][207.0] = ["/DELPHI_2003_I620250/d35-x01-y04"] +# pt out thrust +analyses["Charged"]["ChargedpTOutThrust"][91.2 ] = ["/DELPHI_1996_S3430090/d02-x01-y01","/ALEPH_1996_S3486095/d12-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][183.0] = ["/DELPHI_2003_I620250/d36-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][189.0] = ["/DELPHI_2003_I620250/d36-x01-y02"] +analyses["Charged"]["ChargedpTOutThrust"][192.0] = ["/DELPHI_2003_I620250/d36-x01-y03"] +analyses["Charged"]["ChargedpTOutThrust"][196.0] = ["/DELPHI_2003_I620250/d36-x01-y04"] +analyses["Charged"]["ChargedpTOutThrust"][200.0] = ["/DELPHI_2003_I620250/d37-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][200.5] = ["/OPAL_2003_I595335/d02-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][202.0] = ["/DELPHI_2003_I620250/d37-x01-y02"] +analyses["Charged"]["ChargedpTOutThrust"][205.0] = ["/DELPHI_2003_I620250/d37-x01-y03"] +analyses["Charged"]["ChargedpTOutThrust"][206.0] = ["/ALEPH_2004_S5765862/d35-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][207.0] = ["/DELPHI_2003_I620250/d37-x01-y04"] +# pT +analyses["Charged"]["ChargedpTThrust" ][29.0] = ["/HRS_1985_I201482/d22-x01-y01","/HRS_1985_I201482/d23-x01-y01"] +analyses["Charged"]["ChargedpTvsxpThrust" ][91.2] = ["/DELPHI_1996_S3430090/d10-x01-y01"] +analyses["Charged"]["ChargedpTOutvsxpThrust"][91.2] = ["/DELPHI_1996_S3430090/d09-x01-y01"] +# averages +analyses["Charged"]["ChargedAveragepTThrust" ][20.] = ["/PLUTO_1983_I191161/d01-x01-y01"] +analyses["Charged"]["ChargedAveragepT2Thrust" ][20.] = ["/PLUTO_1983_I191161/d01-x01-y02"] +analyses["Charged"]["ChargedSumpTThrust" ][20.] = ["/PLUTO_1983_I191161/d01-x01-y03"] +analyses["Charged"]["ChargedSumpT2Thrust" ][20.] = ["/PLUTO_1983_I191161/d01-x01-y04"] +analyses["Charged"]["ChargedAveragepTSphericity" ][20.] = ["/PLUTO_1983_I191161/d02-x01-y01"] +analyses["Charged"]["ChargedAveragepT2Sphericity"][20.] = ["/PLUTO_1983_I191161/d02-x01-y02"] +analyses["Charged"]["ChargedSumpTSphericity" ][20.] = ["/PLUTO_1983_I191161/d02-x01-y03"] +analyses["Charged"]["ChargedSumpT2Sphericity" ][20.] = ["/PLUTO_1983_I191161/d02-x01-y04"] +# xF +analyses["Charged"]["ChargedxFThrust"][29.0] = ["/HRS_1985_I201482/d16-x01-y01","/HRS_1985_I201482/d17-x01-y01"] +# rapidity sphericity +analyses["Charged"]["ChargedRapiditySphericity"][35.0 ] = ["/TASSO_1988_I263859/d11-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][91.2 ] = ["/DELPHI_1996_S3430090/d06-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][133.0] = ["/ALEPH_2004_S5765862/d44-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][161.0] = ["/ALEPH_2004_S5765862/d45-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][172.0] = ["/ALEPH_2004_S5765862/d46-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][183.0] = ["/ALEPH_2004_S5765862/d47-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][189.0] = ["/ALEPH_2004_S5765862/d48-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][196.0] = ["/ALEPH_2004_S5765862/d49-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][200.0] = ["/ALEPH_2004_S5765862/d50-x01-y01"] +analyses["Charged"]["ChargedRapiditySphericity"][206.0] = ["/ALEPH_2004_S5765862/d51-x01-y01"] +# pt in sphericity +analyses["Charged"]["ChargedpTInSphericity" ][35.0 ] = ["/TASSO_1988_I263859/d07-x01-y01"] +analyses["Charged"]["ChargedpTInSphericity" ][55.2 ] = ["/AMY_1990_I283337/d06-x01-y01"] +analyses["Charged"]["ChargedpTInSphericity" ][91.2 ] = ["/DELPHI_1996_S3430090/d03-x01-y01"] +# pt out sphericity +analyses["Charged"]["ChargedpTOutSphericity"][35.0 ] = ["/TASSO_1988_I263859/d08-x01-y01"] +analyses["Charged"]["ChargedpTOutSphericity"][55.2 ] = ["/AMY_1990_I283337/d07-x01-y01"] +analyses["Charged"]["ChargedpTOutSphericity"][91.2 ] = ["/DELPHI_1996_S3430090/d04-x01-y01"] +# others +analyses["Charged"]["ChargedpLSphericity" ][55.2] = ["/AMY_1990_I283337/d03-x01-y01" ] +analyses["Charged"]["ChargedpTSphericity" ][55.2] = ["/AMY_1990_I283337/d04-x01-y01" ] +analyses["Charged"]["ChargedpTSphericity" ][35.0] = ["/TASSO_1988_I263859/d09-x01-y01"] +analyses["Charged"]["ChargedpT2Sphericity"][55.2] = ["/AMY_1990_I283337/d05-x01-y01" ] +analyses["Charged"]["ChargedFlowSphericity"][55.2] = ["/AMY_1990_I283337/d10-x01-y01" ] +analyses["Charged"]["ChargedEnergyFlowSphericity"][55.2] = ["/AMY_1990_I283337/d11-x01-y01" ] +analyses["Charged"]["ChargedAveragepT2inSphericity" ][29.0] = ["/HRS_1985_I201482/d24-x01-y01"] +analyses["Charged"]["ChargedAveragepT2inSphericity" ][35.0] = ["/TASSO_1988_I263859/d04-x01-y01"] +analyses["Charged"]["ChargedAveragepT2inSphericity" ][55.2] = ["/AMY_1990_I283337/d08-x01-y01"] +analyses["Charged"]["ChargedAveragepT2outSphericity"][29.0] = ["/HRS_1985_I201482/d25-x01-y01"] +analyses["Charged"]["ChargedAveragepT2outSphericity"][35.0] = ["/TASSO_1988_I263859/d05-x01-y01"] +analyses["Charged"]["ChargedAveragepT2outSphericity"][55.2] = ["/AMY_1990_I283337/d09-x01-y01"] +# identified particle (flavour sep) +analyses["IdentifiedParticleFlavour"][111 ][5]["x"][91.2]=["/DELPHI_1996_I401100/d03-x01-y01","/SLD_2004_S5693039/d05-x01-y03"] +analyses["IdentifiedParticleFlavour"][211 ][5]["x"][91.2]=["/DELPHI_1998_I473409/d26-x01-y01","/DELPHI_1998_I473409/d27-x01-y01", + "/SLD_1999_S3743934/d10-x01-y03"] +analyses["IdentifiedParticleFlavour"][321 ][5]["x"][91.2]=["/DELPHI_1998_I473409/d28-x01-y01","/DELPHI_1998_I473409/d29-x01-y01", + "/SLD_2004_S5693039/d06-x01-y03","/SLD_1999_S3743934/d12-x01-y03"] +analyses["IdentifiedParticleFlavour"][2212][5]["x"][91.2]=["/DELPHI_1998_I473409/d30-x01-y01","/DELPHI_1998_I473409/d31-x01-y01", + "/SLD_2004_S5693039/d07-x01-y03","/SLD_1999_S3743934/d16-x01-y03"] + +analyses["IdentifiedParticleFlavour"][211 ][4]["x"][91.2]=["/SLD_2004_S5693039/d05-x01-y02","/SLD_1999_S3743934/d10-x01-y02"] + +analyses["IdentifiedParticleFlavour"][321 ][4]["x"][91.2]=["/SLD_2004_S5693039/d06-x01-y02","/SLD_1999_S3743934/d12-x01-y02"] +analyses["IdentifiedParticleFlavour"][2212][4]["x"][91.2]=["/SLD_2004_S5693039/d07-x01-y02","/SLD_1999_S3743934/d16-x01-y02"] + +analyses["IdentifiedParticleFlavour"][211 ][1]["x"][91.2]=["/DELPHI_1998_I473409/d34-x01-y01","/DELPHI_1998_I473409/d35-x01-y01", + "/SLD_2004_S5693039/d05-x01-y01","/SLD_1999_S3743934/d10-x01-y01"] +analyses["IdentifiedParticleFlavour"][321 ][1]["x"][91.2]=["/DELPHI_1998_I473409/d36-x01-y01","/DELPHI_1998_I473409/d37-x01-y01", + "/SLD_2004_S5693039/d06-x01-y01","/SLD_1999_S3743934/d12-x01-y01"] +analyses["IdentifiedParticleFlavour"][2212][1]["x"][91.2]=["/DELPHI_1998_I473409/d38-x01-y01","/DELPHI_1998_I473409/d39-x01-y01", + "/SLD_2004_S5693039/d07-x01-y01","/SLD_1999_S3743934/d16-x01-y01"] + +analyses["IdentifiedParticleFlavour"][413][5]["x"][91.2]=["/OPAL_1995_I382219/d04-x01-y01"] +analyses["IdentifiedParticleFlavour"][413][4]["x"][91.2]=["/OPAL_1995_I382219/d05-x01-y01"] + +analyses["IdentifiedParticleFlavour"][313 ][1]["x"][91.2]=["/SLD_1999_S3743934/d14-x01-y01"] +analyses["IdentifiedParticleFlavour"][313 ][4]["x"][91.2]=["/SLD_1999_S3743934/d14-x01-y02"] +analyses["IdentifiedParticleFlavour"][313 ][5]["x"][91.2]=["/SLD_1999_S3743934/d14-x01-y03"] +analyses["IdentifiedParticleFlavour"][3122][1]["x"][91.2]=["/SLD_1999_S3743934/d18-x01-y01"] +analyses["IdentifiedParticleFlavour"][3122][4]["x"][91.2]=["/SLD_1999_S3743934/d18-x01-y02"] +analyses["IdentifiedParticleFlavour"][3122][5]["x"][91.2]=["/SLD_1999_S3743934/d18-x01-y03"] +analyses["IdentifiedParticleFlavour"][311 ][1]["x"][91.2]=["/SLD_1999_S3743934/d20-x01-y01"] +analyses["IdentifiedParticleFlavour"][311 ][4]["x"][91.2]=["/SLD_1999_S3743934/d20-x01-y02"] +analyses["IdentifiedParticleFlavour"][311 ][5]["x"][91.2]=["/SLD_1999_S3743934/d20-x01-y03"] +analyses["IdentifiedParticleFlavour"][333 ][1]["x"][91.2]=["/SLD_1999_S3743934/d22-x01-y01"] +analyses["IdentifiedParticleFlavour"][333 ][4]["x"][91.2]=["/SLD_1999_S3743934/d22-x01-y02"] +analyses["IdentifiedParticleFlavour"][333 ][5]["x"][91.2]=["/SLD_1999_S3743934/d22-x01-y03"] + +analyses["IdentifiedParticleFlavour"][211 ][41]["x"][91.2]=["/SLD_1999_S3743934/d11-x01-y01"] +analyses["IdentifiedParticleFlavour"][211 ][51]["x"][91.2]=["/SLD_1999_S3743934/d11-x01-y02"] +analyses["IdentifiedParticleFlavour"][321 ][41]["x"][91.2]=["/SLD_1999_S3743934/d13-x01-y01"] +analyses["IdentifiedParticleFlavour"][321 ][51]["x"][91.2]=["/SLD_1999_S3743934/d13-x01-y02"] +analyses["IdentifiedParticleFlavour"][313 ][41]["x"][91.2]=["/SLD_1999_S3743934/d15-x01-y01"] +analyses["IdentifiedParticleFlavour"][313 ][51]["x"][91.2]=["/SLD_1999_S3743934/d15-x01-y02"] +analyses["IdentifiedParticleFlavour"][2212][41]["x"][91.2]=["/SLD_1999_S3743934/d17-x01-y01"] +analyses["IdentifiedParticleFlavour"][2212][51]["x"][91.2]=["/SLD_1999_S3743934/d17-x01-y02"] +analyses["IdentifiedParticleFlavour"][3122][41]["x"][91.2]=["/SLD_1999_S3743934/d19-x01-y01"] +analyses["IdentifiedParticleFlavour"][3122][51]["x"][91.2]=["/SLD_1999_S3743934/d19-x01-y02"] +analyses["IdentifiedParticleFlavour"][311 ][41]["x"][91.2]=["/SLD_1999_S3743934/d21-x01-y01"] +analyses["IdentifiedParticleFlavour"][311 ][51]["x"][91.2]=["/SLD_1999_S3743934/d21-x01-y02"] +analyses["IdentifiedParticleFlavour"][333 ][41]["x"][91.2]=["/SLD_1999_S3743934/d23-x01-y01"] +analyses["IdentifiedParticleFlavour"][333 ][51]["x"][91.2]=["/SLD_1999_S3743934/d23-x01-y02"] + +analyses["IdentifiedParticleFlavour"][211][5]["Ratio"][91.2]=["/DELPHI_1998_I473409/d08-x01-y01"] +analyses["IdentifiedParticleFlavour"][211][1]["Ratio"][91.2]=["/DELPHI_1998_I473409/d12-x01-y01"] + +analyses["IdentifiedParticleFlavour"][321][5]["Ratio"][91.2]=["/DELPHI_1998_I473409/d09-x01-y01"] +analyses["IdentifiedParticleFlavour"][321][1]["Ratio"][91.2]=["/DELPHI_1998_I473409/d13-x01-y01"] + +analyses["IdentifiedParticleFlavour"][2212][5]["Ratio"][91.2]=["/DELPHI_1998_I473409/d10-x01-y01"] +analyses["IdentifiedParticleFlavour"][2212][1]["Ratio"][91.2]=["/DELPHI_1998_I473409/d14-x01-y01"] + +analyses["IdentifiedParticleFlavour"]["321/2212"][5]["Ratio"][91.2]=["/DELPHI_1998_I473409/d11-x01-y01"] +analyses["IdentifiedParticleFlavour"]["321/2212"][1]["Ratio"][91.2]=["/DELPHI_1998_I473409/d15-x01-y01"] +analyses["IdentifiedParticleFlavour"][311][4]["Other"][29.0]=["/HRS_1990_I280958/d05-x01-y01"] +analyses["IdentifiedParticleFlavour"][311][1]["Other"][29.0]=["/HRS_1990_I280958/d06-x01-y01"] + + +analyses["MultiplicityFlavour"]["321/2212"][1][91.2] = ["/DELPHI_1998_I473409/d03-x01-y05"] +analyses["MultiplicityFlavour"]["321/2212"][5][91.2] = ["/DELPHI_1998_I473409/d02-x01-y05"] + +analyses["MultiplicityFlavour"][211 ][41][91.2]=["/SLD_1999_S3743934/d25-x01-y01"] +analyses["MultiplicityFlavour"][211 ][51][91.2]=["/SLD_1999_S3743934/d25-x01-y02"] +analyses["MultiplicityFlavour"][321 ][41][91.2]=["/SLD_1999_S3743934/d25-x02-y01"] +analyses["MultiplicityFlavour"][321 ][51][91.2]=["/SLD_1999_S3743934/d25-x02-y02"] +analyses["MultiplicityFlavour"][311 ][41][91.2]=["/SLD_1999_S3743934/d25-x03-y01"] +analyses["MultiplicityFlavour"][311 ][51][91.2]=["/SLD_1999_S3743934/d25-x03-y02"] +analyses["MultiplicityFlavour"][313 ][41][91.2]=["/SLD_1999_S3743934/d25-x04-y01"] +analyses["MultiplicityFlavour"][313 ][51][91.2]=["/SLD_1999_S3743934/d25-x04-y02"] +analyses["MultiplicityFlavour"][333 ][41][91.2]=["/SLD_1999_S3743934/d25-x05-y01"] +analyses["MultiplicityFlavour"][333 ][51][91.2]=["/SLD_1999_S3743934/d25-x05-y02"] +analyses["MultiplicityFlavour"][2212][41][91.2]=["/SLD_1999_S3743934/d25-x06-y01"] +analyses["MultiplicityFlavour"][2212][51][91.2]=["/SLD_1999_S3743934/d25-x06-y02"] +analyses["MultiplicityFlavour"][3122][41][91.2]=["/SLD_1999_S3743934/d25-x07-y01"] +analyses["MultiplicityFlavour"][3122][51][91.2]=["/SLD_1999_S3743934/d25-x07-y02"] + +analyses["MultiplicityFlavour"][211 ][1][91.2]=["/SLD_2004_S5693039/d05-x02-y01","/SLD_1999_S3743934/d24-x01-y02", + "/DELPHI_1998_I473409/d03-x01-y02"] +analyses["MultiplicityFlavour"][211 ][4][91.2]=["/SLD_2004_S5693039/d05-x02-y02","/SLD_1999_S3743934/d24-x01-y03"] +analyses["MultiplicityFlavour"][211 ][5][91.2]=["/SLD_2004_S5693039/d05-x02-y03","/SLD_1999_S3743934/d24-x01-y04", + "/DELPHI_1998_I473409/d02-x01-y02"] +analyses["MultiplicityFlavour"][321 ][1][91.2]=["/SLD_2004_S5693039/d06-x02-y01","/SLD_1999_S3743934/d24-x02-y02", + "/DELPHI_1998_I473409/d03-x01-y03"] +analyses["MultiplicityFlavour"][321 ][4][91.2]=["/SLD_2004_S5693039/d06-x02-y02","/SLD_1999_S3743934/d24-x02-y03"] +analyses["MultiplicityFlavour"][321 ][5][91.2]=["/SLD_2004_S5693039/d06-x02-y03","/SLD_1999_S3743934/d24-x02-y04", + "/DELPHI_1998_I473409/d02-x01-y03"] +analyses["MultiplicityFlavour"][311 ][1][91.2]=["/SLD_1999_S3743934/d24-x03-y02"] +analyses["MultiplicityFlavour"][311 ][4][91.2]=["/SLD_1999_S3743934/d24-x03-y03"] +analyses["MultiplicityFlavour"][311 ][5][91.2]=["/SLD_1999_S3743934/d24-x03-y04"] +analyses["MultiplicityFlavour"][313 ][1][91.2]=["/SLD_1999_S3743934/d24-x04-y02"] +analyses["MultiplicityFlavour"][313 ][4][91.2]=["/SLD_1999_S3743934/d24-x04-y03"] +analyses["MultiplicityFlavour"][313 ][5][91.2]=["/SLD_1999_S3743934/d24-x04-y04"] +analyses["MultiplicityFlavour"][333 ][1][91.2]=["/SLD_1999_S3743934/d24-x05-y02"] +analyses["MultiplicityFlavour"][333 ][4][91.2]=["/SLD_1999_S3743934/d24-x05-y03"] +analyses["MultiplicityFlavour"][333 ][5][91.2]=["/SLD_1999_S3743934/d24-x05-y04"] +analyses["MultiplicityFlavour"][2212][1][91.2]=["/SLD_2004_S5693039/d07-x02-y01","/SLD_1999_S3743934/d24-x06-y02", + "/DELPHI_1998_I473409/d03-x01-y04"] +analyses["MultiplicityFlavour"][2212][4][91.2]=["/SLD_2004_S5693039/d07-x02-y02","/SLD_1999_S3743934/d24-x06-y03"] +analyses["MultiplicityFlavour"][2212][5][91.2]=["/SLD_2004_S5693039/d07-x02-y03","/SLD_1999_S3743934/d24-x06-y04", + "/DELPHI_1998_I473409/d02-x01-y04"] +analyses["MultiplicityFlavour"][3122][1][91.2]=["/SLD_1999_S3743934/d24-x07-y02"] +analyses["MultiplicityFlavour"][3122][4][91.2]=["/SLD_1999_S3743934/d24-x07-y03"] +analyses["MultiplicityFlavour"][3122][5][91.2]=["/SLD_1999_S3743934/d24-x07-y04"] + + + +# identified particle distributions +# photons +# x_E +analyses["IdentifiedParticle"][22 ]["x" ][14.0]=["/CELLO_1983_I191415/d01-x01-y01"] +analyses["IdentifiedParticle"][22 ]["x" ][22.0]=["/CELLO_1983_I191415/d02-x01-y01"] +analyses["IdentifiedParticle"][22 ]["x" ][29.0]=["/TPC_1985_I205868/d01-x01-y01" ] +analyses["IdentifiedParticle"][22 ]["x" ][34.0]=["/CELLO_1983_I191415/d03-x01-y01"] +analyses["IdentifiedParticle"][22 ]["x" ][35.0]=["/CELLO_1989_I276764/d02-x01-y01","/JADE_1990_I282847/d01-x01-y01"] +analyses["IdentifiedParticle"][22 ]["x" ][44.0]=["/JADE_1990_I282847/d02-x01-y01"] +analyses["IdentifiedParticle"][22 ]["x" ][91.2]=["/OPAL_1998_S3749908/d02-x01-y01"] +# xi +analyses["IdentifiedParticle"][22 ]["xi"][91.2]=["/ALEPH_1996_S3486095/d28-x01-y01","/OPAL_1998_S3749908/d03-x01-y01"] +# charged pions +# x +analyses["IdentifiedParticle"][211 ]["x" ][10.0 ] = ["/ARGUS_1989_I276860/d09-x01-y02"] +analyses["IdentifiedParticle"][211 ]["x" ][10.52] = ["/BELLE_2013_I1216515/d01-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][12.0 ] = ["/TASSO_1980_I153656/d02-x01-y02"] +analyses["IdentifiedParticle"][211 ]["x" ][14.0 ] = ["/TASSO_1983_I181470/d20-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][22.0 ] = ["/TASSO_1983_I181470/d22-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][29.0 ] = ["/TPC_1988_I262143/d01-x01-y01","/TPC_1988_I262143/d05-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][30.0 ] = ["/TASSO_1980_I153656/d05-x01-y02"] +analyses["IdentifiedParticle"][211 ]["x" ][34.0 ] = ["/TASSO_1989_I267755/d07-x01-y01","/TASSO_1983_I181470/d24-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][44.0 ] = ["/TASSO_1989_I267755/d10-x01-y01"] +analyses["IdentifiedParticle"][211 ]["x" ][91.2 ] = ["/ALEPH_1995_I382179/d01-x01-y01","/DELPHI_1998_I473409/d19-x01-y01", + "/ALEPH_1996_S3486095/d25-x01-y01","/SLD_2004_S5693039/d02-x01-y02", + "/SLD_1999_S3743934/d01-x01-y02"] +analyses["IdentifiedParticle"][211 ]["Other" ][91.2 ] = ["/SLD_1999_S3743934/d26-x01-y01","/SLD_1999_S3743934/d26-x01-y02", + "/SLD_1999_S3743934/d27-x01-y01","/SLD_2004_S5693039/d09-x01-y01", + "/SLD_2004_S5693039/d09-x01-y02","/SLD_2004_S5693039/d09-x01-y03",] +# p +analyses["IdentifiedParticle"][211 ]["p" ][10.0 ] = ["/ARGUS_1989_I276860/d05-x01-y02"] +analyses["IdentifiedParticle"][211 ]["p" ][10.54] = ["/BABAR_2013_I1238276/d01-x01-y01","/BABAR_2013_I1238276/d02-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][12.0 ] = ["/TASSO_1980_I153656/d02-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][14.0 ] = ["/TASSO_1983_I181470/d19-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][22.0 ] = ["/TASSO_1983_I181470/d25-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][30.0 ] = ["/TASSO_1980_I153656/d05-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][34.0 ] = ["/TASSO_1983_I181470/d13-x01-y01"] +analyses["IdentifiedParticle"][211 ]["p" ][91.2 ] = ["/DELPHI_1998_I473409/d18-x01-y01","/OPAL_1994_S2927284/d01-x01-y01"] +# xi +analyses["IdentifiedParticle"][211 ]["xi"][58.0 ] = ["/TOPAZ_1995_I381900/d02-x01-y01"] +# ratios +analyses["IdentifiedParticle"][211 ]["Ratio"][12.0 ] = ["/TASSO_1980_I153656/d08-x01-y01"] +analyses["IdentifiedParticle"][211 ]["Ratio"][29.0 ] = ["/TPC_1988_I262143/d06-x01-y01"] +analyses["IdentifiedParticle"][211 ]["Ratio"][30.0 ] = ["/TASSO_1980_I153656/d11-x01-y01"] +analyses["IdentifiedParticle"][211 ]["Ratio"][34.0 ] = ["/TASSO_1989_I267755/d01-x01-y01"] +analyses["IdentifiedParticle"][211 ]["Ratio"][44.0 ] = ["/TASSO_1989_I267755/d04-x01-y01"] +analyses["IdentifiedParticle"][211 ]["Ratio"][91.2 ] = ["/DELPHI_1998_I473409/d04-x01-y01","/SLD_1999_S3743934/d01-x01-y01"] +# neutral pions +# x +analyses["IdentifiedParticle"][111 ]["x" ][10.0]=["/ARGUS_1990_I278933/d03-x01-y01","/ARGUS_1990_I278933/d03-x01-y02"] +analyses["IdentifiedParticle"][111 ]["x" ][14.0]=["/TASSO_1982_I168232/d02-x03-y03","/CELLO_1983_I191415/d04-x01-y01"] +analyses["IdentifiedParticle"][111 ]["x" ][22.0]=["/CELLO_1983_I191415/d05-x01-y01"] +analyses["IdentifiedParticle"][111 ]["x" ][29.0]=["/TPC_1985_I205868/d02-x01-y01" ] +analyses["IdentifiedParticle"][111 ]["x" ][34.0]=["/TASSO_1982_I168232/d03-x03-y03","/TASSO_1986_I230950/d02-x01-y01", + "/CELLO_1983_I191415/d06-x01-y01"] +analyses["IdentifiedParticle"][111 ]["x" ][35.0]=["/CELLO_1989_I276764/d03-x01-y01","/CELLO_1989_I276764/d04-x01-y01", + "/JADE_1990_I282847/d03-x01-y01"] +analyses["IdentifiedParticle"][111 ]["x" ][44.0]=["/TASSO_1989_I267755/d13-x01-y01","/JADE_1990_I282847/d04-x01-y01"] +analyses["IdentifiedParticle"][111 ]["x" ][91.2]=["/DELPHI_1996_I401100/d01-x01-y01","/ALEPH_1996_S3486095/d29-x01-y01", + "/OPAL_1998_S3749908/d04-x01-y01",] +# p/E +analyses["IdentifiedParticle"][111 ]["p" ][14.0]=["/TASSO_1982_I168232/d02-x01-y01","/TASSO_1982_I168232/d02-x02-y02"] +analyses["IdentifiedParticle"][111 ]["p" ][34.0]=["/TASSO_1982_I168232/d03-x01-y01","/TASSO_1982_I168232/d03-x02-y02", + "/TASSO_1986_I230950/d01-x01-y01"] +# xi +analyses["IdentifiedParticle"][111 ]["xi"][91.2]=["/OPAL_1998_S3749908/d05-x01-y01"] +# eta +#x +analyses["IdentifiedParticle"][221 ]["x" ][10.0]=["/ARGUS_1990_I278933/d05-x01-y01","/ARGUS_1990_I278933/d05-x01-y02"] +analyses["IdentifiedParticle"][221 ]["x" ][29.0]=["/HRS_1988_I250824/d01-x01-y01"] +analyses["IdentifiedParticle"][221 ]["x" ][35.0]=["/CELLO_1989_I276764/d05-x01-y01" ,"/JADE_1990_I282847/d05-x01-y01"] +analyses["IdentifiedParticle"][221 ]["x" ][91.2]=["/ALEPH_2002_S4823664/d02-x01-y02","/L3_1992_I336180/d01-x01-y01", + "/ALEPH_1996_S3486095/d30-x01-y01","/OPAL_1998_S3749908/d06-x01-y01",] +# xi +analyses["IdentifiedParticle"][221 ]["xi"][91.2]=["/L3_1992_I336180/d02-x01-y01","/OPAL_1998_S3749908/d07-x01-y01"] +# eta' +# x +analyses["IdentifiedParticle"][331 ]["x" ][91.2]=["/L3_1997_I427107/d07-x01-y01" ,"/L3_1997_I427107/d09-x01-y01", + "/ALEPH_1996_S3486095/d31-x01-y01","/OPAL_1998_S3749908/d12-x01-y01"] +# xi +analyses["IdentifiedParticle"][331 ]["xi"][91.2]=["/L3_1997_I427107/d08-x01-y01","/L3_1997_I427107/d10-x01-y01", + "/OPAL_1998_S3749908/d13-x01-y01"] +# rho +/- +analyses["IdentifiedParticle"][213 ]["x" ][91.2] = ["/OPAL_1998_S3749908/d08-x01-y01"] +analyses["IdentifiedParticle"][213 ]["xi"][91.2] = ["/OPAL_1998_S3749908/d09-x01-y01"] +# rho0 +analyses["IdentifiedParticle"][113 ]["x" ][10.0] = ["/ARGUS_1993_S2789213/d10-x01-y01"] +analyses["IdentifiedParticle"][113 ]["x" ][35.0] = ["/JADE_1984_I203145/d02-x01-y01"] +analyses["IdentifiedParticle"][113 ]["x" ][91.2] = ["/DELPHI_1999_S3960137/d01-x01-y01","/ALEPH_1996_S3486095/d37-x01-y01"] +# omega +analyses["IdentifiedParticle"][223 ]["x" ][10.0] = ["/ARGUS_1993_S2789213/d13-x01-y01"] +analyses["IdentifiedParticle"][223 ]["x" ][91.2] = ["/ALEPH_2002_S4823664/d03-x01-y02","/L3_1997_I427107/d05-x01-y01", + "/ALEPH_1996_S3486095/d38-x01-y01","/OPAL_1998_S3749908/d10-x01-y01",] +analyses["IdentifiedParticle"][223 ]["xi"][91.2] = ["/L3_1997_I427107/d06-x01-y01","/OPAL_1998_S3749908/d11-x01-y01"] +# phi +analyses["IdentifiedParticle"][333 ]["x" ][10.0] = ["/ARGUS_1989_I262551/d01-x01-y01"] +analyses["IdentifiedParticle"][333 ]["x" ][29.0] = ["/TPC_1984_I200105/d01-x01-y01"] +analyses["IdentifiedParticle"][333 ]["x" ][91.2] = ["/DELPHI_1996_I420528/d03-x01-y01","/ALEPH_1996_S3486095/d40-x01-y01", + "/OPAL_1998_S3702294/d02-x01-y03","/SLD_1999_S3743934/d09-x01-y01"] +analyses["IdentifiedParticle"][333 ]["Other"][29.0] = ["/TPC_1984_I200105/d03-x01-y01"] +# f_2 +analyses["IdentifiedParticle"][225]["x" ][91.2]=["/DELPHI_1999_S3960137/d01-x01-y03","/OPAL_1998_S3702294/d02-x01-y02"] +# f_2' +analyses["IdentifiedParticle"][335]["x" ][91.2]=["/DELPHI_1996_I416741/d01-x01-y01"] +# f_0(980) +analyses["IdentifiedParticle"][9010221]["x" ][10.0]=["/ARGUS_1993_S2669951/d02-x01-y01"] +analyses["IdentifiedParticle"][9010221]["x" ][91.2]=["/DELPHI_1999_S3960137/d01-x01-y02","/OPAL_1998_S3702294/d02-x01-y01"] +# a_0 =/- +analyses["IdentifiedParticle"][9000211]["x" ][91.2]=["/OPAL_1998_S3749908/d14-x01-y01"] +analyses["IdentifiedParticle"][9000211]["xi" ][91.2]=["/OPAL_1998_S3749908/d15-x01-y01"] +# strange mesons +# K0 +# x +analyses["IdentifiedParticle"][311 ]["x" ][3.63] = ["/PLUTO_1977_I118873/d02-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][4.03] = ["/PLUTO_1977_I118873/d03-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][4.5] = ["/PLUTO_1977_I118873/d04-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][9.4] = ["/PLUTO_1981_I165122/d05-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][10.0] = ["/ARGUS_1989_I276860/d11-x01-y02"] +analyses["IdentifiedParticle"][311 ]["x" ][14.0] = ["/TASSO_1980_I153341/d04-x01-y01","/TASSO_1985_I205119/d01-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][22.0] = ["/TASSO_1985_I205119/d02-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][29.0] = ["/TPC_1984_I205869/d04-x01-y01","/HRS_1990_I280958/d03-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][30.0] = ["/PLUTO_1981_I165122/d04-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][34.0] = ["/TASSO_1985_I205119/d03-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][34.5] = ["/TASSO_1990_I284251/d01-x01-y03"] +analyses["IdentifiedParticle"][311 ]["x" ][35.0] = ["/TASSO_1990_I284251/d01-x01-y02","/CELLO_1990_I283026/d01-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][42.6] = ["/TASSO_1990_I284251/d01-x01-y01"] +analyses["IdentifiedParticle"][311 ]["x" ][91.2] = ["/OPAL_2000_S4418603/d03-x01-y01","/DELPHI_1995_I377487/d08-x01-y01", + "/ALEPH_1996_S3486095/d32-x01-y01","/SLD_1999_S3743934/d05-x01-y01"] +# p +analyses["IdentifiedParticle"][311 ]["p" ][10.0] = ["/ARGUS_1989_I276860/d07-x01-y02"] +analyses["IdentifiedParticle"][311 ]["p" ][14.0] = ["/TASSO_1980_I153341/d02-x01-y01","/TASSO_1985_I205119/d07-x01-y01"] +analyses["IdentifiedParticle"][311 ]["p" ][22.0] = ["/TASSO_1985_I205119/d08-x01-y01"] +analyses["IdentifiedParticle"][311 ]["p" ][34.0] = ["/TASSO_1985_I205119/d09-x01-y01"] +# xi +analyses["IdentifiedParticle"][311 ]["xi" ][58.0] = ["/TOPAZ_1995_I381900/d03-x01-y01"] +analyses["IdentifiedParticle"][311 ]["xi" ][91.2] = ["/DELPHI_1995_I377487/d09-x01-y01"] +# other +analyses["IdentifiedParticle"][311 ]["Other"][14.8 ] = ["/TASSO_1990_I284251/d06-x01-y01","/TASSO_1990_I284251/d06-x01-y02"] +analyses["IdentifiedParticle"][311 ]["Other"][21.5 ] = ["/TASSO_1990_I284251/d07-x01-y01","/TASSO_1990_I284251/d07-x01-y02"] +analyses["IdentifiedParticle"][311 ]["Other"][29.0 ] = ["/HRS_1990_I280958/d04-x01-y01"] +analyses["IdentifiedParticle"][311 ]["Other"][35.0 ] = ["/TASSO_1990_I284251/d05-x01-y03","/TASSO_1990_I284251/d05-x01-y04"] +analyses["IdentifiedParticle"][311 ]["Other"][42.6 ] = ["/TASSO_1990_I284251/d05-x01-y01","/TASSO_1990_I284251/d05-x01-y02"] +# K+/- +# x +analyses["IdentifiedParticle"][321 ]["x" ][10.0 ] = ["/ARGUS_1989_I276860/d10-x01-y02"] +analyses["IdentifiedParticle"][321 ]["x" ][10.52] = ["/BELLE_2013_I1216515/d01-x01-y02"] +analyses["IdentifiedParticle"][321 ]["x" ][12.0 ] = ["/TASSO_1980_I153656/d03-x01-y02"] +analyses["IdentifiedParticle"][321 ]["x" ][14.0 ] = ["/TASSO_1983_I181470/d26-x01-y01"] +analyses["IdentifiedParticle"][321 ]["x" ][22.0 ] = ["/TASSO_1983_I181470/d10-x01-y01"] +analyses["IdentifiedParticle"][321 ]["x" ][29.0 ] = ["/TPC_1988_I262143/d01-x01-y02","/TPC_1988_I262143/d05-x01-y02"] +analyses["IdentifiedParticle"][321 ]["x" ][30.0 ] = ["/TASSO_1980_I153656/d06-x01-y02"] +analyses["IdentifiedParticle"][321 ]["x" ][34.0 ] = ["/TASSO_1989_I267755/d08-x01-y01","/TASSO_1983_I181470/d12-x01-y01"] +analyses["IdentifiedParticle"][321 ]["x" ][44.0 ] = ["/TASSO_1989_I267755/d11-x01-y01"] +analyses["IdentifiedParticle"][321 ]["x" ][91.2 ] = ["/ALEPH_1995_I382179/d02-x01-y01","/DELPHI_1995_I394052/d05-x01-y01", + "/DELPHI_1998_I473409/d21-x01-y01","/SLD_1999_S3743934/d02-x01-y02", + "/ALEPH_1996_S3486095/d26-x01-y01","/SLD_2004_S5693039/d03-x01-y02"] +# p +analyses["IdentifiedParticle"][321 ]["p" ][10.0 ] = ["/ARGUS_1989_I276860/d06-x01-y02"] +analyses["IdentifiedParticle"][321 ]["p" ][10.54] = ["/BABAR_2013_I1238276/d01-x01-y02","/BABAR_2013_I1238276/d02-x01-y02"] +analyses["IdentifiedParticle"][321 ]["p" ][12.0 ] = ["/TASSO_1980_I153656/d03-x01-y01"] +analyses["IdentifiedParticle"][321 ]["p" ][14.0 ] = ["/TASSO_1983_I181470/d21-x01-y01"] +analyses["IdentifiedParticle"][321 ]["p" ][22.0 ] = ["/TASSO_1983_I181470/d27-x01-y01"] +analyses["IdentifiedParticle"][321 ]["p" ][30.0 ] = ["/TASSO_1980_I153656/d06-x01-y01"] +analyses["IdentifiedParticle"][321 ]["p" ][34.0 ] = ["/TASSO_1983_I181470/d15-x01-y01"] +analyses["IdentifiedParticle"][321 ]["p" ][91.2 ] = ["/DELPHI_1995_I394052/d03-x01-y01","/DELPHI_1998_I473409/d20-x01-y01", + "/OPAL_1994_S2927284/d02-x01-y01"] +# xi +analyses["IdentifiedParticle"][321 ]["xi" ][58.0 ] = ["/TOPAZ_1995_I381900/d02-x01-y02"] +# ratio +analyses["IdentifiedParticle"][321 ]["Ratio"][12.0 ] = ["/TASSO_1980_I153656/d09-x01-y01"] +analyses["IdentifiedParticle"][321 ]["Ratio"][29.0 ] = ["/TPC_1988_I262143/d07-x01-y01","/TPC_1988_I262143/d06-x01-y02"] +analyses["IdentifiedParticle"][321 ]["Ratio"][30.0 ] = ["/TASSO_1980_I153656/d12-x01-y01"] +analyses["IdentifiedParticle"][321 ]["Ratio"][34.0 ] = ["/TASSO_1989_I267755/d02-x01-y01"] +analyses["IdentifiedParticle"][321 ]["Ratio"][44.0 ] = ["/TASSO_1989_I267755/d05-x01-y01"] +analyses["IdentifiedParticle"][321 ]["Ratio"][91.2 ] = ["/DELPHI_1998_I473409/d05-x01-y01","/SLD_1999_S3743934/d02-x01-y01"] +# other +analyses["IdentifiedParticle"][321 ]["Other"][91.2 ] = ["/SLD_1999_S3743934/d30-x01-y01","/SLD_1999_S3743934/d30-x01-y02", + "/SLD_1999_S3743934/d31-x01-y01","/SLD_2004_S5693039/d10-x01-y01", + "/SLD_2004_S5693039/d10-x01-y02","/SLD_2004_S5693039/d10-x01-y03"] +# K*0 +analyses["IdentifiedParticle"][313 ]["x" ][10.0 ] = ["/ARGUS_1993_S2789213/d07-x01-y01"] +analyses["IdentifiedParticle"][313 ]["x" ][29.0 ] = ["/TPC_1984_I205869/d03-x01-y01"] +analyses["IdentifiedParticle"][313 ]["x" ][91.2 ] = ["/DELPHI_1996_I420528/d01-x01-y01","/ALEPH_1996_S3486095/d39-x01-y01", + "/OPAL_1997_S3608263/d01-x01-y01","/SLD_1999_S3743934/d08-x01-y01"] +analyses["IdentifiedParticle"][313 ]["Other"][91.2 ] = ["/SLD_1999_S3743934/d28-x01-y01","/SLD_1999_S3743934/d28-x01-y02", + "/SLD_1999_S3743934/d29-x01-y01"] +# K* +/- +analyses["IdentifiedParticle"][323 ]["x" ][10.0 ] = ["/ARGUS_1993_S2789213/d04-x01-y01"] +analyses["IdentifiedParticle"][323 ]["x" ][14.8 ] = ["/TASSO_1990_I284251/d02-x01-y01"] +analyses["IdentifiedParticle"][323 ]["x" ][21.5 ] = ["/TASSO_1990_I284251/d03-x01-y01"] +analyses["IdentifiedParticle"][323 ]["x" ][34.5 ] = ["/TASSO_1990_I284251/d08-x01-y03"] +analyses["IdentifiedParticle"][323 ]["x" ][35.0 ] = ["/TASSO_1990_I284251/d08-x01-y02","/CELLO_1990_I283026/d02-x01-y01", + "/JADE_1984_I203145/d03-x01-y01"] +analyses["IdentifiedParticle"][323 ]["x" ][42.6 ] = ["/TASSO_1990_I284251/d08-x01-y01"] +analyses["IdentifiedParticle"][323 ]["x" ][91.2 ] = ["/OPAL_1993_I342766/d01-x01-y01","/DELPHI_1995_I377487/d10-x01-y01", + "/ALEPH_1996_S3486095/d43-x01-y01"] +analyses["IdentifiedParticle"][323 ]["Other"][35.0 ] = ["/TASSO_1990_I284251/d10-x01-y01","/TASSO_1990_I284251/d10-x01-y02"] +# charm +# D+/- +analyses["IdentifiedParticle"][421 ]["x" ][10.5 ] = ["/CLEO_2004_S5809304/d03-x01-y01","/CLEO_2004_S5809304/d04-x01-y01"] +analyses["IdentifiedParticle"][421 ]["x" ][29.0 ] = ["/HRS_1988_I23360/d02-x01-y01"] +# D0 +analyses["IdentifiedParticle"][411 ]["x" ][10.5 ] = ["/CLEO_2004_S5809304/d02-x01-y01","/CLEO_2004_S5809304/d09-x01-y01"] +analyses["IdentifiedParticle"][411 ]["x" ][29.0 ] = ["/HRS_1988_I23360/d02-x01-y02"] +# D* 0 +analyses["IdentifiedParticle"][423 ]["x" ][10.5]=["/CLEO_2004_S5809304/d07-x01-y01","/CLEO_2004_S5809304/d08-x01-y01"] +# D* +/- +analyses["IdentifiedParticle"][413 ]["x" ][29.0 ] = ["/TPC_1986_I217416/d01-x01-y01","/TPC_1986_I217416/d01-x01-y02", + "/HRS_1988_I23360/d01-x01-y01","/HRS_1988_I23360/d01-x01-y02"] +analyses["IdentifiedParticle"][413 ]["x" ][34.4 ] = ["/JADE_1984_I202785/d01-x01-y01"] +analyses["IdentifiedParticle"][413 ]["x" ][36.2 ] = ["/TASSO_1989_I278856/d01-x01-y01","/TASSO_1989_I278856/d01-x01-y02", + "/TASSO_1989_I278856/d02-x01-y01","/TASSO_1989_I278856/d02-x01-y02"] +analyses["IdentifiedParticle"][413 ]["x" ][91.2 ] = ["/ALEPH_1999_S4193598/d01-x01-y01"] +analyses["IdentifiedParticle"][413 ]["x" ][10.5 ] = ["/CLEO_2004_S5809304/d05-x01-y01","/CLEO_2004_S5809304/d06-x01-y01"] +analyses["IdentifiedParticle"][413 ]["Other"][34.4 ] = ["/JADE_1984_I202785/d03-x01-y01"] +# D_2 +analyses["IdentifiedParticle"][425 ]["x" ][10.0 ] = ["/ARGUS_1989_I268577/d02-x01-y01"] +# D_s+ +analyses["IdentifiedParticle"][431 ]["x" ][10.5 ] = ["/CLEO_2000_I526554/d02-x01-y01","/CLEO_2000_I526554/d04-x01-y01"] +# D_s*+ +analyses["IdentifiedParticle"][433 ]["x" ][10.5 ] = ["/CLEO_2000_I526554/d01-x01-y01","/CLEO_2000_I526554/d03-x01-y01"] +# charmonium +analyses["IdentifiedParticle"][443 ]["x" ][91.2 ] = ["/OPAL_1996_S3257789/d01-x01-y01"] +# other +analyses["IdentifiedParticle"]["321/2212"]["Ratio"][91.2 ] = ["/DELPHI_1998_I473409/d07-x01-y01"] +# +# Baryons +# +# light unflavoured +# proton +# x +analyses["IdentifiedParticle"][2212]["x" ][10.0 ] = ["/ARGUS_1989_I276860/d12-x01-y02"] +analyses["IdentifiedParticle"][2212]["x" ][12.0 ] = ["/TASSO_1980_I153656/d04-x01-y02"] +analyses["IdentifiedParticle"][2212]["x" ][14.0 ] = ["/TASSO_1983_I181470/d14-x01-y01"] +analyses["IdentifiedParticle"][2212]["x" ][22.0 ] = ["/TASSO_1983_I181470/d16-x01-y01"] +analyses["IdentifiedParticle"][2212]["x" ][29.0 ] = ["/TPC_1988_I262143/d01-x01-y03","/TPC_1988_I262143/d05-x01-y03"] +analyses["IdentifiedParticle"][2212]["x" ][30.0 ] = ["/TASSO_1980_I153656/d07-x01-y02"] +analyses["IdentifiedParticle"][2212]["x" ][34.0 ] = ["/TASSO_1989_I267755/d09-x01-y01","/TASSO_1983_I181470/d18-x01-y01"] +analyses["IdentifiedParticle"][2212]["x" ][44.0 ] = ["/TASSO_1989_I267755/d12-x01-y01"] +analyses["IdentifiedParticle"][2212]["x" ][91.2 ] = ["/ALEPH_1995_I382179/d03-x01-y01","/DELPHI_1995_I394052/d06-x01-y01", + "/DELPHI_1998_I473409/d23-x01-y01","/ALEPH_1996_S3486095/d27-x01-y01", + "/SLD_2004_S5693039/d04-x01-y02","/SLD_1999_S3743934/d03-x01-y02"] +# p +analyses["IdentifiedParticle"][2212]["p" ][10.0 ] = ["/ARGUS_1989_I276860/d08-x01-y02"] +analyses["IdentifiedParticle"][2212]["p" ][10.54] = ["/BABAR_2013_I1238276/d01-x01-y03","/BABAR_2013_I1238276/d02-x01-y03"] +analyses["IdentifiedParticle"][2212]["p" ][12.0 ] = ["/TASSO_1980_I153656/d04-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][14.0 ] = ["/TASSO_1983_I181470/d23-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][22.0 ] = ["/TASSO_1983_I181470/d11-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][30.0 ] = ["/TASSO_1980_I153656/d07-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][34.0 ] = ["/TASSO_1989_I267755/d03-x01-y01","/JADE_1981_I166363/d01-x01-y01", + "/TASSO_1983_I181470/d17-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][44.0 ] = ["/TASSO_1989_I267755/d06-x01-y01"] +analyses["IdentifiedParticle"][2212]["p" ][91.2 ] = ["/DELPHI_1995_I394052/d04-x01-y01","/DELPHI_1998_I473409/d22-x01-y01", + "/OPAL_1994_S2927284/d03-x01-y01",] +# xi +analyses["IdentifiedParticle"][2212]["xi" ][58.0 ] = ["/TOPAZ_1995_I381900/d02-x01-y03"] +# ratio +analyses["IdentifiedParticle"][2212]["Ratio"][12.0 ] = ["/TASSO_1980_I153656/d10-x01-y01"] +analyses["IdentifiedParticle"][2212]["Ratio"][29.0 ] = ["/TPC_1988_I262143/d06-x01-y03","/TPC_1988_I262143/d07-x01-y02", + "/TPC_1988_I262143/d07-x01-y03"] +analyses["IdentifiedParticle"][2212]["Ratio"][30.0 ] = ["/TASSO_1980_I153656/d13-x01-y01"] +analyses["IdentifiedParticle"][2212]["Ratio"][91.2 ] = ["/SLD_1999_S3743934/d03-x01-y01","/DELPHI_1998_I473409/d06-x01-y01"] +analyses["IdentifiedParticle"][2212]["Other"][91.2 ] = ["/SLD_1999_S3743934/d32-x01-y01","/SLD_1999_S3743934/d32-x01-y02", + "/SLD_1999_S3743934/d33-x01-y01","/SLD_2004_S5693039/d11-x01-y01", + "/SLD_2004_S5693039/d11-x01-y02","/SLD_2004_S5693039/d11-x01-y03"] +# Delta++ +analyses["IdentifiedParticle"][2224]["x" ][91.2 ] = ["/OPAL_1995_S3198391/d01-x01-y01","/DELPHI_1995_I399737/d01-x01-y01"] +# hyperons +# lambda0 +# x +analyses["IdentifiedParticle"][3122]["x" ][10.0 ] = ["/ARGUS_1988_I251097/d05-x01-y01","/ARGUS_1988_I251097/d06-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][10.52] = ["/BELLE_2017_I1606201/d01-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][14.0 ] = ["/TASSO_1985_I205119/d04-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][22.0 ] = ["/TASSO_1985_I205119/d05-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][29.0 ] = ["/HRS_1992_I339573/d01-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][34.0 ] = ["/TASSO_1985_I205119/d06-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][34.8 ] = ["/TASSO_1989_I266893/d08-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][35.0 ] = ["/CELLO_1990_I283026/d03-x01-y01"] +analyses["IdentifiedParticle"][3122]["x" ][91.2 ] = ["/OPAL_1997_S3396100/d01-x01-y01","/ALEPH_1996_S3486095/d33-x01-y01", + "/DELPHI_1993_I360638/d01-x01-y01","/SLD_1999_S3743934/d07-x01-y01"] +# p +analyses["IdentifiedParticle"][3122]["p" ][14.0 ] = ["/TASSO_1985_I205119/d10-x01-y01"] +analyses["IdentifiedParticle"][3122]["p" ][22.0 ] = ["/TASSO_1985_I205119/d11-x01-y01"] +analyses["IdentifiedParticle"][3122]["p" ][34.0 ] = ["/JADE_1981_I166363/d02-x01-y01","/TASSO_1985_I205119/d12-x01-y01"] +analyses["IdentifiedParticle"][3122]["p" ][34.8 ] = ["/TASSO_1989_I266893/d03-x01-y01"] +# xi +analyses["IdentifiedParticle"][3122]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d02-x01-y01"] +# other +analyses["IdentifiedParticle"][3122]["Other"][34.8 ] = ["/TASSO_1989_I266893/d04-x01-y01","/TASSO_1989_I266893/d05-x01-y01", + "/TASSO_1989_I266893/d06-x01-y01","/TASSO_1989_I266893/d07-x01-y01", + "/TASSO_1989_I266893/d15-x01-y01","/TASSO_1989_I266893/d15-x01-y02", + "/TASSO_1989_I266893/d15-x01-y03"] +analyses["IdentifiedParticle"][3122]["Other"][91.2 ] = ["/DELPHI_1993_I360638/d03-x01-y01","/DELPHI_1993_I360638/d04-x01-y01", + "/DELPHI_1993_I360638/d05-x01-y01","/DELPHI_1993_I360638/d06-x01-y01", + "/SLD_1999_S3743934/d34-x01-y01","/SLD_1999_S3743934/d34-x01-y02", + "/SLD_1999_S3743934/d35-x01-y01"] +# Sigma+ +analyses["IdentifiedParticle"][3222]["x" ][91.2 ] = ["/OPAL_1997_I421977/d01-x01-y01"] +# sigma0 +analyses["IdentifiedParticle"][3212]["x" ][10.52] = ["/BELLE_2017_I1606201/d02-x01-y01"] +# sigma- +analyses["IdentifiedParticle"][3112]["x" ][91.2 ] = ["/OPAL_1997_I421977/d02-x01-y01","/DELPHI_2000_I524694/d01-x01-y01"] +# Sigma*+ +analyses["IdentifiedParticle"][3224 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d03-x01-y01"] +analyses["IdentifiedParticle"][3224 ]["x" ][91.2 ] = ["/DELPHI_1995_S3137023/d03-x01-y01","/OPAL_1997_S3396100/d05-x01-y01"] +analyses["IdentifiedParticle"][3224 ]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d06-x01-y01"] +analyses["IdentifiedParticle"]["3224B"]["x" ][91.2 ] = ["/ALEPH_1996_S3486095/d35-x01-y01"] +# sigma*- +analyses["IdentifiedParticle"][3114 ]["x" ][91.2 ] = ["/OPAL_1997_S3396100/d07-x01-y01"] +analyses["IdentifiedParticle"][3114 ]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d08-x01-y01"] +# xi- +analyses["IdentifiedParticle"][3312]["x" ][10.0 ] = ["/ARGUS_1988_I251097/d09-x01-y01"] +analyses["IdentifiedParticle"][3312]["x" ][10.52] = ["/BELLE_2017_I1606201/d05-x01-y01"] +analyses["IdentifiedParticle"][3312]["x" ][34.4 ] = ["/TASSO_1983_I192072/d02-x01-y01"] +analyses["IdentifiedParticle"][3312]["x" ][34.8 ] = ["/TASSO_1989_I266893/d23-x01-y01"] +analyses["IdentifiedParticle"][3312]["p" ][34.8 ] = ["/TASSO_1989_I266893/d18-x01-y01"] +analyses["IdentifiedParticle"][3312]["x" ][91.2 ] = ["/OPAL_1997_S3396100/d03-x01-y01","/DELPHI_1995_S3137023/d02-x01-y01", + "/ALEPH_1996_S3486095/d34-x01-y01"] +analyses["IdentifiedParticle"][3312]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d04-x01-y01","/DELPHI_2006_I719387/d01-x03-y01",] +analyses["IdentifiedParticle"][3312]["Other"][34.8 ] = ["/TASSO_1989_I266893/d19-x01-y01","/TASSO_1989_I266893/d20-x01-y01", + "/TASSO_1989_I266893/d21-x01-y01","/TASSO_1989_I266893/d22-x01-y01"] +# xi*0 +analyses["IdentifiedParticle"][3324]["x" ][10.52] = ["/BELLE_2017_I1606201/d07-x01-y01"] +analyses["IdentifiedParticle"][3324]["x" ][91.2 ] = ["/OPAL_1997_S3396100/d09-x01-y01","/ALEPH_1996_S3486095/d36-x01-y01"] +analyses["IdentifiedParticle"][3324]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d10-x01-y01"] +# omega +analyses["IdentifiedParticle"][3334]["x" ][10.52] = ["/BELLE_2017_I1606201/d06-x01-y01"] +# lambda 1520 +analyses["IdentifiedParticle"][3124]["x" ][10.0 ] = ["/ARGUS_1989_I262415/d04-x01-y01"] +analyses["IdentifiedParticle"][3124]["x" ][10.52] = ["/BELLE_2017_I1606201/d04-x01-y01"] +analyses["IdentifiedParticle"][3124]["x" ][91.2 ] = ["/OPAL_1997_S3396100/d11-x01-y01","/DELPHI_2000_I524694/d03-x01-y01"] +analyses["IdentifiedParticle"][3124]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d12-x01-y01"] +# charm baryons +# lambda_c +analyses["IdentifiedParticle"][4122 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d08-x01-y01"] +analyses["IdentifiedParticle"][4122 ]["x" ][10.54] = ["/BABAR_2007_S6895344/d01-x01-y01"] +analyses["IdentifiedParticle"][4122 ]["Other"][10.5 ] = ["/CLEO_2001_I552541/d03-x01-y01","/CLEO_2001_I552541/d03-x01-y02", + "/CLEO_2001_I552541/d03-x01-y03","/CLEO_2001_I552541/d03-x01-y04", + "/CLEO_2001_I552541/d04-x01-y01","/CLEO_2001_I552541/d04-x01-y02", + "/CLEO_2001_I552541/d04-x01-y03","/CLEO_2001_I552541/d04-x01-y04",] +# sigma_c0 +analyses["IdentifiedParticle"][4112 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d11-x01-y01"] +# sigma_c*0 +analyses["IdentifiedParticle"][4114 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d12-x01-y01"] +# xi_c +analyses["IdentifiedParticle"][4132 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d14-x01-y01","/BELLE_2017_I1606201/d15-x01-y01"] +analyses["IdentifiedParticle"][4132 ]["p" ][10.58] = ["/BABAR_2005_S6181155/d02-x01-y02"] +# omega_c +analyses["IdentifiedParticle"][4332 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d13-x01-y01"] +# lambda_c(2595) +analyses["IdentifiedParticle"][14122]["x" ][10.52] = ["/BELLE_2017_I1606201/d09-x01-y01"] +# lambda_c(2625) +analyses["IdentifiedParticle"][4124 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d10-x01-y01"] +# b fragmentation +analyses["IdentifiedParticle"][511]["weak" ] = ["/DELPHI_2011_I890503/d01-x01-y01","/SLD_2002_S4869273/d01-x01-y01", + "/ALEPH_2001_S4656318/d01-x01-y01","/OPAL_2003_I599181/d01-x01-y01"] +analyses["IdentifiedParticle"][511]["weak_mean"] = ["/DELPHI_2011_I890503/d02-x01-y01","/ALEPH_2001_S4656318/d07-x01-y01", + "/OPAL_2003_I599181/d02-x01-y01"] +analyses["IdentifiedParticle"][511]["lead" ] = ["/ALEPH_2001_S4656318/d01-x01-y02"] +analyses["IdentifiedParticle"][511]["lead_mean"] = ["/ALEPH_2001_S4656318/d07-x01-y02"] +# multiplcities +analyses["Multiplicity"]["321/2212"][91.2] = ["/DELPHI_1998_I473409/d01-x01-y05"] +# mesons +analyses["Multiplicity"][211 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d01-x01-y01"] +analyses["Multiplicity"][211 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d01-x01-y02"] +analyses["Multiplicity"][211 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d01-x01-y03","/DELPHI_1996_S3430090/d36-x01-y01", + "/DELPHI_1998_I473409/d01-x01-y02","/SLD_2004_S5693039/d02-x02-y02", + "/SLD_1999_S3743934/d24-x01-y01"] +analyses["Multiplicity"][211 ][165.0] = ["/PDG_HADRON_MULTIPLICITIES/d01-x01-y04"] +analyses["Multiplicity"][111 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d02-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y01","/ARGUS_1990_I278933/d01-x01-y01"] +analyses["Multiplicity"][111 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d02-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y02"] +analyses["Multiplicity"][111 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d02-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d02-x01-y03", + "/DELPHI_1996_S3430090/d36-x01-y02","/ALEPH_1996_S3486095/d44-x01-y02"] + +analyses["Multiplicity"][321 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d03-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y01"] +analyses["Multiplicity"][321 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d03-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y02"] +analyses["Multiplicity"][321 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d03-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y03", + "/DELPHI_1996_S3430090/d36-x01-y03","/DELPHI_1998_I473409/d01-x01-y03", + "/SLD_2004_S5693039/d03-x02-y02","/SLD_1999_S3743934/d24-x02-y01"] +analyses["Multiplicity"][321 ][165.0] = ["/PDG_HADRON_MULTIPLICITIES/d03-x01-y04","/PDG_HADRON_MULTIPLICITIES_RATIOS/d03-x01-y04"] +analyses["Multiplicity"][311 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d04-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y01","/PLUTO_1981_I165122/d02-x01-y01"] +analyses["Multiplicity"][311 ][30. ] = ["/TASSO_1990_I284251/d04-x01-y01"] +analyses["Multiplicity"][311 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d04-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y02"] +analyses["Multiplicity"][311 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d04-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y03", + "/DELPHI_1996_S3430090/d36-x01-y04","/ALEPH_1996_S3486095/d44-x01-y05","/SLD_1999_S3743934/d24-x03-y01"] +analyses["Multiplicity"][311 ][165.0] = ["/PDG_HADRON_MULTIPLICITIES/d04-x01-y04","/PDG_HADRON_MULTIPLICITIES_RATIOS/d04-x01-y04"] +analyses["Multiplicity"][221 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d05-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y01","/ARGUS_1990_I278933/d02-x01-y01"] +analyses["Multiplicity"][221 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d05-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y02"] +analyses["Multiplicity"][221 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d05-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d05-x01-y03", + "/DELPHI_1996_S3430090/d36-x01-y05","/ALEPH_1996_S3486095/d44-x01-y03"] +analyses["Multiplicity"][331 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d06-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y01"] +analyses["Multiplicity"][331 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d06-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y02"] +analyses["Multiplicity"][331 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d06-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d06-x01-y03", + "/DELPHI_1996_S3430090/d36-x01-y06","/ALEPH_1996_S3486095/d44-x01-y04"] +analyses["Multiplicity"][411 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d07-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y01"] +analyses["Multiplicity"][411 ][10.58] = ["/CLEO_2004_S5809304/d01-x01-y01"] +analyses["Multiplicity"][411 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d07-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y02"] +analyses["Multiplicity"][411 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d07-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d07-x01-y03","/DELPHI_1996_S3430090/d36-x01-y07"] +analyses["Multiplicity"][421 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d08-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y01"] +analyses["Multiplicity"][421 ][10.58] = ["/CLEO_2004_S5809304/d01-x01-y02","/CLEO_2004_S5809304/d01-x01-y03"] +analyses["Multiplicity"][421 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d08-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y02"] +analyses["Multiplicity"][421 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d08-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d08-x01-y03","/DELPHI_1996_S3430090/d36-x01-y08"] +analyses["Multiplicity"][431 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d09-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y01"] +analyses["Multiplicity"][431 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d09-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y02"] +analyses["Multiplicity"][431 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d09-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d09-x01-y03"] +analyses["Multiplicity"]["511B"][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d10-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d10-x01-y01","/DELPHI_1996_S3430090/d36-x01-y09"] +analyses["Multiplicity"][521 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d11-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d11-x01-y01"] +analyses["Multiplicity"][531 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d12-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d12-x01-y01"] +analyses["Multiplicity"][9010221][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d13-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y01"] +analyses["Multiplicity"][9010221][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d13-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y02"] +analyses["Multiplicity"][9010221][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d13-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d13-x01-y03","/DELPHI_1996_S3430090/d37-x01-y01"] +analyses["Multiplicity"][9000211][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d14-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d14-x01-y01"] +analyses["Multiplicity"][113 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d15-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y01","/ARGUS_1993_S2789213/d01-x01-y02"] +analyses["Multiplicity"][113 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d15-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y02"] +analyses["Multiplicity"][113 ][34.0 ] = ["/TASSO_1982_I179022/d01-x01-y01"] +analyses["Multiplicity"][113 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d15-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d15-x01-y03", + "/ALEPH_1996_S3486095/d44-x01-y06","/DELPHI_1996_S3430090/d38-x01-y01"] +analyses["Multiplicity"][213 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d16-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d16-x01-y01"] +analyses["Multiplicity"][223 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d17-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y01","/ARGUS_1993_S2789213/d01-x01-y01"] +analyses["Multiplicity"][223 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d17-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d17-x01-y02", + "/ALEPH_1996_S3486095/d44-x01-y07"] +analyses["Multiplicity"][323 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d18-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y01","/ARGUS_1993_S2789213/d01-x01-y04"] +analyses["Multiplicity"][323 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d18-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y02"] +analyses["Multiplicity"][323 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d18-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d18-x01-y03", + "/OPAL_1993_I342766/d02-x01-y01","/DELPHI_1996_S3430090/d38-x01-y02","/ALEPH_1996_S3486095/d44-x01-y09"] +analyses["Multiplicity"][313 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d19-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y01","/ARGUS_1993_S2789213/d01-x01-y03"] +analyses["Multiplicity"][313 ][30. ] = ["/TASSO_1990_I284251/d09-x01-y01"] +analyses["Multiplicity"][313 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d19-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y02"] +analyses["Multiplicity"][313 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d19-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d19-x01-y03", + "/DELPHI_1996_S3430090/d38-x01-y03","/ALEPH_1996_S3486095/d44-x01-y10","/SLD_1999_S3743934/d24-x04-y01"] +analyses["Multiplicity"][333 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d20-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y01","/ARGUS_1993_S2789213/d01-x01-y05"] +analyses["Multiplicity"][333 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d20-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y02"] +analyses["Multiplicity"][333 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d20-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d20-x01-y03", + "/DELPHI_1996_S3430090/d38-x01-y04","/ALEPH_1996_S3486095/d44-x01-y08","/SLD_1999_S3743934/d24-x05-y01"] +analyses["Multiplicity"][413 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d21-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y01"] +analyses["Multiplicity"][413 ][10.58] = ["/CLEO_2004_S5809304/d01-x01-y04","/CLEO_2004_S5809304/d01-x01-y05"] +analyses["Multiplicity"][413 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d21-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y02"] +analyses["Multiplicity"][413 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d21-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d21-x01-y03", + "/DELPHI_1996_S3430090/d38-x01-y05","/OPAL_1995_I382219/d03-x01-y01"] +analyses["Multiplicity"][423 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d22-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y01"] +analyses["Multiplicity"][423 ][10.58] = ["/CLEO_2004_S5809304/d01-x01-y06","/CLEO_2004_S5809304/d01-x01-y07"] +analyses["Multiplicity"][423 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d22-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d22-x01-y02"] +analyses["Multiplicity"][433 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d23-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y01"] +analyses["Multiplicity"][433 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d23-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d23-x01-y02"] +analyses["Multiplicity"][513 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d24-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d24-x01-y01"] +analyses["Multiplicity"][443 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d25-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y01"] +analyses["Multiplicity"][443 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d25-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d25-x01-y02", + "/OPAL_1996_S3257789/d02-x01-y01"] +analyses["Multiplicity"][100443 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d26-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d26-x01-y01", + "/OPAL_1996_S3257789/d02-x01-y02"] +analyses["Multiplicity"][553 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d27-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d27-x01-y01"] +analyses["Multiplicity"][20223 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d28-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d28-x01-y01"] +analyses["Multiplicity"][20333 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d29-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d29-x01-y01"] +analyses["Multiplicity"][20443 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d30-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d30-x01-y01"] +analyses["Multiplicity"][225 ][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d31-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y01"] +analyses["Multiplicity"][225 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d31-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y02"] +analyses["Multiplicity"][225 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d31-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d31-x01-y03","/DELPHI_1996_S3430090/d39-x01-y01"] +analyses["Multiplicity"][335 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d32-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d32-x01-y01"] +analyses["Multiplicity"][325 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d33-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d33-x01-y01"] +analyses["Multiplicity"][315 ][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d34-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y01"] +analyses["Multiplicity"][315 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d34-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d34-x01-y02","/DELPHI_1996_S3430090/d39-x01-y02"] +analyses["Multiplicity"][515 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d35-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d35-x01-y01"] +analyses["Multiplicity"][20431][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d36-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d36-x01-y01"] +analyses["Multiplicity"][435 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d37-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d37-x01-y01"] +#baryons +analyses["Multiplicity"][2212][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d38-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y01"] +analyses["Multiplicity"][2212][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d38-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y02"] +analyses["Multiplicity"][2212][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d38-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y03", + "/DELPHI_1996_S3430090/d40-x01-y01","/DELPHI_1998_I473409/d01-x01-y04", + "/SLD_2004_S5693039/d04-x02-y02","/SLD_1999_S3743934/d24-x06-y01"] +analyses["Multiplicity"][2212][165.0] = ["/PDG_HADRON_MULTIPLICITIES/d38-x01-y04","/PDG_HADRON_MULTIPLICITIES_RATIOS/d38-x01-y04"] +analyses["Multiplicity"][3122][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d39-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y01","/ARGUS_1988_I251097/d02-x01-y01"] +analyses["Multiplicity"][3122][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d39-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y02"] +analyses["Multiplicity"][3122][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d39-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y03", + "/DELPHI_1996_S3430090/d40-x01-y02","/ALEPH_1996_S3486095/d44-x01-y11","/DELPHI_1993_I360638/d02-x01-y01", + "/SLD_1999_S3743934/d24-x07-y01"] +analyses["Multiplicity"][3122][165.0] = ["/PDG_HADRON_MULTIPLICITIES/d39-x01-y04","/PDG_HADRON_MULTIPLICITIES_RATIOS/d39-x01-y04"] +analyses["Multiplicity"][3212][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d40-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y01","/ARGUS_1988_I251097/d02-x01-y03"] +analyses["Multiplicity"][3212][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d40-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d40-x01-y02"] +analyses["Multiplicity"][3112][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d41-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d41-x01-y01"] +analyses["Multiplicity"][3222][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d42-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d42-x01-y01","/ALEPH_1996_S3486095/d44-x01-y12"] +analyses["Multiplicity"][3312][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d44-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y01","/ARGUS_1988_I251097/d02-x01-y02"] +analyses["Multiplicity"][3312][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d44-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y02"] +analyses["Multiplicity"][3312][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d44-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d44-x01-y03", + "/DELPHI_1996_S3430090/d40-x01-y03","/ALEPH_1996_S3486095/d44-x01-y13"] +analyses["Multiplicity"][2224][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d45-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y01"] +analyses["Multiplicity"][2224][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d45-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d45-x01-y02","/DELPHI_1996_S3430090/d40-x01-y05"] +analyses["Multiplicity"][3114][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d46-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y01","/ARGUS_1988_I251097/d02-x01-y04"] +analyses["Multiplicity"][3114][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d46-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y02"] +analyses["Multiplicity"][3114][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d46-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d46-x01-y03"] +analyses["Multiplicity"][3224][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d47-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y01","/ARGUS_1988_I251097/d02-x01-y05"] +analyses["Multiplicity"][3224][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d47-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y02"] +analyses["Multiplicity"][3224][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d47-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d47-x01-y03"] +analyses["Multiplicity"][3324][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d49-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y01","/ARGUS_1988_I251097/d02-x01-y06"] +analyses["Multiplicity"][3324][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d49-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d49-x01-y02", + "/DELPHI_1996_S3430090/d40-x01-y07","/ALEPH_1996_S3486095/d44-x01-y15"] +analyses["Multiplicity"][3334][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d50-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y01","/ARGUS_1988_I251097/d02-x01-y07"] +analyses["Multiplicity"][3334][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d50-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y02"] +analyses["Multiplicity"][3334][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d50-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d50-x01-y03", + "/DELPHI_1996_S3430090/d40-x01-y04","/ALEPH_1996_S3486095/d44-x01-y16"] +analyses["Multiplicity"][4122][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d51-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y01", + "/BABAR_2007_S6895344/d02-x01-y01"] +analyses["Multiplicity"][4122][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d51-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y02"] +analyses["Multiplicity"][4122][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d51-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d51-x01-y03"] +analyses["Multiplicity"][5122][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d52-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d52-x01-y01","/DELPHI_1996_S3430090/d40-x01-y08"] +analyses["Multiplicity"][4222][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d53-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d53-x01-y01"] +analyses["Multiplicity"][3124][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d54-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y01"] +analyses["Multiplicity"][3124][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d54-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d54-x01-y02"] +# +analyses["Multiplicity"]["3222B"][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d43-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d43-x01-y01"] +analyses["Multiplicity"]["3224B"][10. ] = ["/PDG_HADRON_MULTIPLICITIES/d48-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y01"] +analyses["Multiplicity"]["3224B"][32.0 ] = ["/PDG_HADRON_MULTIPLICITIES/d48-x01-y02","/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y02"] +analyses["Multiplicity"]["3224B"][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d48-x01-y03","/PDG_HADRON_MULTIPLICITIES_RATIOS/d48-x01-y03", + "/DELPHI_1996_S3430090/d40-x01-y06","/ALEPH_1996_S3486095/d44-x01-y14"] +analyses["Multiplicity"][4132][10.52] = ["/BABAR_2005_S6181155/d03-x01-y01"] +# event shapes +# thrust based +analyses["EventShapes"]["T"][14.0 ] = ["/TASSO_1990_S2148048/d08-x01-y01"] +analyses["EventShapes"]["T"][22.0 ] = ["/TASSO_1990_S2148048/d08-x01-y02"] +analyses["EventShapes"]["T"][29.0 ] = ["/HRS_1985_I201482/d03-x01-y01","/HRS_1985_I201482/d04-x01-y01"] +analyses["EventShapes"]["T"][35.0 ] = ["/TASSO_1990_S2148048/d08-x01-y03","/TASSO_1988_I263859/d03-x01-y01", + "/JADE_1998_S3612880/d06-x01-y01"] +analyses["EventShapes"]["T"][44.0 ] = ["/TASSO_1990_S2148048/d08-x01-y04","/JADE_1998_S3612880/d02-x01-y01"] +analyses["EventShapes"]["T"][45.0 ] = ["/DELPHI_2003_I620250/d01-x01-y01"] +analyses["EventShapes"]["T"][55.2 ] = ["/AMY_1990_I283337/d12-x01-y01"] +analyses["EventShapes"]["T"][58.0 ] = ["/TOPAZ_1993_I361661/d01-x01-y01"] +analyses["EventShapes"]["T"][66.0 ] = ["/DELPHI_2003_I620250/d01-x01-y02"] +analyses["EventShapes"]["T"][76.0 ] = ["/DELPHI_2003_I620250/d01-x01-y03"] +analyses["EventShapes"]["T"][91.2 ] = ["/DELPHI_1996_S3430090/d11-x01-y01","/ALEPH_1996_S3486095/d03-x01-y01", + "/OPAL_2004_S6132243/d01-x01-y01","/ALEPH_2004_S5765862/d54-x01-y01"] +analyses["EventShapes"]["T"][133.0] = ["/ALEPH_2004_S5765862/d55-x01-y01","/OPAL_2004_S6132243/d01-x01-y02"] +analyses["EventShapes"]["T"][161.0] = ["/ALEPH_2004_S5765862/d56-x01-y01"] +analyses["EventShapes"]["T"][172.0] = ["/ALEPH_2004_S5765862/d57-x01-y01"] +analyses["EventShapes"]["T"][177.0] = ["/OPAL_2004_S6132243/d01-x01-y03"] +analyses["EventShapes"]["T"][183.0] = ["/DELPHI_2003_I620250/d38-x01-y01","/ALEPH_2004_S5765862/d58-x01-y01"] +analyses["EventShapes"]["T"][189.0] = ["/DELPHI_2003_I620250/d38-x01-y02","/ALEPH_2004_S5765862/d59-x01-y01"] +analyses["EventShapes"]["T"][192.0] = ["/DELPHI_2003_I620250/d38-x01-y03"] +analyses["EventShapes"]["T"][196.0] = ["/DELPHI_2003_I620250/d38-x01-y04"] +analyses["EventShapes"]["T"][200.0] = ["/DELPHI_2003_I620250/d39-x01-y01","/ALEPH_2004_S5765862/d60-x01-y01"] +analyses["EventShapes"]["T"][197.0] = ["/OPAL_2004_S6132243/d01-x01-y04"] +analyses["EventShapes"]["T"][202.0] = ["/DELPHI_2003_I620250/d39-x01-y02"] +analyses["EventShapes"]["T"][205.0] = ["/DELPHI_2003_I620250/d39-x01-y03"] +analyses["EventShapes"]["T"][206.0] = ["/ALEPH_2004_S5765862/d61-x01-y01"] +analyses["EventShapes"]["T"][207.0] = ["/DELPHI_2003_I620250/d39-x01-y04"] +analyses["EventShapes"]["T"][41.4 ] = ["/L3_2004_I652683/d21-x01-y01"] +analyses["EventShapes"]["T"][55.3 ] = ["/L3_2004_I652683/d21-x01-y02"] +analyses["EventShapes"]["T"][65.4 ] = ["/L3_2004_I652683/d21-x01-y03"] +analyses["EventShapes"]["T"][75.7 ] = ["/L3_2004_I652683/d22-x01-y01"] +analyses["EventShapes"]["T"][82.3 ] = ["/L3_2004_I652683/d22-x01-y02"] +analyses["EventShapes"]["T"][85.1 ] = ["/L3_2004_I652683/d22-x01-y03"] +analyses["EventShapes"]["T"][130.1] = ["/L3_2004_I652683/d23-x01-y01"] +analyses["EventShapes"]["T"][136.3] = ["/L3_2004_I652683/d23-x01-y02"] +analyses["EventShapes"]["T"][161.3] = ["/L3_2004_I652683/d23-x01-y03"] +analyses["EventShapes"]["T"][172.3] = ["/L3_2004_I652683/d24-x01-y01"] +analyses["EventShapes"]["T"][182.8] = ["/L3_2004_I652683/d24-x01-y02"] +analyses["EventShapes"]["T"][188.6] = ["/L3_2004_I652683/d24-x01-y03"] +analyses["EventShapes"]["T"][194.4] = ["/L3_2004_I652683/d25-x01-y01"] +analyses["EventShapes"]["T"][200.2] = ["/L3_2004_I652683/d25-x01-y02"] +analyses["EventShapes"]["T"][206.2] = ["/L3_2004_I652683/d25-x01-y03"] +analyses["EventShapes"]["Moment_T"][91.2 ] = ["/OPAL_2004_S6132243/d15-x01-y01"] +analyses["EventShapes"]["Moment_T"][133.0] = ["/OPAL_2004_S6132243/d15-x01-y02"] +analyses["EventShapes"]["Moment_T"][177.0] = ["/OPAL_2004_S6132243/d15-x01-y03"] +analyses["EventShapes"]["Moment_T"][197.0] = ["/OPAL_2004_S6132243/d15-x01-y04"] + +analyses["EventShapesFlavour"]["T"][2][91.2] = ["/L3_2004_I652683/d47-x01-y01"] +analyses["EventShapesFlavour"]["T"][5][91.2] = ["/L3_2004_I652683/d47-x01-y02"] +analyses["EventShapesFlavour"]["HeavyJetMass"][2][91.2] = ["/L3_2004_I652683/d48-x01-y01"] +analyses["EventShapesFlavour"]["HeavyJetMass"][5][91.2] = ["/L3_2004_I652683/d48-x01-y02"] +analyses["EventShapesFlavour"]["BT"][2][91.2] = ["/L3_2004_I652683/d49-x01-y01"] +analyses["EventShapesFlavour"]["BT"][5][91.2] = ["/L3_2004_I652683/d49-x01-y02"] +analyses["EventShapesFlavour"]["BW"][2][91.2] = ["/L3_2004_I652683/d50-x01-y01"] +analyses["EventShapesFlavour"]["BW"][5][91.2] = ["/L3_2004_I652683/d50-x01-y02"] +analyses["EventShapesFlavour"]["C"][2][91.2] = ["/L3_2004_I652683/d51-x01-y01"] +analyses["EventShapesFlavour"]["C"][5][91.2] = ["/L3_2004_I652683/d51-x01-y02"] +analyses["EventShapesFlavour"]["D"][2][91.2] = ["/L3_2004_I652683/d52-x01-y01"] +analyses["EventShapesFlavour"]["D"][5][91.2] = ["/L3_2004_I652683/d52-x01-y02"] + +analyses["EventShapes"]["Moment_H" ][91.2 ] = ["/OPAL_2004_S6132243/d16-x01-y01"] +analyses["EventShapes"]["Moment_H" ][133.0] = ["/OPAL_2004_S6132243/d16-x01-y02"] +analyses["EventShapes"]["Moment_H" ][177.0] = ["/OPAL_2004_S6132243/d16-x01-y03"] +analyses["EventShapes"]["Moment_H" ][197.0] = ["/OPAL_2004_S6132243/d16-x01-y04"] +analyses["EventShapes"]["Moment_C" ][91.2 ] = ["/OPAL_2004_S6132243/d17-x01-y01"] +analyses["EventShapes"]["Moment_C" ][133.0] = ["/OPAL_2004_S6132243/d17-x01-y02"] +analyses["EventShapes"]["Moment_C" ][177.0] = ["/OPAL_2004_S6132243/d17-x01-y03"] +analyses["EventShapes"]["Moment_C" ][197.0] = ["/OPAL_2004_S6132243/d17-x01-y04"] +analyses["EventShapes"]["Moment_BT"][91.2 ] = ["/OPAL_2004_S6132243/d18-x01-y01"] +analyses["EventShapes"]["Moment_BT"][133.0] = ["/OPAL_2004_S6132243/d18-x01-y02"] +analyses["EventShapes"]["Moment_BT"][177.0] = ["/OPAL_2004_S6132243/d18-x01-y03"] +analyses["EventShapes"]["Moment_BT"][197.0] = ["/OPAL_2004_S6132243/d18-x01-y04"] +analyses["EventShapes"]["Moment_BW"][91.2 ] = ["/OPAL_2004_S6132243/d19-x01-y01"] +analyses["EventShapes"]["Moment_BW"][133.0] = ["/OPAL_2004_S6132243/d19-x01-y02"] +analyses["EventShapes"]["Moment_BW"][177.0] = ["/OPAL_2004_S6132243/d19-x01-y03"] +analyses["EventShapes"]["Moment_BW"][197.0] = ["/OPAL_2004_S6132243/d19-x01-y04"] +analyses["EventShapes"]["Moment_y" ][91.2 ] = ["/OPAL_2004_S6132243/d20-x01-y01"] +analyses["EventShapes"]["Moment_y" ][133.0] = ["/OPAL_2004_S6132243/d20-x01-y02"] +analyses["EventShapes"]["Moment_y" ][177.0] = ["/OPAL_2004_S6132243/d20-x01-y03"] +analyses["EventShapes"]["Moment_y" ][197.0] = ["/OPAL_2004_S6132243/d20-x01-y04"] +analyses["EventShapes"]["Moment_M" ][91.2 ] = ["/OPAL_2004_S6132243/d21-x01-y01"] +analyses["EventShapes"]["Moment_M" ][133.0] = ["/OPAL_2004_S6132243/d21-x01-y02"] +analyses["EventShapes"]["Moment_M" ][177.0] = ["/OPAL_2004_S6132243/d21-x01-y03"] +analyses["EventShapes"]["Moment_M" ][197.0] = ["/OPAL_2004_S6132243/d21-x01-y04"] +analyses["EventShapes"]["Moment_m" ][91.2 ] = ["/OPAL_2004_S6132243/d22-x01-y01"] +analyses["EventShapes"]["Moment_m" ][133.0] = ["/OPAL_2004_S6132243/d22-x01-y02"] +analyses["EventShapes"]["Moment_m" ][177.0] = ["/OPAL_2004_S6132243/d22-x01-y03"] +analyses["EventShapes"]["Moment_m" ][197.0] = ["/OPAL_2004_S6132243/d22-x01-y04"] +analyses["EventShapes"]["Moment_S" ][91.2 ] = ["/OPAL_2004_S6132243/d23-x01-y01"] +analyses["EventShapes"]["Moment_S" ][133.0] = ["/OPAL_2004_S6132243/d23-x01-y02"] +analyses["EventShapes"]["Moment_S" ][177.0] = ["/OPAL_2004_S6132243/d23-x01-y03"] +analyses["EventShapes"]["Moment_S" ][197.0] = ["/OPAL_2004_S6132243/d23-x01-y04"] +analyses["EventShapes"]["Moment_O" ][91.2 ] = ["/OPAL_2004_S6132243/d24-x01-y01"] +analyses["EventShapes"]["Moment_O" ][133.0] = ["/OPAL_2004_S6132243/d24-x01-y02"] +analyses["EventShapes"]["Moment_O" ][177.0] = ["/OPAL_2004_S6132243/d24-x01-y03"] +analyses["EventShapes"]["Moment_O" ][197.0] = ["/OPAL_2004_S6132243/d24-x01-y04"] +analyses["EventShapes"]["Moment_L" ][91.2 ] = ["/OPAL_2004_S6132243/d25-x01-y01"] +analyses["EventShapes"]["Moment_L" ][133.0] = ["/OPAL_2004_S6132243/d25-x01-y02"] +analyses["EventShapes"]["Moment_L" ][177.0] = ["/OPAL_2004_S6132243/d25-x01-y03"] +analyses["EventShapes"]["Moment_L" ][197.0] = ["/OPAL_2004_S6132243/d25-x01-y04"] +analyses["EventShapes"]["Moment_BN"][91.2 ] = ["/OPAL_2004_S6132243/d26-x01-y01"] +analyses["EventShapes"]["Moment_BN"][133.0] = ["/OPAL_2004_S6132243/d26-x01-y02"] +analyses["EventShapes"]["Moment_BN"][177.0] = ["/OPAL_2004_S6132243/d26-x01-y03"] +analyses["EventShapes"]["Moment_BN"][197.0] = ["/OPAL_2004_S6132243/d26-x01-y04"] + +analyses["EventShapes"]["Major"][45.0 ] = ["/DELPHI_2003_I620250/d02-x01-y01"] +analyses["EventShapes"]["Major"][55.2 ] = ["/AMY_1990_I283337/d13-x01-y01"] +analyses["EventShapes"]["Major"][66.0 ] = ["/DELPHI_2003_I620250/d02-x01-y02"] +analyses["EventShapes"]["Major"][76.0 ] = ["/DELPHI_2003_I620250/d02-x01-y03"] +analyses["EventShapes"]["Major"][91.2 ] = ["/DELPHI_1996_S3430090/d12-x01-y01","/OPAL_2004_S6132243/d07-x01-y01", + "/ALEPH_2004_S5765862/d94-x01-y01"] +analyses["EventShapes"]["Major"][133.0] = ["/ALEPH_2004_S5765862/d95-x01-y01","/OPAL_2004_S6132243/d07-x01-y02"] +analyses["EventShapes"]["Major"][161.0] = ["/ALEPH_2004_S5765862/d96-x01-y01"] +analyses["EventShapes"]["Major"][172.0] = ["/ALEPH_2004_S5765862/d97-x01-y01"] +analyses["EventShapes"]["Major"][177.0] = ["/OPAL_2004_S6132243/d07-x01-y03"] +analyses["EventShapes"]["Major"][183.0] = ["/DELPHI_2003_I620250/d40-x01-y01","/ALEPH_2004_S5765862/d98-x01-y01"] +analyses["EventShapes"]["Major"][189.0] = ["/DELPHI_2003_I620250/d40-x01-y02","/ALEPH_2004_S5765862/d99-x01-y01"] +analyses["EventShapes"]["Major"][192.0] = ["/DELPHI_2003_I620250/d40-x01-y03"] +analyses["EventShapes"]["Major"][196.0] = ["/DELPHI_2003_I620250/d40-x01-y04"] +analyses["EventShapes"]["Major"][197.0] = ["/OPAL_2004_S6132243/d07-x01-y04"] +analyses["EventShapes"]["Major"][200.0] = ["/DELPHI_2003_I620250/d41-x01-y01","/ALEPH_2004_S5765862/d100-x01-y01"] +analyses["EventShapes"]["Major"][202.0] = ["/DELPHI_2003_I620250/d41-x01-y02"] +analyses["EventShapes"]["Major"][205.0] = ["/DELPHI_2003_I620250/d41-x01-y03"] +analyses["EventShapes"]["Major"][206.0] = ["/ALEPH_2004_S5765862/d101-x01-y01"] +analyses["EventShapes"]["Major"][207.0] = ["/DELPHI_2003_I620250/d41-x01-y04"] +analyses["EventShapes"]["Minor"][45.0 ] = ["/DELPHI_2003_I620250/d03-x01-y01"] +analyses["EventShapes"]["Minor"][55.2 ] = ["/AMY_1990_I283337/d14-x01-y01"] +analyses["EventShapes"]["Minor"][66.0 ] = ["/DELPHI_2003_I620250/d03-x01-y02"] +analyses["EventShapes"]["Minor"][76.0 ] = ["/DELPHI_2003_I620250/d03-x01-y03"] +analyses["EventShapes"]["Minor"][91.2 ] = ["/DELPHI_1996_S3430090/d13-x01-y01","/ALEPH_2004_S5765862/d102-x01-y01", + "/ALEPH_1996_S3486095/d04-x01-y01","/OPAL_2004_S6132243/d08-x01-y01"] +analyses["EventShapes"]["Minor"][133.0] = ["/ALEPH_2004_S5765862/d103-x01-y01","/OPAL_2004_S6132243/d08-x01-y02"] +analyses["EventShapes"]["Minor"][161.0] = ["/ALEPH_2004_S5765862/d104-x01-y01"] +analyses["EventShapes"]["Minor"][172.0] = ["/ALEPH_2004_S5765862/d105-x01-y01"] +analyses["EventShapes"]["Minor"][177.0] = ["/OPAL_2004_S6132243/d08-x01-y03"] +analyses["EventShapes"]["Minor"][183.0] = ["/DELPHI_2003_I620250/d42-x01-y01","/ALEPH_2004_S5765862/d106-x01-y01"] +analyses["EventShapes"]["Minor"][189.0] = ["/DELPHI_2003_I620250/d42-x01-y02","/ALEPH_2004_S5765862/d107-x01-y01"] +analyses["EventShapes"]["Minor"][192.0] = ["/DELPHI_2003_I620250/d42-x01-y03"] +analyses["EventShapes"]["Minor"][196.0] = ["/DELPHI_2003_I620250/d42-x01-y04"] +analyses["EventShapes"]["Minor"][197.0] = ["/OPAL_2004_S6132243/d08-x01-y04"] +analyses["EventShapes"]["Minor"][200.0] = ["/DELPHI_2003_I620250/d43-x01-y01","/ALEPH_2004_S5765862/d108-x01-y01"] +analyses["EventShapes"]["Minor"][202.0] = ["/DELPHI_2003_I620250/d43-x01-y02"] +analyses["EventShapes"]["Minor"][205.0] = ["/DELPHI_2003_I620250/d43-x01-y03"] +analyses["EventShapes"]["Minor"][206.0] = ["/ALEPH_2004_S5765862/d109-x01-y01"] +analyses["EventShapes"]["Minor"][207.0] = ["/DELPHI_2003_I620250/d43-x01-y04"] + +analyses["EventShapes"]["O"][45.0 ] = ["/DELPHI_2003_I620250/d06-x01-y01"] +analyses["EventShapes"]["O"][55.2 ] = ["/AMY_1990_I283337/d15-x01-y01"] +analyses["EventShapes"]["O"][66.0 ] = ["/DELPHI_2003_I620250/d06-x01-y02"] +analyses["EventShapes"]["O"][76.0 ] = ["/DELPHI_2003_I620250/d06-x01-y03"] +analyses["EventShapes"]["O"][91.2 ] = ["/ALEPH_2004_S5765862/d133-x01-y01","/DELPHI_1996_S3430090/d14-x01-y01", + "/ALEPH_1996_S3486095/d08-x01-y01","/OPAL_2004_S6132243/d11-x01-y01"] +analyses["EventShapes"]["O"][133.0] = ["/ALEPH_2004_S5765862/d134-x01-y01","/OPAL_2004_S6132243/d11-x01-y02"] +analyses["EventShapes"]["O"][161.0] = ["/ALEPH_2004_S5765862/d135-x01-y01"] +analyses["EventShapes"]["O"][172.0] = ["/ALEPH_2004_S5765862/d136-x01-y01"] +analyses["EventShapes"]["O"][177.0] = ["/OPAL_2004_S6132243/d11-x01-y03"] +analyses["EventShapes"]["O"][183.0] = ["/DELPHI_2003_I620250/d44-x01-y01","/ALEPH_2004_S5765862/d137-x01-y01"] +analyses["EventShapes"]["O"][189.0] = ["/DELPHI_2003_I620250/d44-x01-y02","/ALEPH_2004_S5765862/d138-x01-y01"] +analyses["EventShapes"]["O"][192.0] = ["/DELPHI_2003_I620250/d44-x01-y03"] +analyses["EventShapes"]["O"][196.0] = ["/DELPHI_2003_I620250/d44-x01-y04"] +analyses["EventShapes"]["O"][197.0] = ["/OPAL_2004_S6132243/d11-x01-y04"] +analyses["EventShapes"]["O"][200.0] = ["/DELPHI_2003_I620250/d45-x01-y01","/ALEPH_2004_S5765862/d139-x01-y01"] +analyses["EventShapes"]["O"][202.0] = ["/DELPHI_2003_I620250/d45-x01-y02"] +analyses["EventShapes"]["O"][205.0] = ["/DELPHI_2003_I620250/d45-x01-y03"] +analyses["EventShapes"]["O"][206.0] = ["/ALEPH_2004_S5765862/d140-x01-y01"] +analyses["EventShapes"]["O"][207.0] = ["/DELPHI_2003_I620250/d45-x01-y04"] +# jet broadenings +analyses["EventShapes"]["BW"][45.0 ] = ["/DELPHI_2003_I620250/d13-x01-y01"] +analyses["EventShapes"]["BW"][66.0 ] = ["/DELPHI_2003_I620250/d13-x01-y02"] +analyses["EventShapes"]["BW"][76.0 ] = ["/DELPHI_2003_I620250/d13-x01-y03"] +analyses["EventShapes"]["BW"][91.2 ] = ["/DELPHI_1996_S3430090/d23-x01-y01","/ALEPH_2004_S5765862/d78-x01-y01","/OPAL_2004_S6132243/d05-x01-y01"] +analyses["EventShapes"]["BW"][133.0] = ["/OPAL_2004_S6132243/d05-x01-y02","/ALEPH_2004_S5765862/d79-x01-y01"] +analyses["EventShapes"]["BW"][161.0] = ["/ALEPH_2004_S5765862/d80-x01-y01"] +analyses["EventShapes"]["BW"][172.0] = ["/ALEPH_2004_S5765862/d81-x01-y01"] +analyses["EventShapes"]["BW"][177.0] = ["/OPAL_2004_S6132243/d05-x01-y03"] +analyses["EventShapes"]["BW"][183.0] = ["/DELPHI_2003_I620250/d46-x01-y01","/ALEPH_2004_S5765862/d82-x01-y01"] +analyses["EventShapes"]["BW"][189.0] = ["/DELPHI_2003_I620250/d46-x01-y02","/ALEPH_2004_S5765862/d83-x01-y01"] +analyses["EventShapes"]["BW"][192.0] = ["/DELPHI_2003_I620250/d46-x01-y03"] +analyses["EventShapes"]["BW"][196.0] = ["/DELPHI_2003_I620250/d46-x01-y04"] +analyses["EventShapes"]["BW"][197.0] = ["/OPAL_2004_S6132243/d05-x01-y04"] +analyses["EventShapes"]["BW"][200.0] = ["/DELPHI_2003_I620250/d47-x01-y01","/ALEPH_2004_S5765862/d84-x01-y01"] +analyses["EventShapes"]["BW"][202.0] = ["/DELPHI_2003_I620250/d47-x01-y02"] +analyses["EventShapes"]["BW"][205.0] = ["/DELPHI_2003_I620250/d47-x01-y03"] +analyses["EventShapes"]["BW"][206.0] = ["/ALEPH_2004_S5765862/d85-x01-y01"] +analyses["EventShapes"]["BW"][207.0] = ["/DELPHI_2003_I620250/d47-x01-y04"] +analyses["EventShapes"]["BW"][41.4 ] = ["/L3_2004_I652683/d36-x01-y01"] +analyses["EventShapes"]["BW"][55.3 ] = ["/L3_2004_I652683/d36-x01-y02"] +analyses["EventShapes"]["BW"][65.4 ] = ["/L3_2004_I652683/d36-x01-y03"] +analyses["EventShapes"]["BW"][75.7 ] = ["/L3_2004_I652683/d37-x01-y01"] +analyses["EventShapes"]["BW"][82.3 ] = ["/L3_2004_I652683/d37-x01-y02"] +analyses["EventShapes"]["BW"][85.1 ] = ["/L3_2004_I652683/d37-x01-y03"] +analyses["EventShapes"]["BW"][130.1] = ["/L3_2004_I652683/d38-x01-y01"] +analyses["EventShapes"]["BW"][136.3] = ["/L3_2004_I652683/d38-x01-y02"] +analyses["EventShapes"]["BW"][161.3] = ["/L3_2004_I652683/d38-x01-y03"] +analyses["EventShapes"]["BW"][172.3] = ["/L3_2004_I652683/d39-x01-y01"] +analyses["EventShapes"]["BW"][182.8] = ["/L3_2004_I652683/d39-x01-y02"] +analyses["EventShapes"]["BW"][188.6] = ["/L3_2004_I652683/d39-x01-y03"] +analyses["EventShapes"]["BW"][194.4] = ["/L3_2004_I652683/d40-x01-y01"] +analyses["EventShapes"]["BW"][200.2] = ["/L3_2004_I652683/d40-x01-y02"] +analyses["EventShapes"]["BW"][206.2] = ["/L3_2004_I652683/d40-x01-y03"] +analyses["EventShapes"]["BW"][35.0] = ["/JADE_1998_S3612880/d09-x01-y01"] +analyses["EventShapes"]["BW"][44.0] = ["/JADE_1998_S3612880/d05-x01-y01"] +analyses["EventShapes"]["BN"][45.0 ] = ["/DELPHI_2003_I620250/d14-x01-y01"] +analyses["EventShapes"]["BN"][66.0 ] = ["/DELPHI_2003_I620250/d14-x01-y02"] +analyses["EventShapes"]["BN"][76.0 ] = ["/DELPHI_2003_I620250/d14-x01-y03"] +analyses["EventShapes"]["BN"][91.2 ] = ["/DELPHI_1996_S3430090/d24-x01-y01","/OPAL_2004_S6132243/d13-x01-y01"] +analyses["EventShapes"]["BN"][133.0] = ["/OPAL_2004_S6132243/d13-x01-y02"] +analyses["EventShapes"]["BN"][177.0] = ["/OPAL_2004_S6132243/d13-x01-y03"] +analyses["EventShapes"]["BN"][197.0] = ["/OPAL_2004_S6132243/d13-x01-y04"] +analyses["EventShapes"]["BT"][41.4 ] = ["/L3_2004_I652683/d31-x01-y01"] +analyses["EventShapes"]["BT"][55.3 ] = ["/L3_2004_I652683/d31-x01-y02"] +analyses["EventShapes"]["BT"][65.4 ] = ["/L3_2004_I652683/d31-x01-y03"] +analyses["EventShapes"]["BT"][75.7 ] = ["/L3_2004_I652683/d32-x01-y01"] +analyses["EventShapes"]["BT"][82.3 ] = ["/L3_2004_I652683/d32-x01-y02"] +analyses["EventShapes"]["BT"][85.1 ] = ["/L3_2004_I652683/d32-x01-y03"] +analyses["EventShapes"]["BT"][91.2 ] = ["/DELPHI_1996_S3430090/d25-x01-y01","/OPAL_2004_S6132243/d04-x01-y01", + "/ALEPH_2004_S5765862/d70-x01-y01"] +analyses["EventShapes"]["BT"][130.1] = ["/L3_2004_I652683/d33-x01-y01"] +analyses["EventShapes"]["BT"][133.0] = ["/OPAL_2004_S6132243/d04-x01-y02","/ALEPH_2004_S5765862/d71-x01-y01"] +analyses["EventShapes"]["BT"][136.3] = ["/L3_2004_I652683/d33-x01-y02"] +analyses["EventShapes"]["BT"][161.3] = ["/L3_2004_I652683/d33-x01-y03"] +analyses["EventShapes"]["BT"][172.3] = ["/L3_2004_I652683/d34-x01-y01"] +analyses["EventShapes"]["BT"][177.0] = ["/OPAL_2004_S6132243/d04-x01-y03"] +analyses["EventShapes"]["BT"][182.8] = ["/L3_2004_I652683/d34-x01-y02"] +analyses["EventShapes"]["BT"][188.6] = ["/L3_2004_I652683/d34-x01-y03"] +analyses["EventShapes"]["BT"][194.4] = ["/L3_2004_I652683/d35-x01-y01"] +analyses["EventShapes"]["BT"][197.0] = ["/OPAL_2004_S6132243/d04-x01-y04"] +analyses["EventShapes"]["BT"][200.2] = ["/L3_2004_I652683/d35-x01-y02"] +analyses["EventShapes"]["BT"][206.2] = ["/L3_2004_I652683/d35-x01-y03"] +analyses["EventShapes"]["BT"][45.0 ] = ["/DELPHI_2003_I620250/d15-x01-y01"] +analyses["EventShapes"]["BT"][66.0 ] = ["/DELPHI_2003_I620250/d15-x01-y02"] +analyses["EventShapes"]["BT"][76.0 ] = ["/DELPHI_2003_I620250/d15-x01-y03"] +analyses["EventShapes"]["BT"][161.0] = ["/ALEPH_2004_S5765862/d72-x01-y01"] +analyses["EventShapes"]["BT"][172.0] = ["/ALEPH_2004_S5765862/d73-x01-y01"] +analyses["EventShapes"]["BT"][183.0] = ["/DELPHI_2003_I620250/d48-x01-y01","/ALEPH_2004_S5765862/d74-x01-y01"] +analyses["EventShapes"]["BT"][189.0] = ["/DELPHI_2003_I620250/d48-x01-y02","/ALEPH_2004_S5765862/d75-x01-y01"] +analyses["EventShapes"]["BT"][192.0] = ["/DELPHI_2003_I620250/d48-x01-y03"] +analyses["EventShapes"]["BT"][196.0] = ["/DELPHI_2003_I620250/d48-x01-y04"] +analyses["EventShapes"]["BT"][200.0] = ["/DELPHI_2003_I620250/d49-x01-y01","/ALEPH_2004_S5765862/d76-x01-y01"] +analyses["EventShapes"]["BT"][202.0] = ["/DELPHI_2003_I620250/d49-x01-y02"] +analyses["EventShapes"]["BT"][205.0] = ["/DELPHI_2003_I620250/d49-x01-y03"] +analyses["EventShapes"]["BT"][206.0] = ["/ALEPH_2004_S5765862/d77-x01-y01"] +analyses["EventShapes"]["BT"][207.0] = ["/DELPHI_2003_I620250/d49-x01-y04"] +analyses["EventShapes"]["BT"][35.0] = ["/JADE_1998_S3612880/d08-x01-y01"] +analyses["EventShapes"]["BT"][44.0] = ["/JADE_1998_S3612880/d04-x01-y01"] +analyses["EventShapes"]["Bdiff"][45.0 ] = ["/DELPHI_2003_I620250/d16-x01-y01"] +analyses["EventShapes"]["Bdiff"][66.0 ] = ["/DELPHI_2003_I620250/d16-x01-y02"] +analyses["EventShapes"]["Bdiff"][76.0 ] = ["/DELPHI_2003_I620250/d16-x01-y03"] +analyses["EventShapes"]["Bdiff"][91.2 ] = ["/DELPHI_1996_S3430090/d26-x01-y01"] +analyses["EventShapes"]["Bdiff"][183.0] = ["/DELPHI_2003_I620250/d50-x01-y01"] +analyses["EventShapes"]["Bdiff"][189.0] = ["/DELPHI_2003_I620250/d50-x01-y02"] +analyses["EventShapes"]["Bdiff"][192.0] = ["/DELPHI_2003_I620250/d50-x01-y03"] +analyses["EventShapes"]["Bdiff"][196.0] = ["/DELPHI_2003_I620250/d50-x01-y04"] +analyses["EventShapes"]["Bdiff"][200.0] = ["/DELPHI_2003_I620250/d51-x01-y01"] +analyses["EventShapes"]["Bdiff"][202.0] = ["/DELPHI_2003_I620250/d51-x01-y02"] +analyses["EventShapes"]["Bdiff"][205.0] = ["/DELPHI_2003_I620250/d51-x01-y03"] +analyses["EventShapes"]["Bdiff"][207.0] = ["/DELPHI_2003_I620250/d51-x01-y04"] +# C and D +analyses["EventShapes"]["C"][45.0 ] = ["/DELPHI_2003_I620250/d17-x01-y01"] +analyses["EventShapes"]["C"][66.0 ] = ["/DELPHI_2003_I620250/d17-x01-y02"] +analyses["EventShapes"]["C"][76.0 ] = ["/DELPHI_2003_I620250/d17-x01-y03"] +analyses["EventShapes"]["C"][91.2 ] = ["/DELPHI_1996_S3430090/d18-x01-y01","/ALEPH_1996_S3486095/d07-x01-y01", + "/ALEPH_2004_S5765862/d86-x01-y01","/OPAL_2004_S6132243/d03-x01-y01"] +analyses["EventShapes"]["C"][133.0] = ["/OPAL_2004_S6132243/d03-x01-y02","/ALEPH_2004_S5765862/d87-x01-y01"] +analyses["EventShapes"]["C"][161.0] = ["/ALEPH_2004_S5765862/d88-x01-y01"] +analyses["EventShapes"]["C"][172.0] = ["/ALEPH_2004_S5765862/d89-x01-y01"] +analyses["EventShapes"]["C"][177.0] = ["/OPAL_2004_S6132243/d03-x01-y03"] +analyses["EventShapes"]["C"][183.0] = ["/DELPHI_2003_I620250/d52-x01-y01","/ALEPH_2004_S5765862/d90-x01-y01"] +analyses["EventShapes"]["C"][189.0] = ["/DELPHI_2003_I620250/d52-x01-y02","/ALEPH_2004_S5765862/d91-x01-y01"] +analyses["EventShapes"]["C"][192.0] = ["/DELPHI_2003_I620250/d52-x01-y03"] +analyses["EventShapes"]["C"][196.0] = ["/DELPHI_2003_I620250/d52-x01-y04"] +analyses["EventShapes"]["C"][197.0] = ["/OPAL_2004_S6132243/d03-x01-y04"] +analyses["EventShapes"]["C"][200.0] = ["/DELPHI_2003_I620250/d53-x01-y01","/ALEPH_2004_S5765862/d92-x01-y01"] +analyses["EventShapes"]["C"][202.0] = ["/DELPHI_2003_I620250/d53-x01-y02"] +analyses["EventShapes"]["C"][205.0] = ["/DELPHI_2003_I620250/d53-x01-y03"] +analyses["EventShapes"]["C"][206.0] = ["/ALEPH_2004_S5765862/d93-x01-y01"] +analyses["EventShapes"]["C"][207.0] = ["/DELPHI_2003_I620250/d53-x01-y04"] +analyses["EventShapes"]["C"][130.1] = ["/L3_2004_I652683/d41-x01-y01"] +analyses["EventShapes"]["C"][136.3] = ["/L3_2004_I652683/d41-x01-y02"] +analyses["EventShapes"]["C"][161.3] = ["/L3_2004_I652683/d41-x01-y03"] +analyses["EventShapes"]["C"][172.3] = ["/L3_2004_I652683/d42-x01-y01"] +analyses["EventShapes"]["C"][182.8] = ["/L3_2004_I652683/d42-x01-y02"] +analyses["EventShapes"]["C"][188.6] = ["/L3_2004_I652683/d42-x01-y03"] +analyses["EventShapes"]["C"][194.4] = ["/L3_2004_I652683/d43-x01-y01"] +analyses["EventShapes"]["C"][200.2] = ["/L3_2004_I652683/d43-x01-y02"] +analyses["EventShapes"]["C"][206.2] = ["/L3_2004_I652683/d43-x01-y03"] + +analyses["EventShapes"]["D"][91.2 ] = ["/DELPHI_1996_S3430090/d19-x01-y01","/OPAL_2004_S6132243/d14-x01-y01"] +analyses["EventShapes"]["D"][130.1] = ["/L3_2004_I652683/d44-x01-y01"] +analyses["EventShapes"]["D"][133.0] = ["/OPAL_2004_S6132243/d14-x01-y02"] +analyses["EventShapes"]["D"][136.3] = ["/L3_2004_I652683/d44-x01-y02"] +analyses["EventShapes"]["D"][161.3] = ["/L3_2004_I652683/d44-x01-y03"] +analyses["EventShapes"]["D"][172.3] = ["/L3_2004_I652683/d45-x01-y01"] +analyses["EventShapes"]["D"][177.0] = ["/OPAL_2004_S6132243/d14-x01-y03"] +analyses["EventShapes"]["D"][182.8] = ["/L3_2004_I652683/d45-x01-y02"] +analyses["EventShapes"]["D"][188.6] = ["/L3_2004_I652683/d45-x01-y03"] +analyses["EventShapes"]["D"][194.4] = ["/L3_2004_I652683/d46-x01-y01"] +analyses["EventShapes"]["D"][197.0] = ["/OPAL_2004_S6132243/d14-x01-y04"] +analyses["EventShapes"]["D"][200.2] = ["/L3_2004_I652683/d46-x01-y02"] +analyses["EventShapes"]["D"][206.2] = ["/L3_2004_I652683/d46-x01-y03"] +analyses["EventShapes"]["D"][183.0] = ["/DELPHI_2003_I620250/d54-x01-y01"] +analyses["EventShapes"]["D"][189.0] = ["/DELPHI_2003_I620250/d54-x01-y02"] +analyses["EventShapes"]["D"][192.0] = ["/DELPHI_2003_I620250/d54-x01-y03"] +analyses["EventShapes"]["D"][196.0] = ["/DELPHI_2003_I620250/d54-x01-y04"] +analyses["EventShapes"]["D"][200.0] = ["/DELPHI_2003_I620250/d55-x01-y01"] +analyses["EventShapes"]["D"][202.0] = ["/DELPHI_2003_I620250/d55-x01-y02"] +analyses["EventShapes"]["D"][205.0] = ["/DELPHI_2003_I620250/d55-x01-y03"] +analyses["EventShapes"]["D"][207.0] = ["/DELPHI_2003_I620250/d55-x01-y04"] +# hemispheres +analyses["EventShapes"]["HeavyJetMass"][14.0] = ["/TASSO_1989_I279165/d02-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][22.0] = ["/TASSO_1989_I279165/d02-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][34.8] = ["/TASSO_1989_I279165/d02-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][35.0] = ["/JADE_1998_S3612880/d07-x01-y01"] + + +analyses["EventShapes"]["HeavyJetMass"][43.5] = ["/TASSO_1989_I279165/d02-x01-y04"] +analyses["EventShapes"]["HeavyJetMass"][44.0] = ["/JADE_1998_S3612880/d03-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][45.0] = ["/DELPHI_2003_I620250/d07-x01-y01","/DELPHI_2003_I620250/d08-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][55.2] = ["/AMY_1990_I283337/d21-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][58.0] = ["/TOPAZ_1993_I361661/d02-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][66.0] = ["/DELPHI_2003_I620250/d07-x01-y02","/DELPHI_2003_I620250/d08-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][76.0] = ["/DELPHI_2003_I620250/d07-x01-y03","/DELPHI_2003_I620250/d08-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][91.2] = ["/DELPHI_1996_S3430090/d20-x01-y01","/ALEPH_1996_S3486095/d06-x01-y01","/OPAL_2004_S6132243/d02-x01-y01","/ALEPH_2004_S5765862/d62-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][133.0] = ["/OPAL_2004_S6132243/d02-x01-y02","/ALEPH_2004_S5765862/d63-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][161.0] = ["/ALEPH_2004_S5765862/d64-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][172.0] = ["/ALEPH_2004_S5765862/d65-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][177.0] = ["/OPAL_2004_S6132243/d02-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][183.0] = ["/DELPHI_2003_I620250/d56-x01-y01","/DELPHI_2003_I620250/d58-x01-y01", + "/DELPHI_2003_I620250/d60-x01-y01","/ALEPH_2004_S5765862/d66-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][189.0] = ["/DELPHI_2003_I620250/d56-x01-y02","/DELPHI_2003_I620250/d58-x01-y02", + "/DELPHI_2003_I620250/d60-x01-y02","/ALEPH_2004_S5765862/d67-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][192.0] = ["/DELPHI_2003_I620250/d56-x01-y03","/DELPHI_2003_I620250/d58-x01-y03", + "/DELPHI_2003_I620250/d60-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][196.0] = ["/DELPHI_2003_I620250/d56-x01-y04","/DELPHI_2003_I620250/d58-x01-y04", + "/DELPHI_2003_I620250/d60-x01-y04"] +analyses["EventShapes"]["HeavyJetMass"][197.0] = ["/OPAL_2004_S6132243/d02-x01-y04"] +analyses["EventShapes"]["HeavyJetMass"][200.0] = ["/DELPHI_2003_I620250/d57-x01-y01","/DELPHI_2003_I620250/d59-x01-y01", + "/DELPHI_2003_I620250/d61-x01-y01","/ALEPH_2004_S5765862/d68-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][202.0] = ["/DELPHI_2003_I620250/d57-x01-y02","/DELPHI_2003_I620250/d59-x01-y02", + "/DELPHI_2003_I620250/d61-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][205.0] = ["/DELPHI_2003_I620250/d57-x01-y03","/DELPHI_2003_I620250/d59-x01-y03", + "/DELPHI_2003_I620250/d61-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][206.0] = ["/ALEPH_2004_S5765862/d69-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][207.0] = ["/DELPHI_2003_I620250/d57-x01-y04","/DELPHI_2003_I620250/d59-x01-y04", + "/DELPHI_2003_I620250/d61-x01-y04"] +analyses["EventShapes"]["HeavyJetMass"][41.4 ] = ["/L3_2004_I652683/d26-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][55.3 ] = ["/L3_2004_I652683/d26-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][65.4 ] = ["/L3_2004_I652683/d26-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][75.7 ] = ["/L3_2004_I652683/d27-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][82.3 ] = ["/L3_2004_I652683/d27-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][85.1 ] = ["/L3_2004_I652683/d27-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][130.1] = ["/L3_2004_I652683/d28-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][136.3] = ["/L3_2004_I652683/d28-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][161.3] = ["/L3_2004_I652683/d28-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][172.3] = ["/L3_2004_I652683/d29-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][182.8] = ["/L3_2004_I652683/d29-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][188.6] = ["/L3_2004_I652683/d29-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][194.4] = ["/L3_2004_I652683/d30-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][200.2] = ["/L3_2004_I652683/d30-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][206.2] = ["/L3_2004_I652683/d30-x01-y03"] + +analyses["EventShapes"]["JetMassDifference"][14.0] = ["/TASSO_1989_I279165/d01-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][22.0] = ["/TASSO_1989_I279165/d01-x01-y02"] +analyses["EventShapes"]["JetMassDifference"][34.8] = ["/TASSO_1989_I279165/d01-x01-y03"] +analyses["EventShapes"]["JetMassDifference"][43.5] = ["/TASSO_1989_I279165/d01-x01-y04"] +analyses["EventShapes"]["JetMassDifference"][45.0] = ["/DELPHI_2003_I620250/d10-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][55.2] = ["/AMY_1990_I283337/d22-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][66.0] = ["/DELPHI_2003_I620250/d10-x01-y02"] +analyses["EventShapes"]["JetMassDifference"][76.0] = ["/DELPHI_2003_I620250/d10-x01-y03"] +analyses["EventShapes"]["JetMassDifference"][91.2] = ["/DELPHI_1996_S3430090/d22-x01-y01","/ALEPH_2004_S5765862/d110-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][133.0] = ["/ALEPH_2004_S5765862/d111-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][161.0] = ["/ALEPH_2004_S5765862/d112-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][172.0] = ["/ALEPH_2004_S5765862/d113-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][183.0] = ["/DELPHI_2003_I620250/d64-x01-y01","/ALEPH_2004_S5765862/d114-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][189.0] = ["/DELPHI_2003_I620250/d64-x01-y02","/ALEPH_2004_S5765862/d115-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][192.0] = ["/DELPHI_2003_I620250/d64-x01-y03"] +analyses["EventShapes"]["JetMassDifference"][196.0] = ["/DELPHI_2003_I620250/d64-x01-y04"] +analyses["EventShapes"]["JetMassDifference"][200.0] = ["/DELPHI_2003_I620250/d65-x01-y01","/ALEPH_2004_S5765862/d116-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][202.0] = ["/DELPHI_2003_I620250/d65-x01-y02"] +analyses["EventShapes"]["JetMassDifference"][205.0] = ["/DELPHI_2003_I620250/d65-x01-y03"] +analyses["EventShapes"]["JetMassDifference"][206.0] = ["/ALEPH_2004_S5765862/d117-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][207.0] = ["/DELPHI_2003_I620250/d65-x01-y04"] +analyses["EventShapes"]["LightJetMass"][14.0] = ["/TASSO_1989_I279165/d03-x01-y01"] +analyses["EventShapes"]["LightJetMass"][22.0] = ["/TASSO_1989_I279165/d03-x01-y02"] +analyses["EventShapes"]["LightJetMass"][34.8] = ["/TASSO_1989_I279165/d03-x01-y03"] +analyses["EventShapes"]["LightJetMass"][43.5] = ["/TASSO_1989_I279165/d03-x01-y04"] +analyses["EventShapes"]["LightJetMass"][45.0] = ["/DELPHI_2003_I620250/d09-x01-y01"] +analyses["EventShapes"]["LightJetMass"][55.2] = ["/AMY_1990_I283337/d20-x01-y01"] +analyses["EventShapes"]["LightJetMass"][66.0] = ["/DELPHI_2003_I620250/d09-x01-y02"] +analyses["EventShapes"]["LightJetMass"][76.0] = ["/DELPHI_2003_I620250/d09-x01-y03"] +analyses["EventShapes"]["LightJetMass"][91.2] = ["/DELPHI_1996_S3430090/d21-x01-y01","/OPAL_2004_S6132243/d12-x01-y01"] +analyses["EventShapes"]["LightJetMass"][133.0] = ["/OPAL_2004_S6132243/d12-x01-y02"] +analyses["EventShapes"]["LightJetMass"][177.0] = ["/OPAL_2004_S6132243/d12-x01-y03"] +analyses["EventShapes"]["LightJetMass"][183.0] = ["/DELPHI_2003_I620250/d62-x01-y01"] +analyses["EventShapes"]["LightJetMass"][189.0] = ["/DELPHI_2003_I620250/d62-x01-y02"] +analyses["EventShapes"]["LightJetMass"][192.0] = ["/DELPHI_2003_I620250/d62-x01-y03"] +analyses["EventShapes"]["LightJetMass"][196.0] = ["/DELPHI_2003_I620250/d62-x01-y04"] +analyses["EventShapes"]["LightJetMass"][197.0] = ["/OPAL_2004_S6132243/d12-x01-y04"] +analyses["EventShapes"]["LightJetMass"][200.0] = ["/DELPHI_2003_I620250/d63-x01-y01"] +analyses["EventShapes"]["LightJetMass"][202.0] = ["/DELPHI_2003_I620250/d63-x01-y02"] +analyses["EventShapes"]["LightJetMass"][205.0] = ["/DELPHI_2003_I620250/d63-x01-y03"] +analyses["EventShapes"]["LightJetMass"][207.0] = ["/DELPHI_2003_I620250/d63-x01-y04"] +analyses["EventShapes"]["TotalJetMass"][45.0] = ["/DELPHI_2003_I620250/d11-x01-y01","/DELPHI_2003_I620250/d12-x01-y01"] +analyses["EventShapes"]["TotalJetMass"][66.0] = ["/DELPHI_2003_I620250/d11-x01-y02","/DELPHI_2003_I620250/d12-x01-y02"] +analyses["EventShapes"]["TotalJetMass"][76.0] = ["/DELPHI_2003_I620250/d11-x01-y03","/DELPHI_2003_I620250/d12-x01-y03"] +# jets +# y12 +analyses["EventShapes"]["y12_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d149-x01-y01"] +analyses["EventShapes"]["y12_dur"][133.0] = ["/ALEPH_2004_S5765862/d150-x01-y01"] +analyses["EventShapes"]["y12_dur"][161.0] = ["/ALEPH_2004_S5765862/d151-x01-y01"] +analyses["EventShapes"]["y12_dur"][172.0] = ["/ALEPH_2004_S5765862/d152-x01-y01"] +analyses["EventShapes"]["y12_dur"][183.0] = ["/ALEPH_2004_S5765862/d153-x01-y01"] +analyses["EventShapes"]["y12_dur"][189.0] = ["/ALEPH_2004_S5765862/d154-x01-y01"] +analyses["EventShapes"]["y12_dur"][200.0] = ["/ALEPH_2004_S5765862/d155-x01-y01"] +analyses["EventShapes"]["y12_dur"][206.0] = ["/ALEPH_2004_S5765862/d156-x01-y01"] +# y23 +analyses["EventShapes"]["y23_dur"][22.0] = ["/JADE_1998_S3612880/d12-x01-y01"] +analyses["EventShapes"]["y23_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d24-x01-y01","/JADE_1998_S3612880/d11-x01-y01"] +analyses["EventShapes"]["y23_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d25-x01-y01","/JADE_1998_S3612880/d10-x01-y01"] +analyses["EventShapes"]["y23_dur"][58.0 ] = ["/TOPAZ_1993_I361661/d03-x01-y01"] +analyses["EventShapes"]["y23_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d157-x01-y01","/ALEPH_1996_S3486095/d05-x01-y01", + "/OPAL_2004_S6132243/d06-x01-y01","/JADE_OPAL_2000_S4300807/d26-x01-y01", + "/DELPHI_1996_S3430090/d27-x01-y01"] +analyses["EventShapes"]["y23_dur"][133.0] = ["/ALEPH_2004_S5765862/d158-x01-y01","/OPAL_2004_S6132243/d06-x01-y02", + "/JADE_OPAL_2000_S4300807/d27-x01-y01"] +analyses["EventShapes"]["y23_dur"][161.0] = ["/ALEPH_2004_S5765862/d159-x01-y01","/JADE_OPAL_2000_S4300807/d28-x01-y01"] +analyses["EventShapes"]["y23_dur"][172.0] = ["/ALEPH_2004_S5765862/d160-x01-y01","/JADE_OPAL_2000_S4300807/d29-x01-y01"] +analyses["EventShapes"]["y23_dur"][177.0] = ["/OPAL_2004_S6132243/d06-x01-y03"] +analyses["EventShapes"]["y23_dur"][183.0] = ["/ALEPH_2004_S5765862/d161-x01-y01","/JADE_OPAL_2000_S4300807/d30-x01-y01"] +analyses["EventShapes"]["y23_dur"][189.0] = ["/ALEPH_2004_S5765862/d162-x01-y01","/JADE_OPAL_2000_S4300807/d31-x01-y01"] +analyses["EventShapes"]["y23_dur"][197.0] = ["/OPAL_2004_S6132243/d06-x01-y04"] +analyses["EventShapes"]["y23_dur"][200.0] = ["/ALEPH_2004_S5765862/d163-x01-y01"] +analyses["EventShapes"]["y23_dur"][206.0] = ["/ALEPH_2004_S5765862/d164-x01-y01"] +# y34 +analyses["EventShapes"]["y34_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d24-x01-y02"] +analyses["EventShapes"]["y34_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d25-x01-y02"] +analyses["EventShapes"]["y34_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d165-x01-y01","/JADE_OPAL_2000_S4300807/d26-x01-y02", + "/DELPHI_1996_S3430090/d29-x01-y01"] +analyses["EventShapes"]["y34_dur"][133.0] = ["/ALEPH_2004_S5765862/d166-x01-y01","/JADE_OPAL_2000_S4300807/d27-x01-y02"] +analyses["EventShapes"]["y34_dur"][161.0] = ["/ALEPH_2004_S5765862/d167-x01-y01","/JADE_OPAL_2000_S4300807/d28-x01-y02"] +analyses["EventShapes"]["y34_dur"][172.0] = ["/ALEPH_2004_S5765862/d168-x01-y01","/JADE_OPAL_2000_S4300807/d29-x01-y02"] +analyses["EventShapes"]["y34_dur"][183.0] = ["/ALEPH_2004_S5765862/d169-x01-y01","/JADE_OPAL_2000_S4300807/d30-x01-y02"] +analyses["EventShapes"]["y34_dur"][189.0] = ["/ALEPH_2004_S5765862/d170-x01-y01","/JADE_OPAL_2000_S4300807/d31-x01-y02"] +analyses["EventShapes"]["y34_dur"][206.0] = ["/ALEPH_2004_S5765862/d172-x01-y01"] +# y45 +analyses["EventShapes"]["y45_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d24-x01-y03"] +analyses["EventShapes"]["y45_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d25-x01-y03"] +analyses["EventShapes"]["y45_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d173-x01-y01","/JADE_OPAL_2000_S4300807/d26-x01-y03", + "/DELPHI_1996_S3430090/d31-x01-y01"] +analyses["EventShapes"]["y45_dur"][133.0] = ["/ALEPH_2004_S5765862/d174-x01-y01","/JADE_OPAL_2000_S4300807/d27-x01-y03"] +analyses["EventShapes"]["y45_dur"][161.0] = ["/ALEPH_2004_S5765862/d175-x01-y01","/JADE_OPAL_2000_S4300807/d28-x01-y03"] +analyses["EventShapes"]["y45_dur"][172.0] = ["/ALEPH_2004_S5765862/d176-x01-y01","/JADE_OPAL_2000_S4300807/d29-x01-y03"] +analyses["EventShapes"]["y45_dur"][183.0] = ["/ALEPH_2004_S5765862/d177-x01-y01","/JADE_OPAL_2000_S4300807/d30-x01-y03"] +analyses["EventShapes"]["y45_dur"][189.0] = ["/ALEPH_2004_S5765862/d178-x01-y01","/JADE_OPAL_2000_S4300807/d31-x01-y03"] +analyses["EventShapes"]["y45_dur"][200.0] = ["/ALEPH_2004_S5765862/d179-x01-y01"] +# y56 +analyses["EventShapes"]["y56_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d24-x01-y04"] +analyses["EventShapes"]["y56_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d25-x01-y04"] +analyses["EventShapes"]["y56_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d180-x01-y01","/JADE_OPAL_2000_S4300807/d26-x01-y04"] +analyses["EventShapes"]["y56_dur"][133.0] = ["/ALEPH_2004_S5765862/d181-x01-y01","/JADE_OPAL_2000_S4300807/d27-x01-y04"] +analyses["EventShapes"]["y56_dur"][161.0] = ["/ALEPH_2004_S5765862/d182-x01-y01","/JADE_OPAL_2000_S4300807/d28-x01-y04"] +analyses["EventShapes"]["y56_dur"][172.0] = ["/ALEPH_2004_S5765862/d183-x01-y01","/JADE_OPAL_2000_S4300807/d29-x01-y04"] +analyses["EventShapes"]["y56_dur"][183.0] = ["/ALEPH_2004_S5765862/d184-x01-y01","/JADE_OPAL_2000_S4300807/d30-x01-y04"] +analyses["EventShapes"]["y56_dur"][189.0] = ["/ALEPH_2004_S5765862/d185-x01-y01","/JADE_OPAL_2000_S4300807/d31-x01-y04"] +analyses["EventShapes"]["y56_dur"][200.0] = ["/ALEPH_2004_S5765862/d186-x01-y01"] +# jade scheme +analyses["EventShapes"]["y23_jade"][57.7 ] = ["/AMY_1995_I406129/d02-x01-y01","/AMY_1995_I406129/d03-x01-y01", + "/AMY_1995_I406129/d04-x01-y01","/AMY_1995_I406129/d06-x01-y01"] +analyses["EventShapes"]["y23_jade"][91.2 ] = ["/DELPHI_1996_S3430090/d28-x01-y01"] +analyses["EventShapes"]["y34_jade"][91.2 ] = ["/DELPHI_1996_S3430090/d30-x01-y01"] +analyses["EventShapes"]["y45_jade"][91.2 ] = ["/DELPHI_1996_S3430090/d32-x01-y01"] +# jet fractions +# 1 jet +analyses["EventShapes"]["1jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d187-x01-y01"] +analyses["EventShapes"]["1jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d188-x01-y01"] +analyses["EventShapes"]["1jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d189-x01-y01"] +analyses["EventShapes"]["1jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d190-x01-y01"] +analyses["EventShapes"]["1jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d191-x01-y01"] +analyses["EventShapes"]["1jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d192-x01-y01"] +analyses["EventShapes"]["1jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d193-x01-y01"] +analyses["EventShapes"]["1jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d194-x01-y01"] +# 2 jet +analyses["EventShapes"]["2jet_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d16-x01-y01"] +analyses["EventShapes"]["2jet_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d17-x01-y01"] +analyses["EventShapes"]["2jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d195-x01-y01","/JADE_OPAL_2000_S4300807/d18-x01-y01"] +analyses["EventShapes"]["2jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d196-x01-y01","/JADE_OPAL_2000_S4300807/d19-x01-y01"] +analyses["EventShapes"]["2jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d197-x01-y01","/JADE_OPAL_2000_S4300807/d20-x01-y01"] +analyses["EventShapes"]["2jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d198-x01-y01","/JADE_OPAL_2000_S4300807/d21-x01-y01"] +analyses["EventShapes"]["2jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d199-x01-y01","/JADE_OPAL_2000_S4300807/d22-x01-y01"] +analyses["EventShapes"]["2jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d200-x01-y01","/JADE_OPAL_2000_S4300807/d23-x01-y01"] +analyses["EventShapes"]["2jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d201-x01-y01"] +analyses["EventShapes"]["2jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d202-x01-y01"] +# 3 jet +analyses["EventShapes"]["3jet_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d16-x01-y02"] +analyses["EventShapes"]["3jet_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d17-x01-y02"] +analyses["EventShapes"]["3jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d203-x01-y01","/JADE_OPAL_2000_S4300807/d18-x01-y02"] +analyses["EventShapes"]["3jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d204-x01-y01","/JADE_OPAL_2000_S4300807/d19-x01-y02"] +analyses["EventShapes"]["3jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d205-x01-y01","/JADE_OPAL_2000_S4300807/d20-x01-y02"] +analyses["EventShapes"]["3jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d206-x01-y01","/JADE_OPAL_2000_S4300807/d21-x01-y02"] +analyses["EventShapes"]["3jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d207-x01-y01","/JADE_OPAL_2000_S4300807/d22-x01-y02"] +analyses["EventShapes"]["3jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d208-x01-y01","/JADE_OPAL_2000_S4300807/d23-x01-y02"] +analyses["EventShapes"]["3jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d209-x01-y01"] +analyses["EventShapes"]["3jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d210-x01-y01"] +# 4 jet +analyses["EventShapes"]["4jet_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d16-x01-y03"] +analyses["EventShapes"]["4jet_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d17-x01-y03"] +analyses["EventShapes"]["4jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d211-x01-y01","/JADE_OPAL_2000_S4300807/d18-x01-y03"] +analyses["EventShapes"]["4jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d212-x01-y01","/JADE_OPAL_2000_S4300807/d19-x01-y03"] +analyses["EventShapes"]["4jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d213-x01-y01","/JADE_OPAL_2000_S4300807/d20-x01-y03"] +analyses["EventShapes"]["4jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d214-x01-y01","/JADE_OPAL_2000_S4300807/d21-x01-y03"] +analyses["EventShapes"]["4jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d215-x01-y01","/JADE_OPAL_2000_S4300807/d22-x01-y03"] +analyses["EventShapes"]["4jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d216-x01-y01","/JADE_OPAL_2000_S4300807/d23-x01-y03"] +analyses["EventShapes"]["4jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d217-x01-y01"] +analyses["EventShapes"]["4jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d218-x01-y01"] +# 5 jet +analyses["EventShapes"]["5jet_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d16-x01-y04"] +analyses["EventShapes"]["5jet_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d17-x01-y04"] +analyses["EventShapes"]["5jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d219-x01-y01","/JADE_OPAL_2000_S4300807/d18-x01-y04"] +analyses["EventShapes"]["5jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d220-x01-y01","/JADE_OPAL_2000_S4300807/d19-x01-y04"] +analyses["EventShapes"]["5jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d221-x01-y01","/JADE_OPAL_2000_S4300807/d20-x01-y04"] +analyses["EventShapes"]["5jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d222-x01-y01","/JADE_OPAL_2000_S4300807/d21-x01-y04"] +analyses["EventShapes"]["5jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d223-x01-y01","/JADE_OPAL_2000_S4300807/d22-x01-y04"] +analyses["EventShapes"]["5jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d224-x01-y01","/JADE_OPAL_2000_S4300807/d23-x01-y04"] +analyses["EventShapes"]["5jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d225-x01-y01"] +analyses["EventShapes"]["5jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d226-x01-y01"] +# 6 jet +analyses["EventShapes"]["6jet_dur"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d16-x01-y05"] +analyses["EventShapes"]["6jet_dur"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d17-x01-y05"] +analyses["EventShapes"]["6jet_dur"][91.2 ] = ["/ALEPH_2004_S5765862/d227-x01-y01","/JADE_OPAL_2000_S4300807/d18-x01-y05"] +analyses["EventShapes"]["6jet_dur"][133.0] = ["/ALEPH_2004_S5765862/d228-x01-y01","/JADE_OPAL_2000_S4300807/d19-x01-y05"] +analyses["EventShapes"]["6jet_dur"][161.0] = ["/ALEPH_2004_S5765862/d229-x01-y01","/JADE_OPAL_2000_S4300807/d20-x01-y05"] +analyses["EventShapes"]["6jet_dur"][172.0] = ["/ALEPH_2004_S5765862/d230-x01-y01","/JADE_OPAL_2000_S4300807/d21-x01-y05"] +analyses["EventShapes"]["6jet_dur"][183.0] = ["/ALEPH_2004_S5765862/d231-x01-y01","/JADE_OPAL_2000_S4300807/d22-x01-y05"] +analyses["EventShapes"]["6jet_dur"][189.0] = ["/ALEPH_2004_S5765862/d232-x01-y01","/JADE_OPAL_2000_S4300807/d23-x01-y05"] +analyses["EventShapes"]["6jet_dur"][200.0] = ["/ALEPH_2004_S5765862/d233-x01-y01"] +analyses["EventShapes"]["6jet_dur"][206.0] = ["/ALEPH_2004_S5765862/d234-x01-y01"] +# four jet angles +analyses["FourJet"]["BZ" ][91.2] = ["/OPAL_2001_S4553896/d03-x01-y01"] +analyses["FourJet"]["KSW" ][91.2] = ["/OPAL_2001_S4553896/d04-x01-y01"] +analyses["FourJet"]["NR" ][91.2] = ["/OPAL_2001_S4553896/d05-x01-y01"] +analyses["FourJet"]["alpha34"][91.2] = ["/OPAL_2001_S4553896/d06-x01-y01"] +# EEC +analyses["EventShapes"]["EEC" ][7.7 ] = ["/PLUTO_1981_I156315/d01-x01-y01"] +analyses["EventShapes"]["EEC" ][9.4 ] = ["/PLUTO_1981_I156315/d01-x01-y02"] +analyses["EventShapes"]["EEC" ][12.0] = ["/PLUTO_1981_I156315/d01-x01-y03"] +analyses["EventShapes"]["EEC" ][13.0] = ["/PLUTO_1981_I156315/d01-x01-y04"] +analyses["EventShapes"]["EEC" ][14.0] = ["/TASSO_1987_I248660/d01-x01-y01","/JADE_1984_I202784/d01-x01-y01"] +analyses["EventShapes"]["EEC" ][17.0] = ["/PLUTO_1981_I156315/d01-x01-y05"] +analyses["EventShapes"]["EEC" ][22.0] = ["/TASSO_1987_I248660/d02-x01-y01","/JADE_1984_I202784/d01-x01-y02", + "/CELLO_1982_I12010/d01-x01-y01","/PLUTO_1981_I156315/d01-x01-y06"] +analyses["EventShapes"]["EEC" ][27.6] = ["/PLUTO_1981_I156315/d01-x01-y07"] +analyses["EventShapes"]["EEC" ][29.0] = ["/MAC_1985_I202924/d01-x01-y01","/MAC_1985_I202924/d01-x01-y02"] +analyses["EventShapes"]["EEC" ][30.8] = ["/PLUTO_1981_I156315/d01-x01-y08"] +analyses["EventShapes"]["EEC" ][34.0] = ["/JADE_1984_I202784/d01-x01-y03","/CELLO_1982_I12010/d01-x01-y02"] +analyses["EventShapes"]["EEC" ][34.6] = ["/PLUTO_1985_I215869/d01-x01-y01"] +analyses["EventShapes"]["EEC" ][34.8] = ["/TASSO_1987_I248660/d03-x01-y01"] +analyses["EventShapes"]["EEC" ][43.5] = ["/TASSO_1987_I248660/d04-x01-y01"] +analyses["EventShapes"]["EEC" ][53.3] = ["/TOPAZ_1989_I279575/d01-x01-y01","/TOPAZ_1989_I279575/d01-x01-y02"] +analyses["EventShapes"]["EEC" ][91.2] = ["/DELPHI_1996_S3430090/d33-x01-y01"] +analyses["EventShapes"]["EEC" ][59.5] = ["/TOPAZ_1989_I279575/d02-x01-y01","/TOPAZ_1989_I279575/d02-x01-y02"] +# AEEC +analyses["EventShapes"]["AEEC"][8.65] = ["/PLUTO_1981_I156315/d04-x01-y01"] +analyses["EventShapes"]["AEEC"][14.0] = ["/JADE_1984_I202784/d02-x01-y01"] +analyses["EventShapes"]["AEEC"][22.0] = ["/JADE_1984_I202784/d02-x01-y02","/CELLO_1982_I12010/d03-x01-y01"] +analyses["EventShapes"]["AEEC"][29.0] = ["/MAC_1985_I202924/d01-x01-y03"] +analyses["EventShapes"]["AEEC"][30.8] = ["/PLUTO_1981_I156315/d05-x01-y01"] +analyses["EventShapes"]["AEEC"][34.0] = ["/JADE_1984_I202784/d02-x01-y03","/CELLO_1982_I12010/d03-x01-y02"] +analyses["EventShapes"]["AEEC"][53.3] = ["/TOPAZ_1989_I279575/d01-x01-y03"] +analyses["EventShapes"]["AEEC"][59.5] = ["/TOPAZ_1989_I279575/d02-x01-y03"] +analyses["EventShapes"]["AEEC"][91.2] = ["/DELPHI_1996_S3430090/d34-x01-y01"] +# sphericity based +analyses["EventShapes"]["S"][12.0 ] = ["/TASSO_1980_I153511/d01-x01-y01"] +analyses["EventShapes"]["S"][14.0 ] = ["/TASSO_1990_S2148048/d06-x01-y01"] +analyses["EventShapes"]["S"][22.0 ] = ["/TASSO_1990_S2148048/d06-x01-y02"] +analyses["EventShapes"]["S"][29.0 ] = ["/HRS_1985_I201482/d01-x01-y01"] +analyses["EventShapes"]["S"][30.8 ] = ["/TASSO_1980_I153511/d02-x01-y01"] +analyses["EventShapes"]["S"][35.0 ] = ["/TASSO_1990_S2148048/d06-x01-y03","/TASSO_1988_I263859/d01-x01-y01"] +analyses["EventShapes"]["S"][44.0 ] = ["/TASSO_1990_S2148048/d06-x01-y04"] +analyses["EventShapes"]["S"][45.0 ] = ["/DELPHI_2003_I620250/d04-x01-y01"] +analyses["EventShapes"]["S"][55.2 ] = ["/AMY_1990_I283337/d16-x01-y01"] +analyses["EventShapes"]["S"][66.0 ] = ["/DELPHI_2003_I620250/d04-x01-y02"] +analyses["EventShapes"]["S"][76.0 ] = ["/DELPHI_2003_I620250/d04-x01-y03"] +analyses["EventShapes"]["S"][91.2 ] = ["/ALEPH_2004_S5765862/d141-x01-y01","/DELPHI_1996_S3430090/d15-x01-y01", + "/ALEPH_1996_S3486095/d01-x01-y01","/OPAL_2004_S6132243/d10-x01-y01"] +analyses["EventShapes"]["S"][133.0] = ["/ALEPH_2004_S5765862/d142-x01-y01","/OPAL_2004_S6132243/d10-x01-y02"] +analyses["EventShapes"]["S"][161.0] = ["/ALEPH_2004_S5765862/d143-x01-y01"] +analyses["EventShapes"]["S"][172.0] = ["/ALEPH_2004_S5765862/d144-x01-y01"] +analyses["EventShapes"]["S"][177.0] = ["/OPAL_2004_S6132243/d10-x01-y03"] +analyses["EventShapes"]["S"][183.0] = ["/DELPHI_2003_I620250/d66-x01-y01","/ALEPH_2004_S5765862/d145-x01-y01"] +analyses["EventShapes"]["S"][189.0] = ["/DELPHI_2003_I620250/d66-x01-y02","/ALEPH_2004_S5765862/d146-x01-y01"] +analyses["EventShapes"]["S"][192.0] = ["/DELPHI_2003_I620250/d66-x01-y03"] +analyses["EventShapes"]["S"][196.0] = ["/DELPHI_2003_I620250/d66-x01-y04"] +analyses["EventShapes"]["S"][197.0] = ["/OPAL_2004_S6132243/d10-x01-y04"] +analyses["EventShapes"]["S"][200.0] = ["/DELPHI_2003_I620250/d67-x01-y01","/ALEPH_2004_S5765862/d147-x01-y01"] +analyses["EventShapes"]["S"][202.0] = ["/DELPHI_2003_I620250/d67-x01-y02"] +analyses["EventShapes"]["S"][205.0] = ["/DELPHI_2003_I620250/d67-x01-y03"] +analyses["EventShapes"]["S"][206.0] = ["/ALEPH_2004_S5765862/d148-x01-y01"] +analyses["EventShapes"]["S"][207.0] = ["/DELPHI_2003_I620250/d67-x01-y04"] + +analyses["EventShapes"]["P"][45.0 ] = ["/DELPHI_2003_I620250/d05-x01-y01"] +analyses["EventShapes"]["P"][66.0 ] = ["/DELPHI_2003_I620250/d05-x01-y02"] +analyses["EventShapes"]["P"][76.0 ] = ["/DELPHI_2003_I620250/d05-x01-y03"] +analyses["EventShapes"]["P"][91.2 ] = ["/DELPHI_1996_S3430090/d17-x01-y01"] +analyses["EventShapes"]["P"][133.0] = ["/ALEPH_2004_S5765862/d126-x01-y01"] +analyses["EventShapes"]["P"][161.0] = ["/ALEPH_2004_S5765862/d127-x01-y01"] +analyses["EventShapes"]["P"][172.0] = ["/ALEPH_2004_S5765862/d128-x01-y01"] +analyses["EventShapes"]["P"][183.0] = ["/DELPHI_2003_I620250/d68-x01-y01","/ALEPH_2004_S5765862/d129-x01-y01"] +analyses["EventShapes"]["P"][189.0] = ["/DELPHI_2003_I620250/d68-x01-y02","/ALEPH_2004_S5765862/d130-x01-y01"] +analyses["EventShapes"]["P"][192.0] = ["/DELPHI_2003_I620250/d68-x01-y03"] +analyses["EventShapes"]["P"][196.0] = ["/DELPHI_2003_I620250/d68-x01-y04"] +analyses["EventShapes"]["P"][200.0] = ["/DELPHI_2003_I620250/d69-x01-y01","/ALEPH_2004_S5765862/d131-x01-y01"] +analyses["EventShapes"]["P"][202.0] = ["/DELPHI_2003_I620250/d69-x01-y02"] +analyses["EventShapes"]["P"][205.0] = ["/DELPHI_2003_I620250/d69-x01-y03"] +analyses["EventShapes"]["P"][206.0] = ["/ALEPH_2004_S5765862/d132-x01-y01"] +analyses["EventShapes"]["P"][207.0] = ["/DELPHI_2003_I620250/d69-x01-y04"] + +analyses["EventShapes"]["A"][12.0 ] = ["/TASSO_1980_I153511/d03-x01-y01"] +analyses["EventShapes"]["A"][14.0 ] = ["/TASSO_1990_S2148048/d07-x01-y01"] +analyses["EventShapes"]["A"][22.0 ] = ["/TASSO_1990_S2148048/d07-x01-y02","/HRS_1985_I201482/d06-x01-y01"] +analyses["EventShapes"]["A"][30.8 ] = ["/TASSO_1980_I153511/d04-x01-y01"] +analyses["EventShapes"]["A"][35.0 ] = ["/TASSO_1990_S2148048/d07-x01-y03","/TASSO_1988_I263859/d02-x01-y01"] +analyses["EventShapes"]["A"][44.0 ] = ["/TASSO_1990_S2148048/d07-x01-y04"] +analyses["EventShapes"]["A"][55.2 ] = ["/AMY_1990_I283337/d17-x01-y01"] +analyses["EventShapes"]["A"][91.2 ] = ["/ALEPH_2004_S5765862/d118-x01-y01","/DELPHI_1996_S3430090/d16-x01-y01", + "/ALEPH_1996_S3486095/d02-x01-y01","/OPAL_2004_S6132243/d09-x01-y01"] +analyses["EventShapes"]["A"][133.0] = ["/ALEPH_2004_S5765862/d119-x01-y01","/OPAL_2004_S6132243/d09-x01-y02"] +analyses["EventShapes"]["A"][161.0] = ["/ALEPH_2004_S5765862/d120-x01-y01"] +analyses["EventShapes"]["A"][172.0] = ["/ALEPH_2004_S5765862/d121-x01-y01"] +analyses["EventShapes"]["A"][177.0] = ["/OPAL_2004_S6132243/d09-x01-y03"] +analyses["EventShapes"]["A"][183.0] = ["/DELPHI_2003_I620250/d70-x01-y01","/ALEPH_2004_S5765862/d122-x01-y01"] +analyses["EventShapes"]["A"][189.0] = ["/DELPHI_2003_I620250/d70-x01-y02","/ALEPH_2004_S5765862/d123-x01-y01"] +analyses["EventShapes"]["A"][192.0] = ["/DELPHI_2003_I620250/d70-x01-y03"] +analyses["EventShapes"]["A"][196.0] = ["/DELPHI_2003_I620250/d70-x01-y04"] +analyses["EventShapes"]["A"][197.0] = ["/OPAL_2004_S6132243/d09-x01-y04"] +analyses["EventShapes"]["A"][200.0] = ["/DELPHI_2003_I620250/d71-x01-y01","/ALEPH_2004_S5765862/d124-x01-y01"] +analyses["EventShapes"]["A"][202.0] = ["/DELPHI_2003_I620250/d71-x01-y02"] +analyses["EventShapes"]["A"][205.0] = ["/DELPHI_2003_I620250/d71-x01-y03"] +analyses["EventShapes"]["A"][206.0] = ["/ALEPH_2004_S5765862/d125-x01-y01"] +analyses["EventShapes"]["A"][207.0] = ["/DELPHI_2003_I620250/d71-x01-y04"] +# other +analyses["EventShapes"]["Qx" ][55.2] = ["/AMY_1990_I283337/d18-x01-y01"] +analyses["EventShapes"]["Q21"][55.2] = ["/AMY_1990_I283337/d19-x01-y01"] + +analyses["QED"] = ["/ALEPH_1996_S3196992/d03-x01-y01","/ALEPH_1996_S3196992/d04-x01-y01", + "/ALEPH_1996_S3196992/d01-x01-y01","/ALEPH_1996_S3196992/d02-x01-y01", + "/ALEPH_1996_S3196992/d05-x01-y01","/ALEPH_1996_S3196992/d06-x01-y01", + "/ALEPH_1996_S3196992/d07-x01-y01","/ALEPH_1996_S3196992/d08-x01-y01", + "/OPAL_1993_S2692198/d01-x01-y01","/OPAL_1993_S2692198/d02-x01-y01", + "/OPAL_1993_S2692198/d03-x01-y01","/OPAL_1993_S2692198/d03-x01-y02", + "/OPAL_1993_S2692198/d03-x01-y03","/OPAL_1993_S2692198/d03-x01-y04", + "/OPAL_1993_S2692198/d04-x01-y01","/OPAL_1993_S2692198/d04-x01-y02", + "/OPAL_1993_S2692198/d04-x01-y03","/OPAL_1993_S2692198/d04-x01-y04",] +# tau decays +# 2 body +analyses["TauDecays"]["KK" ]["data"] = ["/BABAR_2018_I1679886/d01-x01-y01"] +analyses["TauDecays"]["KK" ]["MC" ] = ["/MC_TAU_Decay/h_2B_m2KK","/MC_TAU_Decay/h_2B_mKK"] +analyses["TauDecays"]["Kpi" ]["data"] = ["/BELLE_2007_I753243/d01-x01-y01"] +analyses["TauDecays"]["Kpi" ]["MC" ] = ["/MC_TAU_Decay/h_2B_m2KpiA","/MC_TAU_Decay/h_2B_m2KpiB", + "/MC_TAU_Decay/h_2B_mKpiA","/MC_TAU_Decay/h_2B_mKpiB"] +analyses["TauDecays"]["2pi" ]["data"] = ["/BELLE_2008_I786560/d01-x01-y01","/ALEPH_2014_I1267648/d01-x01-y01", + "/CLEO_1999_I508944/d01-x01-y01"] +analyses["TauDecays"]["2pi" ]["MC" ] = ["/MC_TAU_Decay/h_2B_m2pipi","/MC_TAU_Decay/h_2B_mpipi"] +analyses["TauDecays"]["3pi" ]["data"] = ["/BELLE_2010_I841618/d01-x01-y01","/BABAR_2007_S7266081/d01-x01-y01", + "/BABAR_2007_S7266081/d02-x01-y01","/BABAR_2007_S7266081/d11-x01-y01", + "/ALEPH_2014_I1267648/d02-x01-y01","/ALEPH_2014_I1267648/d04-x01-y01"] +analyses["TauDecays"]["3pi" ]["MC" ] = ["/MC_TAU_Decay/h_3B_pi0pi0pim_1","/MC_TAU_Decay/h_3B_pi0pi0pim_2","/MC_TAU_Decay/h_3B_pi0pi0pim_3", + "/MC_TAU_Decay/h_3B_pippimpim_1","/MC_TAU_Decay/h_3B_pippimpim_2","/MC_TAU_Decay/h_3B_pippimpim_3"] +analyses["TauDecays"]["Kpipi"]["data"] = ["/BELLE_2010_I841618/d02-x01-y01" ,"/BABAR_2007_S7266081/d03-x01-y01", + "/BABAR_2007_S7266081/d04-x01-y01","/BABAR_2007_S7266081/d05-x01-y01", + "/BABAR_2007_S7266081/d12-x01-y01"] +analyses["TauDecays"]["Kpipi"]["MC" ] = ["/MC_TAU_Decay/h_3B_pi0pi0km_1","/MC_TAU_Decay/h_3B_pi0pi0km_2","/MC_TAU_Decay/h_3B_pi0pi0km_3", + "/MC_TAU_Decay/h_3B_pimk0pi0_1","/MC_TAU_Decay/h_3B_pimk0pi0_2","/MC_TAU_Decay/h_3B_pimk0pi0_3", + "/MC_TAU_Decay/h_3B_pimk0pi0_4"] +analyses["TauDecays"]["KKpi" ]["data"] = ["/BELLE_2010_I841618/d03-x01-y01","/BABAR_2007_S7266081/d06-x01-y01", + "/BABAR_2007_S7266081/d07-x01-y01","/BABAR_2007_S7266081/d08-x01-y01", + "/BABAR_2007_S7266081/d13-x01-y01"] +analyses["TauDecays"]["KKpi" ]["MC" ] = ["/MC_TAU_Decay/h_3B_klpimkl_1","/MC_TAU_Decay/h_3B_klpimkl_2","/MC_TAU_Decay/h_3B_klpimkl_3", + "/MC_TAU_Decay/h_3B_kmpi0k0_1","/MC_TAU_Decay/h_3B_kmpi0k0_2","/MC_TAU_Decay/h_3B_kmpi0k0_3", + "/MC_TAU_Decay/h_3B_kmpi0k0_4","/MC_TAU_Decay/h_3B_kmpimkp_1","/MC_TAU_Decay/h_3B_kmpimkp_2", + "/MC_TAU_Decay/h_3B_kmpimkp_3","/MC_TAU_Decay/h_3B_kmpimkp_4","/MC_TAU_Decay/h_3B_kmpimpip_1", + "/MC_TAU_Decay/h_3B_kmpimpip_2","/MC_TAU_Decay/h_3B_kmpimpip_3","/MC_TAU_Decay/h_3B_kmpimpip_4", + "/MC_TAU_Decay/h_3B_kspimkl_1","/MC_TAU_Decay/h_3B_kspimkl_2","/MC_TAU_Decay/h_3B_kspimkl_3", + "/MC_TAU_Decay/h_3B_kspimkl_4","/MC_TAU_Decay/h_3B_kspimks_1","/MC_TAU_Decay/h_3B_kspimks_2", + "/MC_TAU_Decay/h_3B_kspimks_3"] +analyses["TauDecays"]["3K" ]["data"] = ["/BELLE_2010_I841618/d04-x01-y01","/BABAR_2007_S7266081/d09-x01-y01", + "/BABAR_2007_S7266081/d10-x01-y01","/BABAR_2007_S7266081/d14-x01-y01"] +analyses["TauDecays"]["Keta"]["MC" ] = ["/MC_TAU_Decay/h_2B_m2Keta","/MC_TAU_Decay/h_2B_mKeta"] +analyses["TauDecays"]["lnu" ]["MC" ] = ["/MC_TAU_Decay/h_2B_m2enu","/MC_TAU_Decay/h_2B_m2munu", + "/MC_TAU_Decay/h_2B_menu","/MC_TAU_Decay/h_2B_mmunu"] +analyses["TauDecays"]["2pieta"]["MC" ] = ["/MC_TAU_Decay/h_3B_pimpi0eta_1","/MC_TAU_Decay/h_3B_pimpi0eta_2", + "/MC_TAU_Decay/h_3B_pimpi0eta_3","/MC_TAU_Decay/h_3B_pimpi0eta_4"] +analyses["TauDecays"]["2pigamma"]["MC" ] = ["/MC_TAU_Decay/h_3B_pimpi0gamma_1","/MC_TAU_Decay/h_3B_pimpi0gamma_2", + "/MC_TAU_Decay/h_3B_pimpi0gamma_3","/MC_TAU_Decay/h_3B_pimpi0gamma_4"] +analyses["TauDecays"]["4pi"]["data"] = ["/ALEPH_2014_I1267648/d03-x01-y01","/ALEPH_2014_I1267648/d05-x01-y01"] +analyses["TauDecays"]["4pi"]["MC" ] = ["/MC_TAU_Decay/h_4B_pipi_1","/MC_TAU_Decay/h_4B_pipi_2", + "/MC_TAU_Decay/h_4B_pipi_3","/MC_TAU_Decay/h_4B_pipi_4", + "/MC_TAU_Decay/h_4B_pipi_5","/MC_TAU_Decay/h_4B_pipi_6", + "/MC_TAU_Decay/h_4B_pipipi_1","/MC_TAU_Decay/h_4B_pipipi_2", + "/MC_TAU_Decay/h_4B_pipipi_3","/MC_TAU_Decay/h_4B_pipipi_4", + "/MC_TAU_Decay/h_4B_pipipi_5","/MC_TAU_Decay/h_4B_pipipipi_1", + "/MC_TAU_Decay/h_4B_pipipipi_2"] +analyses["TauDecays"]["5pi"]["MC" ] = ["/MC_TAU_Decay/h_5B_pipi1_1","/MC_TAU_Decay/h_5B_pipi1_2", + "/MC_TAU_Decay/h_5B_pipi1_3","/MC_TAU_Decay/h_5B_pipi1_4", + "/MC_TAU_Decay/h_5B_pipi1_5","/MC_TAU_Decay/h_5B_pipi2_1", + "/MC_TAU_Decay/h_5B_pipi2_2","/MC_TAU_Decay/h_5B_pipi3_1", + "/MC_TAU_Decay/h_5B_pipi3_2","/MC_TAU_Decay/h_5B_pipi3_3", + "/MC_TAU_Decay/h_5B_pipipi1_1","/MC_TAU_Decay/h_5B_pipipi1_2", + "/MC_TAU_Decay/h_5B_pipipi1_3","/MC_TAU_Decay/h_5B_pipipi1_4", + "/MC_TAU_Decay/h_5B_pipipi1_5","/MC_TAU_Decay/h_5B_pipipi2_1", + "/MC_TAU_Decay/h_5B_pipipi2_2","/MC_TAU_Decay/h_5B_pipipi3_1", + "/MC_TAU_Decay/h_5B_pipipi3_2","/MC_TAU_Decay/h_5B_pipipi3_3", + "/MC_TAU_Decay/h_5B_pipipipi1_1","/MC_TAU_Decay/h_5B_pipipipi1_2", + "/MC_TAU_Decay/h_5B_pipipipi1_3","/MC_TAU_Decay/h_5B_pipipipi2_1", + "/MC_TAU_Decay/h_5B_pipipipi2_2","/MC_TAU_Decay/h_5B_pipipipi3_1", + "/MC_TAU_Decay/h_5B_pipipipi3_2","/MC_TAU_Decay/h_5B_q1", + "/MC_TAU_Decay/h_5B_q2","/MC_TAU_Decay/h_5B_q3"] +analyses["EventShapes"]["2jet_jade"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d07-x01-y01"] +analyses["EventShapes"]["3jet_jade"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d07-x01-y02"] +analyses["EventShapes"]["4jet_jade"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d07-x01-y03"] +analyses["EventShapes"]["5jet_jade"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d07-x01-y04"] +analyses["EventShapes"]["6jet_jade"][35.0 ] = ["/JADE_OPAL_2000_S4300807/d07-x01-y05"] +analyses["EventShapes"]["2jet_jade"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d08-x01-y01"] +analyses["EventShapes"]["3jet_jade"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d08-x01-y02"] +analyses["EventShapes"]["4jet_jade"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d08-x01-y03"] +analyses["EventShapes"]["5jet_jade"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d08-x01-y04"] +analyses["EventShapes"]["6jet_jade"][44.0 ] = ["/JADE_OPAL_2000_S4300807/d08-x01-y05"] +analyses["EventShapes"]["2jet_jade"][91.2 ] = ["/JADE_OPAL_2000_S4300807/d09-x01-y01"] +analyses["EventShapes"]["3jet_jade"][91.2 ] = ["/JADE_OPAL_2000_S4300807/d09-x01-y02"] +analyses["EventShapes"]["4jet_jade"][91.2 ] = ["/JADE_OPAL_2000_S4300807/d09-x01-y03"] +analyses["EventShapes"]["5jet_jade"][91.2 ] = ["/JADE_OPAL_2000_S4300807/d09-x01-y04"] +analyses["EventShapes"]["6jet_jade"][91.2 ] = ["/JADE_OPAL_2000_S4300807/d09-x01-y05"] +analyses["EventShapes"]["2jet_jade"][133.0] = ["/JADE_OPAL_2000_S4300807/d10-x01-y01"] +analyses["EventShapes"]["3jet_jade"][133.0] = ["/JADE_OPAL_2000_S4300807/d10-x01-y02"] +analyses["EventShapes"]["4jet_jade"][133.0] = ["/JADE_OPAL_2000_S4300807/d10-x01-y03"] +analyses["EventShapes"]["5jet_jade"][133.0] = ["/JADE_OPAL_2000_S4300807/d10-x01-y04"] +analyses["EventShapes"]["6jet_jade"][133.0] = ["/JADE_OPAL_2000_S4300807/d10-x01-y05"] +analyses["EventShapes"]["2jet_jade"][161.0] = ["/JADE_OPAL_2000_S4300807/d11-x01-y01"] +analyses["EventShapes"]["3jet_jade"][161.0] = ["/JADE_OPAL_2000_S4300807/d11-x01-y02"] +analyses["EventShapes"]["4jet_jade"][161.0] = ["/JADE_OPAL_2000_S4300807/d11-x01-y03"] +analyses["EventShapes"]["5jet_jade"][161.0] = ["/JADE_OPAL_2000_S4300807/d11-x01-y04"] +analyses["EventShapes"]["6jet_jade"][161.0] = ["/JADE_OPAL_2000_S4300807/d11-x01-y05"] +analyses["EventShapes"]["2jet_jade"][172.0] = ["/JADE_OPAL_2000_S4300807/d12-x01-y01"] +analyses["EventShapes"]["3jet_jade"][172.0] = ["/JADE_OPAL_2000_S4300807/d12-x01-y02"] +analyses["EventShapes"]["4jet_jade"][172.0] = ["/JADE_OPAL_2000_S4300807/d12-x01-y03"] +analyses["EventShapes"]["5jet_jade"][172.0] = ["/JADE_OPAL_2000_S4300807/d12-x01-y04"] +analyses["EventShapes"]["6jet_jade"][172.0] = ["/JADE_OPAL_2000_S4300807/d12-x01-y05"] +analyses["EventShapes"]["2jet_jade"][183.0] = ["/JADE_OPAL_2000_S4300807/d13-x01-y01"] +analyses["EventShapes"]["3jet_jade"][183.0] = ["/JADE_OPAL_2000_S4300807/d13-x01-y02"] +analyses["EventShapes"]["4jet_jade"][183.0] = ["/JADE_OPAL_2000_S4300807/d13-x01-y03"] +analyses["EventShapes"]["5jet_jade"][183.0] = ["/JADE_OPAL_2000_S4300807/d13-x01-y04"] +analyses["EventShapes"]["6jet_jade"][183.0] = ["/JADE_OPAL_2000_S4300807/d13-x01-y05"] +analyses["EventShapes"]["2jet_jade"][189.0] = ["/JADE_OPAL_2000_S4300807/d14-x01-y01"] +analyses["EventShapes"]["3jet_jade"][189.0] = ["/JADE_OPAL_2000_S4300807/d14-x01-y02"] +analyses["EventShapes"]["4jet_jade"][189.0] = ["/JADE_OPAL_2000_S4300807/d14-x01-y03"] +analyses["EventShapes"]["5jet_jade"][189.0] = ["/JADE_OPAL_2000_S4300807/d14-x01-y04"] +analyses["EventShapes"]["6jet_jade"][189.0] = ["/JADE_OPAL_2000_S4300807/d14-x01-y05"] + +figures=glob.glob("%s/*/*.dat" % directory) +used=[] +plotOutput="""
+ {name}: {energy} GeV
+ + + +
""" +plotOutput2="""
+ {name}
+ + + +
""" + +def writePlots(plots,output) : + global figures + output.write("
\n") + for energy in sorted(plots.keys()) : + try : + float(energy) + except: + continue + for name in sorted(plots[energy]) : + dat=name[1:] +".dat" + figName = ("%s/%s" %(directory,dat)) + if(figName not in figures) : + continue + used.append(figName) + pdf=name[1:] +".pdf" + png=name[1:] +".png" + output.write(plotOutput.format(name=name[1:],pdf=pdf,png=png,dat=dat,energy=energy)) + output.write("\n") + output.write("
") + +def writePlots2(plots,output) : + global figures + output.write("
\n") + for name in sorted(plots) : + dat=name[1:] +".dat" + figName = ("%s/%s" %(directory,dat)) + tempName=figName.replace(".dat","") + found = False + names=[] + for name in figures : + if(tempName+"_" in name or tempName+".dat"==name) : + found=True + names.append(name) + if(not found) : continue + for name in names : + used.append(name) + trim = name[:-4].replace("%s/"%directory,"") + pdf=trim+".pdf" + png=trim+".png" + dat=trim+".dat" + output.write(plotOutput2.format(name=trim,pdf=pdf,png=png,dat=dat)) + output.write("\n") + output.write("
") + +def writeMisc(index) : + global figures,used + for val in used : + if(val in figures) : + del figures[figures.index(val)] + index.write("
  • Other Plots\n") + print 'Unused figures',len(figures) + for val in figures: + print val + misc=open(os.path.join(directory,"misc.html"),'w') + misc.write(header.format(title="Comparisions of Herwig7 and Miscellaneous $e^+e^-$ Data")) + misc.write("
    \n") + for val in sorted(figures) : + name=val.replace("Rivet-EE","").replace(".dat","") + dat=name[1:] +".dat" + figName = ("%s/%s" %(directory,dat)) + if(figName not in figures) : continue + del figures[figures.index(figName)] + pdf=name[1:] +".pdf" + png=name[1:] +".png" + misc.write(plotOutput.format(name=name[1:],pdf=pdf,png=png,dat=dat,energy="")) + misc.write("\n") + misc.write("
    ") + # footer + misc.write("\n") + misc.close() + +def writeQED(index) : + index.write("
  • QED Radiation\n") + qed=open(os.path.join(directory,"qed.html"),'w') + qed.write(header.format(title="Comparisions of Herwig7 and Photon Radiation Data")) + writePlots2(analyses["QED"],qed) + # footer + qed.write("\n") + qed.close() + +def writeTauDecays(index) : + index.write("
  • Tau Decays\n") + decays=open(os.path.join(directory,"taus.html"),'w') + decays.write(header.format(title="Comparisions of Herwig7 and Tau Decay Data")) + names = { "2pi" : "$\\tau\\to\\nu_\\tau\\pi^-\\pi^0$", + "Kpi" : "$\\tau\\to\\nu_\\tau K\\pi$", + "KK" : "$\\tau\\to\\nu_\\tau KK$", + "lnu" : "$\\tau\\to\\nu_\\tau \\ell\\nu$", + "Keta" : "$\\tau\\to\\nu_\\tau K\\eta$", + "3pi" : "$\\tau\\to\\nu_\\tau\\pi\\pi\\pi$", + "Kpipi" : "$\\tau\\to\\nu_\\tau K\\pi\\pi$", + "KKpi" : "$\\tau\\to\\nu_\\tau KK\\pi$", + "3K" : "$\\tau\\to\\nu_\\tau K^+K^-K^-$", + "2pieta" : "$\\tau\\to\\nu_\\tau\\eta\\pi\\pi$", + "2pigamma" : "$\\tau\\to\\nu_\\tau\\gamma\\pi\\pi$", + "4pi" : "$\\tau\\to\\nu_\\tau4\\pi$", + "5pi" : "$\\tau\\to\\nu_\\tau5\\pi$",} + index.write("\n") + decays.write("\n") + decays.close() + +def writeParticleDecays(particles,decays,index) : + for val in particles : + if val not in analyses["HadronDecays"] : continue + decays.write("
    \n

    %s

    \n" % (val,particleNames[val])) + index.write("
    %s,\n" % (val,particleNames[val])) + if("Modes" in analyses["HadronDecays"][val] and len(analyses["HadronDecays"][val]["Modes"]) !=0) : + for mode,plots in analyses["HadronDecays"][val]["Modes"].iteritems() : + decays.write("
    Mode: %s
    \n" % mode) + if("data" in plots) : + decays.write("
    Data
    \n") + writePlots2(plots["data"],decays) + if("MC" in plots) : + decays.write("
    Monte Carlo
    \n") + writePlots2(plots["MC"],decays) + # multiplicity dist + if("DistChargedMult" in analyses["HadronDecays"][val] and + len(analyses["HadronDecays"][val]["DistChargedMult"]) !=0) : + decays.write("
    Charged Particle Multplicity Distribution
    \n") + if("data" in analyses["HadronDecays"][val]["DistChargedMult"]) : + decays.write("
    Data
    \n") + writePlots2(analyses["HadronDecays"][val]["DistChargedMult"]["data"],decays) + if("MC" in analyses["HadronDecays"][val]["DistChargedMult"]) : + decays.write("
    Monte Carlo
    \n") + writePlots2(analyses["HadronDecays"][val]["DistChargedMult"]["MC"],decays) + # multiplicities + if("Mult" in analyses["HadronDecays"][val] and + len(analyses["HadronDecays"][val]["Mult"]) !=0) : + for prod,plots in sorted(analyses["HadronDecays"][val]["Mult"].iteritems()): + if(len(plots)==0) : continue + decays.write("
    Multiplicity of %s
    \n" % particleNames[prod]) + writePlots2(plots,decays) + # spectra + if("Spectrum" in analyses["HadronDecays"][val] and + len(analyses["HadronDecays"][val]["Spectrum"]) !=0) : + for prod,plots in sorted(analyses["HadronDecays"][val]["Spectrum"].iteritems()): + if(len(plots)==0) : continue + decays.write("
    Spectrum of %s
    \n" % particleNames[prod]) + writePlots2(plots,decays) + +def writeDecays(index) : + decays=open(os.path.join(directory,"decays.html"),'w') + decays.write(header.format(title="Comparisions of Herwig7 and Hadronic Decay Data")) + index.write("
  • Hadron Decays\n") + index.write(" \n") + decays.write("\n") + decays.close() + +def writeMult(index) : + index.write("
  • Identified Particle Multiplicities\n") + mult=open(os.path.join(directory,"mult.html"),'w') + mult.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Particle Multiplicities")) + # mesons + mult.write("

    Mesons

    \n") + mult.write("

    Light, Unflavoured

    \n") + index.write("\n") + mult.write("\n") + mult.close() + +def writeSpectrum(particles,index,ident) : + latexNames = { "x" : "Scaled Momentum/Energy", + "xi" : "Log of Scaled Momentum/Energy", + "p" : "Momentum/Energy", + "Ratio" : "Ratios of particle multiplicities", + "Other" : "Other distributions" } + for pdgId in particles: + if(pdgId not in analyses["IdentifiedParticle"]) : continue + sumL = len(analyses["IdentifiedParticle"][pdgId]["x"])+len(analyses["IdentifiedParticle"][pdgId]["p"])+\ + len(analyses["IdentifiedParticle"][pdgId]["xi"])+len(analyses["IdentifiedParticle"][pdgId]["Ratio"])\ + +len(analyses["IdentifiedParticle"][pdgId]["Other"]) + if(sumL==0) : continue + # lines in html + ident.write("
  • Identified Particle Spectra\n") + index.write("\n") + ident.write("\n") + ident.close() + +def writeFlavour(index) : + flavour=open(os.path.join(directory,"flavour.html"),'w') + flavour.write(header.format(title="Comparisions of Herwig7 and Flavour Separated $e^+e^-$ Data")) + index.write("
  • Flavour Separated\n") + index.write(" \n") + flavour.write("\n") + flavour.close() + +def writeCharged(index) : + # headers + charged=open(os.path.join(directory,"charged.html"),'w') + charged.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Data on Charged Particles")) + index.write("
  • Charged Particles\n") + index.write("\n") + charged.write("\n") + charged.close() + +def writeJets(index) : + jets=open(os.path.join(directory,"jets.html"),'w') + jets.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Jet Data")) + index.write("
  • Jets\n") + index.write("\n") + jets.write("\n") + jets.write("\n") + jets.close() + +def writeEventShapes(index) : + lFormat="""
    \n<{hlevel} id=\"{tag}\">{name}\n""" + index.write("
    \n") + # sphericity and related + index.write("
  • Sphericity related: \n") + event.write("

    Sphericity and Related Variables

    \n") + for obs in ["S","P","A","Qx","Q21"]: + if obs == "S" : title="Sphericity" + elif obs == "P" : title="Planarity" + elif obs == "A" : title="Aplanarity" + elif obs == "Qx" : title="$Q_x$" + elif obs == "Q21": title="$Q_2-Q_1$" + event.write(lFormat.format(hlevel="h3",tag=obs,name=title)) + index.write(" %s,\n" %(obs,title)) + writePlots(analyses["EventShapes"][obs],event) + event.write("\n") + # jet masses + event.write("

    Jet Masses

    \n") + index.write("
  • Jet Masses: \n") + for obs in ["HeavyJetMass","LightJetMass","TotalJetMass","JetMassDifference"]: + if obs == "HeavyJetMass" : title="Heavy Jet Mass" + elif obs == "LightJetMass" : title="Light Jet Mass" + elif obs == "TotalJetMass" : title="Total Jet Mass" + elif obs == "JetMassDifference" : title="Jet Mass Difference" + event.write(lFormat.format(hlevel="h3",tag=obs,name=title)) + index.write(" %s,\n" %(obs,title)) + writePlots(analyses["EventShapes"][obs],event) + event.write("\n") + # EEC and AEEC + event.write("

    Energy-Energy Correlations

    \n") + index.write("
  • Energy-Energy Correlations: \n") + for obs in ["EEC","AEEC"]: + if obs == "EEC" : title="Energy-Energy Correlation" + elif obs == "AEEC" : title="Energy-Energy Asymmetry Correlation" + event.write(lFormat.format(hlevel="h3",tag=obs,name=title)) + index.write(" %s,\n" %(obs,title)) + writePlots(analyses["EventShapes"][obs],event) + event.write("\n") + # jet broadening + event.write("

    Jet Broadenings

    \n") + index.write("
  • Jet Broadening: \n") + for obs in ["BT","BW","BN","Bdiff"]: + if obs == "BT" : title="Total Jet Broadening" + elif obs == "BW" : title="Wide Jet Broadening" + elif obs == "BN" : title="Narrow Jet Broadening" + elif obs == "Bdiff" : title="Difference of Jet Broadenings" + event.write(lFormat.format(hlevel="h3",tag=obs,name=title)) + index.write(" %s,\n" %(obs,title)) + writePlots(analyses["EventShapes"][obs],event) + event.write("\n") + # C and D + event.write("

    C and D parameters

    \n") + index.write("
  • C and D parameters: \n") + for obs in ["C","D"]: + title= "%s-parameter" % obs + event.write(lFormat.format(hlevel="h3",tag=obs,name=title)) + index.write(" %s,\n" %(obs,title)) + writePlots(analyses["EventShapes"][obs],event) + event.write("\n") + # moments of event shapes + event.write("

    Moments of Event Shapes

    \n") + index.write("
  • Moments: \n") + for val in ["Moment_T","Moment_M","Moment_m","Moment_O","Moment_H","Moment_L", + "Moment_BT","Moment_BW","Moment_BN","Moment_C","Moment_S","Moment_y"] : + if(val=="Moment_T") : + event.write("
    \n

    Thrust

    \n") + index.write(" thrust,\n") + elif(val=="Moment_M") : + event.write("
    \n

    Thrust Major

    \n") + index.write("
    major,\n") + elif(val=="Moment_m") : + event.write("
    \n

    Thrust Minor

    \n") + index.write("
    minor,\n") + elif(val=="Moment_O") : + event.write("
    \n

    Oblateness

    \n") + index.write("
    oblateness,\n") + elif(val=="Moment_H") : + event.write("
    \n

    Heavy Jet Mass

    \n") + index.write("
    heavy jet mass,\n") + elif(val=="Moment_L") : + event.write("
    \n

    Light Jet Mass

    \n") + index.write("
    light jet mass,\n") + elif(val=="Moment_BT") : + event.write("
  • Gluons\n") + gluon=open(os.path.join(directory,"gluon.html"),'w') + gluon.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Data on Gluon Jets")) + index.write("
      \n") + # charged particles dists + gluon.write("

      Charged Particle Multiplicity in Gluon Jets

      \n") + index.write("
    • Charged Particle Multiplicity \n") + gluon.write("
      \n") + writePlots(analyses["Charged"]["DistChargedMult"][21],gluon) + gluon.write("
      \n") + # spectra + index.write("
    • Charged Spectra \n") + gluon.write("

      Charged Particle Spectra for Gluon Jets

      \n") + for val in ["x","p","xi"] : + if(len(analyses["Charged"]["ChargedSpectrum"][21][val])==0) : continue + if(val=="x") : + gluon.write("

      Scaled Momentum

      \n") + elif(val=="p") : + gluon.write("

      Momentum

      \n") + elif(val=="xi") : + gluon.write("

      Log of the Scaled Momentum

      \n") + gluon.write("
      \n") + writePlots(analyses["Charged"]["ChargedSpectrum"][21][val],gluon) + gluon.write("
      \n") + # footer + index.write("
    \n") + gluon.write("\n") + gluon.close() + +print 'Total no of figures',len(figures) +index=open(os.path.join(directory,"herwig.html"),'w') +index.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Data")) +# event shapes +writeEventShapes(index) +# charged particles +writeCharged(index) +# jets +writeJets(index) +# identified particle spectra +writeIdentified(index) +# identified particle multiplicity +writeMult(index) +# flavour +writeFlavour(index) +# gluons +writeGluon(index) +# QED +writeQED(index) +# tau decays +writeTauDecays(index) +# hadron decays +writeDecays(index) +# remaining plots +if(len(figures)>0) : + writeMisc(index) +else : + print 'All figures used' +# footer +index.write("\n") +index.write("\n") +index.close() diff --git a/Tests/python/rivet_check.script b/Tests/python/rivet_check.script new file mode 100755 --- /dev/null +++ b/Tests/python/rivet_check.script @@ -0,0 +1,106 @@ +#!/usr/bin/python +import glob,subprocess,os,optparse + +op = optparse.OptionParser(usage=__doc__) +op.add_option("--obsolete", dest="obsolete" , default=False, action="store_true" , help="Warn if obsolete analyses not included") +op.add_option("--search", dest="search" , default=False, action="store_true" , help="Warn if search analyses not included") +op.add_option("--heavy-ion", dest="heavy_ion" , default=False, action="store_true" , help="Warn if heavy ion analyses not included") +op.add_option("--MC", dest="MC" , default=False, action="store_true" , help="Warn if MC analyses not included") +op.add_option("--print-descriptions", dest="output" , default=False, action="store_true" , help="Print analysis descriptions") +opts, args = op.parse_args() + +# analyses to skip +skip = [ "ATLAS_2010_I849050", # alias + "TOTEM_2012_002" , # alias + "TEST" , # test analysis + ] +searches=["ALEPH_2016_I1492968"] + + +p=subprocess.Popen(["rivet","--list"],stdout=subprocess.PIPE) +analyses={} +for line in p.communicate()[0].split("\n") : + line=line.strip() + if(line=="") : continue + temp = line.split(None,1) + if(len(temp)==2) : + analyses[temp[0].strip()] = temp[1].strip() + elif(len(temp)==1) : + analyses[temp[0].strip()] = "" + else : + print line + quit() + +# main line hw analyses at high energy +hw_analyses={} +files=[] +for idir in glob.glob("Rivet/*") : + if( "Powheg" in idir or "MCatNLO" in idir) : continue + if ( not os.path.isdir(idir) ) : continue + if ( "Templates" in idir ) : continue + for ifile in glob.glob("%s/*.in" % idir) : + fshort=ifile.split("/")[-1].replace(".in","") + files.append(fshort) + file=open(ifile) + line=file.readline() + while line: + if("RivetAnalysis:Analyses" in line and line[0]!="#") : + line=line.strip().split() + anal = line[-1].strip().split(":")[0] + if(anal not in hw_analyses) : + hw_analyses[anal] = [fshort] + else : + hw_analyses[anal].append(fshort) + line=file.readline() + +anatohepmc = open("anatohepmc.txt",'w') +hepmctoana = open("hepmctoana.txt",'w') +not_in_rivet=[] +for val in hw_analyses.keys() : not_in_rivet.append(val) +# check the analyses +for analysis in sorted(analyses.keys()) : + # we have it high energy + if(analysis in hw_analyses) : + anatohepmc.write("%s %s\n" % (analysis,' '.join(sorted(hw_analyses[analysis]))) ) + if("[OBSOLETE]" in analyses[analysis]) : + print "WARNING Obsolete analysis %s included : %s" % (analysis,analyses[analysis]) + if(analysis in not_in_rivet) : + not_in_rivet.remove(analysis) + # obsolete + elif("[OBSOLETE]" in analyses[analysis]) : + if(opts.obsolete) : print "Obsolete analysis %s not included : %s" % (analysis,analyses[analysis]) + # searches + elif("Search" in analyses[analysis] or "search" in analyses[analysis] or analysis in searches) : + if(opts.search) : print "Search analysis %s not included : %s" % (analysis,analyses[analysis]) + # mc only + elif(analysis[0:3]=="MC_") : + if(opts.MC) : print "MC analysis %s not included : %s" % (analysis,analyses[analysis]) + # examples + elif("[EXAMPLE]" in analyses[analysis]) : + continue + # we don't have it + else : + p=subprocess.Popen(["rivet","--show-analysis",analysis],stdout=subprocess.PIPE) + desc=p.communicate()[0] + beams=[] + for line in desc.split("\n") : + if("Beams:" in line) : + beams=line.replace("Beams:","").split() + nHeavy = sum((part=="Pb" or part=="Au") for part in beams) + if(nHeavy == len(beams) or nHeavy+1 == len(beams)) : + if(opts.heavy_ion) : print "Heavy Ion analysis %s not included : %s" % (analysis,analyses[analysis]) + else : + print "MISSING ANALYSIS",analysis,analyses[analysis] + if(opts.output) : print desc +# outout analyses missing from rivet +for val in not_in_rivet: + print "NOT IN RIVET ",val +# output second file for rivet +anatohepmc.close() +for fname in sorted(files) : + anals=[] + for anal in hw_analyses : + if(fname in hw_analyses[anal]) : + anals.append(anal) + hepmctoana.write("%s %s\n" % (fname,' '.join(sorted(anals))) ) +hepmctoana.close() diff --git a/src/DIS-Matchbox.in b/src/DIS-Matchbox.in --- a/src/DIS-Matchbox.in +++ b/src/DIS-Matchbox.in @@ -1,151 +1,152 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Matchbox example input file ################################################## ################################################## ## Collider type ################################################## read snippets/Matchbox.in read snippets/EPCollider.in ################################################## ## Beam energies ################################################## cd /Herwig/EventHandlers ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## EP collider parameters cd /Herwig/EventHandlers set EventHandler:BeamA /Herwig/Particles/e- set Luminosity:BeamEMaxA 30.*GeV set EventHandler:BeamB /Herwig/Particles/p+ set Luminosity:BeamEMaxB 920.*GeV ## Set the order of the couplings cd /Herwig/MatrixElements/Matchbox set Factory:OrderInAlphaS 0 set Factory:OrderInAlphaEW 2 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do Factory:Process e- p -> e- j ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in # read Matchbox/MadGraph-OpenLoops.in ################################################## ## Cut selection ## See the documentation for more options ################################################## ## cuts on additional jets cd /Herwig/Cuts # read Matchbox/DefaultEPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox set Factory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/LeptonQ2Scale ################################################## ## Matching and shower selection ## Please also see flavour scheme settings ## towards the end of the input file. ################################################## read Matchbox/MCatNLO-DefaultShower.in # read Matchbox/Powheg-DefaultShower.in ## use for strict LO/NLO comparisons # read Matchbox/MCatLO-DefaultShower.in ## use for improved LO showering # read Matchbox/LO-DefaultShower.in # read Matchbox/MCatNLO-DipoleShower.in # read Matchbox/Powheg-DipoleShower.in ## use for strict LO/NLO comparisons # read Matchbox/MCatLO-DipoleShower.in ## use for improved LO showering # read Matchbox/LO-DipoleShower.in # read Matchbox/NLO-NoShower.in # read Matchbox/LO-NoShower.in ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourScheme.in ## required for dipole shower and fixed order in five flavour scheme # read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +# read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## # cd /Herwig/Analysis # insert Rivet:Analyses 0 XXX_2015_ABC123 # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 Rivet # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMC ################################################## ## Save the generator ################################################## do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode cd /Herwig/Generators saverun DIS-Matchbox EventGenerator diff --git a/src/LHC-MB.in b/src/LHC-MB.in --- a/src/LHC-MB.in +++ b/src/LHC-MB.in @@ -1,103 +1,62 @@ # -*- ThePEG-repository -*- ################################################################################ # This file contains our best tune to UE data from ATLAS at 7 TeV. More recent # tunes and tunes for other centre-of-mass energies as well as more usage # instructions can be obtained from this Herwig wiki page: # http://projects.hepforge.org/herwig/trac/wiki/MB_UE_tunes # The model for soft interactions and diffractions is explained in # [S. Gieseke, P. Kirchgaesser, F. Loshaj, arXiv:1612.04701] ################################################################################ read snippets/PPCollider.in ################################################## # Technical parameters for this run ################################################## cd /Herwig/Generators ################################################## # LHC physics parameters (override defaults here) ################################################## set EventGenerator:EventHandler:LuminosityFunction:Energy 7000.0 # Intrinsic pT tune extrapolated to LHC energy set /Herwig/Shower/ShowerHandler:IntrinsicPtGaussian 2.2*GeV # Minimum Bias read snippets/MB.in -# Read in parameters of the soft model recommended for MB/UE simulations -read snippets/SoftTune.in - - #Diffraction model read snippets/Diffraction.in -#Turn on Baryonic reconnection -read snippets/BaryonicReconnection.in - -# Normalization of the Min bias cross section for correct diffractive cross section -set /Herwig/MatrixElements/MEMinBias:csNorm 0.01 - - -# Use LHC parametrization of the cross section -set /Herwig/UnderlyingEvent/MPIHandler:DLmode 2 - - -#some preliminary parameters for the MPI model which need to be tuned -#TODO -set /Herwig/UnderlyingEvent/MPIHandler:pTmin0 3.02 -set /Herwig/UnderlyingEvent/MPIHandler:InvRadius 1.4 -set /Herwig/UnderlyingEvent/MPIHandler:Power 0.308 -set /Herwig/Partons/RemnantDecayer:ladderMult 0.45 -set /Herwig/Partons/RemnantDecayer:ladderbFactor 1.0 -set /Herwig/UnderlyingEvent/MPIHandler:DiffractiveRatio 0.17 - -#ordered pTs -set /Herwig/Partons/RemnantDecayer:PtDistribution 4 -#use random remnant connections -set /Herwig/Partons/RemnantDecayer:RandomConnection No - -# set the correct PDFs -set /Herwig/Partons/HardLOPDF:PDFName CT14lo -set /Herwig/Partons/ShowerLOPDF:PDFName CT14lo -set /Herwig/Partons/MPIPDF:PDFName CT14lo -set /Herwig/Partons/RemnantPDF:PDFName CT14lo - -#set /Herwig/Shower/ShowerHandler:CascadeHandler NULL # Switch off parton shower -#set /Herwig/Hadronization/HadronizationHandler:HadronizationHandler NULL -# do Soft interactions - -#set /Herwig/Hadronization/ColourReconnector:ColourReconnection No ################################################# # Analyses ################################################## -#Comment these lines out in order to use rivet analyses -cd /Herwig/Analysis -create ThePEG::RivetAnalysis RivetAnalysis RivetAnalysis.so - -cd /Herwig/Generators -insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis - -#Some example analyses -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2012_I1084540 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2010_S8918562 +## Comment these lines out in order to use rivet analyses +# cd /Herwig/Analysis +# create ThePEG::RivetAnalysis RivetAnalysis RivetAnalysis.so + +# cd /Herwig/Generators +# insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/RivetAnalysis +## Some example analyses +# insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2012_I1084540 +# insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ATLAS_2010_S8918562 #set /Herwig/Analysis/Plot:EventNumber 54 #cd /Herwig/Generators #insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/Plot #insert EventGenerator:AnalysisHandlers 0 /Herwig/Analysis/HepMCFile #set /Herwig/Analysis/HepMCFile:PrintEvent 1000000 #set /Herwig/Analysis/HepMCFile:Format GenEvent #set /Herwig/Analysis/HepMCFile:Units GeV_mm #set /Herwig/Analysis/HepMCFile:Filename events.fifo ################################################## # Save run for later usage with 'Herwig run' ################################################## cd /Herwig/Generators saverun LHC-MB EventGenerator diff --git a/src/LHC-Matchbox.in b/src/LHC-Matchbox.in --- a/src/LHC-Matchbox.in +++ b/src/LHC-Matchbox.in @@ -1,157 +1,158 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Matchbox example input file ################################################## ################################################## ## Collider type ################################################## read snippets/Matchbox.in read snippets/PPCollider.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 13000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/MatrixElements/Matchbox set Factory:OrderInAlphaS 0 set Factory:OrderInAlphaEW 2 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do Factory:Process p p -> e+ e- ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in # read Matchbox/MadGraph-OpenLoops.in # read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam # read Matchbox/HiggsEffective.in ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set ChargedLeptonPairMassCut:MinMass 60*GeV set ChargedLeptonPairMassCut:MaxMass 120*GeV ## cuts on additional jets # read Matchbox/DefaultPPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox set Factory:ScaleChoice /Herwig/MatrixElements/Matchbox/Scales/LeptonPairMassScale ################################################## ## Matching and shower selection ## Please also see flavour scheme settings ## towards the end of the input file. ################################################## read Matchbox/MCatNLO-DefaultShower.in # read Matchbox/Powheg-DefaultShower.in ## use for strict LO/NLO comparisons # read Matchbox/MCatLO-DefaultShower.in ## use for improved LO showering # read Matchbox/LO-DefaultShower.in # read Matchbox/MCatNLO-DipoleShower.in # read Matchbox/Powheg-DipoleShower.in ## use for strict LO/NLO comparisons # read Matchbox/MCatLO-DipoleShower.in ## use for improved LO showering # read Matchbox/LO-DipoleShower.in # read Matchbox/NLO-NoShower.in # read Matchbox/LO-NoShower.in ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourScheme.in ## required for dipole shower and fixed order in five flavour scheme # read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +# read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## # cd /Herwig/Analysis # insert Rivet:Analyses 0 XXX_2015_ABC123 # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 Rivet # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMC ################################################## ## Save the generator ################################################## do /Herwig/MatrixElements/Matchbox/Factory:ProductionMode cd /Herwig/Generators saverun LHC-Matchbox EventGenerator diff --git a/src/Matchbox/CT14.in b/src/Matchbox/CT14.in new file mode 100644 --- /dev/null +++ b/src/Matchbox/CT14.in @@ -0,0 +1,12 @@ +# -*- ThePEG-repository -*- + +cd /Herwig/Partons + +set HardLOPDF:PDFName CT14lo +set HardNLOPDF:PDFName CT14nlo + +set ShowerLOPDF:PDFName CT14lo +set ShowerNLOPDF:PDFName CT14nlo + +set MPIPDF:PDFName CT14lo +set RemnantPDF:PDFName CT14lo diff --git a/src/Matchbox/Makefile.am b/src/Matchbox/Makefile.am --- a/src/Matchbox/Makefile.am +++ b/src/Matchbox/Makefile.am @@ -1,66 +1,67 @@ BUILT_SOURCES = done-all-links Matchboxdir = ${pkgdatadir}/Matchbox INPUTFILES = \ CMEC.in \ DefaultEEJets.in \ DefaultEPJets.in \ DefaultPPJets.in \ DiagonalCKM.in \ FiveFlavourNoBMassScheme.in \ FiveFlavourScheme.in \ FourFlavourScheme.in \ GoSam-GoSam.in \ HiggsEffective.in \ HJets.in \ IdentifiedBs.in \ InclusiveDurhamJets.in \ IncreaseVerbosity.in \ KrkNLO-DipoleShower.in \ LO-DefaultShower.in \ LO-DipoleShower.in \ LO.in \ LO-NoShower.in \ MadGraph-GoSam.in \ MadGraph-MadGraph.in \ MadGraph-NJet.in \ MadGraph-OpenLoops.in \ MCatLO-DefaultShower.in \ MCatLO-DipoleShower.in \ MCatNLO-DefaultShower.in \ MCatNLO-Dipole-HardAlphaSTune.in \ MCatNLO-DipoleShower.in \ MMHT2014.in \ +CT14.in \ MuDown.in \ MuQDown.in \ MuQUp.in \ MuUp.in \ NJet-NJet.in \ NLO-NoShower.in \ NonDiagonalCKM.in \ OnShellHProduction.in \ OnShellTopProduction.in \ OnShellWProduction.in \ OnShellZProduction.in \ OpenLoops-OpenLoops.in \ Powheg-DefaultShower.in \ Powheg-DipoleShower.in \ Powheg.in \ PQCDLevel.in \ StandardModelLike.in \ ShowerBenchmarks.in \ VBFDiagramsOnly.in \ VBFNLO.in \ VBFNLOPhasespace.in dist_Matchbox_DATA = $(INPUTFILES) CLEANFILES = done-all-links done-all-links: $(INPUTFILES) @echo "Linking input files" @for i in $(INPUTFILES); do \ if test -f $(srcdir)/$$i -a ! -e $$i; then \ $(LN_S) -f $(srcdir)/$$i; fi; done @touch done-all-links diff --git a/src/Merging/LHC-H-Merging.in b/src/Merging/LHC-H-Merging.in --- a/src/Merging/LHC-H-Merging.in +++ b/src/Merging/LHC-H-Merging.in @@ -1,194 +1,195 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Merging example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 8000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/Merging set MergingFactory:OrderInAlphaS 2 set MergingFactory:OrderInAlphaEW 1 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do MergingFactory:Process p p -> h0 [ j j ] set MergingFactory:NLOProcesses 2 # Set the merging scale deviding the parton shower # from the matrix element region in phase space. set Merger:MergingScale 15.*GeV set Merger:MergingScaleSmearing 0.1 # The following line clear a preweighter # that is not working for Higgs as here # pt and HT are 0 before the shower. # See other merging files for more information. clear MergingFactory:Preweighters # The next line can switch of hadronization # and MPI modelling. Use with care!! # read Matchbox/PQCDLevel.in ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in read Matchbox/OnShellHProduction.in set /Herwig/Particles/h0:Stable Stable # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in read Matchbox/MadGraph-OpenLoops.in #read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam and ## MadGraph-Openloops #read Matchbox/HiggsEffective.in cd /Herwig/MatrixElements/Matchbox/Amplitudes set OpenLoops:HiggsEff Yes set MadGraph:Model heft ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set ChargedLeptonPairMassCut:MinMass 60*GeV set ChargedLeptonPairMassCut:MaxMass 120*GeV cd /Herwig/MatrixElements/Matchbox/Utility insert DiagramGenerator:ExcludeInternal 0 /Herwig/Particles/gamma ## cuts on additional jets cd /Herwig/Cuts/ # read Matchbox/DefaultPPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox/Scales/ set /Herwig/Merging/MergingFactory:ScaleChoice FixedScale set FixedScale:FixedScale 125.*GeV ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## CMW - Scheme ################################################## read snippets/Dipole_AutoTune_prel.in ### Use factor in alpha_s argument: alpha_s(q) -> alpha_s(fac*q) ### with fac=exp(-(67-3pi^2-10/3*Nf)/(33-2Nf)) read Merging/FactorCMWScheme.in ### Linear CMW multiplication: ### alpha_s(q) -> alpha_s(q)(1+K_g*alpha_s(q)/2pi ) # read Merging/LinearCMWScheme.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +#read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## cd /Herwig/Analysis ## Write HepMC events. Modify the PrintEvent interface for your needs. # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMCFile ## Setup the Rivet analysis: #read snippets/Rivet.in #insert Rivet:Analyses 0 XXX_2017_ABC123 ## Here we collected a various Rivet analysis for Higgs at LHC ## at the 8 TeV. (The collection might not be complete.) # read Merging/LHC8-H-Analysis.in ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode set /Herwig/Generators/EventGenerator:IntermediateOutput Yes cd /Herwig/Generators saverun LHC-H-Merging EventGenerator diff --git a/src/Merging/LHC-J-Merging.in b/src/Merging/LHC-J-Merging.in --- a/src/Merging/LHC-J-Merging.in +++ b/src/Merging/LHC-J-Merging.in @@ -1,191 +1,192 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Merging example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 7000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/Merging set MergingFactory:OrderInAlphaS 2 set MergingFactory:OrderInAlphaEW 0 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do MergingFactory:Process p p -> j j [ j ] set MergingFactory:NLOProcesses 1 # Set the merging scale deviding the parton shower # from the matrix element region in phase space. set Merger:MergingScale 20.*GeV set Merger:MergingScaleSmearing 0.1 # The following lines control a preweighter, # that can be used to force more events in higher # HT or pt regions. The unweighted events are accepted # with a enhanced probability W, that is divided fron the # event weight once the event is accepted. # W = ((HT/scale)^HTPower + (pt_max/scale)^MaxPTPower) # with scale = MZ (can be changed) # Note that the weights will therefore differ from "1" # if the powers are not zero. set MPreWeight:HTPower 0 set MPreWeight:MaxPTPower 0 set MPreWeight:OnlyColoured No # The next line can switch of hadronization # and MPI modelling. Use with care!! # read Matchbox/PQCDLevel.in ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in read Matchbox/MadGraph-OpenLoops.in # read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam ## and MadGraph-OpenLoops # read Matchbox/HiggsEffective.in ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set ChargedLeptonPairMassCut:MinMass 60*GeV set ChargedLeptonPairMassCut:MaxMass 120*GeV cd /Herwig/MatrixElements/Matchbox/Utility insert DiagramGenerator:ExcludeInternal 0 /Herwig/Particles/gamma ## cuts on additional jets cd /Herwig/Cuts/ read Matchbox/DefaultPPJets.in insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox/Scales/ set /Herwig/Merging/MergingFactory:ScaleChoice MaxJetPtScale ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## CMW - Scheme ################################################## read snippets/Dipole_AutoTune_prel.in ### Use factor in alpha_s argument: alpha_s(q) -> alpha_s(fac*q) ### with fac=exp(-(67-3pi^2-10/3*Nf)/(33-2Nf)) read Merging/FactorCMWScheme.in ### Linear CMW multiplication: ### alpha_s(q) -> alpha_s(q)(1+K_g*alpha_s(q)/2pi ) # read Merging/LinearCMWScheme.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +# read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## cd /Herwig/Analysis ## Write HepMC events. Modify the PrintEvent interface for your needs. # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMCFile ## Setup the Rivet analysis: #read snippets/Rivet.in #insert Rivet:Analyses 0 XXX_2017_ABC123 ## Here we collected a various Rivet analysis for Jets at LHC ## at the 7 TeV. (The collection might not be complete.) # read Merging/LHC7-J-Analysis.in ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode set /Herwig/Generators/EventGenerator:IntermediateOutput Yes cd /Herwig/Generators saverun LHC-J-Merging EventGenerator diff --git a/src/Merging/LHC-T-Merging.in b/src/Merging/LHC-T-Merging.in --- a/src/Merging/LHC-T-Merging.in +++ b/src/Merging/LHC-T-Merging.in @@ -1,193 +1,194 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Merging example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 7000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/Merging set MergingFactory:OrderInAlphaS 2 set MergingFactory:OrderInAlphaEW 0 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do MergingFactory:Process p p -> t tbar [ j] set MergingFactory:NLOProcesses 1 # Set the merging scale deviding the parton shower # from the matrix element region in phase space. set Merger:MergingScale 20.*GeV set Merger:MergingScaleSmearing 0.1 # The following lines control a preweighter, # that can be used to force more events in higher # HT or pt regions. The unweighted events are accepted # with a enhanced probability W, that is divided fron the # event weight once the event is accepted. # W = ((HT/scale)^HTPower + (pt_max/scale)^MaxPTPower) # with scale = MZ (can be changed) # Note that the weights will therefore differ from "1" # if the powers are not zero. set MPreWeight:HTPower 0 set MPreWeight:MaxPTPower 0 set MPreWeight:OnlyColoured No # The next line can switch of hadronization # and MPI modelling. Use with care!! # read Matchbox/PQCDLevel.in ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in read Matchbox/MadGraph-OpenLoops.in # read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam and ## MadGraph-Openloops # read Matchbox/HiggsEffective.in ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set ChargedLeptonPairMassCut:MinMass 60*GeV set ChargedLeptonPairMassCut:MaxMass 120*GeV cd /Herwig/MatrixElements/Matchbox/Utility insert DiagramGenerator:ExcludeInternal 0 /Herwig/Particles/gamma ## cuts on additional jets cd /Herwig/Cuts/ # read Matchbox/DefaultPPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox/Scales/ set /Herwig/Merging/MergingFactory:ScaleChoice TopPairMassScale ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## CMW - Scheme ################################################## read snippets/Dipole_AutoTune_prel.in ### Use factor in alpha_s argument: alpha_s(q) -> alpha_s(fac*q) ### with fac=exp(-(67-3pi^2-10/3*Nf)/(33-2Nf)) read Merging/FactorCMWScheme.in ### Linear CMW multiplication: ### alpha_s(q) -> alpha_s(q)(1+K_g*alpha_s(q)/2pi ) # read Merging/LinearCMWScheme.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +# read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## cd /Herwig/Analysis ## Write HepMC events. Modify the PrintEvent interface for your needs. # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMCFile ## Setup the Rivet analysis: #read snippets/Rivet.in #insert Rivet:Analyses 0 XXX_2017_ABC123 ## Here we collected a various Rivet analysis for Tops at LHC ## at the 7 TeV. (The collection might not be complete.) # read Merging/LHC7-T-Analysis.in ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode set /Herwig/Generators/EventGenerator:IntermediateOutput Yes cd /Herwig/Generators saverun LHC-T-Merging EventGenerator diff --git a/src/Merging/LHC-W-Merging.in b/src/Merging/LHC-W-Merging.in --- a/src/Merging/LHC-W-Merging.in +++ b/src/Merging/LHC-W-Merging.in @@ -1,194 +1,195 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Merging example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 7000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/Merging set MergingFactory:OrderInAlphaS 0 set MergingFactory:OrderInAlphaEW 2 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do MergingFactory:Process p p -> l nu [ j j ] set MergingFactory:NLOProcesses 2 # Set the merging scale deviding the parton shower # from the matrix element region in phase space. set Merger:MergingScale 15.*GeV set Merger:MergingScaleSmearing 0.1 # The following lines control a preweighter, # that can be used to force more events in higher # HT or pt regions. The unweighted events are accepted # with a enhanced probability W, that is divided fron the # event weight once the event is accepted. # W = ((HT/scale)^HTPower + (pt_max/scale)^MaxPTPower) # with scale = MZ (can be changed) # Note that the weights will therefore differ from "1" # if the powers are not zero. set MPreWeight:HTPower 0 set MPreWeight:MaxPTPower 0 set MPreWeight:OnlyColoured No # The next line can switch of hadronization # and MPI modelling. Use with care!! # read Matchbox/PQCDLevel.in ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in # read Matchbox/MadGraph-OpenLoops.in # read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam and ## MadGraph-Openloops # read Matchbox/HiggsEffective.in ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set /Herwig/Cuts/LeptonPairMassCut:MinMass 60*GeV set /Herwig/Cuts/LeptonPairMassCut:MaxMass 120*GeV cd /Herwig/MatrixElements/Matchbox/Utility insert DiagramGenerator:ExcludeInternal 0 /Herwig/Particles/gamma ## cuts on additional jets cd /Herwig/Cuts/ # read Matchbox/DefaultPPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox/Scales/ set /Herwig/Merging/MergingFactory:ScaleChoice LeptonPairMassScale ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## CMW - Scheme ################################################## read snippets/Dipole_AutoTune_prel.in ### Use factor in alpha_s argument: alpha_s(q) -> alpha_s(fac*q) ### with fac=exp(-(67-3pi^2-10/3*Nf)/(33-2Nf)) read Merging/FactorCMWScheme.in ### Linear CMW multiplication: ### alpha_s(q) -> alpha_s(q)(1+K_g*alpha_s(q)/2pi ) # read Merging/LinearCMWScheme.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +# read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## cd /Herwig/Analysis ## Write HepMC events. Modify the PrintEvent interface for your needs. # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMCFile ## Setup the Rivet analysis: #read snippets/Rivet.in #insert Rivet:Analyses 0 XXX_2017_ABC123 ## Here we collected a various Rivet analysis for Ws at LHC ## at the 7 TeV. (The collection might not be complete.) # read Merging/LHC7-W-Analysis.in ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode set /Herwig/Generators/EventGenerator:IntermediateOutput Yes cd /Herwig/Generators saverun LHC-W-Merging EventGenerator diff --git a/src/Merging/LHC-Z-Merging.in b/src/Merging/LHC-Z-Merging.in --- a/src/Merging/LHC-Z-Merging.in +++ b/src/Merging/LHC-Z-Merging.in @@ -1,194 +1,195 @@ # -*- ThePEG-repository -*- ################################################## ## Herwig/Merging example input file ################################################## ################################################## ## Collider type ################################################## read snippets/DipoleMerging.in read snippets/PPCollider.in read snippets/MonacoSampler.in ################################################## ## Beam energy sqrt(s) ################################################## cd /Herwig/EventHandlers set EventHandler:LuminosityFunction:Energy 7000*GeV ################################################## ## Process selection ################################################## ## Note that event generation may fail if no matching matrix element has ## been found. Coupling orders are with respect to the Born process, ## i.e. NLO QCD does not require an additional power of alphas. ## Model assumptions read Matchbox/StandardModelLike.in read Matchbox/DiagonalCKM.in ## Set the order of the couplings cd /Herwig/Merging set MergingFactory:OrderInAlphaS 0 set MergingFactory:OrderInAlphaEW 2 ## Select the process ## You may use identifiers such as p, pbar, j, l, mu+, h0 etc. do MergingFactory:Process p p -> e+ e- [ j j ] set MergingFactory:NLOProcesses 2 # Set the merging scale deviding the parton shower # from the matrix element region in phase space. set Merger:MergingScale 15.*GeV set Merger:MergingScaleSmearing 0.1 # The following lines control a preweighter, # that can be used to force more events in higher # HT or pt regions. The unweighted events are accepted # with a enhanced probability W, that is divided fron the # event weight once the event is accepted. # W = ((HT/scale)^HTPower + (pt_max/scale)^MaxPTPower) # with scale = MZ (can be changed) # Note that the weights will therefore differ from "1" # if the powers are not zero. set MPreWeight:HTPower 0 set MPreWeight:MaxPTPower 0 set MPreWeight:OnlyColoured No # The next line can switch of hadronization # and MPI modelling. Use with care!! # read Matchbox/PQCDLevel.in ## Special settings required for on-shell production of unstable particles ## enable for on-shell top production # read Matchbox/OnShellTopProduction.in ## enable for on-shell W, Z or h production # read Matchbox/OnShellWProduction.in # read Matchbox/OnShellZProduction.in # read Matchbox/OnShellHProduction.in # Special settings for the VBF approximation # read Matchbox/VBFDiagramsOnly.in ################################################## ## Matrix element library selection ################################################## ## Select a generic tree/loop combination or a ## specialized NLO package # read Matchbox/MadGraph-GoSam.in # read Matchbox/MadGraph-MadGraph.in # read Matchbox/MadGraph-NJet.in # read Matchbox/MadGraph-OpenLoops.in # read Matchbox/HJets.in # read Matchbox/VBFNLO.in ## Uncomment this to use ggh effective couplings ## currently only supported by MadGraph-GoSam and ## MadGraph-Openloops # read Matchbox/HiggsEffective.in ################################################## ## Cut selection ## See the documentation for more options ################################################## cd /Herwig/Cuts/ set ChargedLeptonPairMassCut:MinMass 60*GeV set ChargedLeptonPairMassCut:MaxMass 120*GeV cd /Herwig/MatrixElements/Matchbox/Utility insert DiagramGenerator:ExcludeInternal 0 /Herwig/Particles/gamma ## cuts on additional jets cd /Herwig/Cuts/ # read Matchbox/DefaultPPJets.in # insert JetCuts:JetRegions 0 FirstJet # insert JetCuts:JetRegions 1 SecondJet # insert JetCuts:JetRegions 2 ThirdJet # insert JetCuts:JetRegions 3 FourthJet ################################################## ## Scale choice ## See the documentation for more options ################################################## cd /Herwig/MatrixElements/Matchbox/Scales/ set /Herwig/Merging/MergingFactory:ScaleChoice LeptonPairMassScale ################################################## ## Scale uncertainties ################################################## # read Matchbox/MuDown.in # read Matchbox/MuUp.in ################################################## ## Shower scale uncertainties ################################################## # read Matchbox/MuQDown.in # read Matchbox/MuQUp.in ################################################## ## CMW - Scheme ################################################## read snippets/Dipole_AutoTune_prel.in ### Use factor in alpha_s argument: alpha_s(q) -> alpha_s(fac*q) ### with fac=exp(-(67-3pi^2-10/3*Nf)/(33-2Nf)) read Merging/FactorCMWScheme.in ### Linear CMW multiplication: ### alpha_s(q) -> alpha_s(q)(1+K_g*alpha_s(q)/2pi ) # read Merging/LinearCMWScheme.in ################################################## ## PDF choice ################################################## read Matchbox/FiveFlavourNoBMassScheme.in -read Matchbox/MMHT2014.in +read Matchbox/CT14.in +#read Matchbox/MMHT2014.in ################################################## ## Analyses ################################################## cd /Herwig/Analysis ## Write HepMC events. Modify the PrintEvent interface for your needs. # insert /Herwig/Generators/EventGenerator:AnalysisHandlers 0 HepMCFile ## Setup the Rivet analysis: #read snippets/Rivet.in #insert Rivet:Analyses 0 XXX_2017_ABC123 ## Here we collected a various Rivet analysis for Zs at LHC ## at the 8 TeV. (The collection might not be complete.) # read Merging/LHC7-Z-Analysis.in ################################################## ## Save the generator ################################################## do /Herwig/Merging/MergingFactory:ProductionMode set /Herwig/Generators/EventGenerator:IntermediateOutput Yes cd /Herwig/Generators saverun LHC-Z-Merging EventGenerator diff --git a/src/defaults/Cuts.in b/src/defaults/Cuts.in --- a/src/defaults/Cuts.in +++ b/src/defaults/Cuts.in @@ -1,118 +1,118 @@ # -*- ThePEG-repository -*- ########################################################### # Default cuts (applied to the hard subprocess) # # Don't change values here, re-set them in your own input # files using these as examples. ########################################################### mkdir /Herwig/Matchers cd /Herwig/Matchers create ThePEG::Matcher Lepton create ThePEG::Matcher Neutrino create ThePEG::Matcher ChargedLepton create ThePEG::Matcher LightQuark create ThePEG::Matcher LightParticle create ThePEG::Matcher LightAntiQuark create ThePEG::Matcher StandardQCDParton create ThePEG::Matcher Photon create ThePEG::Matcher Top create ThePEG::Matcher Bottom create ThePEG::Matcher WBoson create ThePEG::Matcher ZBoson create ThePEG::Matcher HiggsBoson mkdir /Herwig/Cuts cd /Herwig/Cuts # cut on jet pt create ThePEG::SimpleKTCut JetKtCut SimpleKTCut.so newdef JetKtCut:Matcher /Herwig/Matchers/StandardQCDParton newdef JetKtCut:MinKT 20.0*GeV # cut on photon create ThePEG::SimpleKTCut PhotonKtCut SimpleKTCut.so newdef PhotonKtCut:Matcher /Herwig/Matchers/Photon newdef PhotonKtCut:MinKT 20.0*GeV newdef PhotonKtCut:MinEta -3. newdef PhotonKtCut:MaxEta 3. # cut on leptons create ThePEG::SimpleKTCut LeptonKtCut SimpleKTCut.so newdef LeptonKtCut:Matcher /Herwig/Matchers/Lepton newdef LeptonKtCut:MinKT 0.0*GeV # cut on charged leptons create ThePEG::SimpleKTCut ChargedLeptonKtCut SimpleKTCut.so newdef ChargedLeptonKtCut:Matcher /Herwig/Matchers/ChargedLepton newdef ChargedLeptonKtCut:MinKT 0.0*GeV # cut on top quarks create ThePEG::KTRapidityCut TopKtCut KTRapidityCut.so newdef TopKtCut:Matcher /Herwig/Matchers/Top newdef TopKtCut:MinKT 0.0*GeV # cut on W bosons create ThePEG::KTRapidityCut WBosonKtCut KTRapidityCut.so newdef WBosonKtCut:Matcher /Herwig/Matchers/WBoson newdef WBosonKtCut:MinKT 0.0*GeV # cut on Z bosons create ThePEG::KTRapidityCut ZBosonKtCut KTRapidityCut.so newdef ZBosonKtCut:Matcher /Herwig/Matchers/ZBoson newdef ZBosonKtCut:MinKT 0.0*GeV # cut on Higgs bosons create ThePEG::KTRapidityCut HiggsBosonKtCut KTRapidityCut.so newdef HiggsBosonKtCut:Matcher /Herwig/Matchers/HiggsBoson newdef HiggsBosonKtCut:MinKT 0.0*GeV # cut on Higgs bosons create ThePEG::KTRapidityCut LightParticleKtCut KTRapidityCut.so newdef LightParticleKtCut:Matcher /Herwig/Matchers/LightParticle newdef LightParticleKtCut:MinKT 0.0*GeV # create a cut on the invariant mass of lepton pairs create ThePEG::V2LeptonsCut MassCut V2LeptonsCut.so newdef MassCut:Families All newdef MassCut:CComb All newdef MassCut:MinM 20.*GeV newdef MassCut:MaxM 14000.*GeV # create a cut on Q^2 for neutral current DIS create ThePEG::SimpleDISCut NeutralCurrentCut SimpleDISCut.so newdef NeutralCurrentCut:MinQ2 20. newdef NeutralCurrentCut:Current Neutral # create a cut on Q^2 for charged current DIS create ThePEG::SimpleDISCut ChargedCurrentCut SimpleDISCut.so newdef ChargedCurrentCut:MinQ2 20. newdef ChargedCurrentCut:Current Charged # create a cut of Q^2 for charged current DIS # Default Cuts object create ThePEG::Cuts Cuts newdef /Herwig/Generators/EventGenerator:EventHandler:Cuts /Herwig/Cuts/Cuts newdef Cuts:MHatMin 20.*GeV # insert into hadron cuts (by defaults) insert Cuts:OneCuts[0] JetKtCut insert Cuts:OneCuts[1] PhotonKtCut insert Cuts:OneCuts[2] LeptonKtCut insert Cuts:OneCuts[3] TopKtCut insert Cuts:OneCuts[4] WBosonKtCut insert Cuts:OneCuts[5] ZBosonKtCut insert Cuts:OneCuts[6] HiggsBosonKtCut insert Cuts:OneCuts[7] ChargedLeptonKtCut insert Cuts:MultiCuts[0] MassCut # create diffrent cuts object for MinBias to avoid numerical problems create ThePEG::Cuts MinBiasCuts newdef MinBiasCuts:ScaleMin 2.0*GeV2 -newdef MinBiasCuts:X1Min 0.055 -newdef MinBiasCuts:X2Min 0.055 +newdef MinBiasCuts:X1Min 0.011 +newdef MinBiasCuts:X2Min 0.011 newdef MinBiasCuts:MHatMin 0.0*GeV diff --git a/src/defaults/Hadronization.in b/src/defaults/Hadronization.in --- a/src/defaults/Hadronization.in +++ b/src/defaults/Hadronization.in @@ -1,95 +1,96 @@ # -*- ThePEG-repository -*- ############################################################ # Setup of default hadronization # # There are no user servicable parts inside. # # Anything that follows below should only be touched if you # know what you're doing. ############################################################# cd /Herwig/Particles create ThePEG::ParticleData Cluster setup Cluster 81 Cluster 0.00990 0.0 0.0 0.0 0 0 0 1 create ThePEG::ParticleData Remnant setup Remnant 82 Remnant 0.00990 0.0 0.0 0.0 0 0 0 1 mkdir /Herwig/Hadronization cd /Herwig/Hadronization create Herwig::ClusterHadronizationHandler ClusterHadHandler create Herwig::PartonSplitter PartonSplitter create Herwig::ClusterFinder ClusterFinder create Herwig::ColourReconnector ColourReconnector create Herwig::ClusterFissioner ClusterFissioner create Herwig::LightClusterDecayer LightClusterDecayer create Herwig::ClusterDecayer ClusterDecayer create Herwig::HwppSelector HadronSelector newdef ClusterHadHandler:PartonSplitter PartonSplitter newdef ClusterHadHandler:ClusterFinder ClusterFinder newdef ClusterHadHandler:ColourReconnector ColourReconnector newdef ClusterHadHandler:ClusterFissioner ClusterFissioner newdef ClusterHadHandler:LightClusterDecayer LightClusterDecayer newdef ClusterHadHandler:ClusterDecayer ClusterDecayer newdef ClusterHadHandler:MinVirtuality2 0.1*GeV2 newdef ClusterHadHandler:MaxDisplacement 1.0e-10*millimeter newdef ClusterHadHandler:UnderlyingEventHandler NULL newdef ClusterFissioner:HadronSelector HadronSelector newdef LightClusterDecayer:HadronSelector HadronSelector newdef ClusterDecayer:HadronSelector HadronSelector newdef ColourReconnector:ColourReconnection Yes -newdef ColourReconnector:ReconnectionProbability 0.652710 -newdef ColourReconnector:Algorithm Plain -newdef ColourReconnector:InitialTemperature 0.01 -newdef ColourReconnector:AnnealingFactor 0.21 -newdef ColourReconnector:AnnealingSteps 10 -newdef ColourReconnector:TriesPerStepFactor 0.66 +newdef ColourReconnector:ReconnectionProbabilityBaryonic 0.57 +newdef ColourReconnector:ReconnectionProbability 0.89 +newdef ColourReconnector:Algorithm Baryonic newdef ColourReconnector:OctetTreatment All # Clustering parameters for light quarks newdef ClusterFissioner:ClMaxLight 3.649 newdef ClusterFissioner:ClPowLight 2.780 newdef ClusterFissioner:PSplitLight 0.899 newdef ClusterDecayer:ClDirLight 1 newdef ClusterDecayer:ClSmrLight 0.78 # Clustering parameters for b-quarks newdef ClusterFissioner:ClMaxBottom 3.757 newdef ClusterFissioner:ClPowBottom 0.547 newdef ClusterFissioner:PSplitBottom 0.625 newdef ClusterDecayer:ClDirBottom 1 newdef ClusterDecayer:ClSmrBottom 0.078 newdef HadronSelector:SingleHadronLimitBottom 0.000 # Clustering parameters for c-quarks newdef ClusterFissioner:ClMaxCharm 3.950 newdef ClusterFissioner:ClPowCharm 2.559 newdef ClusterFissioner:PSplitCharm 0.994 newdef ClusterDecayer:ClDirCharm 1 newdef ClusterDecayer:ClSmrCharm 0.163 newdef HadronSelector:SingleHadronLimitCharm 0.000 # Clustering parameters for exotic quarks # (e.g. hadronizing Susy particles) newdef ClusterFissioner:ClMaxExotic 2.7*GeV newdef ClusterFissioner:ClPowExotic 1.46 newdef ClusterFissioner:PSplitExotic 1.00 newdef ClusterDecayer:ClDirExotic 1 newdef ClusterDecayer:ClSmrExotic 0. newdef HadronSelector:SingleHadronLimitExotic 0. # +newdef PartonSplitter:SplitPwtSquark 0.824135 +newdef PartonSplitter:Split uds + +# newdef HadronSelector:PwtDquark 1.0 newdef HadronSelector:PwtUquark 1.0 -newdef HadronSelector:PwtSquark 0.700 +newdef HadronSelector:PwtSquark 0.291717 newdef HadronSelector:PwtCquark 1.0 newdef HadronSelector:PwtBquark 1.0 newdef HadronSelector:PwtDIquark 0.298 newdef HadronSelector:SngWt 0.74 newdef HadronSelector:DecWt 0.62 newdef HadronSelector:Mode 1 newdef HadronSelector:BelowThreshold All diff --git a/src/defaults/MatrixElements.in b/src/defaults/MatrixElements.in --- a/src/defaults/MatrixElements.in +++ b/src/defaults/MatrixElements.in @@ -1,249 +1,250 @@ # -*- ThePEG-repository -*- ############################################################################## # Setup of default matrix elements. # # Only one ME is activated by default, but this file lists # some alternatives. All available MEs can be found in the # 'include/Herwig/MatrixElements' subdirectory of your Herwig # installation. # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # # Instead of editing this file directly, you should reset # the matrix elements in your own input files: # # - create your custom SubProcessHandler # - insert the MEs you need # - set your SubProcessHandler instead of the default (see HerwigDefaults.in) ############################################################################## mkdir /Herwig/MatrixElements cd /Herwig/MatrixElements library HwMELepton.so library HwMEHadron.so library HwMEDIS.so ############################################################ # e+e- matrix elements ############################################################ # e+e- > q qbar create Herwig::MEee2gZ2qq MEee2gZ2qq newdef MEee2gZ2qq:MinimumFlavour 1 newdef MEee2gZ2qq:MaximumFlavour 5 newdef MEee2gZ2qq:AlphaQCD /Herwig/Shower/AlphaQCD newdef MEee2gZ2qq:AlphaQED /Herwig/Shower/AlphaQED # e+e- -> l+l- create Herwig::MEee2gZ2ll MEee2gZ2ll newdef MEee2gZ2ll:Allowed Charged set MEee2gZ2ll:AlphaQED /Herwig/Shower/AlphaQED # e+e- -> W+W- ZZ create Herwig::MEee2VV MEee2VV # e+e- -> ZH create Herwig::MEee2ZH MEee2ZH newdef MEee2ZH:Coupling /Herwig/Shower/AlphaQCD # e+e- -> e+e-H/nu_enu_ebarH create Herwig::MEee2HiggsVBF MEee2HiggsVBF ############################################################ # NLO (POWHEG e+e- matrix elements ############################################################ library HwPowhegMELepton.so create Herwig::MEee2gZ2qqPowheg PowhegMEee2gZ2qq newdef PowhegMEee2gZ2qq:MinimumFlavour 1 newdef PowhegMEee2gZ2qq:MaximumFlavour 5 newdef PowhegMEee2gZ2qq:AlphaQCD /Herwig/Shower/AlphaQCD newdef PowhegMEee2gZ2qq:AlphaQED /Herwig/Shower/AlphaQED create Herwig::MEee2gZ2llPowheg PowhegMEee2gZ2ll newdef PowhegMEee2gZ2ll:Allowed Charged set PowhegMEee2gZ2ll:AlphaQED /Herwig/Shower/AlphaQED ############################################################ # hadron-hadron matrix elements ############################################################ ################################### # Electroweak processes ################################### # q qbar -> gamma/Z -> l+l- create Herwig::MEqq2gZ2ff MEqq2gZ2ff newdef MEqq2gZ2ff:Process 3 newdef MEqq2gZ2ff:Coupling /Herwig/Shower/AlphaQCD # q qbar to W -> l nu create Herwig::MEqq2W2ff MEqq2W2ff newdef MEqq2W2ff:Process 2 newdef MEqq2W2ff:Coupling /Herwig/Shower/AlphaQCD # W+jet create Herwig::MEPP2WJet MEWJet newdef MEWJet:WDecay Leptons # Z+jet create Herwig::MEPP2ZJet MEZJet newdef MEZJet:ZDecay ChargedLeptons # PP->WW/WZ/ZZ create Herwig::MEPP2VV MEPP2VV # PP->WZ gamma create Herwig::MEPP2VGamma MEPP2VGamma ################################### # Photon and jet processes ################################### # qqbar/gg -> gamma gamma create Herwig::MEPP2GammaGamma MEGammaGamma # hadron-hadron to gamma+jet create Herwig::MEPP2GammaJet MEGammaJet # QCD 2-to-2 create Herwig::MEQCD2to2 MEQCD2to2 # MinBias create Herwig::MEMinBias MEMinBias - +newdef MEMinBias:csNorm 0.01 +newdef MEMinBias:Scale 2.0 ################################### # Heavy Quark ################################### # qqbar/gg -> t tbar create Herwig::MEPP2QQ MEHeavyQuark create Herwig::MEPP2SingleTop MESingleTopTChannel set MESingleTopTChannel:Process tChannel create Herwig::MEPP2SingleTop MESingleTopSChannel set MESingleTopSChannel:Process sChannel create Herwig::MEPP2SingleTop MESingleTopTW set MESingleTopTW:Process tW ################################### # Higgs processes ################################### # hadron-hadron to higgs create Herwig::MEPP2Higgs MEHiggs newdef MEHiggs:ShapeScheme MassGenerator newdef MEHiggs:Process gg newdef MEHiggs:Coupling /Herwig/Shower/AlphaQCD # hadron-hadron to higgs+jet create Herwig::MEPP2HiggsJet MEHiggsJet # PP->ZH create Herwig::MEPP2ZH MEPP2ZH newdef MEPP2ZH:Coupling /Herwig/Shower/AlphaQCD # PP->WH create Herwig::MEPP2WH MEPP2WH newdef MEPP2WH:Coupling /Herwig/Shower/AlphaQCD # PP -> Higgs via VBF create Herwig::MEPP2HiggsVBF MEPP2HiggsVBF newdef MEPP2HiggsVBF:ShowerAlphaQCD /Herwig/Shower/AlphaQCD # PP -> t tbar Higgs create Herwig::MEPP2QQHiggs MEPP2ttbarH newdef MEPP2ttbarH:QuarkType Top # PP -> b bbar Higgs create Herwig::MEPP2QQHiggs MEPP2bbbarH newdef MEPP2bbbarH:QuarkType Bottom ########################################################## # Hadron-Hadron NLO matrix elements in the Powheg scheme ########################################################## library HwPowhegMEHadron.so # q qbar -> gamma/Z -> l+l- create Herwig::MEqq2gZ2ffPowheg PowhegMEqq2gZ2ff newdef PowhegMEqq2gZ2ff:Process 3 newdef PowhegMEqq2gZ2ff:Coupling /Herwig/Shower/AlphaQCD # q qbar to W -> l nu create Herwig::MEqq2W2ffPowheg PowhegMEqq2W2ff newdef PowhegMEqq2W2ff:Process 2 newdef PowhegMEqq2W2ff:Coupling /Herwig/Shower/AlphaQCD # PP->ZH create Herwig::MEPP2ZHPowheg PowhegMEPP2ZH newdef PowhegMEPP2ZH:Coupling /Herwig/Shower/AlphaQCD # PP->WH create Herwig::MEPP2WHPowheg PowhegMEPP2WH newdef PowhegMEPP2WH:Coupling /Herwig/Shower/AlphaQCD # hadron-hadron to higgs create Herwig::MEPP2HiggsPowheg PowhegMEHiggs newdef PowhegMEHiggs:ShapeScheme MassGenerator newdef PowhegMEHiggs:Process gg newdef PowhegMEHiggs:Coupling /Herwig/Shower/AlphaQCD # PP->VV create Herwig::MEPP2VVPowheg PowhegMEPP2VV newdef PowhegMEPP2VV:Coupling /Herwig/Shower/AlphaQCD # PP -> Higgs via VBF create Herwig::MEPP2HiggsVBFPowheg PowhegMEPP2HiggsVBF newdef PowhegMEPP2HiggsVBF:ShowerAlphaQCD /Herwig/Shower/AlphaQCD # PP -> diphoton NLO create Herwig::MEPP2GammaGammaPowheg MEGammaGammaPowheg set MEGammaGammaPowheg:Process 0 set MEGammaGammaPowheg:Contribution 1 set MEGammaGammaPowheg:ShowerAlphaQCD /Herwig/Shower/AlphaQCD set MEGammaGammaPowheg:ShowerAlphaQED /Herwig/Shower/AlphaQED ########################################################## # DIS matrix elements ########################################################## # neutral current create Herwig::MENeutralCurrentDIS MEDISNC newdef MEDISNC:Coupling /Herwig/Shower/AlphaQCD newdef MEDISNC:Contribution 0 # charged current create Herwig::MEChargedCurrentDIS MEDISCC newdef MEDISCC:Coupling /Herwig/Shower/AlphaQCD newdef MEDISCC:Contribution 0 # neutral current (POWHEG) create Herwig::MENeutralCurrentDIS PowhegMEDISNC newdef PowhegMEDISNC:Coupling /Herwig/Shower/AlphaQCD newdef PowhegMEDISNC:Contribution 1 # charged current (POWHEG) create Herwig::MEChargedCurrentDIS PowhegMEDISCC newdef PowhegMEDISCC:Coupling /Herwig/Shower/AlphaQCD newdef PowhegMEDISCC:Contribution 1 ########################################################## # Gamma-Gamma matrix elements ########################################################## # fermion-antiferimon create Herwig::MEGammaGamma2ff MEgg2ff HwMEGammaGamma.so # W+ W- create Herwig::MEGammaGamma2WW MEgg2WW HwMEGammaGamma.so ########################################################## # Gamma-Hadron matrix elements ########################################################## # gamma parton -> 2 jets create Herwig::MEGammaP2Jets MEGammaP2Jets HwMEGammaHadron.so ########################################################## # Set up the Subprocesses # # Generic for all colliders ########################################################## create ThePEG::SubProcessHandler SubProcess newdef SubProcess:PartonExtractor /Herwig/Partons/PPExtractor diff --git a/src/defaults/PDF.in.in b/src/defaults/PDF.in.in --- a/src/defaults/PDF.in.in +++ b/src/defaults/PDF.in.in @@ -1,77 +1,77 @@ # -*- ThePEG-repository -*- # PDF.in. Generated from PDF.in.in by Makefile.am ##################################### # Default PDF set ##################################### # Handle leptons create ThePEG::LeptonLeptonPDF LeptonPDF LeptonLeptonPDF.so newdef LeptonPDF:RemnantHandler LeptonRemnants newdef /Herwig/Particles/e-:PDF LeptonPDF newdef /Herwig/Particles/e+:PDF LeptonPDF # Handle hadrons # NEW DEFAULT for Hw 7 library ThePEGLHAPDF.so create ThePEG::LHAPDF HardLOPDF newdef HardLOPDF:RemnantHandler HadronRemnants create ThePEG::LHAPDF HardNLOPDF newdef HardNLOPDF:RemnantHandler HadronRemnants create ThePEG::LHAPDF ShowerLOPDF newdef ShowerLOPDF:RemnantHandler HadronRemnants create ThePEG::LHAPDF ShowerNLOPDF newdef ShowerNLOPDF:RemnantHandler HadronRemnants create ThePEG::LHAPDF MPIPDF newdef MPIPDF:RemnantHandler HadronRemnants create ThePEG::LHAPDF RemnantPDF newdef RemnantPDF:RemnantHandler HadronRemnants -newdef HardLOPDF:PDFName MMHT2014lo68cl -newdef HardNLOPDF:PDFName MMHT2014nlo68cl +newdef HardLOPDF:PDFName CT14lo +newdef HardNLOPDF:PDFName CT14nlo -newdef ShowerLOPDF:PDFName MMHT2014lo68cl -newdef ShowerNLOPDF:PDFName MMHT2014nlo68cl +newdef ShowerLOPDF:PDFName CT14lo +newdef ShowerNLOPDF:PDFName CT14nlo -newdef MPIPDF:PDFName MMHT2014lo68cl -newdef RemnantPDF:PDFName MMHT2014lo68cl - +newdef MPIPDF:PDFName CT14lo +newdef RemnantPDF:PDFName CT14lo + # set LO PDFS for hard process and can be changed later newdef /Herwig/Particles/p+:PDF HardLOPDF newdef /Herwig/Particles/pbar-:PDF HardLOPDF # photons from leptons in WW approx create ThePEG::WeizsackerWilliamsPDF WWPDF WeizsackerWilliamsPDF.so create ThePEG::UnResolvedRemnant /Herwig/Partons/LeptonGammaRemnants newdef /Herwig/Partons/WWPDF:RemnantHandler /Herwig/Partons/LeptonGammaRemnants # photons from protons in Budnev approx create ThePEG::BudnevPDF BudnevPDF BudnevPDF.so create ThePEG::UnResolvedRemnant /Herwig/Partons/HadronGammaRemnants newdef /Herwig/Partons/BudnevPDF:RemnantHandler /Herwig/Partons/HadronGammaRemnants # partons inside photons create Herwig::SaSPhotonPDF /Herwig/Partons/SaSPDF HwSaSPhotonPDF.so set /Herwig/Partons/SaSPDF:RemnantHandler /Herwig/Partons/HadronRemnants # pomerons create Herwig::PomeronFlux PomeronFlux HwPomeronFlux.so newdef PomeronFlux:PDFFit Pomeron2006A newdef PomeronFlux:Q2Max 1. newdef PomeronFlux:Q2Min 1.0e-6 create ThePEG::UnResolvedRemnant /Herwig/Partons/ProtonRemnant UnResolvedRemnant.so newdef /Herwig/Partons/PomeronFlux:RemnantHandler /Herwig/Partons/ProtonRemnant create Herwig::PomeronPDF PomeronPDF HwPomeronPDF.so newdef PomeronPDF:RemnantHandler HadronRemnants newdef PomeronPDF:RootName @HERWIG_PDF_POMERON@ newdef /Herwig/Particles/pomeron:PDF PomeronPDF newdef PomeronPDF:PDFFit 2006A diff --git a/src/defaults/Partons.in b/src/defaults/Partons.in --- a/src/defaults/Partons.in +++ b/src/defaults/Partons.in @@ -1,36 +1,37 @@ # -*- ThePEG-repository -*- mkdir /Herwig/Partons cd /Herwig/Partons create ThePEG::NoRemnants NoRemnants create ThePEG::NoPDF NoPDF newdef NoPDF:RemnantHandler NoRemnants create ThePEG::UnResolvedRemnant LeptonRemnants UnResolvedRemnant.so create Herwig::HwRemDecayer RemnantDecayer HwShower.so newdef RemnantDecayer:PomeronStructure Gluon -newdef RemnantDecayer:colourDisrupt 0.7983 +newdef RemnantDecayer:colourDisrupt 0.0 newdef RemnantDecayer:ladderPower -0.088983 newdef RemnantDecayer:ladderNorm 1.086029 +newdef RemnantDecayer:PtDistribution 4 create ThePEG::SoftRemnantHandler HadronRemnants newdef HadronRemnants:RemnantDecayer RemnantDecayer read PDF.in # Make particle extractors create ThePEG::PartonExtractor EEExtractor newdef EEExtractor:NoPDF NoPDF cp EEExtractor PPExtractor newdef PPExtractor:FlatSHatY 1 newdef PPExtractor:FirstPDF HardLOPDF newdef PPExtractor:SecondPDF HardLOPDF cp EEExtractor EPExtractor newdef EPExtractor:FlatSHatY 1 newdef PPExtractor:FirstPDF HardLOPDF newdef PPExtractor:SecondPDF HardLOPDF newdef EPExtractor:SecondPDF HardLOPDF diff --git a/src/defaults/Shower.in b/src/defaults/Shower.in --- a/src/defaults/Shower.in +++ b/src/defaults/Shower.in @@ -1,321 +1,321 @@ # -*- ThePEG-repository -*- ############################################################ # Setup of default parton shower # # Useful switches for users are marked near the top of # this file. # # Don't edit this file directly, but reset the switches # in your own input files! ############################################################ library HwMPI.so library HwShower.so library HwMatching.so mkdir /Herwig/Shower cd /Herwig/Shower create Herwig::QTildeShowerHandler ShowerHandler newdef ShowerHandler:MPIHandler /Herwig/UnderlyingEvent/MPIHandler newdef ShowerHandler:RemDecayer /Herwig/Partons/RemnantDecayer # use LO PDFs for Shower, can be changed later newdef ShowerHandler:PDFA /Herwig/Partons/ShowerLOPDF newdef ShowerHandler:PDFB /Herwig/Partons/ShowerLOPDF newdef ShowerHandler:PDFARemnant /Herwig/Partons/RemnantPDF newdef ShowerHandler:PDFBRemnant /Herwig/Partons/RemnantPDF ##################################### # initial setup, don't change these! ##################################### create Herwig::SplittingGenerator SplittingGenerator create Herwig::ShowerAlphaQCD AlphaQCD create Herwig::ShowerAlphaQED AlphaQED create Herwig::PartnerFinder PartnerFinder -newdef PartnerFinder:PartnerMethod 1 -newdef PartnerFinder:ScaleChoice 1 +newdef PartnerFinder:PartnerMethod 0 +newdef PartnerFinder:ScaleChoice 0 create Herwig::KinematicsReconstructor KinematicsReconstructor newdef KinematicsReconstructor:ReconstructionOption Colour3 newdef KinematicsReconstructor:InitialStateReconOption SofterFraction newdef KinematicsReconstructor:InitialInitialBoostOption LongTransBoost newdef KinematicsReconstructor:FinalFinalWeight Yes newdef /Herwig/Partons/RemnantDecayer:AlphaS AlphaQCD newdef /Herwig/Partons/RemnantDecayer:AlphaEM AlphaQED newdef ShowerHandler:PartnerFinder PartnerFinder newdef ShowerHandler:KinematicsReconstructor KinematicsReconstructor newdef ShowerHandler:SplittingGenerator SplittingGenerator newdef ShowerHandler:SpinCorrelations Yes newdef ShowerHandler:SoftCorrelations Singular ################################################################## # Intrinsic pT # # Recommended: # 1.9 GeV for Tevatron W/Z production. # 2.1 GeV for LHC W/Z production at 10 TeV # 2.2 GeV for LHC W/Z production at 14 TeV # # Set all parameters to 0 to disable ################################################################## -newdef ShowerHandler:IntrinsicPtGaussian 1.3*GeV +newdef ShowerHandler:IntrinsicPtGaussian 2.2*GeV newdef ShowerHandler:IntrinsicPtBeta 0 newdef ShowerHandler:IntrinsicPtGamma 0*GeV newdef ShowerHandler:IntrinsicPtIptmax 0*GeV ############################################################# # Set up truncated shower handler. ############################################################# create Herwig::PowhegShowerHandler PowhegShowerHandler set PowhegShowerHandler:MPIHandler /Herwig/UnderlyingEvent/MPIHandler set PowhegShowerHandler:RemDecayer /Herwig/Partons/RemnantDecayer newdef PowhegShowerHandler:PDFA /Herwig/Partons/ShowerLOPDF newdef PowhegShowerHandler:PDFB /Herwig/Partons/ShowerLOPDF newdef PowhegShowerHandler:PDFARemnant /Herwig/Partons/RemnantPDF newdef PowhegShowerHandler:PDFBRemnant /Herwig/Partons/RemnantPDF newdef PowhegShowerHandler:MPIHandler /Herwig/UnderlyingEvent/MPIHandler newdef PowhegShowerHandler:RemDecayer /Herwig/Partons/RemnantDecayer newdef PowhegShowerHandler:PDFA /Herwig/Partons/ShowerLOPDF newdef PowhegShowerHandler:PDFB /Herwig/Partons/ShowerLOPDF newdef PowhegShowerHandler:PDFARemnant /Herwig/Partons/RemnantPDF newdef PowhegShowerHandler:PDFBRemnant /Herwig/Partons/RemnantPDF newdef PowhegShowerHandler:PartnerFinder PartnerFinder newdef PowhegShowerHandler:KinematicsReconstructor KinematicsReconstructor newdef PowhegShowerHandler:SplittingGenerator SplittingGenerator newdef PowhegShowerHandler:Interactions QCDandQED newdef PowhegShowerHandler:SpinCorrelations Yes newdef PowhegShowerHandler:SoftCorrelations Singular -newdef PowhegShowerHandler:IntrinsicPtGaussian 1.3*GeV +newdef PowhegShowerHandler:IntrinsicPtGaussian 2.2*GeV newdef PowhegShowerHandler:IntrinsicPtBeta 0 newdef PowhegShowerHandler:IntrinsicPtGamma 0*GeV newdef PowhegShowerHandler:IntrinsicPtIptmax 0*GeV newdef PowhegShowerHandler:EvolutionScheme DotProduct ############################################################# # End of interesting user servicable section. # # Anything that follows below should only be touched if you # know what you're doing. # # Really. ############################################################# # # a few default values newdef ShowerHandler:MECorrMode 1 newdef ShowerHandler:EvolutionScheme DotProduct newdef AlphaQCD:ScaleFactor 1.0 newdef AlphaQCD:NPAlphaS 2 newdef AlphaQCD:Qmin 0.935 newdef AlphaQCD:NumberOfLoops 2 newdef AlphaQCD:AlphaIn 0.1186 # # # Lets set up all the splittings create Herwig::HalfHalfOneSplitFn QtoQGammaSplitFn set QtoQGammaSplitFn:InteractionType QED set QtoQGammaSplitFn:ColourStructure ChargedChargedNeutral set QtoQGammaSplitFn:AngularOrdered Yes set QtoQGammaSplitFn:StrictAO Yes create Herwig::HalfHalfOneSplitFn QtoQGSplitFn newdef QtoQGSplitFn:InteractionType QCD newdef QtoQGSplitFn:ColourStructure TripletTripletOctet set QtoQGSplitFn:AngularOrdered Yes set QtoQGSplitFn:StrictAO Yes create Herwig::OneOneOneSplitFn GtoGGSplitFn newdef GtoGGSplitFn:InteractionType QCD newdef GtoGGSplitFn:ColourStructure OctetOctetOctet set GtoGGSplitFn:AngularOrdered Yes set GtoGGSplitFn:StrictAO Yes create Herwig::OneOneOneMassiveSplitFn WtoWGammaSplitFn newdef WtoWGammaSplitFn:InteractionType QED newdef WtoWGammaSplitFn:ColourStructure ChargedChargedNeutral set WtoWGammaSplitFn:AngularOrdered Yes set WtoWGammaSplitFn:StrictAO Yes create Herwig::OneHalfHalfSplitFn GtoQQbarSplitFn newdef GtoQQbarSplitFn:InteractionType QCD newdef GtoQQbarSplitFn:ColourStructure OctetTripletTriplet set GtoQQbarSplitFn:AngularOrdered Yes set GtoQQbarSplitFn:StrictAO Yes create Herwig::OneHalfHalfSplitFn GammatoQQbarSplitFn newdef GammatoQQbarSplitFn:InteractionType QED newdef GammatoQQbarSplitFn:ColourStructure NeutralChargedCharged set GammatoQQbarSplitFn:AngularOrdered Yes set GammatoQQbarSplitFn:StrictAO Yes create Herwig::HalfOneHalfSplitFn QtoGQSplitFn newdef QtoGQSplitFn:InteractionType QCD newdef QtoGQSplitFn:ColourStructure TripletOctetTriplet set QtoGQSplitFn:AngularOrdered Yes set QtoGQSplitFn:StrictAO Yes create Herwig::HalfOneHalfSplitFn QtoGammaQSplitFn newdef QtoGammaQSplitFn:InteractionType QED newdef QtoGammaQSplitFn:ColourStructure ChargedNeutralCharged set QtoGammaQSplitFn:AngularOrdered Yes set QtoGammaQSplitFn:StrictAO Yes # # Now the Sudakovs create Herwig::PTCutOff PTCutOff newdef PTCutOff:pTmin 0.958*GeV create Herwig::SudakovFormFactor SudakovCommon newdef SudakovCommon:Alpha AlphaQCD newdef SudakovCommon:Cutoff PTCutOff newdef SudakovCommon:PDFmax 1.0 cp SudakovCommon QtoQGSudakov newdef QtoQGSudakov:SplittingFunction QtoQGSplitFn newdef QtoQGSudakov:PDFmax 1.9 cp SudakovCommon QtoQGammaSudakov set QtoQGammaSudakov:SplittingFunction QtoQGammaSplitFn set QtoQGammaSudakov:Alpha AlphaQED set QtoQGammaSudakov:PDFmax 1.9 cp QtoQGammaSudakov LtoLGammaSudakov cp PTCutOff LtoLGammaPTCutOff # Technical parameter to stop evolution. set LtoLGammaPTCutOff:pTmin 0.000001 set LtoLGammaSudakov:Cutoff LtoLGammaPTCutOff cp SudakovCommon GtoGGSudakov newdef GtoGGSudakov:SplittingFunction GtoGGSplitFn newdef GtoGGSudakov:PDFmax 2.0 cp SudakovCommon WtoWGammaSudakov newdef WtoWGammaSudakov:SplittingFunction WtoWGammaSplitFn set WtoWGammaSudakov:Alpha AlphaQED cp SudakovCommon GtoQQbarSudakov newdef GtoQQbarSudakov:SplittingFunction GtoQQbarSplitFn newdef GtoQQbarSudakov:PDFmax 120.0 cp SudakovCommon GammatoQQbarSudakov newdef GammatoQQbarSudakov:SplittingFunction GammatoQQbarSplitFn set GammatoQQbarSudakov:Alpha AlphaQED newdef GammatoQQbarSudakov:PDFmax 120.0 cp SudakovCommon GtobbbarSudakov newdef GtobbbarSudakov:SplittingFunction GtoQQbarSplitFn newdef GtobbbarSudakov:PDFmax 40000.0 cp SudakovCommon GtoccbarSudakov newdef GtoccbarSudakov:SplittingFunction GtoQQbarSplitFn newdef GtoccbarSudakov:PDFmax 2000.0 cp SudakovCommon QtoGQSudakov newdef QtoGQSudakov:SplittingFunction QtoGQSplitFn cp SudakovCommon QtoGammaQSudakov newdef QtoGammaQSudakov:SplittingFunction QtoGammaQSplitFn set QtoGammaQSudakov:Alpha AlphaQED cp SudakovCommon utoGuSudakov newdef utoGuSudakov:SplittingFunction QtoGQSplitFn newdef utoGuSudakov:PDFFactor OverOneMinusZ newdef utoGuSudakov:PDFmax 5.0 cp SudakovCommon dtoGdSudakov newdef dtoGdSudakov:SplittingFunction QtoGQSplitFn newdef dtoGdSudakov:PDFFactor OverOneMinusZ # # Now add the final splittings # do SplittingGenerator:AddFinalSplitting u->u,g; QtoQGSudakov do SplittingGenerator:AddFinalSplitting d->d,g; QtoQGSudakov do SplittingGenerator:AddFinalSplitting s->s,g; QtoQGSudakov do SplittingGenerator:AddFinalSplitting c->c,g; QtoQGSudakov do SplittingGenerator:AddFinalSplitting b->b,g; QtoQGSudakov do SplittingGenerator:AddFinalSplitting t->t,g; QtoQGSudakov # do SplittingGenerator:AddFinalSplitting g->g,g; GtoGGSudakov # do SplittingGenerator:AddFinalSplitting g->u,ubar; GtoQQbarSudakov do SplittingGenerator:AddFinalSplitting g->d,dbar; GtoQQbarSudakov do SplittingGenerator:AddFinalSplitting g->s,sbar; GtoQQbarSudakov do SplittingGenerator:AddFinalSplitting g->c,cbar; GtoccbarSudakov do SplittingGenerator:AddFinalSplitting g->b,bbar; GtobbbarSudakov do SplittingGenerator:AddFinalSplitting g->t,tbar; GtoQQbarSudakov # do SplittingGenerator:AddFinalSplitting gamma->u,ubar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->d,dbar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->s,sbar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->c,cbar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->b,bbar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->t,tbar; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->e-,e+; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->mu-,mu+; GammatoQQbarSudakov do SplittingGenerator:AddFinalSplitting gamma->tau-,tau+; GammatoQQbarSudakov # do SplittingGenerator:AddFinalSplitting u->u,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting d->d,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting s->s,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting c->c,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting b->b,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting t->t,gamma; QtoQGammaSudakov do SplittingGenerator:AddFinalSplitting e-->e-,gamma; LtoLGammaSudakov do SplittingGenerator:AddFinalSplitting mu-->mu-,gamma; LtoLGammaSudakov do SplittingGenerator:AddFinalSplitting tau-->tau-,gamma; LtoLGammaSudakov do SplittingGenerator:AddFinalSplitting W+->W+,gamma; WtoWGammaSudakov # # Now lets add the initial splittings. Remember the form a->b,c; means # that the current particle b is given and we backward branch to new # particle a which is initial state and new particle c which is final state # do SplittingGenerator:AddInitialSplitting u->u,g; QtoQGSudakov do SplittingGenerator:AddInitialSplitting d->d,g; QtoQGSudakov do SplittingGenerator:AddInitialSplitting s->s,g; QtoQGSudakov do SplittingGenerator:AddInitialSplitting c->c,g; QtoQGSudakov do SplittingGenerator:AddInitialSplitting b->b,g; QtoQGSudakov do SplittingGenerator:AddInitialSplitting u->u,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting d->d,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting s->s,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting c->c,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting b->b,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting t->t,gamma; QtoQGammaSudakov do SplittingGenerator:AddInitialSplitting g->g,g; GtoGGSudakov # do SplittingGenerator:AddInitialSplitting g->d,dbar; GtoQQbarSudakov do SplittingGenerator:AddInitialSplitting g->u,ubar; GtoQQbarSudakov do SplittingGenerator:AddInitialSplitting g->s,sbar; GtoQQbarSudakov do SplittingGenerator:AddInitialSplitting g->c,cbar; GtoccbarSudakov do SplittingGenerator:AddInitialSplitting g->b,bbar; GtobbbarSudakov # do SplittingGenerator:AddInitialSplitting gamma->d,dbar; GammatoQQbarSudakov do SplittingGenerator:AddInitialSplitting gamma->u,ubar; GammatoQQbarSudakov do SplittingGenerator:AddInitialSplitting gamma->s,sbar; GammatoQQbarSudakov do SplittingGenerator:AddInitialSplitting gamma->c,cbar; GammatoQQbarSudakov do SplittingGenerator:AddInitialSplitting gamma->b,bbar; GammatoQQbarSudakov # do SplittingGenerator:AddInitialSplitting d->g,d; dtoGdSudakov do SplittingGenerator:AddInitialSplitting u->g,u; utoGuSudakov do SplittingGenerator:AddInitialSplitting s->g,s; QtoGQSudakov do SplittingGenerator:AddInitialSplitting c->g,c; QtoGQSudakov do SplittingGenerator:AddInitialSplitting b->g,b; QtoGQSudakov do SplittingGenerator:AddInitialSplitting dbar->g,dbar; dtoGdSudakov do SplittingGenerator:AddInitialSplitting ubar->g,ubar; utoGuSudakov do SplittingGenerator:AddInitialSplitting sbar->g,sbar; QtoGQSudakov do SplittingGenerator:AddInitialSplitting cbar->g,cbar; QtoGQSudakov do SplittingGenerator:AddInitialSplitting bbar->g,bbar; QtoGQSudakov # do SplittingGenerator:AddInitialSplitting d->gamma,d; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting u->gamma,u; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting s->gamma,s; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting c->gamma,c; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting b->gamma,b; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting dbar->gamma,dbar; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting ubar->gamma,ubar; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting sbar->gamma,sbar; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting cbar->gamma,cbar; QtoGammaQSudakov do SplittingGenerator:AddInitialSplitting bbar->gamma,bbar; QtoGammaQSudakov diff --git a/src/defaults/UnderlyingEvent.in b/src/defaults/UnderlyingEvent.in --- a/src/defaults/UnderlyingEvent.in +++ b/src/defaults/UnderlyingEvent.in @@ -1,75 +1,82 @@ # -*- ThePEG-repository -*- ################################################ # Set up the handler for the underlying event. ################################################ mkdir /Herwig/UnderlyingEvent cd /Herwig/UnderlyingEvent ######## cuts ################################################# library SimpleKTCut.so # cut on pt. Without a specific matcher object, it works on all # particles create ThePEG::SimpleKTCut KtCut newdef KtCut:MinKT 3.06 # create the cuts object for the Underlying Event create ThePEG::Cuts UECuts # This should always be 2*MinKT!! newdef UECuts:MHatMin 6.12 insert UECuts:OneCuts 0 KtCut ######## subprocess ########################################### create ThePEG::SubProcessHandler FastQCD create Herwig::MEQCD2to2Fast MEQCD2to2Fast HwMEHadronFast.so insert FastQCD:MatrixElements 0 MEQCD2to2Fast cp /Herwig/Partons/PPExtractor /Herwig/Partons/MPIExtractor newdef /Herwig/Partons/MPIExtractor:FlatSHatY 1 newdef FastQCD:PartonExtractor /Herwig/Partons/MPIExtractor # always use LO PDF for MPI and remnants newdef /Herwig/Partons/MPIExtractor:FirstPDF /Herwig/Partons/MPIPDF newdef /Herwig/Partons/MPIExtractor:SecondPDF /Herwig/Partons/MPIPDF ######## MPI Handler ########################################## library JetCuts.so library HwMPI.so create Herwig::MPIHandler MPIHandler # set the subprocesses and corresponding cuts insert MPIHandler:SubProcessHandlers 0 FastQCD insert MPIHandler:Cuts 0 UECuts # energy extrapolation for the MinKT cut newdef MPIHandler:EnergyExtrapolation Power -newdef MPIHandler:Power 0.420445 -newdef MPIHandler:pTmin0 3.568157 +newdef MPIHandler:Power 0.322 +newdef MPIHandler:pTmin0 2.55 newdef MPIHandler:ReferenceScale 7000.*GeV newdef MPIHandler:EEparamA 0.585*GeV newdef MPIHandler:EEparamB 37.45*GeV +# Paramters for the ladders for soft MPIs +newdef /Herwig/Partons/RemnantDecayer:ladderMult 0.466 +newdef /Herwig/Partons/RemnantDecayer:ladderbFactor 0.46 + +# Ratio of diffractive events in MinBias runs +newdef MPIHandler:DiffractiveRatio 0.133 + # The inverse hadron radius -newdef MPIHandler:InvRadius 1.489997 +newdef MPIHandler:InvRadius 1.58 # Set the details of the soft model # Flag to decide whether additional soft interactions (i.e. pt < ptmin) # should be simulated at all newdef MPIHandler:softInt Yes # Flag to decide whether to use the 2 component model. In this model, # the hadron radius (or better: mean parton-parton separation) can be # different for hard and soft scatters. The radius for the soft scatters # is computed during the run startup so that the elastic t-slope, B_el, # coincides with current measurements (for CMenergy < 1.8 TeV) or # Donnachie-Landshoff pomeron fit (CMenergy > 1.8 TeV). If this model is # disabled one has to take care that this observable is correctly # described by adjusting InvRadius properly. newdef MPIHandler:twoComp Yes newdef MPIHandler:DLmode 2 diff --git a/src/defaults/quarks.in b/src/defaults/quarks.in --- a/src/defaults/quarks.in +++ b/src/defaults/quarks.in @@ -1,35 +1,35 @@ # -*- ThePEG-repository -*- # # file containing the particle data for the quarks # create ThePEG::ConstituentParticleData d setup d 1 d 0.005 0. 0 0 -1 3 2 1 0.325 create ThePEG::ConstituentParticleData dbar setup dbar -1 dbar 0.005 0. 0 0 1 -3 2 1 0.325 makeanti dbar d create ThePEG::ConstituentParticleData ubar setup ubar -2 ubar 0.0023 0. 0 0 -2 -3 2 1 0.325 create ThePEG::ConstituentParticleData u setup u 2 u 0.0023 0. 0 0 2 3 2 1 0.325 makeanti u ubar create ThePEG::ConstituentParticleData c setup c 4 c 1.25 0. 0 0 2 3 2 1 1.6 create ThePEG::ConstituentParticleData cbar setup cbar -4 cbar 1.25 0. 0 0 -2 -3 2 1 1.6 makeanti cbar c create ThePEG::ConstituentParticleData sbar -setup sbar -3 sbar 0.095 0. 0 0 1 -3 2 1 0.5 +setup sbar -3 sbar 0.095 0. 0 0 1 -3 2 1 0.45 create ThePEG::ConstituentParticleData s -setup s 3 s 0.095 0. 0 0 -1 3 2 1 0.5 +setup s 3 s 0.095 0. 0 0 -1 3 2 1 0.45 makeanti s sbar create ThePEG::ConstituentParticleData b setup b 5 b 4.2 0. 0 0 -1 3 2 1 5 create ThePEG::ConstituentParticleData bbar setup bbar -5 bbar 4.2 0. 0 0 1 -3 2 1 5 makeanti bbar b create ThePEG::ParticleData t setup t 6 t 174.2 1.4 14 0 2 3 2 0 create ThePEG::ParticleData tbar setup tbar -6 tbar 174.2 1.4 14 0 -2 -3 2 0 makeanti tbar t diff --git a/src/snippets/BaryonicReconnection.in b/src/snippets/BaryonicReconnection.in --- a/src/snippets/BaryonicReconnection.in +++ b/src/snippets/BaryonicReconnection.in @@ -1,17 +1,10 @@ # Set strange quark mass to 0.45 in order to allow alternative gluon splitting set /Herwig/Particles/s:ConstituentMass 0.45*GeV set /Herwig/Particles/sbar:ConstituentMass 0.45*GeV # Use Baryonic Colour Reconnection Model set /Herwig/Hadronization/ColourReconnector:Algorithm Baryonic # Allow alternative gluon splitting set /Herwig/Hadronization/PartonSplitter:Split uds -# Parameters for the Baryonic Reconnection Model -set /Herwig/Hadronization/ColourReconnector:ReconnectionProbability 0.772606 -set /Herwig/Hadronization/ColourReconnector:ReconnectionProbabilityBaryonic 0.477612 -set /Herwig/UnderlyingEvent/MPIHandler:pTmin0 3.053252 -set /Herwig/UnderlyingEvent/MPIHandler:InvRadius 1.282032 -set /Herwig/Hadronization/HadronSelector:PwtSquark 0.291717 -set /Herwig/Hadronization/PartonSplitter:SplitPwtSquark 0.824135 diff --git a/src/snippets/SoftTune.in b/src/snippets/SoftTune.in --- a/src/snippets/SoftTune.in +++ b/src/snippets/SoftTune.in @@ -1,8 +1,16 @@ -# Recommended set of parameters for MB/UE runs +# Tund for UE and MB (these are the default parameters) -set /Herwig/Hadronization/ColourReconnector:ReconnectionProbability 0.5 -set /Herwig/UnderlyingEvent/MPIHandler:pTmin0 3.502683 -set /Herwig/UnderlyingEvent/MPIHandler:InvRadius 1.402055 -set /Herwig/UnderlyingEvent/MPIHandler:Power 0.416852 -set /Herwig/Partons/RemnantDecayer:ladderPower -0.08 -set /Herwig/Partons/RemnantDecayer:ladderNorm 0.95 +set /Herwig/MatrixElements/MEMinBias:csNorm 0.01 +set /Herwig/UnderlyingEvent/MPIHandler:DLmode 2 +set /Herwig/UnderlyingEvent/MPIHandler:pTmin0 2.55 +set /Herwig/UnderlyingEvent/MPIHandler:InvRadius 1.58 +set /Herwig/UnderlyingEvent/MPIHandler:Power 0.322 +set /Herwig/Partons/RemnantDecayer:ladderMult 0.466 +set /Herwig/Partons/RemnantDecayer:ladderbFactor 0.46 +set /Herwig/UnderlyingEvent/MPIHandler:DiffractiveRatio 0.133 +set /Herwig/Partons/RemnantDecayer:PtDistribution 4 +set /Herwig/Hadronization/ColourReconnector:ReconnectionProbability 0.89 +set /Herwig/Hadronization/ColourReconnector:ReconnectionProbabilityBaryonic 0.57 +set /Herwig/Hadronization/HadronSelector:PwtSquark 0.291717 +set /Herwig/Hadronization/PartonSplitter:SplitPwtSquark 0.824135 +