diff --git a/Decay/General/SSVDecayer.cc b/Decay/General/SSVDecayer.cc --- a/Decay/General/SSVDecayer.cc +++ b/Decay/General/SSVDecayer.cc @@ -1,372 +1,343 @@ // -*- C++ -*- // // SSVDecayer.cc is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2019 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 SSVDecayer class. // #include "SSVDecayer.h" #include "ThePEG/Utilities/DescribeClass.h" #include "ThePEG/Interface/ClassDocumentation.h" #include "ThePEG/Persistency/PersistentOStream.h" #include "ThePEG/Persistency/PersistentIStream.h" #include "ThePEG/PDT/DecayMode.h" #include "Herwig/Utilities/Kinematics.h" #include "ThePEG/Helicity/WaveFunction/ScalarWaveFunction.h" #include "ThePEG/Helicity/WaveFunction/VectorWaveFunction.h" #include "Herwig/Decay/GeneralDecayMatrixElement.h" using namespace Herwig; using namespace ThePEG::Helicity; IBPtr SSVDecayer::clone() const { return new_ptr(*this); } IBPtr SSVDecayer::fullclone() const { return new_ptr(*this); } void SSVDecayer::setDecayInfo(PDPtr incoming, PDPair outgoing, vector vertex, map & inV, const vector > & outV, map fourV) { decayInfo(incoming,outgoing); - for(auto vert : vertex) { + for(auto vert : vertex) vertex_ .push_back(dynamic_ptr_cast(vert)); - perturbativeVertex_.push_back(dynamic_ptr_cast (vert)); - } vector itemp={ShowerInteraction::QCD,ShowerInteraction::QED}; for(auto & inter : itemp) { incomingVertex_[inter] = dynamic_ptr_cast(inV.at(inter)); fourPointVertex_[inter] = dynamic_ptr_cast(fourV.at(inter)); outgoingVertexS_[inter] = AbstractVSSVertexPtr(); outgoingVertexV_[inter] = AbstractVVVVertexPtr(); if(outV[0].at(inter)) { if (outV[0].at(inter)->getName()==VertexType::VSS) outgoingVertexS_[inter] = dynamic_ptr_cast(outV[0].at(inter)); else outgoingVertexV_[inter] = dynamic_ptr_cast(outV[0].at(inter)); } if(outV[1].at(inter)) { if (outV[1].at(inter)->getName()==VertexType::VSS) outgoingVertexS_[inter] = dynamic_ptr_cast(outV[1].at(inter)); else outgoingVertexV_[inter] = dynamic_ptr_cast(outV[1].at(inter)); } } } void SSVDecayer::persistentOutput(PersistentOStream & os) const { - os << vertex_ << perturbativeVertex_ + os << vertex_ << incomingVertex_ << outgoingVertexS_ << outgoingVertexV_ << fourPointVertex_; } void SSVDecayer::persistentInput(PersistentIStream & is, int) { - is >> vertex_ >> perturbativeVertex_ + is >> vertex_ >> incomingVertex_ >> outgoingVertexS_ >> outgoingVertexV_ >> fourPointVertex_; } // The following static variable is needed for the type // description system in ThePEG. DescribeClass describeHerwigSSVDecayer("Herwig::SSVDecayer", "Herwig.so"); void SSVDecayer::Init() { static ClassDocumentation documentation ("This implements the decay of a scalar to a vector and a scalar"); } void SSVDecayer:: constructSpinInfo(const Particle & part, ParticleVector decay) const { unsigned int isc(0),ivec(1); if(decay[0]->dataPtr()->iSpin() != PDT::Spin0) swap(isc,ivec); ScalarWaveFunction:: constructSpinInfo(const_ptr_cast(&part),incoming,true); ScalarWaveFunction:: constructSpinInfo(decay[isc],outgoing,true); VectorWaveFunction:: constructSpinInfo(vector_,decay[ivec],outgoing,true,false); } double SSVDecayer::me2(const int,const Particle & part, const tPDVector & outgoing, const vector & momenta, MEOption meopt) const { unsigned int isc(0),ivec(1); if(outgoing[0]->iSpin() != PDT::Spin0) swap(isc,ivec); if(!ME()) { if(ivec==1) ME(new_ptr(GeneralDecayMatrixElement(PDT::Spin0,PDT::Spin0,PDT::Spin1))); else ME(new_ptr(GeneralDecayMatrixElement(PDT::Spin0,PDT::Spin1,PDT::Spin0))); } if(meopt==Initialize) { ScalarWaveFunction:: calculateWaveFunctions(rho_,const_ptr_cast(&part),incoming); swave_ = ScalarWaveFunction(part.momentum(),part.dataPtr(),incoming); // fix rho if no correlations fixRho(rho_); } VectorWaveFunction:: calculateWaveFunctions(vector_,momenta[ivec],outgoing[ivec],Helicity::outgoing,false); ScalarWaveFunction sca(momenta[isc],outgoing[isc],Helicity::outgoing); Energy2 scale(sqr(part.mass())); //make sure decay matrix element is in the correct order double output(0.); if(ivec == 0) { for(unsigned int ix = 0; ix < 3; ++ix) { (*ME())(0, ix, 0) = 0.; for(auto vert : vertex_) (*ME())(0, ix, 0) += vert->evaluate(scale,vector_[ix],sca, swave_); } } else { for(unsigned int ix = 0; ix < 3; ++ix) { (*ME())(0, 0, ix) = 0.; for(auto vert : vertex_) (*ME())(0, 0, ix) += vert->evaluate(scale,vector_[ix],sca,swave_); } } output = (ME()->contract(rho_)).real()/scale*UnitRemoval::E2; // colour and identical particle factors output *= colourFactor(part.dataPtr(),outgoing[0],outgoing[1]); // return the answer return output; } Energy SSVDecayer:: partialWidth(PMPair inpart, PMPair outa, PMPair outb) const { if( inpart.second < outa.second + outb.second ) return ZERO; - if(perturbativeVertex_.size()==1 && - perturbativeVertex_[0]) { - double mu1sq(sqr(outa.second/inpart.second)), - mu2sq(sqr(outb.second/inpart.second)); - tcPDPtr in = inpart.first->CC() ? tcPDPtr(inpart.first->CC()) : inpart.first; - if(outa.first->iSpin() == PDT::Spin0) { - perturbativeVertex_[0]->setCoupling(sqr(inpart.second), outb.first, outa.first,in); - } - else { - swap(mu1sq,mu2sq); - perturbativeVertex_[0]->setCoupling(sqr(inpart.second), outa.first, outb.first,in); - } - double me2(0.); - if(mu2sq == 0.) - me2 = -2.*mu1sq - 2.; - else - me2 = ( sqr(mu2sq - mu1sq) - 2.*(mu2sq + mu1sq) + 1. )/mu2sq; - Energy pcm = Kinematics::pstarTwoBodyDecay(inpart.second, outa.second, - outb.second); - Energy output = pcm*me2*norm(perturbativeVertex_[0]->norm())/8./Constants::pi; - // colour factor - output *= colourFactor(inpart.first,outa.first,outb.first); - // return the answer - return output; - } - else { - return GeneralTwoBodyDecayer::partialWidth(inpart,outa,outb); - } + return GeneralTwoBodyDecayer::partialWidth(inpart,outa,outb); } double SSVDecayer::threeBodyME(const int , const Particle & inpart, const ParticleVector & decay, ShowerInteraction inter, MEOption meopt) { int iscal (0), ivect (1), iglu (2); // get location of outgoing scalar/vector if(decay[1]->dataPtr()->iSpin()==PDT::Spin0) swap(iscal,ivect); if(meopt==Initialize) { // create scalar wavefunction for decaying particle ScalarWaveFunction::calculateWaveFunctions(rho3_,const_ptr_cast(&inpart),incoming); swave3_ = ScalarWaveFunction(inpart.momentum(),inpart.dataPtr(),incoming); } // setup spin information when needed if(meopt==Terminate) { ScalarWaveFunction:: constructSpinInfo(const_ptr_cast(&inpart),incoming,true); ScalarWaveFunction:: constructSpinInfo(decay[iscal],outgoing,true); VectorWaveFunction:: constructSpinInfo(vector3_,decay[ivect],outgoing,true,false); VectorWaveFunction:: constructSpinInfo(gluon_, decay[iglu ],outgoing,true,false); return 0.; } // calculate colour factors and number of colour flows unsigned int nflow; vector cfactors = getColourFactors(inpart, decay, nflow); vector ME(nflow,new_ptr(GeneralDecayMatrixElement(PDT::Spin0, PDT::Spin0, PDT::Spin1, PDT::Spin1))); // create wavefunctions ScalarWaveFunction scal(decay[iscal]->momentum(), decay[iscal]->dataPtr(),outgoing); VectorWaveFunction::calculateWaveFunctions(vector3_,decay[ivect],outgoing,false); VectorWaveFunction::calculateWaveFunctions(gluon_, decay[iglu ],outgoing,true ); // gauge invariance test #ifdef GAUGE_CHECK gluon_.clear(); for(unsigned int ix=0;ix<3;++ix) { if(ix==1) gluon_.push_back(VectorWaveFunction()); else { gluon_.push_back(VectorWaveFunction(decay[iglu ]->momentum(), decay[iglu ]->dataPtr(),10, outgoing)); } } #endif if (! ((incomingVertex_[inter] && (outgoingVertexS_[inter] || outgoingVertexV_[inter])) || (outgoingVertexS_[inter] && outgoingVertexV_[inter]))) throw Exception() << "Invalid vertices for radiation in SSV decay in SSVDecayer::threeBodyME" << Exception::runerror; // sort out colour flows int S(1), V(2); if (decay[iscal]->dataPtr()->iColour()==PDT::Colour3bar && decay[ivect]->dataPtr()->iColour()==PDT::Colour8) swap(S,V); else if (decay[ivect]->dataPtr()->iColour()==PDT::Colour3 && decay[iscal]->dataPtr()->iColour()==PDT::Colour8) swap(S,V); Energy2 scale(sqr(inpart.mass())); const GeneralTwoBodyDecayer::CFlow & colourFlow = colourFlows(inpart, decay); double gs(0.); bool couplingSet(false); #ifdef GAUGE_CHECK double total=0.; #endif for(unsigned int iv = 0; iv < 3; ++iv) { for(unsigned int ig = 0; ig < 2; ++ig) { // radiation from the incoming scalar if((inpart.dataPtr()->coloured() && inter==ShowerInteraction::QCD) || (inpart.dataPtr()->charged() && inter==ShowerInteraction::QED) ) { assert(incomingVertex_[inter]); ScalarWaveFunction scalarInter = incomingVertex_[inter]->evaluate(scale,3,inpart.dataPtr(), gluon_[2*ig],swave3_,inpart.mass()); assert(swave3_.particle()->id()==scalarInter.particle()->id()); Complex diag = 0.; for(auto vertex : vertex_) diag += vertex->evaluate(scale,vector3_[iv],scal,scalarInter); if(!couplingSet) { gs = abs(incomingVertex_[inter]->norm()); couplingSet = true; } for(unsigned int ix=0;ixdataPtr()->coloured() && inter==ShowerInteraction::QCD) || (decay[iscal]->dataPtr()->charged() && inter==ShowerInteraction::QED) ) { assert(outgoingVertexS_[inter]); // ensure you get correct outgoing particle from first vertex tcPDPtr off = decay[iscal]->dataPtr(); if(off->CC()) off = off->CC(); ScalarWaveFunction scalarInter = outgoingVertexS_[inter]->evaluate(scale,3,off,gluon_[2*ig],scal,decay[iscal]->mass()); assert(scal.particle()->id()==scalarInter.particle()->id()); if(!couplingSet) { gs = abs(outgoingVertexS_[inter]->norm()); couplingSet = true; } Complex diag = 0.; for(auto vertex : vertex_) diag += vertex->evaluate(scale,vector3_[iv],scalarInter,swave3_); for(unsigned int ix=0;ixdataPtr()->coloured() && inter==ShowerInteraction::QCD) || (decay[ivect]->dataPtr()->charged() && inter==ShowerInteraction::QED) ) { assert(outgoingVertexV_[inter]); // ensure you get correct outgoing particle from first vertex tcPDPtr off = decay[ivect]->dataPtr(); if(off->CC()) off = off->CC(); VectorWaveFunction vectorInter = outgoingVertexV_[inter]->evaluate(scale,3,off,gluon_[2*ig], vector3_[iv],decay[ivect]->mass()); assert(vector3_[iv].particle()->id()==vectorInter.particle()->id()); if(!couplingSet) { gs = abs(outgoingVertexV_[inter]->norm()); couplingSet = true; } Complex diag = 0.; for(auto vertex : vertex_) diag += vertex->evaluate(scale,vectorInter,scal,swave3_); for(unsigned int ix=0;ixevaluate(scale, gluon_[2*ig], vector3_[iv], scal, swave3_); for(unsigned int ix=0;ixcontract(*ME[iy],rho3_)).real(); } } // divide by alpha_(S,EM) output*=(4.*Constants::pi)/sqr(gs); #ifdef GAUGE_CHECK double ratio = output/total; if(abs(ratio)>1e-20) { generator()->log() << "Test of gauge invariance in decay\n" << inpart << "\n"; for(unsigned int ix=0;ixlog() << *decay[ix] << "\n"; generator()->log() << "Test of gauge invariance " << ratio << "\n"; } #endif // return the answer return output; } diff --git a/Decay/General/SSVDecayer.h b/Decay/General/SSVDecayer.h --- a/Decay/General/SSVDecayer.h +++ b/Decay/General/SSVDecayer.h @@ -1,233 +1,228 @@ // -*- C++ -*- // // SSVDecayer.h is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2019 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_SSVDecayer_H #define HERWIG_SSVDecayer_H // // This is the declaration of the SSVDecayer class. // #include "GeneralTwoBodyDecayer.h" #include "ThePEG/Helicity/Vertex/Scalar/VSSVertex.h" #include "ThePEG/Helicity/Vertex/Vector/VVVVertex.h" #include "ThePEG/Helicity/Vertex/Scalar/VVSSVertex.h" #include "ThePEG/Repository/EventGenerator.h" namespace Herwig { using namespace ThePEG; using Helicity::VSSVertexPtr; /** \ingroup Decay * The SSVDecayer class implements the decay of a scalar to a vector * and a scalar in a general model. It holds an VSSVertex pointer * that must be typecast from the VertexBase pointer held in * GeneralTwoBodyDecayer. It implents the virtual functions me2() and * partialWidth(). * * @see GeneralTwoBodyDecayer */ class SSVDecayer: public GeneralTwoBodyDecayer { public: /** * The default constructor. */ SSVDecayer() {} /** @name Virtual functions required by the Decayer class. */ //@{ /** * Return the matrix element squared for a given mode and phase-space channel. * @param ichan The channel we are calculating the matrix element for. * @param part The decaying Particle. * @param outgoing The particles produced in the decay * @param momenta The momenta of the particles produced in the decay * @param meopt Option for the calculation of the matrix element * @return The matrix element squared for the phase-space configuration. */ double me2(const int ichan,const Particle & part, const tPDVector & outgoing, const vector & momenta, MEOption meopt) const; /** * Construct the SpinInfos for the particles produced in the decay */ virtual void constructSpinInfo(const Particle & part, ParticleVector outgoing) const; /** * Function to return partial Width * @param inpart The decaying particle. * @param outa One of the decay products. * @param outb The other decay product. */ virtual Energy partialWidth(PMPair inpart, PMPair outa, PMPair outb) const; /** * Has a POWHEG style correction */ virtual POWHEGType hasPOWHEGCorrection() { POWHEGType output = FSR; for(auto vertex : vertex_) { if(vertex->orderInAllCouplings()!=1) { output = No; break; } } return output; } /** * Three-body matrix element including additional QCD radiation */ virtual double threeBodyME(const int , const Particle & inpart, const ParticleVector & decay, ShowerInteraction inter, MEOption meopt); /** * Set the information on the decay */ virtual void setDecayInfo(PDPtr incoming, PDPair outgoing, vector, map &, const vector > &, map); //@} 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. */ 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: /** * The assignment operator is private and must never be called. * In fact, it should not even be implemented. */ SSVDecayer & operator=(const SSVDecayer &) = delete; private: /** * Abstract pointer to AbstractFFVVertex */ vector vertex_; - - /** - * Pointer to the perturbative vertex - */ - vector perturbativeVertex_; /** * Abstract pointer to AbstractVSSVertex for QCD radiation from incoming scalar */ map incomingVertex_; /** * Abstract pointer to AbstractVSSVertex for QCD radiation from outgoing scalar */ map outgoingVertexS_; /** * Abstract pointer to AbstractVVVVertex for QCD radiation from outgoing vector */ map outgoingVertexV_; /** * Abstract pointer to AbstractVVSSVertex for QCD radiation from 4 point vertex */ map fourPointVertex_; /** * Spinor density matrix */ mutable RhoDMatrix rho_; /** * Scalar wavefunction */ mutable Helicity::ScalarWaveFunction swave_; /** * Vector wavefunction */ mutable vector vector_; /** * Spin density matrix for 3 body decay */ mutable RhoDMatrix rho3_; /** * Scalar wavefunction for 3 body decay */ mutable Helicity::ScalarWaveFunction swave3_; /** * Scalar wavefunction for 3 body decay */ mutable Helicity::ScalarWaveFunction scal_; /** * Vector wavefunction for 3 body decay */ mutable vector vector3_; /** * Vector wavefunction for 3 body decay */ mutable vector gluon_; }; } #endif /* HERWIG_SSVDecayer_H */ diff --git a/MatrixElement/Matchbox/Matching/ShowerApproximation.cc b/MatrixElement/Matchbox/Matching/ShowerApproximation.cc --- a/MatrixElement/Matchbox/Matching/ShowerApproximation.cc +++ b/MatrixElement/Matchbox/Matching/ShowerApproximation.cc @@ -1,716 +1,718 @@ // -*- C++ -*- // // ShowerApproximation.cc is a part of Herwig - A multi-purpose Monte Carlo event generator // Copyright (C) 2002-2019 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 ShowerApproximation class. // #include "ShowerApproximation.h" #include "ThePEG/Interface/ClassDocumentation.h" #include "ThePEG/Interface/Switch.h" #include "ThePEG/Interface/Reference.h" #include "ThePEG/Interface/Parameter.h" #include "ThePEG/EventRecord/Particle.h" #include "ThePEG/Repository/UseRandom.h" #include "ThePEG/Repository/EventGenerator.h" #include "ThePEG/Utilities/DescribeClass.h" #include "ThePEG/Persistency/PersistentOStream.h" #include "ThePEG/Persistency/PersistentIStream.h" #include "Herwig/MatrixElement/Matchbox/Dipoles/SubtractionDipole.h" #include "Herwig/MatrixElement/Matchbox/Phasespace/TildeKinematics.h" #include "Herwig/MatrixElement/Matchbox/Phasespace/InvertedTildeKinematics.h" using namespace Herwig; ShowerApproximation::ShowerApproximation() : HandlerBase(), theExtrapolationX(1.0), theBelowCutoff(false), theFFPtCut(1.0*GeV), theFFScreeningScale(ZERO), theFIPtCut(1.0*GeV), theFIScreeningScale(ZERO), theIIPtCut(1.0*GeV), theIIScreeningScale(ZERO), theSafeCut(0.0*GeV), theRestrictPhasespace(true), theHardScaleFactor(1.0), theRenormalizationScaleFactor(1.0), theFactorizationScaleFactor(1.0), theRealEmissionScaleInSubtraction(showerScale), theBornScaleInSubtraction(showerScale), theEmissionScaleInSubtraction(showerScale), theRealEmissionScaleInSplitting(showerScale), theBornScaleInSplitting(showerScale), theEmissionScaleInSplitting(showerScale), theRenormalizationScaleFreeze(1.*GeV), theFactorizationScaleFreeze(1.*GeV), maxPtIsMuF(false), theOpenZ(true) {} ShowerApproximation::~ShowerApproximation() {} void ShowerApproximation::setLargeNBasis() { assert(dipole()->realEmissionME()->matchboxAmplitude()); if ( !dipole()->realEmissionME()->matchboxAmplitude()->treeAmplitudes() ) return; if ( !theLargeNBasis ) { if ( !dipole()->realEmissionME()->matchboxAmplitude()->colourBasis() ) throw Exception() << "ShowerApproximation::setLargeNBasis(): Expecting a colour basis object." << Exception::runerror; theLargeNBasis = dipole()->realEmissionME()->matchboxAmplitude()->colourBasis()->cloneMe(); theLargeNBasis->clear(); theLargeNBasis->doLargeN(); } } void ShowerApproximation::setDipole(Ptr::tptr dip) { theDipole = dip; setLargeNBasis(); } Ptr::tptr ShowerApproximation::dipole() const { return theDipole; } Ptr::tptr ShowerApproximation::showerTildeKinematics() const { return Ptr::tptr(); } Ptr::tptr ShowerApproximation::showerInvertedTildeKinematics() const { return Ptr::tptr(); } void ShowerApproximation::checkCutoff() { assert(!showerTildeKinematics()); } void ShowerApproximation::getShowerVariables() { // check for the cutoff dipole()->isAboveCutoff(isAboveCutoff()); // get the hard scale dipole()->showerHardScale(hardScale()); // set the shower scale and variables for completeness dipole()->showerScale(dipole()->lastPt()); dipole()->showerParameters().resize(1); dipole()->showerParameters()[0] = dipole()->lastZ(); // check for phase space dipole()->isInShowerPhasespace(isInShowerPhasespace()); } bool ShowerApproximation::isAboveCutoff() const { if ( dipole()->bornEmitter() > 1 && dipole()->bornSpectator() > 1 ) { return dipole()->lastPt() >= max(ffPtCut(),safeCut()); } else if ( ( dipole()->bornEmitter() > 1 && dipole()->bornSpectator() < 2 ) || ( dipole()->bornEmitter() < 2 && dipole()->bornSpectator() > 1 ) ) { return dipole()->lastPt() >= max(fiPtCut(),safeCut()); } else { assert(dipole()->bornEmitter() < 2 && dipole()->bornSpectator() < 2); return dipole()->lastPt() >= max(iiPtCut(),safeCut()); } return true; } Energy ShowerApproximation::hardScale() const { if ( !maxPtIsMuF ) { if ( !bornCXComb()->mePartonData()[0]->coloured() && !bornCXComb()->mePartonData()[1]->coloured() ) { Energy maxPt = (bornCXComb()->meMomenta()[0] + bornCXComb()->meMomenta()[1]).m(); maxPt *= hardScaleFactor(); return maxPt; } Energy maxPt = generator()->maximumCMEnergy(); vector::const_iterator p = bornCXComb()->meMomenta().begin() + 2; cPDVector::const_iterator pp = bornCXComb()->mePartonData().begin() + 2; for ( ; p != bornCXComb()->meMomenta().end(); ++p, ++pp ) if ( (**pp).coloured() ) maxPt = min(maxPt,p->mt()); if ( maxPt == generator()->maximumCMEnergy() ) maxPt = (bornCXComb()->meMomenta()[0] + bornCXComb()->meMomenta()[1]).m(); maxPt *= hardScaleFactor(); return maxPt; } else { return hardScaleFactor()*sqrt(bornCXComb()->lastShowerScale()); } } bool ShowerApproximation::isInShowerPhasespace() const { if ( !dipole()->isAboveCutoff() ) return false; if ( !restrictPhasespace() ) return true; InvertedTildeKinematics& kinematics = const_cast(*dipole()->invertedTildeKinematics()); tcStdXCombPtr tmpreal = kinematics.realXComb(); tcStdXCombPtr tmpborn = kinematics.bornXComb(); Ptr::tptr tmpdip = kinematics.dipole(); Energy hard = dipole()->showerHardScale(); Energy pt = dipole()->lastPt(); double z = dipole()->lastZ(); pair zbounds(0.,1.); kinematics.dipole(const_ptr_cast::tptr>(theDipole)); kinematics.prepare(realCXComb(),bornCXComb()); if ( pt > hard ) { kinematics.dipole(tmpdip); kinematics.prepare(tmpreal,tmpborn); return false; } try { zbounds = kinematics.zBounds(pt,openZ() ? kinematics.ptMax() : hard); } catch(...) { kinematics.dipole(tmpdip); kinematics.prepare(tmpreal,tmpborn); throw; } kinematics.dipole(tmpdip); kinematics.prepare(tmpreal,tmpborn); return z > zbounds.first && z < zbounds.second; } Energy2 ShowerApproximation::showerEmissionScale() const { Energy2 mur = sqr(dipole()->lastPt()); if ( dipole()->bornEmitter() > 1 && dipole()->bornSpectator() > 1 ) { return mur + sqr(ffScreeningScale()); } else if ( ( dipole()->bornEmitter() > 1 && dipole()->bornSpectator() < 2 ) || ( dipole()->bornEmitter() < 2 && dipole()->bornSpectator() > 1 ) ) { return mur + sqr(fiScreeningScale()); } else { assert(dipole()->bornEmitter() < 2 && dipole()->bornSpectator() < 2); return mur + sqr(iiScreeningScale()); } return mur; } Energy2 ShowerApproximation::bornRenormalizationScale() const { return sqr(dipole()->underlyingBornME()->renormalizationScaleFactor()) * dipole()->underlyingBornME()->renormalizationScale(); } Energy2 ShowerApproximation::bornFactorizationScale() const { return sqr(dipole()->underlyingBornME()->factorizationScaleFactor()) * dipole()->underlyingBornME()->factorizationScale(); } Energy2 ShowerApproximation::realRenormalizationScale() const { return sqr(dipole()->realEmissionME()->renormalizationScaleFactor()) * dipole()->realEmissionME()->renormalizationScale(); } Energy2 ShowerApproximation::realFactorizationScale() const { return sqr(dipole()->realEmissionME()->factorizationScaleFactor()) * dipole()->realEmissionME()->factorizationScale(); } double ShowerApproximation::bornPDFWeight(Energy2 muf) const { if ( !bornCXComb()->mePartonData()[0]->coloured() && !bornCXComb()->mePartonData()[1]->coloured() ) return 1.; if ( muf < sqr(theFactorizationScaleFreeze) ) muf = sqr(theFactorizationScaleFreeze); double pdfweight = 1.; if ( bornCXComb()->mePartonData()[0]->coloured() && dipole()->underlyingBornME()->havePDFWeight1() ) pdfweight *= dipole()->underlyingBornME()->pdf1(muf,theExtrapolationX); if ( bornCXComb()->mePartonData()[1]->coloured() && dipole()->underlyingBornME()->havePDFWeight2() ) pdfweight *= dipole()->underlyingBornME()->pdf2(muf,theExtrapolationX); return pdfweight; } double ShowerApproximation::realPDFWeight(Energy2 muf) const { if ( !realCXComb()->mePartonData()[0]->coloured() && !realCXComb()->mePartonData()[1]->coloured() ) return 1.; if ( muf < sqr(theFactorizationScaleFreeze) ) muf = sqr(theFactorizationScaleFreeze); double pdfweight = 1.; if ( realCXComb()->mePartonData()[0]->coloured() && dipole()->realEmissionME()->havePDFWeight1() ) pdfweight *= dipole()->realEmissionME()->pdf1(muf,theExtrapolationX); if ( realCXComb()->mePartonData()[1]->coloured() && dipole()->realEmissionME()->havePDFWeight2() ) pdfweight *= dipole()->realEmissionME()->pdf2(muf,theExtrapolationX); return pdfweight; } double ShowerApproximation::scaleWeight(int rScale, int bScale, int eScale) const { double emissionAlpha = 1.; Energy2 emissionScale = ZERO; Energy2 showerscale = ZERO; if ( eScale == showerScale || bScale == showerScale || eScale == showerScale ) { showerscale = showerRenormalizationScale(); if ( showerscale < sqr(theRenormalizationScaleFreeze) ) showerscale = sqr(theFactorizationScaleFreeze); } if ( eScale == showerScale ) { emissionAlpha = SM().alphaS(showerscale); emissionScale = showerFactorizationScale(); } else if ( eScale == realScale ) { emissionAlpha = dipole()->realEmissionME()->lastXComb().lastAlphaS(); emissionScale = dipole()->realEmissionME()->lastScale(); } else if ( eScale == bornScale ) { emissionAlpha = dipole()->underlyingBornME()->lastXComb().lastAlphaS(); emissionScale = dipole()->underlyingBornME()->lastScale(); } double emissionPDF = realPDFWeight(emissionScale); double couplingFactor = 1.; if ( bScale != rScale ) { double bornAlpha = 1.; if ( bScale == showerScale ) { bornAlpha = SM().alphaS(showerscale); } else if ( bScale == realScale ) { bornAlpha = dipole()->realEmissionME()->lastXComb().lastAlphaS(); } else if ( bScale == bornScale ) { bornAlpha = dipole()->underlyingBornME()->lastXComb().lastAlphaS(); } double realAlpha = 1.; if ( rScale == showerScale ) { realAlpha = SM().alphaS(showerscale); } else if ( rScale == realScale ) { realAlpha = dipole()->realEmissionME()->lastXComb().lastAlphaS(); } else if ( rScale == bornScale ) { realAlpha = dipole()->underlyingBornME()->lastXComb().lastAlphaS(); } couplingFactor *= pow(realAlpha/bornAlpha,(double)(dipole()->underlyingBornME()->orderInAlphaS())); } Energy2 hardScale = ZERO; if ( bScale == showerScale ) { hardScale = showerFactorizationScale(); } else if ( bScale == realScale ) { hardScale = dipole()->realEmissionME()->lastScale(); } else if ( bScale == bornScale ) { hardScale = dipole()->underlyingBornME()->lastScale(); } double bornPDF = bornPDFWeight(hardScale); - if ( bornPDF < 1e-8 ) + if ( abs(bornPDF) < 1e-8 ) bornPDF = 0.0; - if ( emissionPDF < 1e-8 ) + if ( abs(emissionPDF) < 1e-8 ) emissionPDF = 0.0; if ( emissionPDF == 0.0 || bornPDF == 0.0 ) return 0.0; + double pdfRatio = emissionPDF/bornPDF; + pdfRatio = min(abs(pdfRatio),100000.); + return - emissionAlpha * emissionPDF * - couplingFactor / bornPDF; + emissionAlpha * pdfRatio * couplingFactor; } double ShowerApproximation::channelWeight(int emitter, int emission, int spectator, int) const { double cfac = 1.; double Nc = generator()->standardModel()->Nc(); if (realCXComb()->mePartonData()[emitter]->iColour() == PDT::Colour8){ if (realCXComb()->mePartonData()[emission]->iColour() == PDT::Colour8) cfac = Nc; else if ( realCXComb()->mePartonData()[emission]->iColour() == PDT::Colour3 || realCXComb()->mePartonData()[emission]->iColour() == PDT::Colour3bar) cfac = 0.5; else assert(false); } else if ((realCXComb()->mePartonData()[emitter] ->iColour() == PDT::Colour3 || realCXComb()->mePartonData()[emitter] ->iColour() == PDT::Colour3bar)) cfac = (sqr(Nc)-1.)/(2.*Nc); else assert(false); // do the most simple thing for the time being; needs fixing later if ( realCXComb()->mePartonData()[emission]->id() == ParticleID::g ) { Energy2 pipk = realCXComb()->meMomenta()[emitter] * realCXComb()->meMomenta()[spectator]; Energy2 pipj = realCXComb()->meMomenta()[emitter] * realCXComb()->meMomenta()[emission]; Energy2 pjpk = realCXComb()->meMomenta()[emission] * realCXComb()->meMomenta()[spectator]; return cfac *GeV2 * pipk / ( pipj * ( pipj + pjpk ) ); } return cfac * GeV2 / (realCXComb()->meMomenta()[emitter] * realCXComb()->meMomenta()[emission]); } double ShowerApproximation::channelWeight() const { double currentChannel = channelWeight(dipole()->realEmitter(), dipole()->realEmission(), dipole()->realSpectator(), dipole()->bornEmitter()); if ( currentChannel == 0. ) return 0.; double sum = 0.; for ( vector::tptr>::const_iterator dip = dipole()->partnerDipoles().begin(); dip != dipole()->partnerDipoles().end(); ++dip ) sum += channelWeight((**dip).realEmitter(), (**dip).realEmission(), (**dip).realSpectator(), (**dip).bornEmitter()); assert(sum > 0.0); return currentChannel / sum; } // If needed, insert default implementations of virtual function defined // in the InterfacedBase class here (using ThePEG-interfaced-impl in Emacs). void ShowerApproximation::doinit() { if ( profileScales() ) { if ( profileScales()->unrestrictedPhasespace() && restrictPhasespace() ) { generator()->log() << "ShowerApproximation warning: The scale profile chosen requires an unrestricted phase space,\n" << "however, the phase space was set to be restricted. Will switch to unrestricted phase space.\n" << flush; restrictPhasespace(false); } } HandlerBase::doinit(); } void ShowerApproximation::persistentOutput(PersistentOStream & os) const { os << theLargeNBasis << theBornXComb << theRealXComb << theTildeXCombs << theDipole << theBelowCutoff << ounit(theFFPtCut,GeV) << ounit(theFFScreeningScale,GeV) << ounit(theFIPtCut,GeV) << ounit(theFIScreeningScale,GeV) << ounit(theIIPtCut,GeV) << ounit(theIIScreeningScale,GeV) << ounit(theSafeCut,GeV) << theRestrictPhasespace << theHardScaleFactor << theRenormalizationScaleFactor << theFactorizationScaleFactor << theExtrapolationX << theRealEmissionScaleInSubtraction << theBornScaleInSubtraction << theEmissionScaleInSubtraction << theRealEmissionScaleInSplitting << theBornScaleInSplitting << theEmissionScaleInSplitting << ounit(theRenormalizationScaleFreeze,GeV) << ounit(theFactorizationScaleFreeze,GeV) << maxPtIsMuF << theHardScaleProfile << theOpenZ; } void ShowerApproximation::persistentInput(PersistentIStream & is, int) { is >> theLargeNBasis >> theBornXComb >> theRealXComb >> theTildeXCombs >> theDipole >> theBelowCutoff >> iunit(theFFPtCut,GeV) >> iunit(theFFScreeningScale,GeV) >> iunit(theFIPtCut,GeV) >> iunit(theFIScreeningScale,GeV) >> iunit(theIIPtCut,GeV) >> iunit(theIIScreeningScale,GeV) >> iunit(theSafeCut,GeV) >> theRestrictPhasespace >> theHardScaleFactor >> theRenormalizationScaleFactor >> theFactorizationScaleFactor >> theExtrapolationX >> theRealEmissionScaleInSubtraction >> theBornScaleInSubtraction >> theEmissionScaleInSubtraction >> theRealEmissionScaleInSplitting >> theBornScaleInSplitting >> theEmissionScaleInSplitting >> iunit(theRenormalizationScaleFreeze,GeV) >> iunit(theFactorizationScaleFreeze,GeV) >> maxPtIsMuF >> theHardScaleProfile >> theOpenZ; } // *** Attention *** The following static variable is needed for the type // description system in ThePEG. Please check that the template arguments // are correct (the class and its base class), and that the constructor // arguments are correct (the class name and the name of the dynamically // loadable library where the class implementation can be found). DescribeAbstractClass describeHerwigShowerApproximation("Herwig::ShowerApproximation", "Herwig.so"); void ShowerApproximation::Init() { static ClassDocumentation documentation ("ShowerApproximation describes the shower emission to be used " "in NLO matching."); static Parameter interfaceFFPtCut ("FFPtCut", "Set the pt infrared cutoff", &ShowerApproximation::theFFPtCut, GeV, 1.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceFIPtCut ("FIPtCut", "Set the pt infrared cutoff", &ShowerApproximation::theFIPtCut, GeV, 1.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceIIPtCut ("IIPtCut", "Set the pt infrared cutoff", &ShowerApproximation::theIIPtCut, GeV, 1.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceSafeCut ("SafeCut", "Set the enhanced infrared cutoff for the Matching.", &ShowerApproximation::theSafeCut, GeV, 0.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceFFScreeningScale ("FFScreeningScale", "Set the screening scale", &ShowerApproximation::theFFScreeningScale, GeV, 0.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceFIScreeningScale ("FIScreeningScale", "Set the screening scale", &ShowerApproximation::theFIScreeningScale, GeV, 0.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Parameter interfaceIIScreeningScale ("IIScreeningScale", "Set the screening scale", &ShowerApproximation::theIIScreeningScale, GeV, 0.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); static Switch interfaceRestrictPhasespace ("RestrictPhasespace", "Switch on or off phasespace restrictions", &ShowerApproximation::theRestrictPhasespace, true, false, false); static SwitchOption interfaceRestrictPhasespaceYes (interfaceRestrictPhasespace, "Yes", "Perform phasespace restrictions", true); static SwitchOption interfaceRestrictPhasespaceNo (interfaceRestrictPhasespace, "No", "Do not perform phasespace restrictions", false); static Parameter interfaceHardScaleFactor ("HardScaleFactor", "The hard scale factor.", &ShowerApproximation::theHardScaleFactor, 1.0, 0.0, 0, false, false, Interface::lowerlim); static Parameter interfaceRenormalizationScaleFactor ("RenormalizationScaleFactor", "The hard scale factor.", &ShowerApproximation::theRenormalizationScaleFactor, 1.0, 0.0, 0, false, false, Interface::lowerlim); static Parameter interfaceFactorizationScaleFactor ("FactorizationScaleFactor", "The hard scale factor.", &ShowerApproximation::theFactorizationScaleFactor, 1.0, 0.0, 0, false, false, Interface::lowerlim); static Parameter interfaceExtrapolationX ("ExtrapolationX", "The x from which on extrapolation should be performed.", &ShowerApproximation::theExtrapolationX, 1.0, 0.0, 1.0, false, false, Interface::limited); static Switch interfaceRealEmissionScaleInSubtraction ("RealEmissionScaleInSubtraction", "Set the scale choice for the real emission cross section in the matching subtraction.", &ShowerApproximation::theRealEmissionScaleInSubtraction, showerScale, false, false); static SwitchOption interfaceRealEmissionScaleInSubtractionRealScale (interfaceRealEmissionScaleInSubtraction, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceRealEmissionScaleInSubtractionBornScale (interfaceRealEmissionScaleInSubtraction, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceRealEmissionScaleInSubtractionShowerScale (interfaceRealEmissionScaleInSubtraction, "ShowerScale", "Use the shower scale", showerScale); interfaceRealEmissionScaleInSubtraction.rank(-1); static Switch interfaceBornScaleInSubtraction ("BornScaleInSubtraction", "Set the scale choice for the Born cross section in the matching subtraction.", &ShowerApproximation::theBornScaleInSubtraction, showerScale, false, false); static SwitchOption interfaceBornScaleInSubtractionRealScale (interfaceBornScaleInSubtraction, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceBornScaleInSubtractionBornScale (interfaceBornScaleInSubtraction, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceBornScaleInSubtractionShowerScale (interfaceBornScaleInSubtraction, "ShowerScale", "Use the shower scale", showerScale); interfaceBornScaleInSubtraction.rank(-1); static Switch interfaceEmissionScaleInSubtraction ("EmissionScaleInSubtraction", "Set the scale choice for the emission in the matching subtraction.", &ShowerApproximation::theEmissionScaleInSubtraction, showerScale, false, false); static SwitchOption interfaceEmissionScaleInSubtractionRealScale (interfaceEmissionScaleInSubtraction, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceEmissionScaleInSubtractionEmissionScale (interfaceEmissionScaleInSubtraction, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceEmissionScaleInSubtractionShowerScale (interfaceEmissionScaleInSubtraction, "ShowerScale", "Use the shower scale", showerScale); interfaceEmissionScaleInSubtraction.rank(-1); static Switch interfaceRealEmissionScaleInSplitting ("RealEmissionScaleInSplitting", "Set the scale choice for the real emission cross section in the splitting.", &ShowerApproximation::theRealEmissionScaleInSplitting, showerScale, false, false); static SwitchOption interfaceRealEmissionScaleInSplittingRealScale (interfaceRealEmissionScaleInSplitting, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceRealEmissionScaleInSplittingBornScale (interfaceRealEmissionScaleInSplitting, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceRealEmissionScaleInSplittingShowerScale (interfaceRealEmissionScaleInSplitting, "ShowerScale", "Use the shower scale", showerScale); interfaceRealEmissionScaleInSplitting.rank(-1); static Switch interfaceBornScaleInSplitting ("BornScaleInSplitting", "Set the scale choice for the Born cross section in the splitting.", &ShowerApproximation::theBornScaleInSplitting, showerScale, false, false); static SwitchOption interfaceBornScaleInSplittingRealScale (interfaceBornScaleInSplitting, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceBornScaleInSplittingBornScale (interfaceBornScaleInSplitting, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceBornScaleInSplittingShowerScale (interfaceBornScaleInSplitting, "ShowerScale", "Use the shower scale", showerScale); interfaceBornScaleInSplitting.rank(-1); static Switch interfaceEmissionScaleInSplitting ("EmissionScaleInSplitting", "Set the scale choice for the emission in the splitting.", &ShowerApproximation::theEmissionScaleInSplitting, showerScale, false, false); static SwitchOption interfaceEmissionScaleInSplittingRealScale (interfaceEmissionScaleInSplitting, "RealScale", "Use the real emission scale.", realScale); static SwitchOption interfaceEmissionScaleInSplittingEmissionScale (interfaceEmissionScaleInSplitting, "BornScale", "Use the Born scale.", bornScale); static SwitchOption interfaceEmissionScaleInSplittingShowerScale (interfaceEmissionScaleInSplitting, "ShowerScale", "Use the shower scale", showerScale); interfaceEmissionScaleInSplitting.rank(-1); static Parameter interfaceRenormalizationScaleFreeze ("RenormalizationScaleFreeze", "The freezing scale for the renormalization scale.", &ShowerApproximation::theRenormalizationScaleFreeze, GeV, 1.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); interfaceRenormalizationScaleFreeze.rank(-1); static Parameter interfaceFactorizationScaleFreeze ("FactorizationScaleFreeze", "The freezing scale for the factorization scale.", &ShowerApproximation::theFactorizationScaleFreeze, GeV, 1.0*GeV, 0.0*GeV, 0*GeV, false, false, Interface::lowerlim); interfaceFactorizationScaleFreeze.rank(-1); static Reference interfaceHardScaleProfile ("HardScaleProfile", "The hard scale profile to use.", &ShowerApproximation::theHardScaleProfile, false, false, true, true, false); static Reference interfaceLargeNBasis ("LargeNBasis", "Set the large-N colour basis implementation.", &ShowerApproximation::theLargeNBasis, false, false, true, true, false); interfaceLargeNBasis.rank(-1); static Switch interfaceMaxPtIsMuF ("MaxPtIsMuF", "", &ShowerApproximation::maxPtIsMuF, false, false, false); static SwitchOption interfaceMaxPtIsMuFYes (interfaceMaxPtIsMuF, "Yes", "", true); static SwitchOption interfaceMaxPtIsMuFNo (interfaceMaxPtIsMuF, "No", "", false); } diff --git a/Tests/Makefile.am b/Tests/Makefile.am --- a/Tests/Makefile.am +++ b/Tests/Makefile.am @@ -1,379 +1,379 @@ 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-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/EE{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg,-Merging}-{7.7,9.4,12,13,17,27.6,27.7,29,30.2,30.7,30,31.3,31.6,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.17,4.3,4.41,5.0,5.2,4.6,4.8,5.8,6.2,6.6,7.0,7.4,3.63,4.03,4.5,9.46,10.52,10.52-sym,10.54,10.58,10.45,10.47,10.6}.in) \ - $(shell echo Rivet/EE-{Upsilon,Upsilon2,Upsilon4,Upsilon4-asym,JPsi,Psi2S,Tau,Phi,Lambdac,Omega-Meson,Omega-Baryon,Eta,Xi0,Xic0,Omegac0,Xim}.in) \ + $(shell echo Rivet/EE{,-Powheg,-Matchbox,-Dipole,-Dipole-MCatNLO,-Dipole-Matchbox-Powheg,-Matchbox-Powheg}-{2.2,2.6,3.0,3.2,4.17,4.3,4.41,5.0,5.2,4.6,4.8,5.8,6.2,6.6,7.0,7.4,3.63,4.03,4.5,8.8,9.27,9.46,9.51,10.52,10.52-sym,10.54,10.58,10.45,10.47,10.6}.in) \ + $(shell echo Rivet/EE-{Upsilon,Upsilon2,Upsilon3,Upsilon4,Upsilon4-asym,JPsi,Psi2S,Tau,Phi,Lambdac,Omega-Meson,Omega-Baryon,Eta,Xi0,Xic0,Omegac0,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-{{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}-2760-Jets-{1..3}.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}-{53,63,200,500,546,900}-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,13}-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,-Dipole}-{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{,-Dipole}-{30,44,53,62}-UE.in Rivet/EHS{,-Dipole}-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-EE-Gamma: Rivet-EE-Gamma/done touch $@ 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-EE : Rivet-EE/done touch $@ Rivet-EE/done : $(shell echo Rivet{,-Powheg}-EE-{7.7,9.4,12,13,14,14.8,17,27.6,27.7,29,30.2,30.7,30,31.3,31.6,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,10.6,2.2,2.6,3.0,3.2,4.6,4.8,5.8,6.2,6.6,7.0,7.4,3.63,4.03,4.17,4.3,4.41,5.0,5.2,4.5,9.46,10.54,10.58,10.45,10.47,Upsilon,Upsilon2,Upsilon4,Upsilon4-asym,Tau,Phi,Lambdac,Omega-Meson,Omega-Baryon,Eta,Xi0,Xic0,Omegac0,Xim,JPsi,Psi2S}.yoda) + $(shell echo Rivet-EE-{10.52,10.52-sym,10.6,2.2,2.6,3.0,3.2,4.6,4.8,5.8,6.2,6.6,7.0,7.4,3.63,4.03,4.17,4.3,4.41,5.0,5.2,4.5,8.8,9.27,9.46,9.51,10.54,10.58,10.45,10.47,Upsilon,Upsilon2,Upsilon3,Upsilon4,Upsilon4-asym,Tau,Phi,Lambdac,Omega-Meson,Omega-Baryon,Eta,Xi0,Xic0,Omegac0,Xim,JPsi,Psi2S}.yoda) rm -rf Rivet-EE python/merge-EE --with-gg --with-decay 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-LowEnergy-%.yoda: $(HWBUILD) -c .cache/$(subst .yoda,,$@) Rivet/$(subst .yoda,.in,$@) $(HWRUN) $(subst .yoda,.run,$@) Rivet-LowEnergy-%: args="--process "$(word 1,$(subst -, ,$(subst Rivet-LowEnergy-,,$@))); if [ -n "$(strip $(word 2,$(subst -, ,$(subst Rivet-LowEnergy-,,$@))))" ]; then args+=" --flavour "$(word 2,$(subst -, ,$(subst Rivet-LowEnergy-,,$@))); fi; OUTPUT=`python/LowEnergy.py $$args --non-perturbative --perturbative`; $(MAKE) $$OUTPUT NUMEVENTS=$${NUMEVENTS:-10000}; args="--process "$(word 1,$(subst -, ,$(subst Rivet-LowEnergy-,,$@))); plots=`python/LowEnergy.py $$args --plots`; python/mergeLowEnergy.py $(subst Rivet-LowEnergy-,,$@) $$plots; if [ -e LowEnergy-EE-NonPerturbative-$(subst Rivet-LowEnergy-,,$@).yoda ] && [ -e LowEnergy-EE-Perturbative-$(subst Rivet-LowEnergy-,,$@).yoda ]; then rivet-mkhtml -o Rivet-LowEnergy-$(subst Rivet-LowEnergy-,,$@) LowEnergy-EE-NonPerturbative-$(subst Rivet-LowEnergy-,,$@).yoda:"Non-Pert" LowEnergy-EE-Perturbative-$(subst Rivet-LowEnergy-,,$@).yoda:"Pert" $$plots; elif [ -e LowEnergy-EE-NonPerturbative-$(subst Rivet-LowEnergy-,,$@).yoda ]; then rivet-mkhtml -o Rivet-LowEnergy-$(subst Rivet-LowEnergy-,,$@) LowEnergy-EE-NonPerturbative-$(subst Rivet-LowEnergy-,,$@).yoda:"Non-Pert" $$plots; elif [ -e LowEnergy-EE-Perturbative-$(subst Rivet-LowEnergy-,,$@).yoda ]; then rivet-mkhtml -o Rivet-LowEnergy-$(subst Rivet-LowEnergy-,,$@) LowEnergy-EE-Perturbative-$(subst Rivet-LowEnergy-,,$@).yoda:"Pert" $$plots; fi Rivet-R: OUTPUT=`python/R.py --perturbative --non-perturbative`; $(MAKE) $$OUTPUT NUMEVENTS=$${NUMEVENTS:-10000}; plots=`python/R.py --perturbative --non-perturbative --plots`; python/mergeLowEnergy.py R $$plots; rivet-mkhtml -o Rivet-R LowEnergy-EE-Perturbative-R.yoda:"Pert" LowEnergy-EE-NonPerturbative-R.yoda:"Non-Pert" $$plots 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 $@ Rivet-SppS/done : $(shell echo Rivet-SppS-{53,63,200,500,546,900}-UE.yoda ) \ $(shell echo Rivet-ISR-{30,44,53,62}-UE.yoda ) Rivet-EHS-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-{{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,13}-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 anatohepmc.txt hepmctoana.txt rm -rf Rivet-* distclean-local: rm -rf .cache diff --git a/Tests/Rivet/EE/EE-10.47.in b/Tests/Rivet/EE/EE-10.47.in --- a/Tests/Rivet/EE/EE-10.47.in +++ b/Tests/Rivet/EE/EE-10.47.in @@ -1,11 +1,13 @@ # -*- 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 +# ARGUS charged particle multiplicity insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319102 +# ARGUS charm hadron production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1991_I315059 diff --git a/Tests/Rivet/EE/EE-10.52-sym.in b/Tests/Rivet/EE/EE-10.52-sym.in --- a/Tests/Rivet/EE/EE-10.52-sym.in +++ b/Tests/Rivet/EE/EE-10.52-sym.in @@ -1,22 +1,24 @@ # -*- 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 # CLEO D* polarization insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1998_I467595 # CLEO D* polarization insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1991_I314060 # CLEO D_1/D_2 decay insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1990_I281039 +# ARGUS Xi_c+ spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1990_I296522 diff --git a/Tests/Rivet/EE/EE-10.52.in b/Tests/Rivet/EE/EE-10.52.in --- a/Tests/Rivet/EE/EE-10.52.in +++ b/Tests/Rivet/EE/EE-10.52.in @@ -1,13 +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 -# BABAR Xi_c production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 diff --git a/Tests/Rivet/EE/EE-10.54.in b/Tests/Rivet/EE/EE-10.54.in --- a/Tests/Rivet/EE/EE-10.54.in +++ b/Tests/Rivet/EE/EE-10.54.in @@ -1,12 +1,14 @@ # -*- 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 +# BABAR Xi_c production insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 +# BABAR Lambda_c production insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_S6895344 -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1238276 \ No newline at end of file +# BABAR pions, kaons and protons +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2013_I1238276 diff --git a/Tests/Rivet/EE/EE-10.58.in b/Tests/Rivet/EE/EE-10.58.in --- a/Tests/Rivet/EE/EE-10.58.in +++ b/Tests/Rivet/EE/EE-10.58.in @@ -1,12 +1,12 @@ # -*- 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 distributions -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2019_I1718551 +#insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2019_I1718551 # BABAR Xi_c production insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 diff --git a/Tests/Rivet/EE/EE-10.6.in b/Tests/Rivet/EE/EE-10.6.in --- a/Tests/Rivet/EE/EE-10.6.in +++ b/Tests/Rivet/EE/EE-10.6.in @@ -1,13 +1,52 @@ # -*- ThePEG-repository -*- create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.3*GeV set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.3*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 -# ARGUS charm hadron production -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1991_I315059 # BELLE Lambda polarization insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2019_I1687566 +# BELLE charmonium +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2002_I563840 +# CLEO Xi'_c production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1999_I478217 +# CLEO Xi_c production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1995_I404590 +# CLEO Xi_c1 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1999_I501417 +# CLEO D_s1 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1993_I352823 +# BABAR D_s1 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2011_I892421 +# BELLE D_s1 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2008_I762013 +# CLEO Lambda_c* production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1994_I381696 +# ARGUS Lambda_c* production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1997_I440304 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1993_I357132 +# CLEO Xi_c*0 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1995_I397770 +# CLEO Xi_c*+ production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1996_I416471 +# CLEO D_1+, D_2+ production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1994_I378319 +# CLEO D_10, D_20 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1994_I372349 +# ARGUS D_s2 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1995_I397794 +# CLEO Sigma_c* +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1997_I424575 +# CLEO Lambda_c +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1990_I298611 +# BABAR Omega_c spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_I746745 +# BABAR Xi'_c spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_I722622 +# BABAR J/Psi production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2001_I558091 +# BABAR D_s spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2002_I582184 diff --git a/Tests/Rivet/EE/EE-10.in b/Tests/Rivet/EE/EE-10.in --- a/Tests/Rivet/EE/EE-10.in +++ b/Tests/Rivet/EE/EE-10.in @@ -1,27 +1,33 @@ # -*- 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 # ARGUS D2 spectrum insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I268577 # ARGUS D1/D2 spectrum and decay angles insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I280943 # ARGUS sigma_c spectrum insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1988_I261672 # 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 # BABAR D hadron decays insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2010_I867611 # LHCB D hadron decays insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LHCB_2013_I1243156 +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 +# ARGUS thrust +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1986_I227324 +# ARGUS D_s1 production +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1989_I282570 diff --git a/Tests/Rivet/EE/EE-3.63.in b/Tests/Rivet/EE/EE-3.63.in --- a/Tests/Rivet/EE/EE-3.63.in +++ b/Tests/Rivet/EE/EE-3.63.in @@ -1,13 +1,14 @@ # -*- 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 insert /Herwig/Analysis/RivetAnalysis:Analyses 0 DASP_1979_I132045 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2016_I1384778 \ No newline at end of file diff --git a/Tests/Rivet/EE/EE-7.4.in b/Tests/Rivet/EE/EE-7.4.in --- a/Tests/Rivet/EE/EE-7.4.in +++ b/Tests/Rivet/EE/EE-7.4.in @@ -1,12 +1,14 @@ # -*- ThePEG-repository -*- ################################################## # LEP physics parameters (override defaults) ################################################## set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 7.4 set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 ################################################## # select the analyses ################################################## # Validated ################################################## insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MARKI_1976_I109792 +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 diff --git a/Tests/Rivet/EE/EE-8.8.in b/Tests/Rivet/EE/EE-8.8.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-8.8.in @@ -0,0 +1,13 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 8.8 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 2.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 diff --git a/Tests/Rivet/EE/EE-9.27.in b/Tests/Rivet/EE/EE-9.27.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-9.27.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 9.27 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 + diff --git a/Tests/Rivet/EE/EE-9.51.in b/Tests/Rivet/EE/EE-9.51.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-9.51.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +################################################## +# LEP physics parameters (override defaults) +################################################## +set /Herwig/Generators/EventGenerator:EventHandler:LuminosityFunction:Energy 9.51 +set /Herwig/Generators/EventGenerator:EventHandler:Cuts:MHatMin 9.0 +################################################## +# select the analyses +################################################## +# Validated +################################################## +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 + diff --git a/Tests/Rivet/EE/EE-Lambdac.in b/Tests/Rivet/EE/EE-Lambdac.in --- a/Tests/Rivet/EE/EE-Lambdac.in +++ b/Tests/Rivet/EE/EE-Lambdac.in @@ -1,16 +1,23 @@ # -*- 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 +# Lambda_c decays (Lambda Pi+) insert /Herwig/Analysis/RivetAnalysis:Analyses 0 FOCUS_2006_I693639 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1992_I319105 +# Lambda_c decays (Lambda Pi+ and Sigma+ Pi0) +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1995_I392704 +# Lambda_c decays (e+ nu_e) +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1994_I371613 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1994_I371611 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_2005_I668268 diff --git a/Tests/Rivet/EE/EE-Psi2S.in b/Tests/Rivet/EE/EE-Psi2S.in --- a/Tests/Rivet/EE/EE-Psi2S.in +++ b/Tests/Rivet/EE/EE-Psi2S.in @@ -1,21 +1,25 @@ # -*- 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 EventGenerator:EventHandler:LuminosityFunction:Energy 3.686097 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; /Herwig/Particles/psi(2S)/psi(2S)->Xi*-,Xi*bar+; +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; /Herwig/Particles/psi(2S)/psi(2S)->Xi*-,Xi*bar+; /Herwig/Particles/psi(2S)/psi(2S)->Jpsi,pi+,pi-; # 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 # psi(2S) -> xi*- insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2019_I1747092 +# MARKII psi(2s) -> J/Psi pi+pi- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MARKII_1979_I144382 +# BES psi(2s) -> J/Psi pi+pi- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BES_1999_I507637 diff --git a/Tests/Rivet/EE/EE-Upsilon.in b/Tests/Rivet/EE/EE-Upsilon.in --- a/Tests/Rivet/EE/EE-Upsilon.in +++ b/Tests/Rivet/EE/EE-Upsilon.in @@ -1,22 +1,31 @@ # -*- 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 +# CLEO eta' spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_2002_I601701 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOIII_2006_I728679 +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 +# ARGUS thrust +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1986_I227324 +# BABAR D*=/- spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2009_I836615 \ No newline at end of file diff --git a/Tests/Rivet/EE/EE-Upsilon2.in b/Tests/Rivet/EE/EE-Upsilon2.in --- a/Tests/Rivet/EE/EE-Upsilon2.in +++ b/Tests/Rivet/EE/EE-Upsilon2.in @@ -1,17 +1,23 @@ # -*- 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 +# LENA thrust and mult +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 LENA_1981_I164397 +# CUSB Upsilon 2S -> Upsilon 1S pi+pi- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CUSB_1984_I199809 +# CLEO Upsilon 2S -> Upsilon 1S pi+pi- +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1998_I467642 \ No newline at end of file diff --git a/Tests/Rivet/EE/EE-Upsilon3.in b/Tests/Rivet/EE/EE-Upsilon3.in new file mode 100644 --- /dev/null +++ b/Tests/Rivet/EE/EE-Upsilon3.in @@ -0,0 +1,14 @@ +# -*- ThePEG-repository -*- +create ThePEG::LuminosityFunction /Herwig/EventHandlers/BFactoryLuminosity +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxA 5.1776*GeV +set /Herwig/EventHandlers/BFactoryLuminosity:BeamEMaxB 5.1776*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(3S) +set /Herwig/MatrixElements/MEUpsilon:Coupling 74.96836 +set /Herwig/MatrixElements/SubProcess:MatrixElements 0 /Herwig/MatrixElements/MEUpsilon +# CLEO Upsilon 3S -> Upsilon pipi +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1994_I356001 diff --git a/Tests/Rivet/EE/EE-Upsilon4-asym.in b/Tests/Rivet/EE/EE-Upsilon4-asym.in --- a/Tests/Rivet/EE/EE-Upsilon4-asym.in +++ b/Tests/Rivet/EE/EE-Upsilon4-asym.in @@ -1,20 +1,20 @@ # -*- 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 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 # 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 # BELLE distributions -insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2019_I1718551 +#insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2019_I1718551 # BABAR Xi_c production insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2005_S6181155 diff --git a/Tests/Rivet/EE/EE-Upsilon4.in b/Tests/Rivet/EE/EE-Upsilon4.in --- a/Tests/Rivet/EE/EE-Upsilon4.in +++ b/Tests/Rivet/EE/EE-Upsilon4.in @@ -1,49 +1,77 @@ # -*- 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 # 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 # kaons in b decays insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1994_I354224 # charm hadrons in b decays insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2006_I719111 # phi spectrum insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2007_I728872 # D_s spectrum insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_2005_I1649168 # # 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_D_Dalitz -#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 MC_Meson_Meson_Leptons_Decay +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 MC_D_Dalitz +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 # ARGUS charm hadron production insert /Herwig/Analysis/RivetAnalysis:Analyses 0 ARGUS_1991_I315059 # BELLE B0 -> D* semi-leptonic insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2017_I1512299 +# BABAR D0 -> K- semi-leptonic +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_I1091435 +# BES-III D0 -> pi semi-leptonic +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BESIII_2018_I1655158 +# BABAR e- spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2017_I1498564 +# CLEO multiplicty in Upsilon(4S) decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1999_I504672 +# BELLE Upsilon(4S) -> pi+pi- Upsilon(1S) decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2009_I810744 +# BABAR Upsilon(4S) -> pi+pi- Upsilon(1,2S) decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2006_I714448 +# CLEO Xi_c spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_1997_I442910 +# CLEO baryon spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEO_1992_I315181 +# BABAR Omega_c spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_I746745 +# BABAR Xi'_c spectra +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2007_I722622 +# CLEO J/psi and psi(2s) in b decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_2002_I606309 +# BABAR eta' in b decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2004_I642355 +# BELLE eta in b decays +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BELLE_2010_I835104 +# BABAR D_s spectrum +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 BABAR_2002_I582184 diff --git a/Tests/Rivet/EE/EE-Xim.in b/Tests/Rivet/EE/EE-Xim.in --- a/Tests/Rivet/EE/EE-Xim.in +++ b/Tests/Rivet/EE/EE-Xim.in @@ -1,16 +1,17 @@ # -*- 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 +# asymmetry parameter in Xi decays insert /Herwig/Analysis/RivetAnalysis:Analyses 0 E756_2000_I530367 +insert /Herwig/Analysis/RivetAnalysis:Analyses 0 CLEOII_2000_I533575 diff --git a/Tests/python/LowEnergy.py b/Tests/python/LowEnergy.py --- a/Tests/python/LowEnergy.py +++ b/Tests/python/LowEnergy.py @@ -1,444 +1,467 @@ #! /usr/bin/env python import yoda,os,math,subprocess,optparse from string import Template # get the path for the rivet data p = subprocess.Popen(["rivet-config", "--datadir"],stdout=subprocess.PIPE) path=p.communicate()[0].strip() #Define the arguments op = optparse.OptionParser(usage=__doc__) op.add_option("--process" , dest="processes" , default=[], action="append") op.add_option("--path" , dest="path" , default=path) op.add_option("--non-perturbative", dest="nonPerturbative" , default=False, action="store_true") op.add_option("--perturbative" , dest="perturbative" , default=False, action="store_true") op.add_option("--dest" , dest="dest" , default="Rivet") op.add_option("--list" , dest="list" , default=False, action="store_true") op.add_option("--flavour" , dest="flavour" , default="All" ) op.add_option("--plots" , dest="plot" , default=False, action="store_true") opts, args = op.parse_args() path=opts.path thresholds = [0.7,2.*.5,2.*1.87,2.*5.28] # the list of analyses and processes analyses = { 'KK' : {}, 'PiPi' : {}, 'PPbar' : {}, "3Pi" : {}, "EtaprimePiPi" : {}, "4Pi" : {}, "EtaPhi" : {}, "EtaOmega" : {}, "2K1Pi" : {}, "2K2Pi" : {}, "4K" : {}, "6m" : {}, "EtaPiPi" : {}, "OmegaPi" : {}, "PiGamma" : {}, "EtaGamma" : {}, "PhiPi" : {}, "OmegaPiPi" : {}, "DD" : {}, "BB" : {}, - "5Pi" : {}, "LL" : {} } + "5Pi" : {}, "LL" : {}, "Baryon" : {} } # pi+pi- analyses["PiPi"]["KLOE_2009_I797438" ] = ["d02-x01-y01"] analyses["PiPi"]["KLOE_2005_I655225" ] = ["d02-x01-y01"] analyses["PiPi"]["KLOE2_2017_I1634981" ] = ["d01-x01-y01"] analyses["PiPi"]["BABAR_2009_I829441" ] = ["d01-x01-y01"] analyses["PiPi"]["DM1_1978_I134061" ] = ["d01-x01-y01"] analyses["PiPi"]["DM2_1989_I267118" ] = ["d01-x01-y01"] analyses["PiPi"]["CMD2_2007_I728302" ] = ["d02-x01-y01"] analyses["PiPi"]["CMD2_2006_I728191" ] = ["d03-x01-y01"] analyses["PiPi"]["BESIII_2016_I1385603"] = ["d01-x01-y01"] analyses["PiPi"]["SND_2005_I686349" ] = ["d01-x01-y01"] analyses["PiPi"]["CMD_1985_I221309" ] = ["d01-x01-y01","d02-x01-y01"] analyses["PiPi"]["CMD2_2002_I568807" ] = ["d01-x01-y02"] analyses["PiPi"]["CMD2_1999_I498859" ] = ["d01-x01-y01"] analyses['PiPi']["CLEOC_2005_I693873" ] = ["d01-x01-y01"] analyses['PiPi']["ND_1991_I321108" ] = ["d11-x01-y01"] analyses['PiPi']["OLYA_1984_I208231" ] = ["d01-x01-y01"] # K+K- and K_S^0 K_L^0 analyses['KK']["BESIII_2018_I1704558"] = ["d01-x01-y01"] analyses['KK']["BABAR_2013_I1238807" ] = ["d01-x01-y01"] analyses['KK']["DM1_1981_I156053" ] = ["d01-x01-y01"] analyses['KK']["DM1_1981_I156054" ] = ["d01-x01-y01"] analyses['KK']["CLEOC_2005_I693873" ] = ["d01-x01-y02"] analyses['KK']["BABAR_2015_I1383130" ] = ["d01-x01-y04"] analyses['KK']["DM2_1988_I262690" ] = ["d01-x01-y01"] analyses['KK']["SND_2007_I755881" ] = ["d01-x01-y01"] analyses['KK']["SND_2001_I533574" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03", "d02-x01-y01","d02-x01-y02","d02-x01-y03"] analyses['KK']["SND_2006_I720035" ] = ["d01-x01-y01"] analyses['KK']["BABAR_2014_I1287920" ] = ["d09-x01-y01"] analyses['KK']["CMD2_2003_I601222" ] = ["d01-x01-y01"] analyses['KK']["CMD3_2016_I1444990" ] = ["d01-x01-y06"] analyses['KK']["CMD2_1995_I406880" ] = ["d01-x01-y01","d01-x01-y02"] analyses['KK']["CMD2_1999_I502164" ] = ["d01-x01-y01","d02-x01-y01", "d03-x01-y01","d04-x01-y01"] analyses['KK']["CMD2_2008_I782516" ] = ["d01-x01-y01","d02-x01-y01"] analyses['KK']["ND_1991_I321108" ] = ["d12-x01-y01","d13-x01-y01"] analyses['KK']["OLYA_1981_I173076" ] = ["d01-x01-y01"] analyses['KK']["SND_2016_I1484677" ] = ["d01-x01-y01","d02-x01-y01"] # proton-antiproton analyses['PPbar']["BESIII_2019_I1736235"] = ["d01-x01-y01"] analyses['PPbar']["BESIII_2019_I1718337"] = ["d01-x01-y01"] analyses['PPbar']["BESIII_2015_I1358937"] = ["d01-x01-y05"] analyses['PPbar']["BABAR_2013_I1217421" ] = ["d01-x01-y01"] +analyses['PPbar']["BABAR_2013_I1247058" ] = ["d01-x01-y01"] analyses['PPbar']["SND_2014_I1321689" ] = ["d01-x01-y01","d02-x01-y01"] analyses['PPbar']["CMD3_2016_I1385598" ] = ["d01-x01-y06"] analyses['PPbar']["CLEOC_2005_I693873" ] = ["d01-x01-y03"] analyses['PPbar']["BABAR_2006_I700020" ] = ["d01-x01-y01","d02-x01-y01"] analyses['PPbar']["DM2_1983_I190558" ] = ["d01-x01-y01"] analyses["PPbar"]["DM2_1990_I297706" ] = ["d01-x01-y01"] analyses["PPbar"]["DM1_1979_I141565" ] = ["d01-x01-y01"] analyses["PPbar"]["FENICE_1998_I471263" ] = ["d01-x01-y01"] analyses["PPbar"]["FENICE_1994_I377833" ] = ["d01-x01-y01"] analyses['PPbar']["BESII_2005_I685906" ] = ["d01-x01-y01"] analyses['PPbar']["BESIII_2014_I1286898"] = ["d01-x01-y06"] # pi0 gamma analyses["PiGamma"]["SND_2018_I1694988"] = ["d01-x01-y01"] analyses["PiGamma"]["SND_2016_I1418483"] = ["d01-x01-y05"] analyses["PiGamma"]["SND_2003_I612867" ] = ["d01-x01-y01"] analyses["PiGamma"]["CMD2_2005_I658856"] = ["d02-x01-y01"] analyses["PiGamma"]["SND_2000_I524221" ] = ["d01-x01-y02"] # eta gamma analyses["EtaGamma"]["CMD2_2005_I658856" ] = ["d01-x01-y01"] analyses["EtaGamma"]["SND_2006_I717778" ] = ["d01-x01-y01","d02-x01-y01"] analyses["EtaGamma"]["SND_2014_I1275333" ] = ["d01-x01-y01"] analyses["EtaGamma"]["SND_2000_I524221" ] = ["d01-x01-y01"] analyses["EtaGamma"]["CMD2_1999_I503154" ] = ["d01-x01-y01"] analyses["EtaGamma"]["CMD2_2001_I554522" ] = ["d01-x01-y01"] analyses['EtaGamma']["CMD2_1995_I406880" ] = ["d01-x01-y04"] analyses['EtaGamma']["BABAR_2006_I716277"] = ["d01-x01-y01"] # 3 pion analyses["3Pi"]["BABAR_2004_I656680" ] = ["d01-x01-y01"] analyses["3Pi"]["BESIII_2019_I1773081" ] = ["d01-x01-y01"] analyses["3Pi"]["SND_2002_I582183" ] = ["d01-x01-y01"] analyses["3Pi"]["SND_2003_I619011" ] = ["d01-x01-y01"] analyses["3Pi"]["SND_1999_I508003" ] = ["d01-x01-y01"] analyses["3Pi"]["SND_2001_I533574" ] = ["d01-x01-y04","d02-x01-y04"] analyses["3Pi"]["CMD2_2000_I523691" ] = ["d01-x01-y01"] analyses["3Pi"]["CMD2_1998_I480170" ] = ["d01-x01-y01"] analyses['3Pi']["CMD2_1995_I406880" ] = ["d01-x01-y03"] analyses['3Pi']["DM2_1992_I339265" ] = ["d01-x01-y01"] analyses['3Pi']["DM1_1980_I140174" ] = ["d01-x01-y01"] analyses['3Pi']["ND_1991_I321108" ] = ["d05-x01-y01","d10-x01-y04"] analyses['3Pi']["GAMMAGAMMA_1981_I158474"] = ["d01-x01-y01"] analyses["3Pi"]["CLEO_2006_I691720" ] = ["d01-x01-y01"] analyses["3Pi"]["SND_2015_I1389908" ] = ["d01-x01-y01"] # eta pipi analyses["EtaPiPi"]["BABAR_2018_I1700745"] = ["d01-x01-y01","d02-x01-y01"] analyses["EtaPiPi"]["BABAR_2018_I1647139"] = ["d01-x01-y01"] analyses["EtaPiPi"]["SND_2015_I1332929" ] = ["d01-x01-y01"] analyses["EtaPiPi"]["SND_2018_I1638368" ] = ["d01-x01-y01"] analyses["EtaPiPi"]["BABAR_2007_I758568" ] = ["d01-x01-y01","d02-x01-y01"] analyses["EtaPiPi"]["CMD2_2000_I532970" ] = ["d02-x01-y01"] analyses["EtaPiPi"]["DM2_1988_I264144" ] = ["d01-x01-y01"] analyses['EtaPiPi']["ND_1991_I321108" ] = ["d06-x01-y01","d14-x01-y01"] analyses['EtaPiPi']["CMD3_2019_I1744510" ] = ["d02-x01-y01"] # eta' pipi analyses["EtaprimePiPi"]["BABAR_2007_I758568"] = ["d05-x01-y01","d06-x01-y01"] # Eta Phi analyses["EtaPhi"]["BABAR_2008_I765258" ] = ["d04-x01-y01","d05-x01-y01"] analyses["EtaPhi"]["BABAR_2007_I758568" ] = ["d08-x01-y01","d09-x01-y01"] analyses["EtaPhi"]["SND_2018_I1693737" ] = ["d01-x01-y01"] analyses["EtaPhi"]["BABAR_2017_I1511276" ] = ["d03-x01-y01"] analyses["EtaPhi"]["SND_2019_I1726419" ] = ["d01-x01-y01","d01-x01-y03"] analyses["EtaPhi"]["CMD3_2019_I1740541" ] = ["d01-x01-y06","d02-x01-y06","d03-x01-y06"] analyses["EtaPhi"]["CMD3_2017_I1606078" ] = ["d01-x01-y01"] analyses["EtaPhi"]["BABAR_2006_I709730" ] = ["d02-x01-y01"] analyses["EtaPhi"]["BESII_2008_I801210" ] = ["d01-x01-y03"] +analyses["EtaPhi"]["BABAR_2006_I731865" ] = ["d01-x01-y02"] +analyses["EtaPhi"]["BELLE_2009_I823878" ] = ["d01-x01-y01"] # Eta Omega analyses["EtaOmega"]["SND_2016_I1473343" ] = ["d01-x01-y01"] analyses["EtaOmega"]["BABAR_2006_I709730"] = ["d02-x01-y01"] analyses["EtaOmega"]["SND_2019_I1726419" ] = ["d01-x01-y01","d01-x01-y02"] analyses["EtaOmega"]["CMD3_2017_I1606078"] = ["d01-x01-y01","d01-x01-y02"] analyses["EtaOmega"]["BESII_2008_I801210" ] = ["d01-x01-y03"] # 4 pions analyses["4Pi"]["BABAR_2017_I1621593" ] = ["d01-x01-y01","d02-x01-y01"] analyses["4Pi"]["BABAR_2012_I1086164" ] = ["d01-x01-y01"] analyses["4Pi"]["CMD2_2000_I531667" ] = ["d01-x01-y01"] analyses["4Pi"]["CMD2_2004_I648023" ] = ["d01-x01-y01"] analyses["4Pi"]["BABAR_2005_I676691" ] = ["d01-x01-y01"] analyses["4Pi"]["CMD2_2000_I511375" ] = ["d01-x01-y01"] analyses["4Pi"]["CMD2_1999_I483994" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01"] analyses["4Pi"]["BESII_2008_I801210" ] = ["d01-x01-y01"] analyses["4Pi"]["KLOE_2008_I791841" ] = ["d01-x01-y01"] analyses['4Pi']["ND_1991_I321108" ] = ["d07-x01-y01","d08-x01-y01","d10-x01-y01","d10-x01-y02", "d01-x01-y01","d02-x01-y01","d03-x01-y01","d04-x01-y01","d10-x01-y03"] analyses['4Pi']["BESII_2007_I750713" ] = ["d01-x01-y03"] analyses['4Pi']["SND_2001_I579319" ] = ["d01-x01-y01","d02-x01-y01"] analyses['4Pi']["DM1_1982_I168552" ] = ["d01-x01-y01"] analyses['4Pi']["DM1_1979_I132828" ] = ["d01-x01-y01"] analyses['4Pi']["GAMMAGAMMA_1980_I153382"] = ["d01-x01-y01"] analyses['4Pi']["GAMMAGAMMA_1981_I158474"] = ["d01-x01-y02"] # (these are Omega(-> pi0 gamma) pi0) analyses["OmegaPi"]["SND_2016_I1489182" ] = ["d01-x01-y01"] analyses["OmegaPi"]["SND_2000_I527752" ] = ["d01-x01-y01"] analyses["OmegaPi"]["SND_2000_I503946" ] = ["d01-x01-y01"] analyses["OmegaPi"]["CMD2_2003_I616446" ] = ["d01-x01-y01"] # non Omega analyses["OmegaPi"]["SND_2002_I587084" ] = ["d01-x01-y01"] analyses["OmegaPi"]["CMD2_2004_I630009" ] = ["d01-x01-y01"] analyses["OmegaPi"]["KLOE_2008_I791841" ] = ["d02-x01-y01"] # from 4 Pion analyses["OmegaPi"]["CMD2_1999_I483994" ] = ["d03-x01-y01"] analyses['OmegaPi']["ND_1991_I321108" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01", "d04-x01-y01","d10-x01-y03"] # 5 pion and related analyses["OmegaPiPi"]["DM1_1981_I166964" ] = ["d01-x01-y01"] analyses["OmegaPiPi"]["DM2_1992_I339265" ] = ["d02-x01-y01"] analyses["OmegaPiPi"]["CMD2_2000_I532970" ] = ["d01-x01-y01"] analyses["OmegaPiPi"]["BABAR_2018_I1700745"] = ["d01-x01-y01","d03-x01-y01"] analyses["OmegaPiPi"]["BABAR_2007_I758568" ] = ["d01-x01-y01","d03-x01-y01","d04-x01-y01"] analyses['OmegaPiPi']["ND_1991_I321108" ] = ["d14-x01-y01"] analyses["5Pi"]["CMD2_2000_I532970" ] = ["d03-x01-y01"] analyses["5Pi"]["BABAR_2007_I758568" ] = ["d01-x01-y01"] analyses['5Pi']["ND_1991_I321108" ] = ["d14-x01-y01"] analyses['5Pi']["GAMMAGAMMA_1981_I158474" ] = ["d01-x01-y03"] analyses["5Pi"]["BABAR_2018_I1700745" ] = ["d01-x01-y01"] # 2K 1 pi analyses["2K1Pi"]["BABAR_2008_I765258" ] = ["d01-x01-y01","d02-x01-y01"] analyses["2K1Pi"]["DM1_1982_I176801" ] = ["d01-x01-y01"] analyses["2K1Pi"]["DM2_1991_I318558" ] = ["d01-x01-y01","d02-x01-y01"] analyses["2K1Pi"]["BESII_2008_I801208" ] = ["d01-x01-y01"] analyses["2K1Pi"]["SND_2018_I1637194" ] = ["d01-x01-y01"] analyses["2K1Pi"]["BESIII_2018_I1691798"] = ["d01-x01-y01"] analyses["2K1Pi"]["BABAR_2017_I1511276" ] = ["d01-x01-y01"] analyses["PhiPi"]["BABAR_2017_I1511276" ] = ["d01-x01-y01","d02-x01-y01"] analyses["PhiPi"]["BABAR_2008_I765258" ] = ["d02-x01-y01","d03-x01-y01"] # 2K 2 pi analyses["2K2Pi"]["DM1_1982_I169382" ] = ["d01-x01-y01"] analyses["2K2Pi"]["BABAR_2005_I676691" ] = ["d02-x01-y01"] analyses["2K2Pi"]["BABAR_2014_I1287920" ] = ["d09-x01-y01","d10-x01-y01","d11-x01-y01"] analyses["2K2Pi"]["BABAR_2012_I892684" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01", "d04-x01-y01","d05-x01-y01", "d06-x01-y01","d07-x01-y01"] analyses["2K2Pi"]["BABAR_2007_I747875" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01", "d04-x01-y01","d05-x01-y01","d07-x01-y01"] analyses["2K2Pi"]["BESII_2008_I801210" ] = ["d01-x01-y02"] analyses["2K2Pi"]["BESII_2008_I801208" ] = ["d01-x01-y02"] analyses["2K2Pi"]["BELLE_2009_I809630" ] = ["d01-x01-y01"] analyses["2K2Pi"]["CMD3_2016_I1395968" ] = ["d01-x01-y01"] analyses['2K2Pi']["BESII_2007_I750713" ] = ["d01-x01-y04"] analyses["2K2Pi"]["BABAR_2017_I1511276" ] = ["d03-x01-y01","d04-x01-y01"] analyses["2K2Pi"]["BABAR_2017_I1591716" ] = ["d01-x01-y01","d02-x01-y01"] analyses['2K2Pi']["BESIII_2018_I1699641"] = ["d01-x01-y01","d02-x01-y01"] analyses['2K2Pi']["CMD3_2019_I1770428" ] = ["d01-x01-y06"] # 4K analyses["4K"]["BESIII_2019_I1743841"] = ["d01-x01-y01","d02-x01-y01"] analyses["4K"]["BABAR_2005_I676691" ] = ["d03-x01-y01"] analyses["4K"]["BABAR_2014_I1287920" ] = ["d12-x01-y01"] analyses["4K"]["BABAR_2012_I892684" ] = ["d08-x01-y01"] analyses["4K"]["BABAR_2007_I747875" ] = ["d07-x01-y01"] analyses['4K']["BESII_2007_I750713" ] = ["d01-x01-y06","d01-x01-y07"] # 6 mesons analyses["6m"]["CMD3_2013_I1217420" ] = ["d01-x01-y01"] analyses["6m"]["SND_2019_I1726419" ] = ["d01-x01-y01","d01-x01-y04"] analyses["6m"]["CMD3_2017_I1606078" ] = ["d01-x01-y03","d01-x01-y04"] analyses["6m"]["CMD3_2019_I1720610" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03"] analyses["6m"]["BABAR_2018_I1700745"] = ["d04-x01-y01","d05-x01-y01"] analyses["6m"]["SND_2016_I1471515" ] = ["d01-x01-y06"] analyses["6m"]["DM1_1981_I166353" ] = ["d01-x01-y01"] analyses["6m"]["BABAR_2006_I709730" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01"] analyses["6m"]["BABAR_2007_I758568" ] = ["d05-x01-y01","d07-x01-y01", "d08-x01-y01","d09-x01-y01","d10-x01-y01","d11-x01-y01"] analyses["6m"]["BESII_2007_I763880" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03","d01-x01-y04", "d01-x01-y05","d01-x01-y06","d01-x01-y07"] analyses["6m"]["BESII_2007_I762901" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03","d01-x01-y04", "d01-x01-y06","d01-x01-y07","d01-x01-y08","d01-x01-y09","d01-x01-y10"] analyses["6m"]["CLEO_2006_I691720" ] = ["d01-x01-y02","d01-x01-y03","d01-x01-y04","d01-x01-y05", "d01-x01-y07","d01-x01-y08","d01-x01-y09","d01-x01-y10","d01-x01-y11", "d01-x01-y12","d01-x01-y13","d01-x01-y14","d01-x01-y15","d01-x01-y17"] analyses["6m"]["BESII_2008_I801210" ] = ["d01-x01-y03","d01-x01-y04","d01-x01-y05"] analyses["6m"]["BESII_2008_I801208" ] = ["d01-x01-y03","d01-x01-y04","d01-x01-y05","d01-x01-y06"] analyses["6m"]["MARKI_1982_I169326" ] = ["d06-x01-y01"] analyses["6m"]["MARKI_1975_I100592" ] = ["d01-x01-y01","d02-x01-y01"] analyses['6m']["BESII_2007_I750713" ] = ["d01-x01-y08","d01-x01-y09","d01-x01-y11", "d01-x01-y12","d01-x01-y13","d01-x01-y14", "d01-x01-y15","d01-x01-y16","d01-x01-y17","d01-x01-y18"] analyses['6m']["SND_2016_I1473343" ] = ["d01-x01-y01"] +# other baryon processes +analyses['Baryon']["BESIII_2017_I1509241" ] = ["d01-x01-y01"] # DD analyses["DD"]["BELLE_2007_I723333" ] = ["d01-x01-y01","d02-x01-y01"] analyses["DD"]["BELLE_2007_I756012" ] = ["d01-x01-y01"] analyses["DD"]["BELLE_2007_I756643" ] = ["d01-x01-y01"] analyses["DD"]["BELLE_2008_I757220" ] = ["d01-x01-y01","d02-x01-y01"] analyses["DD"]["BELLE_2008_I759073" ] = ["d01-x01-y01"] analyses["DD"]["BABAR_2008_I776519" ] = ["d01-x01-y01","d01-x01-y02"] analyses["DD"]["BELLE_2008_I791660" ] = ["d01-x01-y01"] analyses["DD"]["BELLE_2013_I1225975" ] = ["d01-x01-y01"] analyses["DD"]["BELLE_2014_I1282602" ] = ["d01-x01-y01"] analyses["DD"]["BELLE_2015_I1324785" ] = ["d01-x01-y01"] analyses["DD"]["BESIII_2016_I1457597" ] = ["d01-x01-y07"] analyses["DD"]["BESIII_2015_I1355215" ] = ["d01-x01-y10"] analyses["DD"]["BESIII_2015_I1377204" ] = ["d01-x01-y10"] analyses["DD"]["BESIII_2016_I1495838" ] = ["d01-x01-y01","d02-x01-y01"] analyses["DD"]["CRYSTAL_BALL_1986_I238081"] = ["d02-x01-y01"] analyses["DD"]["CLEOC_2008_I777917" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03", "d02-x01-y01","d02-x01-y02","d02-x01-y03", "d03-x01-y01","d03-x01-y02","d03-x01-y03", "d04-x01-y01","d04-x01-y02", "d05-x01-y01","d05-x01-y02"] analyses["DD"]["BELLE_2017_I1613517" ] = ["d01-x01-y01","d01-x01-y02"] analyses["DD"]["BESIII_2014_I1323621" ] = ["d01-x01-y01"] analyses["DD"]["BESIII_2015_I1406939" ] = ["d02-x01-y06","d03-x01-y06"] analyses["DD"]["BESIII_2017_I1628093" ] = ["d01-x01-y01"] analyses["DD"]["BESIII_2019_I1723934" ] = ["d01-x01-y01"] analyses["DD"]["BESIII_2019_I1756876" ] = ["d01-x01-y09","d01-x01-y10"] analyses["DD"]["BABAR_2007_I729388" ] = ["d01-x01-y01"] analyses["DD"]["BESIII_2015_I1329785" ] = ["d01-x01-y08","d02-x01-y08","d03-x01-y08"] +analyses["DD"]["BESIII_2017_I1494065" ] = ["d01-x01-y01","d02-x01-y01"] +analyses["DD"]["BESIII_2017_I1596897" ] = ["d01-x01-y01"] +analyses["DD"]["BESIII_2018_I1653121" ] = ["d01-x01-y01","d01-x01-y02"] +analyses["DD"]["BESIII_2020_I1762922" ] = ["d01-x01-y01"] +analyses["DD"]["BESIII_2018_I1633425" ] = ["d01-x01-y01"] +analyses["DD"]["BESIII_2018_I1685535" ] = ["d01-x01-y01","d02-x01-y01"] +analyses["DD"]["BELLE_2011_I878228" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03"] +analyses["DD"]["BABAR_2010_I864027" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03"] +analyses["DD"]["BABAR_2009_I815035" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03","d02-x01-y01"] +analyses["DD"]["BES_1999_I508349" ] = ["d01-x01-y01","d01-x01-y02","d01-x01-y03","d01-x01-y04"] # BB analyses["BB"]["BELLE_2016_I1389855" ] = ["d01-x01-y02","d01-x01-y03"] analyses["BB"]["BELLE_2008_I764099" ] = ["d01-x01-y01","d02-x01-y01", "d03-x01-y01","d04-x01-y01"] analyses["BB"]["CLEO_1999_I474676" ] = ["d01-x01-y01","d01-x01-y02"] analyses["BB"]["CUSB_1991_I325661" ] = ["d01-x01-y01"] analyses["BB"]["CLEO_1991_I29927" ] = ["d01-x01-y01"] # hyperons analyses["LL"]["BESIII_2018_I1627871"] = ["d01-x01-y01"] analyses["LL"]["DM2_1990_I297706" ] = ["d02-x01-y01"] analyses["LL"]["BESIII_2019_I1758883"] = ["d01-x01-y05"] +analyses["LL"]["BESIII_2019_I1726357"] = ["d01-x01-y01"] analyses["LL"]["BABAR_2007_I760730" ] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01"] # list the analysis if required and quit() allProcesses=False if "All" in opts.processes : allProcesses=True processes = sorted(list(analyses.keys())) else : processes = sorted(list(set(opts.processes))) if(opts.list) : for process in processes : print " ".join(analyses[process]) quit() if(opts.plot) : output="" for process in processes: for analysis in analyses[process] : if(analysis=="CMD3_2019_I1770428") : - output+= " -m/%s/%s" % (analysis,"d02-x01-y01") - output+= " -m/%s/%s" % (analysis,"d02-x01-y02") + for iy in range(1,3) : + output+= " -m/%s/%s" % (analysis,"d02-x01-y0%s"%iy) + elif(analysis=="BES_1999_I508349") : + for ix in range(2,4) : + for iy in range(1,3) : + output+= " -m/%s/%s" % (analysis,"d0%s-x01-y0%s"%(ix,iy)) + elif(analysis=="BESIII_2019_I1726357") : + for ix in range(2,4) : + output+= " -m/%s/%s" % (analysis,"d0%s-x01-y01"% ix) for plot in analyses[process][analysis]: output+= " -m/%s/%s" % (analysis,plot) print output quit() # mapping of process to me to use me = { "PiPi" : "MEee2Pions", "KK" : "MEee2Kaons", "3Pi" : "MEee3Pions", "4Pi" : "MEee4Pions", "EtaPiPi" : "MEee2EtaPiPi", "EtaprimePiPi" : "MEee2EtaPrimePiPi", "EtaPhi" : "MEee2EtaPhi", "EtaOmega" : "MEee2EtaOmega", "OmegaPi" : "MEee2OmegaPi", "OmegaPiPi" : "MEee2OmegaPiPi", "PhiPi" : "MEee2PhiPi", "PiGamma" : "MEee2PiGamma", "EtaGamma" : "MEee2EtaGamma", "PPbar" : "MEee2PPbar", "LL" : "MEee2LL" , "2K1Pi" : "MEee2KKPi" } # get the particle masses from Herwig particles = { "pi+" : 0., "pi0" : 0. ,"eta" : 0. ,"eta'" : 0. ,"phi" : 0. ,"omega" : 0. ,"p+" : 0. ,"K+" : 0.} for val in particles : tempTxt = "get /Herwig/Particles/%s:NominalMass\nget /Herwig/Particles/%s:WidthLoCut\n" % (val,val) with open("temp.in",'w') as f: f.write(tempTxt) p = subprocess.Popen(["../src/Herwig", "read","temp.in"],stdout=subprocess.PIPE) vals = p.communicate()[0].split() mass = float(vals[0])-float(vals[1]) particles[val]=mass os.remove("temp.in") # minimum CMS energies for specific processes minMass = { "PiPi" : 2.*particles["pi+"], "KK" : 2.*particles["K+"], "3Pi" : 2.*particles["pi+"]+particles["pi0"], "4Pi" : 2.*particles["pi+"]+2.*particles["pi0"], "EtaPiPi" : particles["eta"]+2.*particles["pi+"], "EtaprimePiPi" : particles["eta'"]+2.*particles["pi+"], "EtaPhi" : particles["phi"]+particles["eta"], "EtaOmega" : particles["omega"]+particles["eta"], "OmegaPi" : particles["omega"]+particles["pi0"], "OmegaPiPi" : particles["omega"]+2.*particles["pi0"], "PhiPi" : particles["phi"]+particles["pi0"], "PiGamma" : particles["pi0"], "EtaGamma" : particles["eta"], "PPbar" : 2.*particles["p+"], "LL" : 0., "2K1Pi" : 2.*particles["K+"]+particles["pi0"] } # energies we need energies={} def nearestEnergy(en) : Emin=0 delta=1e30 anals=[] for val in energies : if(abs(val-en)200) : energy *= 0.001 emin,delta,anals = nearestEnergy(energy) if(energy in energies) : if(analysis not in energies[energy][1]) : energies[energy][1].append(analysis) if(matrix!="" and matrix not in energies[energy][0] and minMass[process]<=energy) : energies[energy][0].append(matrix) elif(delta<1e-7) : if(analysis not in anals[1]) : anals[1].append(analysis) if(matrix!="" and matrix not in anals[0] and minMass[process]<=energy) : anals[0].append(matrix) else : if(matrix=="") : energies[energy]=[[],[analysis]] elif(minMass[process]<=energy) : energies[energy]=[[matrix],[analysis]] with open("python/LowEnergy-EE-Perturbative.in", 'r') as f: templateText = f.read() perturbative=Template( templateText ) with open("python/LowEnergy-EE-NonPerturbative.in", 'r') as f: templateText = f.read() nonPerturbative=Template( templateText ) targets="" for energy in sorted(energies) : anal="" for analysis in energies[energy][1]: anal+= "insert /Herwig/Analysis/Rivet:Analyses 0 %s\n" %analysis proc="" matrices = energies[energy][0] if(allProcesses) : matrices = me.values() for matrix in matrices: proc+="insert SubProcess:MatrixElements 0 %s\n" % matrix proc+="set %s:Flavour %s\n" % (matrix,opts.flavour) maxflavour =5 if(energy thresholds[0]) : inputPerturbative = perturbative.substitute({"ECMS" : "%8.6f" % energy, "ANALYSES" : anal, "lepton" : "", "maxflavour" : maxflavour}) with open(opts.dest+"/Rivet-LowEnergy-EE-Perturbative-%8.6f.in" % energy ,'w') as f: f.write(inputPerturbative) targets += "Rivet-LowEnergy-EE-Perturbative-%8.6f.yoda " % energy # input file for currents if(opts.nonPerturbative and proc!="") : inputNonPerturbative = nonPerturbative.substitute({"ECMS" : "%8.6f" % energy, "ANALYSES" : anal, "processes" : proc}) with open(opts.dest+"/Rivet-LowEnergy-EE-NonPerturbative-%8.6f.in" % energy ,'w') as f: f.write(inputNonPerturbative) targets += "Rivet-LowEnergy-EE-NonPerturbative-%8.6f.yoda " % energy print targets diff --git a/Tests/python/R.py b/Tests/python/R.py --- a/Tests/python/R.py +++ b/Tests/python/R.py @@ -1,192 +1,193 @@ #! /usr/bin/env python import yoda,os,math,subprocess,optparse from string import Template # get the path for the rivet data p = subprocess.Popen(["rivet-config", "--datadir"],stdout=subprocess.PIPE) path=p.communicate()[0].strip() thresholds = [2.*1.87,2.*5.28] #Define the arguments op = optparse.OptionParser(usage=__doc__) op.add_option("--process" , dest="processes" , default=[], action="append") op.add_option("--path" , dest="path" , default=path) op.add_option("--non-perturbative", dest="nonPerturbative" , default=False, action="store_true") op.add_option("--perturbative" , dest="perturbative" , default=False, action="store_true") op.add_option("--dest" , dest="dest" , default="Rivet") op.add_option("--list" , dest="list" , default=False, action="store_true") op.add_option("--max-energy" , dest="maxEnergy" , default=11.5, type="float", action="store") op.add_option("--plots" , dest="plot" , default=False, action="store_true") opts, args = op.parse_args() path=opts.path # list of analyses analyses={} analyses["CLEO_2007_I753556"] = ["d01-x01-y01"] analyses["DASP_1978_I129715"] = ["d01-x01-y01"] analyses["CLEO_1984_I193577"] = ["d01-x01-y01"] analyses["AMY_1990_I294525" ] = ["d01-x01-y01"] analyses["BABAR_2009_I797507"] = ["d01-x01-y01"] analyses["BELLE_2015_I1336624"] = ["d02-x01-y01","d01-x01-y01","d01-x01-y02","d01-x01-y03"] analyses["TASSO_1982_I176887"] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01"] analyses["CRYSTAL_BALL_1986_I238081"] = ["d01-x01-y01"] analyses["CRYSTAL_BALL_1990_I294419"] = ["d01-x01-y01","d02-x01-y01"] analyses["CRYSTAL_BALL_1988_I261078"] = ["d01-x01-y01"] analyses["TOPAZ_1990_I283003"] = ["d01-x01-y01"] analyses["TOPAZ_1993_I353845"] = ["d02-x01-y01"] analyses["TOPAZ_1995_I381777"] = ["d01-x01-y01"] analyses["VENUS_1987_I251274"] = ["d01-x01-y01"] analyses["VENUS_1990_I283774"] = ["d01-x01-y01"] analyses["VENUS_1990_I296392"] = ["d03-x01-y01"] analyses["VENUS_1999_I500179"] = ["d01-x01-y01"] analyses["MD1_1986_I364141"] = ["d01-x01-y01"] analyses["MUPI_1972_I84978"] = ["d01-x01-y01"] analyses["MUPI_1973_I95215"] = ["d01-x01-y01"] analyses["NMD_1974_I745" ] = ["d01-x01-y01","d01-x01-y02"] analyses["GAMMAGAMMA_1979_I141722"] = ["d01-x01-y01","d02-x01-y01","d02-x01-y02"] analyses["MARKI_1975_I100733"] = ["d01-x01-y01","d02-x01-y01"] analyses["MARKI_1977_I119979"] = ["d01-x01-y01","d02-x01-y01"] analyses["MARKI_1976_I108144"] = ["d01-x01-y01"] analyses["DASP_1982_I178613"] = ["d02-x01-y01"] analyses["DESY147_1980_I153896"] = ["d01-x01-y01"] analyses["DESY147_1978_I131524"] = ["d01-x01-y01","d02-x01-y01"] analyses["CLEO_1983_I188805"] = ["d01-x01-y01"] analyses["CLEO_1998_I445351"] = ["d01-x01-y01"] analyses["CLEO_1983_I188803"] = ["d02-x01-y01"] analyses["CLEOC_2008_I777917"] = ["d06-x01-y01","d06-x01-y02"] analyses["CLEO_2006_I700665"] = ["d01-x01-y01"] analyses["CUSB_1982_I180613"] = ["d03-x01-y01"] analyses["MAC_1985_I206052"] = ["d01-x01-y01"] analyses["MARKII_1991_I295286"] = ["d01-x01-y01"] analyses["MARKJ_1979_I141976"] = ["d01-x01-y01"] analyses["MARKJ_1980_I158857"] = ["d01-x01-y01"] analyses["MARKJ_1982_I166369"] = ["d01-x01-y01"] analyses["MARKJ_1983_I182337"] = ["d04-x01-y01"] analyses["MARKJ_1984_I196567"] = ["d01-x01-y01"] analyses["MARKJ_1986_I230297"] = ["d01-x01-y01"] analyses["LENA_1982_I179431"] = ["d01-x01-y01","d02-x01-y01","d03-x01-y01"] analyses["MARKII_1979_I143939"] = ["d02-x01-y01","d03-x01-y01"] analyses["ARGUS_1992_I319102"] = ["d01-x01-y01"] analyses["CELLO_1981_I166365"] = ["d01-x01-y01"] analyses["CELLO_1984_I202783"] = ["d02-x01-y01"] analyses["CELLO_1987_I236981"] = ["d01-x01-y01"] analyses["TASSO_1979_I140303"] = ["d01-x01-y01"] analyses["TASSO_1980_I143690"] = ["d01-x01-y01"] analyses["TASSO_1984_I199468"] = ["d01-x01-y01","d02-x01-y01"] analyses["JADE_1987_I234905"] = ["d01-x01-y01"] analyses["PLUTO_1982_I166799"] = ["d01-x01-y01","d02-x01-y01"] analyses["PLUTO_1979_I142517"] = ["d01-x01-y01"] analyses["PLUTO_1979_I140818"] = ["d02-x01-y01"] analyses["PLUTO_1979_I140294"] = ["d01-x01-y01","d02-x01-y01"] analyses["PLUTO_1980_I152291"] = ["d01-x01-y01","d02-x01-y01"] analyses["BBAR_1980_I152630"] = ["d01-x01-y01"] analyses["BESII_2000_I505323"] = ["d01-x01-y01"] analyses["BESII_2002_I552757"] = ["d01-x01-y01"] analyses["BES_1995_I39870"] = ["d01-x01-y01"] analyses["BESII_2009_I814778"] = ["d01-x01-y01"] analyses["BESII_2006_I717665"] = ["d02-x01-y01"] analyses["GAMMAGAMMA_1979_I133588"] = ["d01-x01-y01","d01-x01-y02"] analyses["GAMMAGAMMA_1975_I100016"] = ["d01-x01-y01","d01-x01-y02"] analyses["GAMMAGAMMA_1973_I84794"] = ["d03-x01-y01","d04-x01-y01"] analyses["GAMMAGAMMA_1981_I158474"] = ["d02-x01-y01","d02-x01-y02","d01-x01-y05","d01-x01-y06"] analyses["TASSO_1984_I195333"] = ["d01-x01-y01","d04-x01-y01"] analyses["PLUTO_1977_I110272"]=["d02-x01-y01"] analyses["FENICE_1996_I426675"]=["d01-x01-y01"] analyses["PLUTO_1981_I165122"]=["d01-x01-y01","d02-x01-y01","d03-x01-y01"] analyses["KEDR_2019_I1673357"]=["d01-x01-y01","d01-x01-y02"] +analyses["BELLE_2011_I878228"] = ["d02-x01-y01"] # list analyses if needed if(opts.list) : print " ".join(analyses.keys()) quit() if(opts.plot) : output="" for analysis in analyses.keys(): for plot in analyses[analysis]: output+= " -m/%s/%s" % (analysis,plot) for i in xrange(1,7) : output += " -m/BESII_2004_I622224/d0%s-x01-y01" % i print output quit() energies={} def nearestEnergy(en) : Emin=0 delta=1e30 anals=[] for val in energies : if(abs(val-en)200) : energy *= 0.001 emin,delta,anals = nearestEnergy(energy) if(energy in energies) : if(analysis not in energies[energy]) : energies[energy].append(analysis) elif(delta<1e-7) : if(analysis not in anals) : anals.append(analysis) else : energies[energy]=[analysis] # add the bes spectra for val in [2.2,2.6,3.0,3.2,4.6,4.8] : if val in energies : energies[val].append("BESII_2004_I622224") else: energies[val] = ["BESII_2004_I622224"] # set up the templates with open("python/LowEnergy-EE-Perturbative.in", 'r') as f: templateText = f.read() perturbative=Template( templateText ) with open("python/LowEnergy-EE-NonPerturbative.in", 'r') as f: templateText = f.read() nonPerturbative=Template( templateText ) # lepton matrix element lepton_me="insert SubProcess:MatrixElements 0 MEee2gZ2ll\nset MEee2gZ2ll:Allowed Muon\n" # low energy matrix element mes = ["MEee2Pions", "MEee2Kaons", "MEee3Pions", "MEee4Pions", "MEee2EtaPiPi", "MEee2EtaPrimePiPi", "MEee2EtaPhi", "MEee2EtaOmega", "MEee2OmegaPi", "MEee2OmegaPiPi", "MEee2PhiPi", "MEee2PiGamma", "MEee2EtaGamma", "MEee2PPbar", "MEee2LL" , "MEee2KKPi" ] proc=lepton_me for matrix in mes : proc+="insert SubProcess:MatrixElements 0 %s\n" % matrix targets="" for energy in sorted(energies) : anal="" for analysis in energies[energy]: anal+= "insert /Herwig/Analysis/Rivet:Analyses 0 %s\n" %analysis # input file for perturbative QCD maxflavour =5 if(energy= 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 + if "LENA_1981_I164397" in desthisto.path() : sqrts2=9.4624 elif sqrts=="U2" : sqrts2=10.02 + if "LENA_1981_I164397" in desthisto.path() : sqrts2=10.0148 elif sqrts=="U4" : sqrts2=10.58 else : sqrts2=float(sqrts) - if("ARGUS_1989_I276860" in desthisto.path() and sqrts2==10.) : sqrts2=9.98 + if ("ARGUS_1989_I276860" in desthisto.path() and sqrts2==10. ) : sqrts2=9.98 + elif ( "LENA_1981_I164397" in desthisto.path() and sqrts2==10. ) : sqrts2=9.9903 + elif ( "LENA_1981_I164397" in desthisto.path() and sqrts2==9.51) : sqrts2=9.5149 step = 0.001 if("TASSO_1980_I143691" in desthisto.path()) : step=0.3 if("JADE_1979_I142874" 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()) : 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 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].setPath(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 analyses") parser.add_option("--without-gg", action='store_false', dest="gg", default=False, help="Don\'t include gg analyses") parser.add_option("--with-decay", action='store_true' , dest="decay", default=False, help="Include decay analyses") parser.add_option("--without-decay", action='store_false', dest="decay", default=False, help="Don\'t include decay 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","27.7","29","30.2","34.5",\ - "30.7","30","31.3","31.6","34","34.8","43.6","50","52","53.3",\ + "30.7","30","31.3","31.6","34","34.8","42.1","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","2.2","2.6","3.0","3.2","4.6","4.8", "5.8","6.2","6.6","7.0","7.4","3.63","4.03","4.17","4.3", - "4.41","5.0","5.2","4.5","9.46","10.52","10.52-sym","10.54","10.58", + "4.41","5.0","5.2","4.5","8.8","9.27","9.46","9.51","10.52","10.52-sym","10.54","10.58", "10.6","10.45","10.47"] # 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"] # add decays if needed if(opts.decay) : - yodafiles += ["Upsilon","Upsilon2","Upsilon4","Upsilon4-asym", + yodafiles += ["Upsilon","Upsilon2","Upsilon3","Upsilon4","Upsilon4-asym", "Tau","Phi","Lambdac","Omega-Meson", "Omega-Baryon","Eta","Xi0","Xic0", "Omegac0","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("Omega-Meson")>0) : sqrts="omega" 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 or file.find("Eta")>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 or "/_" 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("132410" )>0 or "JADE_1979_I142874" in aopath or + "LENA_1981_I164397" in aopath or "ARGUS_1991_I315059" in aopath or + "TASSO_1989_I266893" in aopath or ("OPAL_2000_I513476" in aopath and ("d14" in aopath or "d20" in aopath )) 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 - elif(aopath.find("ARGUS_1991_I315059")>=0) : - if(file.find("sym")>=0) : - if("d01" in aopath or "d02" in aopath or - "d03" in aopath or "d04" in aopath) : - outhistos[aopath] = ao - else : - if("d05" in aopath or "d07" in aopath or - "d07" in aopath) : - outhistos[aopath] = ao elif(aopath.find("A2_2017_I1486671")>=0) : if("Eta" in file) : if "d01" in aopath : outhistos[aopath] = ao elif("Omega" in file) : if "d02" in aopath : outhistos[aopath] = ao else : outhistos[aopath] = ao elif("ARGUS_1992_I319102" in aopath) : - if("d02" in aopath and sqrts==10.47) : + if(("d02" in aopath or "d04" in aopath) and sqrts==10.47) : outhistos[aopath] = ao - elif("d03"in aopath and sqrts=="U4") : + elif(("d03"in aopath or "d05" in aopath) and sqrts=="U4") : outhistos[aopath] = ao elif("MC_OmegaPhia1_3Pion_Decay" in aopath) : if("_1" in aopath and "Omega" in file) : outhistos[aopath] = ao elif("_2" in aopath and "Phi" in file) : outhistos[aopath] = ao elif("BABAR_2006_I719581" in aopath) : if("d02" in aopath and "Omega" in file) : outhistos[aopath] = ao elif("d01" in aopath and "Xi" in file) : outhistos[aopath] = ao + elif("BABAR_2002_I582184" in aopath) : + if(("d02" in aopath or "d05" in aopath ) and "Upsilon" in file) : + outhistos[aopath] = ao + elif( not ("d02" in aopath or "d05" in aopath ) and sqrts==10.6) : + outhistos[aopath] = ao + elif(aopath=="/BABAR_2007_I746745/d01-x01-y01") : + htemp = aos["/RAW/BABAR_2007_I746745/d01-x01-y01"] + htemp.scaleW(aos["/_XSEC"].points()[0].x()/aos["/_EVTCOUNT"].val()) + htemp.setPath("/BABAR_2007_I746745/d01-x01-y01") + if "/BABAR_2007_I746745/d01-x01-y01" in outhistos : + htemp2=htemp+outhistos["/BABAR_2007_I746745/d01-x01-y01"] + htemp2.setPath("/BABAR_2007_I746745/d01-x01-y01") + outhistos["/BABAR_2007_I746745/d01-x01-y01"]=htemp2 + else : + outhistos["/BABAR_2007_I746745/d01-x01-y01"]=htemp + elif(aopath=="/BABAR_2007_I722622/d03-x01-y01" or + aopath=="/BABAR_2007_I722622/d03-x01-y02" or + aopath=="/BABAR_2007_I722622/d04-x01-y01") : + htemp = aos["/RAW"+aopath] + htemp.scaleW(aos["/_XSEC"].points()[0].x()/aos["/_EVTCOUNT"].val()) + htemp.setPath(aopath) + if aopath in outhistos : + htemp2=htemp+outhistos[aopath] + htemp2.setPath(aopath) + outhistos[aopath]=htemp2 + else : + outhistos[aopath]=htemp 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 or hpath.find("132410" )>0 or "OPAL_2000_I513476" in hpath or - "JADE_1979_I142874" in hpath): + "JADE_1979_I142874" in hpath or + "LENA_1981_I164397" in hpath): if(hpath=="/PLUTO_1981_I165122/d01-x01-y01" or hpath=="/PLUTO_1981_I165122/d03-x01-y01" ) : continue title="" path="" histo = hsets.values()[0] if hasattr(histo, 'title'): title=histo.title() if hasattr(histo, 'path'): path=histo.path() if(type(histo)==yoda.core.Scatter2D) : outhistos[hpath] = yoda.core.Scatter2D(path,title) elif(type(histo)==yoda.core.Profile1D) : outhistos[hpath] = yoda.core.Profile1D(path,title) for i in range(0,histo.numBins()) : outhistos[hpath].addBin(histo.bins()[i].xMin(), histo.bins()[i].xMax()) elif(type(histo)==yoda.core.Histo1D) : outhistos[hpath] = yoda.core.Histo1D(path,title) for i in range(0,histo.numBins()) : outhistos[hpath].addBin(histo.bins()[i].xMin(), histo.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") +# 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") +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") +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/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","206") -# 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","206") -# 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") +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","206") +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","206") +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") +# 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-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/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") +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") +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") +# 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","U4") +useOne("/BABAR_2007_S6895344/d04-x01-y01","U4") +# 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") +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_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") +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") +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") +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") +useOne("/ARGUS_1989_I262415/d03-x01-y01","U1") +useOne("/ARGUS_1989_I262415/d04-x01-y01","10.00") +useOne("/ARGUS_1989_I262415/d01-x01-y01","U1") +useOne("/ARGUS_1989_I262415/d01-x01-y02","10.00") +useOne("/ARGUS_1989_I262415/d01-x02-y01","U1") +useOne("/ARGUS_1989_I262415/d01-x02-y02","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") +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.") +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") -# merge("/DASP_1979_I132410/d01-x01-y01") -# # 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) +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") +merge("/DASP_1979_I132410/d01-x01-y01") +# 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)) +# 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)) -# merge("/OPAL_2000_I513476/d14-x01-y01") -# merge("/OPAL_2000_I513476/d20-x01-y01") -# merge("/OPAL_2000_I513476/d20-x01-y02") -# merge("/OPAL_2000_I513476/d20-x01-y03") -# merge("/OPAL_2000_I513476/d20-x01-y04") +merge("/OPAL_2000_I513476/d14-x01-y01") +merge("/OPAL_2000_I513476/d20-x01-y01") +merge("/OPAL_2000_I513476/d20-x01-y02") +merge("/OPAL_2000_I513476/d20-x01-y03") +merge("/OPAL_2000_I513476/d20-x01-y04") + merge("/JADE_1979_I142874/d02-x01-y01") +merge("/LENA_1981_I164397/d03-x01-y01") + +useOne("/LENA_1981_I164397/d04-x01-y01","9.51") +useOne("/LENA_1981_I164397/d04-x01-y02","10.") +useOne("/LENA_1981_I164397/d04-x01-y03","U1") +useOne("/LENA_1981_I164397/d04-x01-y04","U2") + +useOne("/ARGUS_1991_I315059/d01-x01-y01","10.47") +useOne("/ARGUS_1991_I315059/d01-x01-y02","10.47") +useOne("/ARGUS_1991_I315059/d01-x01-y03","10.47") +useOne("/ARGUS_1991_I315059/d02-x01-y01","10.47") +useOne("/ARGUS_1991_I315059/d03-x01-y01","10.47") +useOne("/ARGUS_1991_I315059/d04-x01-y01","10.47") +useOne("/ARGUS_1991_I315059/d05-x01-y01","U4") +useOne("/ARGUS_1991_I315059/d06-x01-y01","U4") +useOne("/ARGUS_1991_I315059/d07-x01-y01","U4") + +for i in [3,4,5,6,7,8,18,19,20,21,22,23] : + useOne("/TASSO_1989_I266893/d%02d-x01-y01" %i ,"34.8") +for i in range(9,15) : + useOne("/TASSO_1989_I266893/d%02d-x01-y01" %i ,"42.1") +for i in range(1,4) : + useOne("/TASSO_1989_I266893/d15-x01-y%02d" %i ,"34.8") + useOne("/TASSO_1989_I266893/d16-x01-y%02d" %i ,"42.1") +# normalize where we have sum histos +outhistos["/BABAR_2007_I746745/d01-x01-y01"].normalize() +outhistos["/BABAR_2007_I722622/d03-x01-y01"].normalize() +outhistos["/BABAR_2007_I722622/d03-x01-y02"].normalize() +outhistos["/BABAR_2007_I722622/d04-x01-y01"].normalize() + # Choose output file name = args[0]+".yoda" # output the yoda file yoda.writeYODA(outhistos,name) sys.exit(0) diff --git a/Tests/python/mergeLowEnergy.py b/Tests/python/mergeLowEnergy.py --- a/Tests/python/mergeLowEnergy.py +++ b/Tests/python/mergeLowEnergy.py @@ -1,105 +1,106 @@ #! /usr/bin/env python import yoda,glob,math,optparse op = optparse.OptionParser(usage=__doc__) op.add_option("-m" , dest="plots" , default=[], action="append") opts, args = op.parse_args() if(len(args)!=1) : print 'Must be one and only 1 name' quit() cmd3_weights = { 2007. : [0.5 ,4259], 1980 : [1 , 2368], 1951 : [11,5230], 1907.5: [17.5,5497], 1877 : [7 ,16803], 1830 : [30,8287], 1740. : [40 ,8728], 1640 : [40, 7299] } wSum=0. for key in cmd3_weights.keys() : wSum+= cmd3_weights[key][1] for key in cmd3_weights.keys() : cmd3_weights[key][1] /= wSum for runType in ["NonPerturbative","Perturbative"]: outhistos={} for fileName in glob.glob("Rivet-LowEnergy-EE-%s-*.yoda" % runType): energy = float(fileName.split("-")[-1].strip(".yoda")) energyMeV = energy*1000. aos = yoda.read(fileName) for hpath,histo in aos.iteritems(): if("/_" in hpath or "TMP" in hpath or "RAW" in hpath) : continue if(len(opts.plots)>0 and hpath not in opts.plots) : continue - if(type(histo)==yoda.core.Histo1D) : - if( "CMD3_2019_I1770428" in path ) : + if(type(histo)==yoda.core.Histo1D or + (type(histo)==yoda.core.Scatter2D and hpath=="/BESIII_2019_I1726357/d03-x01-y01") ) : + if( "CMD3_2019_I1770428" in hpath ) : val=0. for key in cmd3_weights.keys() : if(abs(energyMeV-val)>abs(energyMeV-key)) : val=key histo.scaleW(cmd3_weights[val][1]) if(hpath in outhistos) : outhistos[hpath] += histo else : outhistos[hpath] = histo else : outhistos[hpath] = histo continue # create histo if it doesn't exist elif(hpath not in outhistos) : title="" path="" if hasattr(histo, 'title'): title=histo.title() if hasattr(histo, 'path'): path=histo.path() outhistos[hpath] = yoda.core.Scatter2D(path,title) matched = False for i in range(0,aos[hpath].numPoints()) : x = aos[hpath].points()[i].x() delta=1e-5 if("KLOE_2009_I797438" in hpath or "KLOE_2005_I655225" in hpath or "KLOE2_2017_I1634981" in hpath or "FENICE_1994_I377833" in hpath or "FENICE_1996_I426675" in hpath): x=math.sqrt(x) delta=1e-3 if(abs(x-energy)<1e-3*delta or abs(x-energyMeV) xmin and energy < xmax) or (energyMeV > xmin and energyMeV < xmax) ) : duplicate = False for j in range(0,outhistos[hpath].numPoints()) : if(outhistos[hpath].points()[j].x()==aos[hpath].points()[i].x()) : duplicate = True break if(not duplicate) : outhistos[hpath].addPoint(aos[hpath].points()[i]) break if len(outhistos) == 0: continue for val in outhistos.keys() : if type(outhistos[val]) is yoda.core.Scatter2D : if(outhistos[val].numPoints()==0) : del outhistos[val] elif (type(outhistos[val]) is yoda.core.Histo1D or type(outhistos[val]) is yoda.core.Profile1D) : if(outhistos[val].numBins()==0) : del outhistos[val] else : print type(outhistos[val]) yoda.writeYODA(outhistos,"LowEnergy-EE-%s-%s.yoda" % (runType,args[0])) diff --git a/Tests/python/plot-EE b/Tests/python/plot-EE --- a/Tests/python/plot-EE +++ b/Tests/python/plot-EE @@ -1,3655 +1,4358 @@ #! /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" : {}, + "TauDecays" : { "1pi" : {}, + "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" : {}}, + "ChargedSpectrum" : { 0 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}}, 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" : {}}, + 10423 : { "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" : {}}, + 10433 : { "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" : {}}, + 100443 : { "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" : {}}, + 513 : { "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" : {}}, + 4222 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, 4114 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, 4124 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4312 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4322 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4314 : { "x" : {}, "p" : {}, "xi" : {}, "Other" : {}, "Ratio" : {}}, + 4324 : { "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" : {}, + "Polarization" : { 213 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 223 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 413 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 513 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 3122 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 333 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 313 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + 5122 : { "alpha" : {}, "rho00" : {}, "cos" : {}, "rho10" : {}, "rho11" : {}, "phi" : {}, "Other" : {}}, + } } particleNames = { + 11 : "$e^-$", 13 : "$\\mu^-$", 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}$", + 10423: "$D^0_1,\\bar{D}_1^0$", + 431 : "$D_s^\\pm$", 435 : "$D^\\pm_{s2}$", 20431 : "$D^\\pm_{s1}$", 433 : "$D_s^{*\\pm}$", 10433 : "$D_{s1}(2536)^+$", 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)$", + 441 : "$\\eta_c$", 100553 : "$\Upsilon(2S)$", 200553 : "$\Upsilon(3S)$", 300553 : "$\Upsilon(4S)$", 400553 : "$\Upsilon(5S)$", 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^+$", + 4122 : "$\\Lambda_c^+,\\bar{\\Lambda}^+_c$", 4222 : "$\\Sigma_c^{++}, \\Sigma_c^{0}, \\bar{\\Sigma}_c^{++}, \\bar{\\Sigma}_c^{0}$", + 14122 : "$\\Lambda_c(2595)^+,\\bar{\\Lambda}(2595)_c^+$", 4314 : "$\\Xi^{*0}_c$", 4324 : "$\\Xi^{*+}_c$", 4322 : "$\\Xi_c^{\\prime+}$", + 4312 : "$\\Xi_c^{\\prime0}$", + 5122 : "$\\Lambda_b^0,\\bar{\\Lambda}^0_b$", 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$", + 4332 : "$\\Omega_c^0,\\bar{\\Omega}_c^0$", 4132 : "$\\Xi_c^0,\\bar{\\Xi}_c^0$", 4232 : "$\\Xi_c^+,\\bar{\\Xi}_c^-$", "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] +mCharm = [411,421,413,423,425,20431,10423,431,433,435,10433] mBottom = [511,"511B",521,531,513,515] mccbar = [441,443,100443,20443,30443] -mbbbar = [553,100553,300553] +mbbbar = [553,100553,200553,300553,400553] 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] +bCharm = [4122,4112,4222,4114,4332,4132,4232,14122,4124,4312,4322,4314,4324] 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 \\mu^+\\mu^-$" : {}, "$\\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 \\mu^+\\mu^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_13_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_13_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_221p_22p_13_mff"] 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$" : {},}} + "$\\phi\\to \\eta\\pi^0\\gamma$" : {}, + "$\\phi\\to \\mu^+\\mu^-\\pi^0$" : {}, + "$\\phi\\to \\mu^+\\mu^-\\eta$" : {},}} 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 \\mu^+\\mu^-\\pi^0$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_333p_111p_13_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_333p_111p_13_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_333p_111p_13_mff"] 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 \\mu^+\\mu^-\\eta$"]["MC"] = ["/MC_Meson_Meson_Leptons_Decay/h_333p_221p_13_mPf", + "/MC_Meson_Meson_Leptons_Decay/h_333p_221p_13_mPfbar", + "/MC_Meson_Meson_Leptons_Decay/h_333p_221p_13_mff"] 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$" ]["data"] = ["/BESIII_2017_I1519425/d01-x01-y01"] 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"] + "/MC_Semi_Leptonic_Decay/h_411p_311m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_311p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_311p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_311m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_311m_13m_scale", + "/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^0e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_111p_11m_energy", - "/MC_Semi_Leptonic_Decay/h_411p_111p_11m_scale"] + "/MC_Semi_Leptonic_Decay/h_411p_111p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_111p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_111p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_111p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_111p_13m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_111p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_111p_13p_scale"] analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0e^+\\nu_e$" ]["data"] = ["/BESIII_2017_I1519425/d02-x01-y01"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\pi^0\\mu^+\\nu_\\mu$" ]["data"] = ["/BESIII_2018_I1655158/d01-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_411p_10313m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_10313p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_10313p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to \\bar{K}_1(1270)^0\\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_10313m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_10313m_13m_scale", + "/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_411p_221p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_221p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_221p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_221p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_221p_13m_scale", + "/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_411p_331p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_331p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_331p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\eta^\\prime\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_331p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_331p_13m_scale", + "/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_411p_113p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_113p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_113p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\rho^0\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_113p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_113p_13m_scale", + "/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_411p_223p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_223p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_223p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\omega\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_223p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_223p_13m_scale", + "/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_411p_313m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_313p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_313p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}^{*0}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_313m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_313m_13m_scale", + "/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_411p_315m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_411m_315p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_411m_315p_11p_scale"] +analyses["HadronDecays"][411]["Modes"]["$D^+\\to\\bar{K}_2^{*0}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_411p_315m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_411p_315m_13m_scale", + "/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_421p_323m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_323p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_323p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_323m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_323m_13m_scale", + "/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_421p_325m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_325p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_325p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^{*-}_2\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_325m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_325m_13m_scale", + "/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_421p_10323m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_10323p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_10323p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K_1(1270)^{-}\\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_10323m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_10323m_13m_scale", + "/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$" ]["data"] = ["/BESIII_2015_I1391138/d01-x01-y03", + "/BABAR_2007_I1091435/d01-x01-y01"] 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_421p_321m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_321p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_321p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to K^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_321m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_321m_13m_scale", + "/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^-\\mu^+\\nu_\\mu$" ]["data"] = ["/BESIII_2018_I1655158/d02-x01-y01"] 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_421p_211m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_211p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_211p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\pi^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_211m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_211m_13m_scale", + "/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_421p_213m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_421m_213p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_421m_213p_11p_scale"] +analyses["HadronDecays"][421]["Modes"]["$D^0\\to \\rho^-\\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_421p_213m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_421p_213m_13m_scale", + "/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_431p_221p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431m_221p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_221p_11p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_221p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_221p_13m_scale", + "/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_431p_331p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431m_331p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_331p_11p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\eta^\\prime \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_331p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_331p_13m_scale", + "/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_431p_333p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431m_333p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_333p_11p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to \\phi \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_333p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_333p_13m_scale", + "/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_311p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_311p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_431m_311m_11p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_311m_11p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_311p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_431p_311p_13m_scale", + "/MC_Semi_Leptonic_Decay/h_431m_311m_13p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_311m_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"] + "/MC_Semi_Leptonic_Decay/h_431m_313m_11p_energy", + "/MC_Semi_Leptonic_Decay/h_431m_313m_11p_scale"] +analyses["HadronDecays"][431]["Modes"]["$D_s^+\\to K^{*0} \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_431p_313p_13m_scale", + "/MC_Semi_Leptonic_Decay/h_431p_313p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_431m_313m_13p_scale", + "/MC_Semi_Leptonic_Decay/h_431m_313m_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"] +# D_2 +analyses["HadronDecays"][425] = { "Modes" : { "$D^0_2\\to D^+\pi^-$" : {}, + "$D^0_2\\to D^{*+}\pi^-$" : {}}} +analyses["HadronDecays"][425]["Modes"]["$D^0_2\\to D^+\pi^-$" ]["data"] = ["/ARGUS_1989_I268577/d03-x01-y01"] +analyses["HadronDecays"][425]["Modes"]["$D^0_2\\to D^{*+}\pi^-$"]["data"] = ["/ARGUS_1989_I280943/d03-x01-y02","/BABAR_2010_I867611/d01-x01-y02", + "/CLEO_1990_I281039/d01-x01-y02","/LHCB_2013_I1243156/d08-x01-y02"] +# D_1 +analyses["HadronDecays"][10423] = { "Modes" : { "$D^0_1\\to D^{*+}\pi^-$" : {}}} +analyses["HadronDecays"][10423]["Modes"]["$D^0_1\\to D^{*+}\pi^-$"]["data"] = ["/ARGUS_1989_I280943/d03-x01-y01","/BABAR_2010_I867611/d01-x01-y01", + "/CLEO_1990_I281039/d01-x01-y01","/LHCB_2013_I1243156/d08-x01-y01"] + 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$" : {}, +analyses["HadronDecays"][521]={ "Spectrum" : {}, + "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"][511]["Spectrum"][311 ] = ["/ARGUS_1994_I354224/d01-x01-y01"] + +analyses["HadronDecays"][521]["Spectrum"][411 ] = ["/BABAR_2006_I719111/d01-x01-y01","/BABAR_2006_I719111/d01-x01-y02"] +analyses["HadronDecays"][521]["Spectrum"][421 ] = ["/BABAR_2006_I719111/d02-x01-y01","/BABAR_2006_I719111/d02-x01-y02"] +analyses["HadronDecays"][521]["Spectrum"][431 ] = ["/BABAR_2006_I719111/d03-x01-y01","/BABAR_2006_I719111/d03-x01-y02"] +analyses["HadronDecays"][521]["Spectrum"][4122] = ["/BABAR_2006_I719111/d04-x01-y01","/BABAR_2006_I719111/d04-x01-y02"] +analyses["HadronDecays"][511]["Spectrum"][411 ] = ["/BABAR_2006_I719111/d05-x01-y01","/BABAR_2006_I719111/d05-x01-y02", + "/ARGUS_1991_I315059/d05-x01-y01"] +analyses["HadronDecays"][511]["Spectrum"][413 ] = ["/ARGUS_1991_I315059/d07-x01-y01"] +analyses["HadronDecays"][511]["Spectrum"][421 ] = ["/BABAR_2006_I719111/d06-x01-y01","/BABAR_2006_I719111/d06-x01-y02", + "/ARGUS_1991_I315059/d06-x01-y01"] +analyses["HadronDecays"][511]["Spectrum"][431 ] = ["/BABAR_2006_I719111/d07-x01-y01","/BABAR_2006_I719111/d07-x01-y02"] +analyses["HadronDecays"][511]["Spectrum"][4122] = ["/BABAR_2006_I719111/d08-x01-y01","/BABAR_2006_I719111/d08-x01-y02"] 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_521p_111p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_111p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_111p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\pi^0 \\mu^+\\nu_\\mu$" ]["MC"] = ["/MC_Semi_Leptonic_Decay/h_521p_111p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_111p_13m_scale", + "/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_511p_211m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_211p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_211p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\pi^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_211m_13m_scale", + "/MC_Semi_Leptonic_Decay/h_511p_211m_13m_energy", + "/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",] + "/MC_Semi_Leptonic_Decay/h_511p_213m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_213p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_213p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to\\rho^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_213m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_213m_13m_scale", + "/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\\omega e^+\\nu_e$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_223p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_223p_11p_scale", + "/MC_Semi_Leptonic_Decay/h_521p_223p_11m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_223p_11m_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\omega \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521m_223p_13p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_223p_13p_scale", + "/MC_Semi_Leptonic_Decay/h_521p_223p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_223p_13m_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_521p_113p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_113p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_113p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\rho^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_113p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_113p_13m_scale", + "/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_511p_411m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_411p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_411p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^- \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_411m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_411m_13m_scale", + "/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",] + "/MC_Semi_Leptonic_Decay/h_511p_413m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_413p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_413p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-} \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_413m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_413m_13m_scale", + "/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_511p_415m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_415p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_415p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_2 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_415m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_415m_13m_scale", + "/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_521p_331p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_331p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_331p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta^\\prime \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_331p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_331p_13m_scale", + "/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_521p_221p_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_221p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_221p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\eta \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_221p_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_221p_13m_scale", + "/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_521p_421m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_421p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_421p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^0 \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_421m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_421m_13m_scale", + "/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_521p_423m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_423p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_423p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0} \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_423m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_423m_13m_scale", + "/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_521p_425m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_425p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_425p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_2 \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_425m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_425m_13m_scale", + "/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_521p_10421m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_10421p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_10421p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{*0}_0(2400) \\mu^+\\nu_\\mu$"]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_10421m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_10421m_13m_scale", + "/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_521p_20423m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_20423p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_20423p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2430) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_20423m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_20423m_13m_scale", + "/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_521p_10423m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_521m_10423p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_521m_10423p_11p_scale"] +analyses["HadronDecays"][521]["Modes"]["$B^+\\to\\bar{D}^{0}_1(2420) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_521p_10423m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_521p_10423m_13m_scale", + "/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_511p_10411m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_10411p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_10411p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{*-}_0(2400) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_10411m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_10411m_13m_scale", + "/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_511p_20413m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_20413p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_20413p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2430) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_20413m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_20413m_13m_scale", + "/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_511p_10413m_11m_scale", + "/MC_Semi_Leptonic_Decay/h_511m_10413p_11p_energy", + "/MC_Semi_Leptonic_Decay/h_511m_10413p_11p_scale"] +analyses["HadronDecays"][511]["Modes"]["$B^0\\to D^{-}_1(2420) \\mu^+\\nu_\\mu$" ]["MC" ] = ["/MC_Semi_Leptonic_Decay/h_511p_10413m_13m_energy", + "/MC_Semi_Leptonic_Decay/h_511p_10413m_13m_scale", + "/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\\gamma \\mu^+\\mu^-$" : {}, "$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^{*-}\\bar\\Xi^{*+}$" : {}, "$J/\\psi\\to \\Xi^{0}\\bar\\Xi^{0}$" : {}, "$J/\\psi\\to \\Lambda^{0}\\bar\\Lambda^{0}$" : {}, + "$J/\\psi\\to \\Lambda^{0}\\bar\\Sigma^{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\\gamma \\mu^+\\mu^-$"]["MC" ] = ["/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_13_mVf", + "/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_13_mVfbar", + "/MC_Meson_Meson_Leptons_Decay/h2_443p_22p_13_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\\Sigma^{0}$" ]["data"] = ["/BESIII_2012_I1121378/d01-x01-y01","/BESIII_2012_I1121378/d01-x01-y02", + "/BESIII_2012_I1121378/d05-x01-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"] +analyses["HadronDecays"][443]["Modes"]["$J/\\psi\\to \\Xi^{*-}\\bar\\Xi^{*+}$" ]["data"] = ["/BESIII_2019_I1765606/d02-x01-y01","/BESIII_2019_I1765606/d01-x01-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^{*-}\\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}$" : {}, }} + "$\\psi(2S)\\to \\Sigma^{0}\\bar\\Sigma^{0}$" : {}, + "$\\psi(2S)\\to J/\\psi\\pi^+\\pi^-$" : {}, + "$\\psi(2S)\\to J/\\psi\\pi^0\\pi^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"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to \\Xi^{*-}\\bar\\Xi^{*+}$" ]["data"] = ["/BESIII_2019_I1747092/d01-x01-y01","/BESIII_2019_I1747092/d01-x01-y02", + "/BESIII_2019_I1747092/d02-x01-y01"] + +analyses["HadronDecays"][100443]["Modes"]["$\\psi(2S)\\to J/\\psi\\pi^+\\pi^-$"]["data"] = ["/MARKII_1979_I144382/d01-x01-y01"] +analyses["HadronDecays"][100443]["Modes"]["$\\psi(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"][100443]["Modes"]["$\\psi(2S)\\to J/\\psi\\pi^+\\pi^-$"]["MC" ] = ["/MC_Onium_PiPi_Decay/h_100443_443_hpippim", + "/MC_Onium_PiPi_Decay/h_100443_443_mpippim"] + + + # bottomonium # upsilon(1s) -analyses["HadronDecays"][553] = { "Mult" : {}, "Spectrum" : {} } +analyses["HadronDecays"][553] = { "Mult" : {}, "Spectrum" : {}, "Shapes" : [] } +analyses["HadronDecays"][553]["Shapes"]=["/ARGUS_1986_I227324/d01-x01-y01","/ARGUS_1986_I227324/d02-x01-y01","/LENA_1981_I164397/d04-x01-y03"] 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"][331 ] = ["/ARGUS_1993_S2669951/d01-x01-y01","/ARGUS_1993_S2669951/d01-x01-y02", + "/CLEOII_2002_I601701/d02-x01-y03","/CLEOIII_2006_I728679/d02-x01-y01"] 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"] +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"] +analyses["HadronDecays"][553]["Spectrum"][331 ] = ["/CLEOII_2002_I601701/d01-x01-y03","/CLEOIII_2006_I728679/d01-x01-y01"] +analyses["HadronDecays"][553]["Spectrum"][413 ] = ["/BABAR_2009_I836615/d01-x01-y01"] # upsion(2s) -analyses["HadronDecays"][100553] = { "Mult" : {}, "Spectrum" : {}, +analyses["HadronDecays"][100553] = { "Mult" : {}, "Spectrum" : {}, "Shapes" : [], "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]["Shapes"] = ["/LENA_1981_I164397/d04-x01-y04"] 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$"]["data"] = ["/CLEOII_1998_I467642/d03-x01-y01"] 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"] +analyses["HadronDecays"][100553]["Modes"]["$\\Upsilon(2S)\\to \\Upsilon(1S)\\pi^+\\pi^-$" ]["data"] = ["/CUSB_1984_I199809/d01-x01-y01", + "/CLEOII_1998_I467642/d01-x01-y01","/CLEOII_1998_I467642/d02-x01-y01", + "/CLEOII_1998_I467642/d04-x01-y01","/CLEOII_1998_I467642/d04-x01-y02", + "/CLEOII_1998_I467642/d05-x01-y01","/CLEOII_1998_I467642/d05-x01-y02", + "/CLEOII_1998_I467642/d06-x01-y01","/CLEOII_1998_I467642/d06-x01-y02", + "/CLEOII_1994_I356001/d04-x01-y01","/CLEOII_1994_I356001/d04-x01-y02"] +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 3S +analyses["HadronDecays"][200553] = { "Modes" : {"$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^0\\pi^0$" : {}, + "$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^+\\pi^-$" : {}, + "$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^0\\pi^0$" : {}, + "$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^+\\pi^-$" : {}}} +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^0\\pi^0$"]["data"]=["/CLEOII_1994_I356001/d01-x01-y01"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^+\\pi^-$"]["data"]=["/CLEOII_1994_I356001/d02-x01-y01", + "/CLEOII_1994_I356001/d02-x01-y02"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^0\\pi^0$"]["data"]=["/CLEOII_1994_I356001/d01-x01-y02"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^+\\pi^-$"]["data"]=["/CLEOII_1994_I356001/d03-x01-y01", + "/CLEOII_1994_I356001/d03-x01-y02"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^0\\pi^0$"]["MC"]=["/MC_Onium_PiPi_Decay/h_200553_553_hpi0pi0", + "/MC_Onium_PiPi_Decay/h_200553_553_mpi0pi0"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(1S)\\pi^+\\pi^-$"]["MC"]=["/MC_Onium_PiPi_Decay/h_200553_553_hpippim", + "/MC_Onium_PiPi_Decay/h_200553_553_mpippim"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^0\\pi^0$"]["MC"]=["/MC_Onium_PiPi_Decay/h_200553_100553_hpi0pi0", + "/MC_Onium_PiPi_Decay/h_200553_100553_mpi0pi0"] +analyses["HadronDecays"][200553]["Modes"]["$\\Upsilon(3S)\\to\\Upsilon(2S)\\pi^+\\pi^-$"]["MC"]=["/MC_Onium_PiPi_Decay/h_200553_100553_hpippim", + "/MC_Onium_PiPi_Decay/h_200553_100553_mpippim"] # 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\\Upsilon(2S)\\pi^0\\pi^0$" : {}, + "$\\Upsilon(4S)\\to\\Upsilon(2S)\\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", +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(1S)\\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\\Upsilon(1S)\\pi^+\\pi^-$"]["MC"]=["/MC_Onium_PiPi_Decay/h_300553_553_hpippim", + "/MC_Onium_PiPi_Decay/h_300553_553_mpippim"] +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(1S)\\pi^+\\pi^-$"]["data"]=["/BELLE_2009_I810744/d01-x01-y01"] +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(2S)\\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", +analyses["HadronDecays"][300553]["Modes"]["$\\Upsilon(4S)\\to\\Upsilon(2S)\\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]["DistChargedMult"]["data"] = ["/ARGUS_1992_I319102/d03-x01-y01","/CLEOII_1999_I504672/d02-x01-y01"] +analyses["HadronDecays"][300553]["Mult"]["Charged"] = ["/CLEOII_1999_I504672/d01-x01-y01","/CLEOII_1999_I504672/d01-x01-y02","/CLEOII_1999_I504672/d01-x01-y03"] 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"][4132 ] = ["/BABAR_2005_S6181155/d01-x01-y01","/BABAR_2005_S6181155/d02-x01-y01", + "/CLEOII_1997_I442910/d01-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"][300553]["Spectrum"][431 ] = ["/CLEO_2005_I1649168/d01-x01-y07"] +analyses["HadronDecays"][300553]["Spectrum"][333 ] = ["/CLEO_2007_I728872/d01-x01-y05"] +analyses["HadronDecays"][300553]["Spectrum"][4232 ] = ["/CLEOII_1997_I442910/d02-x01-y01"] +analyses["HadronDecays"][300553]["Spectrum"][11] = ["/BABAR_2017_I1498564/d01-x01-y01","/BABAR_2017_I1498564/d01-x01-y02"] +# upsilon(5s) +analyses["HadronDecays"][400553] = {"Spectrum" : {}} +analyses["HadronDecays"][400553]["Spectrum"][431 ] = ["/CLEO_2005_I1649168/d01-x01-y08"] +analyses["HadronDecays"][400553]["Spectrum"][333 ] = ["/CLEO_2007_I728872/d02-x01-y05" ] # 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^-$"]["data"] = ["/E756_2000_I530367/d01-x01-y01","/E756_2000_I530367/d01-x01-y02", + "/CLEOII_2000_I533575/d01-x01-y01","/CLEOII_2000_I533575/d01-x01-y02", + "/CLEOII_2000_I533575/d02-x01-y01","/CLEOII_2000_I533575/d02-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^-$" : {},"$\\Omega^-\\to\\Xi^0\\pi^-$" : {}, "$\\Omega^-\\to\\Xi^-\\pi^0$" : {} } } 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", "/WA46_1984_I206647/d01-x01-y01"] analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Lambda^0K^-$"]["MC" ] = ["/HyperCP_2005_I677384/cthetaM", "/HyperCP_2005_I677384/cthetaP", "/HyperCP_2005_I677384/cthetaAll", - "/WA46_1984_I206647/Lambda"] + "/WA46_1984_I206647/cthetaLambda"] analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^0\\pi^-$"]["data"]=["/WA46_1984_I206647/d01-x01-y02"] -analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^0\\pi^-$"]["MC" ]=["/WA46_1984_I206647/Xi0"] +analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^0\\pi^-$"]["MC" ]=["/WA46_1984_I206647/cthetaXi0"] analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^-\\pi^0$"]["data"]=["/WA46_1984_I206647/d01-x01-y03"] -analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^-\\pi^0$"]["MC" ]=["/WA46_1984_I206647/Xim"] +analyses["HadronDecays"][3334]["Modes"]["$\\Omega^-\\to\\Xi^-\\pi^0$"]["MC" ]=["/WA46_1984_I206647/cthetaXim"] -analyses["HadronDecays"][4132] = { "Modes" : { "$\\Xi^0_c\\to\\Xi^-\\pi^+$" : {} } } +analyses["HadronDecays"][4132] = { "Modes" : { "$\\Xi^0_c\\to\\Xi^-\\pi^+$" : {}, "$\\Xi^0_c\\to\\Omega^-K^+" : {} } } 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"][4132]["Modes"]["$\\Xi^0_c\\to\\Omega^-K^+"]["data"] = ["/BABAR_2006_I719581/d01-x01-y01","/BABAR_2006_I719581/d02-x01-y01"] -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"] - +analyses["HadronDecays"][4122] = { "Modes" : { "$\\Lambda^+_c\\to\\Lambda^0\\pi^+$" : {}, "$\\Lambda^+_c\\to\\Sigma^+\\pi^0$" : {}, + "$\\Lambda^+_c\\to\\Lambda^0 e^+\\bar{\\nu}_e$" : {} } } +analyses["HadronDecays"][4122]["Modes"]["$\\Lambda^+_c\\to\\Lambda^0\\pi^+$"]["data"] = ["/FOCUS_2006_I693639/d01-x01-y01","/FOCUS_2006_I693639/d02-x01-y01", + "/FOCUS_2006_I693639/d03-x01-y01", + "/CLEO_1995_I392704/d01-x01-y01","/CLEO_1995_I392704/d03-x01-y01", + "/ARGUS_1992_I319105/d02-x01-y01","/ARGUS_1992_I319105/d03-x01-y01"] +analyses["HadronDecays"][4122]["Modes"]["$\\Lambda^+_c\\to\\Sigma^+\\pi^0$"]["data"] = ["/CLEO_1995_I392704/d02-x01-y01","/CLEO_1995_I392704/d04-x01-y01"] +analyses["HadronDecays"][4122]["Modes"]["$\\Lambda^+_c\\to\\Lambda^0 e^+\\bar{\\nu}_e$"]["data"] = ["/CLEOII_2005_I668268/d01-x01-y01","/CLEOII_1994_I371611/d01-x01-y01", + "/CLEOII_1994_I371611/d02-x01-y01","/ARGUS_1994_I371613/d01-x01-y01"] # charged multiplicity (total) +analyses["Charged"]["TotalChargedMult"][0][9.5 ] = ["/LENA_1981_I164397/d03-x01-y01"] 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][22.0 ] = ["/TASSO_1980_I143691/d01-x01-y01","/JADE_1979_I142874/d02-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][57.8 ] = ["/TOPAZ_1997_I454183/d01-x01-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"] +analyses["Charged"]["TotalChargedMult"][0][161.0] = ["/OPAL_1997_I440721/d02-x01-y01"] +analyses["Charged"]["TotalChargedMult"][0][172.0] = ["/OPAL_2000_I513476/d14-x01-y01"] # light quark events analyses["Charged"]["TotalChargedMult"][1][29.0 ] = ["/TPC_1987_I235694/d04-x01-y04"] +analyses["Charged"]["TotalChargedMult"][1][58.0 ] = ["/VENUS_1998_I453613/d01-x01-y02"] 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"] + "/SLD_1996_S3398250/d03-x01-y01","/DELPHI_1999_I448370/d09-x01-y02", + "/OPAL_2001_I536266/d01-x01-y01","/OPAL_2001_I536266/d01-x01-y02", + "/OPAL_2001_I536266/d01-x01-y03","/OPAL_2001_I536266/d02-x01-y01", + "/OPAL_2001_I536266/d02-x01-y02","/OPAL_2001_I536266/d02-x01-y03"] 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][58.0 ] = ["/VENUS_1998_I453613/d01-x01-y01"] 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"] + "/SLD_1996_S3398250/d01-x01-y01","/DELPHI_1999_I448370/d09-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][58.0 ] = ["/VENUS_1998_I453613/d01-x01-y03"] 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"][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.0] = ["/OPAL_1997_I440721/d26-x01-y01"] +analyses["Charged"]["DistChargedMult"][0][161.3] = ["/L3_2004_I652683/d60-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][172.0] = ["/OPAL_2000_I513476/d13-x01-y01"] +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][183.0] = ["/OPAL_2000_I513476/d13-x01-y02"] +analyses["Charged"]["DistChargedMult"][0][188.6] = ["/L3_2004_I652683/d61-x01-y03"] +analyses["Charged"]["DistChargedMult"][0][189.0] = ["/OPAL_2000_I513476/d13-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.0] = ["/ALEPH_2004_S5765862/d12-x01-y01","/OPAL_1997_I440721/d25-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.0] = ["/ALEPH_2004_S5765862/d13-x01-y01","/OPAL_2000_I513476/d19-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"][183.0] = ["/DELPHI_2003_I620250/d32-x01-y01","/ALEPH_2004_S5765862/d14-x01-y01", + "/OPAL_2000_I513476/d19-x01-y02"] 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"][189.0] = ["/ALEPH_2004_S5765862/d15-x01-y01","/DELPHI_2003_I620250/d32-x01-y02", + "/OPAL_2000_I513476/d19-x01-y03"] 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" ][ 3.0 ] = ["/MARKI_1976_I109792/d02-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 4.8 ] = ["/MARKI_1976_I109792/d03-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 5.8 ] = ["/MARKI_1976_I109792/d04-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 6.2 ] = ["/MARKI_1976_I109792/d05-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 6.6 ] = ["/MARKI_1976_I109792/d06-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 7.0 ] = ["/MARKI_1976_I109792/d07-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][ 7.4 ] = ["/MARKI_1976_I109792/d08-x01-y01"] 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" ][161.0] = ["/ALEPH_2004_S5765862/d03-x01-y01","/ALEPH_2004_S5765862/d20-x01-y01", + "/OPAL_1997_I440721/d24-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][172.0] = ["/ALEPH_2004_S5765862/d04-x01-y01","/ALEPH_2004_S5765862/d21-x01-y01", + "/OPAL_2000_I513476/d18-x01-y01"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][183.0] = ["/ALEPH_2004_S5765862/d05-x01-y01","/ALEPH_2004_S5765862/d22-x01-y01", + "/OPAL_2000_I513476/d18-x01-y02"] +analyses["Charged"]["ChargedSpectrum"][0]["x" ][189.0] = ["/ALEPH_2004_S5765862/d06-x01-y01","/ALEPH_2004_S5765862/d23-x01-y01", + "/OPAL_2000_I513476/d18-x01-y03"] 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"] +# misc +analyses["Charged"]["ChargedSpectrum"][0]["Other"][91.2] = ["/DELPHI_1999_I448370/d01-x01-y01","/DELPHI_1999_I448370/d02-x01-y01", + "/DELPHI_1999_I448370/d03-x01-y01","/DELPHI_1999_I448370/d04-x01-y01", + "/DELPHI_1999_I448370/d05-x01-y01","/DELPHI_1999_I448370/d05-x01-y02", + "/DELPHI_1999_I448370/d05-x01-y03","/DELPHI_1999_I448370/d06-x01-y01", + "/DELPHI_1999_I448370/d06-x01-y02","/DELPHI_1999_I448370/d07-x01-y01", + "/DELPHI_1999_I448370/d07-x01-y02","/DELPHI_1999_I448370/d08-x01-y01", + "/DELPHI_1999_I448370/d08-x01-y02"] # 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"][161.0] = ["/ALEPH_2004_S5765862/d37-x01-y01","/OPAL_1997_I440721/d23-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][172.0] = ["/ALEPH_2004_S5765862/d38-x01-y01","/OPAL_2000_I513476/d17-x01-y01"] +analyses["Charged"]["ChargedRapidityThrust"][183.0] = ["/DELPHI_2003_I620250/d30-x01-y01","/ALEPH_2004_S5765862/d39-x01-y01", + "/OPAL_2000_I513476/d17-x01-y02"] +analyses["Charged"]["ChargedRapidityThrust"][189.0] = ["/DELPHI_2003_I620250/d30-x01-y02","/ALEPH_2004_S5765862/d40-x01-y01", + "/OPAL_2000_I513476/d17-x01-y03"] 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" ][161.0] = ["/ALEPH_2004_S5765862/d28-x01-y01","/OPAL_1997_I440721/d21-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][172.0] = ["/ALEPH_2004_S5765862/d29-x01-y01","/OPAL_2000_I513476/d15-x01-y01"] +analyses["Charged"]["ChargedpTInThrust" ][183.0] = ["/DELPHI_2003_I620250/d34-x01-y01","/ALEPH_2004_S5765862/d30-x01-y01", + "/OPAL_2000_I513476/d15-x01-y02"] +analyses["Charged"]["ChargedpTInThrust" ][189.0] = ["/DELPHI_2003_I620250/d34-x01-y02","/ALEPH_2004_S5765862/d31-x01-y01", + "/OPAL_2000_I513476/d15-x01-y03"] 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"][161.0] = ["/OPAL_1997_I440721/d22-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][172.0] = ["/OPAL_2000_I513476/d16-x01-y01"] +analyses["Charged"]["ChargedpTOutThrust"][183.0] = ["/DELPHI_2003_I620250/d36-x01-y01","/OPAL_2000_I513476/d16-x01-y02"] +analyses["Charged"]["ChargedpTOutThrust"][189.0] = ["/DELPHI_2003_I620250/d36-x01-y02","/OPAL_2000_I513476/d16-x01-y03"] 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" ][3.635] = ["/DASP_1979_I132045/d18-x01-y01"] analyses["IdentifiedParticle"][211 ]["x" ][4.04 ] = ["/DASP_1979_I132045/d18-x01-y02"] analyses["IdentifiedParticle"][211 ]["x" ][4.17 ] = ["/DASP_1979_I132045/d18-x01-y03"] analyses["IdentifiedParticle"][211 ]["x" ][4.30 ] = ["/DASP_1979_I132045/d18-x01-y04"] analyses["IdentifiedParticle"][211 ]["x" ][4.41 ] = ["/DASP_1979_I132045/d18-x01-y05"] analyses["IdentifiedParticle"][211 ]["x" ][4.72 ] = ["/DASP_1979_I132045/d18-x01-y06"] analyses["IdentifiedParticle"][211 ]["x" ][5.0 ] = ["/DASP_1979_I132045/d18-x01-y07"] analyses["IdentifiedParticle"][211 ]["x" ][5.2 ] = ["/DASP_1979_I132045/d18-x01-y08"] 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" ][3.635] = ["/DASP_1979_I132045/d01-x01-y01"] analyses["IdentifiedParticle"][211 ]["p" ][4.04 ] = ["/DASP_1979_I132045/d01-x01-y02"] analyses["IdentifiedParticle"][211 ]["p" ][4.17 ] = ["/DASP_1979_I132045/d01-x01-y03"] analyses["IdentifiedParticle"][211 ]["p" ][4.30 ] = ["/DASP_1979_I132045/d01-x01-y04"] analyses["IdentifiedParticle"][211 ]["p" ][4.41 ] = ["/DASP_1979_I132045/d01-x01-y05"] analyses["IdentifiedParticle"][211 ]["p" ][4.72 ] = ["/DASP_1979_I132045/d01-x01-y06"] analyses["IdentifiedParticle"][211 ]["p" ][5.0 ] = ["/DASP_1979_I132045/d01-x01-y07"] analyses["IdentifiedParticle"][211 ]["p" ][5.2 ] = ["/DASP_1979_I132045/d01-x01-y08"] 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",] + "/OPAL_1998_S3749908/d04-x01-y01","/ALEPH_1997_I427131/d02-x01-y02", + "/ALEPH_2000_I507531/d01-x01-y01","/ALEPH_2000_I507531/d04-x01-y01", + "/ALEPH_2000_I507531/d07-x01-y01","/ALEPH_2000_I507531/d08-x01-y01", + "/ALEPH_2000_I507531/d09-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"] +# others +analyses["IdentifiedParticle"][111 ]["Other"][91.2]=["/ALEPH_1997_I427131/d03-x01-y01","/ALEPH_1997_I427131/d04-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",] + "/ALEPH_1996_S3486095/d30-x01-y01","/OPAL_1998_S3749908/d06-x01-y01", + "/ALEPH_2000_I507531/d02-x01-y01","/ALEPH_2000_I507531/d05-x01-y01", + "/ALEPH_2000_I507531/d10-x01-y01","/ALEPH_2000_I507531/d11-x01-y01", + "/ALEPH_2000_I507531/d12-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"] + "/ALEPH_1996_S3486095/d31-x01-y01","/OPAL_1998_S3749908/d12-x01-y01", + "/ALEPH_2000_I507531/d03-x01-y01","/ALEPH_2000_I507531/d06-x01-y01", + "/ALEPH_2000_I507531/d13-x01-y01","/ALEPH_2000_I507531/d14-x01-y01", + "/ALEPH_2000_I507531/d15-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"] + "/ALEPH_1996_S3486095/d32-x01-y01","/SLD_1999_S3743934/d05-x01-y01", + "/OPAL_1995_I393503/d02-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"] +analyses["IdentifiedParticle"][311 ]["xi" ][91.2] = ["/DELPHI_1995_I377487/d09-x01-y01","/OPAL_1995_I393503/d03-x01-y01", + "/ALEPH_2000_I507531/d16-x01-y01","/ALEPH_2000_I507531/d18-x01-y01", + "/ALEPH_2000_I507531/d20-x01-y01","/ALEPH_2000_I507531/d21-x01-y01", + "/ALEPH_2000_I507531/d21-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" ][3.635] = ["/DASP_1979_I132045/d19-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][4.04 ] = ["/DASP_1979_I132045/d20-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][4.17 ] = ["/DASP_1979_I132045/d21-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][4.30 ] = ["/DASP_1979_I132045/d22-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][4.41 ] = ["/DASP_1979_I132045/d23-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][4.72 ] = ["/DASP_1979_I132045/d24-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][5.0 ] = ["/DASP_1979_I132045/d25-x01-y01"] analyses["IdentifiedParticle"][321 ]["x" ][5.2 ] = ["/DASP_1979_I132045/d26-x01-y01"] 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" ][3.635] = ["/DASP_1979_I132045/d02-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][4.04 ] = ["/DASP_1979_I132045/d03-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][4.17 ] = ["/DASP_1979_I132045/d04-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][4.30 ] = ["/DASP_1979_I132045/d05-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][4.41 ] = ["/DASP_1979_I132045/d06-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][4.72 ] = ["/DASP_1979_I132045/d07-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][5.0 ] = ["/DASP_1979_I132045/d08-x01-y01"] analyses["IdentifiedParticle"][321 ]["p" ][5.2 ] = ["/DASP_1979_I132045/d09-x01-y01"] 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"] + "/SLD_2004_S5693039/d10-x01-y02","/SLD_2004_S5693039/d10-x01-y03", + "/DELPHI_1995_I382285/a_K","/DELPHI_1995_I382285/d01-x01-y01"] # 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.47] = ["/ARGUS_1991_I315059/d03-x01-y01"] 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.47] = ["/ARGUS_1991_I315059/d02-x01-y01"] 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.47] = ["/ARGUS_1991_I315059/d04-x01-y01"] 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"] +analyses["IdentifiedParticle"][425 ]["x" ][10.0 ] = ["/ARGUS_1989_I268577/d02-x01-y01","/ARGUS_1989_I280943/d04-x01-y02"] +analyses["IdentifiedParticle"][10423]["x" ][10.0 ] = ["/ARGUS_1989_I280943/d04-x01-y01"] # D_s+ -analyses["IdentifiedParticle"][431 ]["x" ][10.5 ] = ["/CLEO_2000_I526554/d02-x01-y01","/CLEO_2000_I526554/d04-x01-y01"] +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"] +analyses["IdentifiedParticle"][433 ]["x" ][10.5 ] = ["/CLEO_2000_I526554/d01-x01-y01","/CLEO_2000_I526554/d03-x01-y01"] +# D_s1(2536) +analyses["IdentifiedParticle"][10433]["x" ][10.5 ] = ["/CLEOII_1993_I352823/d03-x01-y01"] # charmonium -analyses["IdentifiedParticle"][443 ]["x" ][91.2 ] = ["/OPAL_1996_S3257789/d01-x01-y01"] +analyses["IdentifiedParticle"][443 ]["p" ][10.6 ] = ["/BELLE_2002_I563840/d03-x01-y01","/BELLE_2002_I563840/d03-x01-y02"] +analyses["IdentifiedParticle"][443 ]["x" ][91.2 ] = ["/OPAL_1996_S3257789/d01-x01-y01"] +analyses["IdentifiedParticle"][100443]["p" ][10.6 ] = ["/BELLE_2002_I563840/d03-x02-y01"] # other analyses["IdentifiedParticle"]["321/2212"]["Ratio"][91.2 ] = ["/DELPHI_1998_I473409/d07-x01-y01"] # # Baryons # # light unflavoured # proton # x analyses["IdentifiedParticle"][2212]["x" ][3.635] = ["/DASP_1979_I132045/d27-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][4.04 ] = ["/DASP_1979_I132045/d28-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][4.17 ] = ["/DASP_1979_I132045/d29-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][4.30 ] = ["/DASP_1979_I132045/d30-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][4.41 ] = ["/DASP_1979_I132045/d31-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][4.72 ] = ["/DASP_1979_I132045/d32-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][5.0 ] = ["/DASP_1979_I132045/d33-x01-y01"] analyses["IdentifiedParticle"][2212]["x" ][5.2 ] = ["/DASP_1979_I132045/d34-x01-y01"] 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" ][3.635] = ["/DASP_1979_I132045/d10-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][4.04 ] = ["/DASP_1979_I132045/d11-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][4.17 ] = ["/DASP_1979_I132045/d12-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][4.30 ] = ["/DASP_1979_I132045/d13-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][4.41 ] = ["/DASP_1979_I132045/d14-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][4.72 ] = ["/DASP_1979_I132045/d15-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][5.0 ] = ["/DASP_1979_I132045/d16-x01-y01"] analyses["IdentifiedParticle"][2212]["p" ][5.2 ] = ["/DASP_1979_I132045/d17-x01-y01"] 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" ][42.1 ] = ["/TASSO_1989_I266893/d14-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"] +analyses["IdentifiedParticle"][3122]["p" ][42.1 ] = ["/TASSO_1989_I266893/d09-x01-y01"] # xi -analyses["IdentifiedParticle"][3122]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d02-x01-y01"] +analyses["IdentifiedParticle"][3122]["xi" ][91.2 ] = ["/OPAL_1997_S3396100/d02-x01-y01","/ALEPH_2000_I507531/d17-x01-y01", + "/ALEPH_2000_I507531/d19-x01-y01","/ALEPH_2000_I507531/d22-x01-y01", + "/ALEPH_2000_I507531/d23-x01-y01","/ALEPH_2000_I507531/d24-x01-y01", + "/ALEPH_2000_I507531/d25-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"][42.1 ] = ["/TASSO_1989_I266893/d10-x01-y01","/TASSO_1989_I266893/d11-x01-y01", + "/TASSO_1989_I266893/d12-x01-y01","/TASSO_1989_I266893/d13-x01-y01", + "/TASSO_1989_I266893/d16-x01-y01","/TASSO_1989_I266893/d16-x01-y02", + "/TASSO_1989_I266893/d16-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"] + "/SLD_1999_S3743934/d35-x01-y01","/OPAL_1997_I447188/d03-x01-y01", + "/OPAL_1997_I447188/d03-x01-y02","/OPAL_1997_I447188/d03-x01-y03", + "/OPAL_2000_I474010/d04-x01-y01","/OPAL_2000_I474010/d05-x01-y01", + "/DELPHI_1995_I382285/a_Lam","/DELPHI_1995_I382285/d01-x01-y02", + "/ALEPH_1996_I415745/d03-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"] +analyses["IdentifiedParticle"][4222 ]["x" ][10. ] = ["/ARGUS_1988_I261672/d01-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"] +# xi_c' +analyses["IdentifiedParticle"][4312 ]["x" ][10.58] = ["/CLEOII_1999_I478217/d01-x01-y01"] +# xi_c* +analyses["IdentifiedParticle"][4314 ]["x" ][10.58] = ["/CLEOII_1995_I397770/d02-x01-y01"] +analyses["IdentifiedParticle"][4324 ]["x" ][10.58] = ["/CLEOII_1996_I416471/d02-x01-y01"] # 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"] +analyses["IdentifiedParticle"][14122]["x" ][10.58] = ["/ARGUS_1993_I357132/d01-x01-y01","/CLEOII_1994_I381696/d05-x01-y01"] # lambda_c(2625) analyses["IdentifiedParticle"][4124 ]["x" ][10.52] = ["/BELLE_2017_I1606201/d10-x01-y01"] +analyses["IdentifiedParticle"][4124 ]["x" ][10.58] = ["/ARGUS_1997_I440304/d02-x01-y01","/CLEOII_1994_I381696/d06-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"] +analyses["IdentifiedParticle"][513]["x"][91.2] = ["/DELPHI_1995_I395026/d04-x01-y01"] # 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 ][4. ] = ["/DASP_1979_I132410/d01-x01-y01"] 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.47] = ["/ARGUS_1991_I315059/d01-x01-y02"] 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.47] = ["/ARGUS_1991_I315059/d01-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"][413 ][10.47] = ["/ARGUS_1991_I315059/d01-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"][513 ][91.2 ] = ["/PDG_HADRON_MULTIPLICITIES/d24-x01-y01","/PDG_HADRON_MULTIPLICITIES_RATIOS/d24-x01-y01", + "/DELPHI_1995_I395026/d02-x01-y01","/ALEPH_1995_I398426/d01-x01-y01", + "/L3_1995_I381046/d01-x01-y01","/OPAL_1996_I428493/d01-x01-y01", + "/DELPHI_1995_I395026/d01-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"] + "/SLD_1999_S3743934/d24-x07-y01", + "/OPAL_2000_I474010/d01-x01-y01","/OPAL_2000_I474010/d01-x01-y02","/OPAL_2000_I474010/d01-x01-y03", + "/OPAL_2000_I474010/d02-x01-y01","/OPAL_2000_I474010/d02-x01-y02","/OPAL_2000_I474010/d02-x01-y03", + "/OPAL_2000_I474010/d03-x01-y01","/OPAL_2000_I474010/d03-x01-y02","/OPAL_2000_I474010/d03-x01-y03"] 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 +# thrust +analyses["EventShapes"]["T"][9.98 ] = ["/ARGUS_1986_I227324/d02-x01-y02"] +analyses["EventShapes"]["T"][9.5149] = ["/LENA_1981_I164397/d04-x01-y01"] +analyses["EventShapes"]["T"][9.9903] = ["/LENA_1981_I164397/d04-x01-y02"] 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"][133.0] = ["/ALEPH_2004_S5765862/d55-x01-y01","/OPAL_2004_S6132243/d01-x01-y02", + "/DELPHI_1999_I499183/d13-x01-y01"] +analyses["EventShapes"]["T"][161.0] = ["/ALEPH_2004_S5765862/d56-x01-y01","/DELPHI_1999_I499183/d13-x01-y02", + "/OPAL_1997_I440721/d03-x01-y01"] +analyses["EventShapes"]["T"][172.0] = ["/ALEPH_2004_S5765862/d57-x01-y01","/DELPHI_1999_I499183/d13-x01-y03", + "/OPAL_2000_I513476/d01-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"][183.0] = ["/DELPHI_2003_I620250/d38-x01-y01","/ALEPH_2004_S5765862/d58-x01-y01", + "/DELPHI_1999_I499183/d14-x01-y01","/OPAL_2000_I513476/d01-x01-y02"] +analyses["EventShapes"]["T"][189.0] = ["/DELPHI_2003_I620250/d38-x01-y02","/ALEPH_2004_S5765862/d59-x01-y01", + "/OPAL_2000_I513476/d01-x01-y03"] 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"][133.0] = ["/ALEPH_2004_S5765862/d95-x01-y01","/OPAL_2004_S6132243/d07-x01-y02", + "/DELPHI_1999_I499183/d15-x01-y01"] +analyses["EventShapes"]["Major"][161.0] = ["/ALEPH_2004_S5765862/d96-x01-y01","/DELPHI_1999_I499183/d15-x01-y02", + "/OPAL_1997_I440721/d04-x01-y01"] +analyses["EventShapes"]["Major"][172.0] = ["/ALEPH_2004_S5765862/d97-x01-y01","/DELPHI_1999_I499183/d15-x01-y03", + "/OPAL_2000_I513476/d02-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"][183.0] = ["/DELPHI_2003_I620250/d40-x01-y01","/ALEPH_2004_S5765862/d98-x01-y01", + "/DELPHI_1999_I499183/d16-x01-y01","/OPAL_2000_I513476/d02-x01-y02"] +analyses["EventShapes"]["Major"][189.0] = ["/DELPHI_2003_I620250/d40-x01-y02","/ALEPH_2004_S5765862/d99-x01-y01", + "/OPAL_2000_I513476/d02-x01-y03"] 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"][133.0] = ["/ALEPH_2004_S5765862/d103-x01-y01","/OPAL_2004_S6132243/d08-x01-y02", + "/DELPHI_1999_I499183/d17-x01-y01"] +analyses["EventShapes"]["Minor"][161.0] = ["/ALEPH_2004_S5765862/d104-x01-y01","/DELPHI_1999_I499183/d17-x01-y02", + "/OPAL_1997_I440721/d05-x01-y01"] +analyses["EventShapes"]["Minor"][172.0] = ["/ALEPH_2004_S5765862/d105-x01-y01","/DELPHI_1999_I499183/d17-x01-y03", + "/OPAL_2000_I513476/d03-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"][183.0] = ["/DELPHI_2003_I620250/d42-x01-y01","/ALEPH_2004_S5765862/d106-x01-y01", + "/DELPHI_1999_I499183/d18-x01-y01","/OPAL_2000_I513476/d03-x01-y02"] +analyses["EventShapes"]["Minor"][189.0] = ["/DELPHI_2003_I620250/d42-x01-y02","/ALEPH_2004_S5765862/d107-x01-y01", + "/OPAL_2000_I513476/d03-x01-y03"] 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"][133.0] = ["/ALEPH_2004_S5765862/d134-x01-y01","/OPAL_2004_S6132243/d11-x01-y02", + "/DELPHI_1999_I499183/d19-x01-y01"] +analyses["EventShapes"]["O"][161.0] = ["/ALEPH_2004_S5765862/d135-x01-y01","/DELPHI_1999_I499183/d19-x01-y02", + "/OPAL_1997_I440721/d06-x01-y01"] +analyses["EventShapes"]["O"][172.0] = ["/ALEPH_2004_S5765862/d136-x01-y01","/DELPHI_1999_I499183/d19-x01-y03", + "/OPAL_2000_I513476/d05-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"][183.0] = ["/DELPHI_2003_I620250/d44-x01-y01","/ALEPH_2004_S5765862/d137-x01-y01", + "/DELPHI_1999_I499183/d20-x01-y01","/OPAL_2000_I513476/d05-x01-y02"] +analyses["EventShapes"]["O"][189.0] = ["/DELPHI_2003_I620250/d44-x01-y02","/ALEPH_2004_S5765862/d138-x01-y01", + "/OPAL_2000_I513476/d05-x01-y03"] 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 +# wide +analyses["EventShapes"]["BW"][35.0 ] = ["/JADE_1998_S3612880/d09-x01-y01"] +analyses["EventShapes"]["BW"][41.4 ] = ["/L3_2004_I652683/d36-x01-y01"] +analyses["EventShapes"]["BW"][44.0 ] = ["/JADE_1998_S3612880/d05-x01-y01"] analyses["EventShapes"]["BW"][45.0 ] = ["/DELPHI_2003_I620250/d13-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"][66.0 ] = ["/DELPHI_2003_I620250/d13-x01-y02"] +analyses["EventShapes"]["BW"][75.7 ] = ["/L3_2004_I652683/d37-x01-y01"] 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"][82.3 ] = ["/L3_2004_I652683/d37-x01-y02"] +analyses["EventShapes"]["BW"][85.1 ] = ["/L3_2004_I652683/d37-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"][130.1] = ["/L3_2004_I652683/d38-x01-y01"] +analyses["EventShapes"]["BW"][133.0] = ["/OPAL_2004_S6132243/d05-x01-y02","/ALEPH_2004_S5765862/d79-x01-y01", + "/DELPHI_1999_I499183/d33-x01-y01"] +analyses["EventShapes"]["BW"][136.3] = ["/L3_2004_I652683/d38-x01-y02"] +analyses["EventShapes"]["BW"][161.0] = ["/ALEPH_2004_S5765862/d80-x01-y01","/DELPHI_1999_I499183/d33-x01-y02", + "/OPAL_1997_I440721/d12-x01-y01"] +analyses["EventShapes"]["BW"][161.3] = ["/L3_2004_I652683/d38-x01-y03"] +analyses["EventShapes"]["BW"][172.0] = ["/ALEPH_2004_S5765862/d81-x01-y01","/DELPHI_1999_I499183/d33-x01-y03", + "/OPAL_2000_I513476/d10-x01-y01"] +analyses["EventShapes"]["BW"][172.3] = ["/L3_2004_I652683/d39-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"][182.8] = ["/L3_2004_I652683/d39-x01-y02"] +analyses["EventShapes"]["BW"][183.0] = ["/DELPHI_2003_I620250/d46-x01-y01","/ALEPH_2004_S5765862/d82-x01-y01", + "/DELPHI_1999_I499183/d34-x01-y01","/OPAL_2000_I513476/d10-x01-y02"] +analyses["EventShapes"]["BW"][188.6] = ["/L3_2004_I652683/d39-x01-y03"] +analyses["EventShapes"]["BW"][189.0] = ["/DELPHI_2003_I620250/d46-x01-y02","/ALEPH_2004_S5765862/d83-x01-y01", + "/OPAL_2000_I513476/d10-x01-y03"] analyses["EventShapes"]["BW"][192.0] = ["/DELPHI_2003_I620250/d46-x01-y03"] +analyses["EventShapes"]["BW"][194.4] = ["/L3_2004_I652683/d40-x01-y01"] 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"][200.2] = ["/L3_2004_I652683/d40-x01-y02"] 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"][206.2] = ["/L3_2004_I652683/d40-x01-y03"] 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"] +# narrow 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"][133.0] = ["/OPAL_2004_S6132243/d13-x01-y02","/DELPHI_1999_I499183/d35-x01-y01"] +analyses["EventShapes"]["BN"][161.0] = ["/DELPHI_1999_I499183/d35-x01-y02"] +analyses["EventShapes"]["BN"][172.0] = ["/DELPHI_1999_I499183/d35-x01-y03"] analyses["EventShapes"]["BN"][177.0] = ["/OPAL_2004_S6132243/d13-x01-y03"] +analyses["EventShapes"]["BN"][183.0] = ["/DELPHI_1999_I499183/d36-x01-y01"] analyses["EventShapes"]["BN"][197.0] = ["/OPAL_2004_S6132243/d13-x01-y04"] +# total +analyses["EventShapes"]["BT"][35.0 ] = ["/JADE_1998_S3612880/d08-x01-y01"] analyses["EventShapes"]["BT"][41.4 ] = ["/L3_2004_I652683/d31-x01-y01"] +analyses["EventShapes"]["BT"][44.0 ] = ["/JADE_1998_S3612880/d04-x01-y01"] +analyses["EventShapes"]["BT"][45.0 ] = ["/DELPHI_2003_I620250/d15-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"][66.0 ] = ["/DELPHI_2003_I620250/d15-x01-y02"] analyses["EventShapes"]["BT"][75.7 ] = ["/L3_2004_I652683/d32-x01-y01"] +analyses["EventShapes"]["BT"][76.0 ] = ["/DELPHI_2003_I620250/d15-x01-y03"] 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"][133.0] = ["/OPAL_2004_S6132243/d04-x01-y02","/ALEPH_2004_S5765862/d71-x01-y01", + "/DELPHI_1999_I499183/d37-x01-y01"] analyses["EventShapes"]["BT"][136.3] = ["/L3_2004_I652683/d33-x01-y02"] +analyses["EventShapes"]["BT"][161.0] = ["/ALEPH_2004_S5765862/d72-x01-y01","/DELPHI_1999_I499183/d37-x01-y02", + "/OPAL_1997_I440721/d11-x01-y01"] analyses["EventShapes"]["BT"][161.3] = ["/L3_2004_I652683/d33-x01-y03"] +analyses["EventShapes"]["BT"][172.0] = ["/ALEPH_2004_S5765862/d73-x01-y01","/DELPHI_1999_I499183/d37-x01-y03", + "/OPAL_2000_I513476/d09-x01-y01"] 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"][183.0] = ["/DELPHI_2003_I620250/d48-x01-y01","/ALEPH_2004_S5765862/d74-x01-y01", + "/DELPHI_1999_I499183/d38-x01-y01","/OPAL_2000_I513476/d09-x01-y02"] analyses["EventShapes"]["BT"][188.6] = ["/L3_2004_I652683/d34-x01-y03"] +analyses["EventShapes"]["BT"][189.0] = ["/DELPHI_2003_I620250/d48-x01-y02","/ALEPH_2004_S5765862/d75-x01-y01", + "/OPAL_2000_I513476/d09-x01-y03"] +analyses["EventShapes"]["BT"][192.0] = ["/DELPHI_2003_I620250/d48-x01-y03"] analyses["EventShapes"]["BT"][194.4] = ["/L3_2004_I652683/d35-x01-y01"] +analyses["EventShapes"]["BT"][196.0] = ["/DELPHI_2003_I620250/d48-x01-y04"] analyses["EventShapes"]["BT"][197.0] = ["/OPAL_2004_S6132243/d04-x01-y04"] +analyses["EventShapes"]["BT"][200.0] = ["/DELPHI_2003_I620250/d49-x01-y01","/ALEPH_2004_S5765862/d76-x01-y01"] 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"][206.2] = ["/L3_2004_I652683/d35-x01-y03"] 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"] +# difference 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"][133.0] = ["/DELPHI_1999_I499183/d39-x01-y01"] +analyses["EventShapes"]["Bdiff"][161.0] = ["/DELPHI_1999_I499183/d39-x01-y02"] +analyses["EventShapes"]["Bdiff"][172.0] = ["/DELPHI_1999_I499183/d39-x01-y03"] +analyses["EventShapes"]["Bdiff"][183.0] = ["/DELPHI_2003_I620250/d50-x01-y01","/DELPHI_1999_I499183/d40-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"][133.0] = ["/OPAL_2004_S6132243/d03-x01-y02","/ALEPH_2004_S5765862/d87-x01-y01", + "/DELPHI_1999_I499183/d41-x01-y01"] +analyses["EventShapes"]["C"][161.0] = ["/ALEPH_2004_S5765862/d88-x01-y01","/DELPHI_1999_I499183/d41-x01-y02", + "/OPAL_1997_I440721/d09-x01-y01"] +analyses["EventShapes"]["C"][172.0] = ["/ALEPH_2004_S5765862/d89-x01-y01","/DELPHI_1999_I499183/d41-x01-y03", + "/OPAL_2000_I513476/d06-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"][183.0] = ["/DELPHI_2003_I620250/d52-x01-y01","/ALEPH_2004_S5765862/d90-x01-y01", + "/DELPHI_1999_I499183/d42-x01-y01","/OPAL_2000_I513476/d06-x01-y02"] +analyses["EventShapes"]["C"][189.0] = ["/DELPHI_2003_I620250/d52-x01-y02","/ALEPH_2004_S5765862/d91-x01-y01", + "/OPAL_2000_I513476/d06-x01-y03"] 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"] - +# D parameter 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"][133.0] = ["/OPAL_2004_S6132243/d14-x01-y02","/DELPHI_1999_I499183/d43-x01-y01"] analyses["EventShapes"]["D"][136.3] = ["/L3_2004_I652683/d44-x01-y02"] +analyses["EventShapes"]["D"][161.0] = ["/DELPHI_1999_I499183/d43-x01-y02"] analyses["EventShapes"]["D"][161.3] = ["/L3_2004_I652683/d44-x01-y03"] +analyses["EventShapes"]["D"][172.0] = ["/DELPHI_1999_I499183/d43-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"][183.0] = ["/DELPHI_2003_I620250/d54-x01-y01","/DELPHI_1999_I499183/d44-x01-y01"] 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"][194.4] = ["/L3_2004_I652683/d46-x01-y01"] analyses["EventShapes"]["D"][196.0] = ["/DELPHI_2003_I620250/d54-x01-y04"] +analyses["EventShapes"]["D"][197.0] = ["/OPAL_2004_S6132243/d14-x01-y04"] analyses["EventShapes"]["D"][200.0] = ["/DELPHI_2003_I620250/d55-x01-y01"] +analyses["EventShapes"]["D"][200.2] = ["/L3_2004_I652683/d46-x01-y02"] 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"][206.2] = ["/L3_2004_I652683/d46-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"] +# heavy jet mass +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"][41.4 ] = ["/L3_2004_I652683/d26-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"][55.3 ] = ["/L3_2004_I652683/d26-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][58.0 ] = ["/TOPAZ_1993_I361661/d02-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][65.4 ] = ["/L3_2004_I652683/d26-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][66.0 ] = ["/DELPHI_2003_I620250/d07-x01-y02","/DELPHI_2003_I620250/d08-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][75.7 ] = ["/L3_2004_I652683/d27-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][76.0 ] = ["/DELPHI_2003_I620250/d07-x01-y03","/DELPHI_2003_I620250/d08-x01-y03"] +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"][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"][130.1] = ["/L3_2004_I652683/d28-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][133.0] = ["/OPAL_2004_S6132243/d02-x01-y02","/ALEPH_2004_S5765862/d63-x01-y01", + "/DELPHI_1999_I499183/d27-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][136.3] = ["/L3_2004_I652683/d28-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][161.0] = ["/ALEPH_2004_S5765862/d64-x01-y01","/DELPHI_1999_I499183/d27-x01-y02", + "/OPAL_1997_I440721/d10-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][161.3] = ["/L3_2004_I652683/d28-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][172.0] = ["/ALEPH_2004_S5765862/d65-x01-y01","/DELPHI_1999_I499183/d27-x01-y03", + "/OPAL_2000_I513476/d07-x01-y01"] +analyses["EventShapes"]["HeavyJetMass"][172.3] = ["/L3_2004_I652683/d29-x01-y01"] analyses["EventShapes"]["HeavyJetMass"][177.0] = ["/OPAL_2004_S6132243/d02-x01-y03"] +analyses["EventShapes"]["HeavyJetMass"][182.8] = ["/L3_2004_I652683/d29-x01-y02"] 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"] + "/DELPHI_2003_I620250/d60-x01-y01","/ALEPH_2004_S5765862/d66-x01-y01", + "/DELPHI_1999_I499183/d28-x01-y01","/OPAL_2000_I513476/d07-x01-y02"] +analyses["EventShapes"]["HeavyJetMass"][188.6] = ["/L3_2004_I652683/d29-x01-y03"] 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"] + "/DELPHI_2003_I620250/d60-x01-y02","/ALEPH_2004_S5765862/d67-x01-y01", + "/OPAL_2000_I513476/d07-x01-y03"] 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"][194.4] = ["/L3_2004_I652683/d30-x01-y01"] 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"][200.2] = ["/L3_2004_I652683/d30-x01-y02"] 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"][206.2] = ["/L3_2004_I652683/d30-x01-y03"] 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"] +# jet mass difference +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","/DELPHI_1999_I499183/d31-x01-y01"] +analyses["EventShapes"]["JetMassDifference"][161.0] = ["/ALEPH_2004_S5765862/d112-x01-y01","/DELPHI_1999_I499183/d31-x01-y02"] +analyses["EventShapes"]["JetMassDifference"][172.0] = ["/ALEPH_2004_S5765862/d113-x01-y01","/DELPHI_1999_I499183/d31-x01-y03"] +analyses["EventShapes"]["JetMassDifference"][183.0] = ["/DELPHI_2003_I620250/d64-x01-y01","/ALEPH_2004_S5765862/d114-x01-y01", + "/DELPHI_1999_I499183/d32-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"] +# light jet mass +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","/DELPHI_1999_I499183/d29-x01-y01"] +analyses["EventShapes"]["LightJetMass"][161.0] = ["/DELPHI_1999_I499183/d29-x01-y02"] +analyses["EventShapes"]["LightJetMass"][172.0] = ["/DELPHI_1999_I499183/d29-x01-y03"] 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"][183.0] = ["/DELPHI_2003_I620250/d62-x01-y01","/DELPHI_1999_I499183/d30-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"] +# total jet mass +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"][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"][161.0] = ["/ALEPH_2004_S5765862/d159-x01-y01","/JADE_OPAL_2000_S4300807/d28-x01-y01", + "/OPAL_1997_I440721/d20-x01-y01"] +analyses["EventShapes"]["y23_dur"][172.0] = ["/ALEPH_2004_S5765862/d160-x01-y01","/JADE_OPAL_2000_S4300807/d29-x01-y01", + "/OPAL_2000_I513476/d11-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"][183.0] = ["/ALEPH_2004_S5765862/d161-x01-y01","/JADE_OPAL_2000_S4300807/d30-x01-y01", + "/OPAL_2000_I513476/d11-x01-y02"] +analyses["EventShapes"]["y23_dur"][189.0] = ["/ALEPH_2004_S5765862/d162-x01-y01","/JADE_OPAL_2000_S4300807/d31-x01-y01", + "/OPAL_2000_I513476/d11-x01-y03"] 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"][9.98 ] = ["/ARGUS_1986_I227324/d01-x01-y02"] 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"][133.0] = ["/ALEPH_2004_S5765862/d142-x01-y01","/OPAL_2004_S6132243/d10-x01-y02", + "/DELPHI_1999_I499183/d21-x01-y01"] +analyses["EventShapes"]["S"][161.0] = ["/ALEPH_2004_S5765862/d143-x01-y01","/DELPHI_1999_I499183/d21-x01-y02", + "/OPAL_1997_I440721/d07-x01-y01"] +analyses["EventShapes"]["S"][172.0] = ["/ALEPH_2004_S5765862/d144-x01-y01","/DELPHI_1999_I499183/d21-x01-y03", + "/OPAL_2000_I513476/d08-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"][183.0] = ["/DELPHI_2003_I620250/d66-x01-y01","/ALEPH_2004_S5765862/d145-x01-y01", + "/DELPHI_1999_I499183/d22-x01-y01", "/OPAL_2000_I513476/d08-x01-y02"] +analyses["EventShapes"]["S"][189.0] = ["/DELPHI_2003_I620250/d66-x01-y02","/ALEPH_2004_S5765862/d146-x01-y01", + "/OPAL_2000_I513476/d08-x01-y03"] 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"][133.0] = ["/ALEPH_2004_S5765862/d126-x01-y01","/DELPHI_1999_I499183/d23-x01-y01"] +analyses["EventShapes"]["P"][161.0] = ["/ALEPH_2004_S5765862/d127-x01-y01","/DELPHI_1999_I499183/d23-x01-y02"] +analyses["EventShapes"]["P"][172.0] = ["/ALEPH_2004_S5765862/d128-x01-y01","/DELPHI_1999_I499183/d23-x01-y03"] +analyses["EventShapes"]["P"][183.0] = ["/DELPHI_2003_I620250/d68-x01-y01","/ALEPH_2004_S5765862/d129-x01-y01", + "/DELPHI_1999_I499183/d24-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"][133.0] = ["/ALEPH_2004_S5765862/d119-x01-y01","/OPAL_2004_S6132243/d09-x01-y02", + "/DELPHI_1999_I499183/d25-x01-y01"] +analyses["EventShapes"]["A"][161.0] = ["/ALEPH_2004_S5765862/d120-x01-y01","/DELPHI_1999_I499183/d25-x01-y02", + "/OPAL_1997_I440721/d08-x01-y01"] +analyses["EventShapes"]["A"][172.0] = ["/ALEPH_2004_S5765862/d121-x01-y01","/DELPHI_1999_I499183/d25-x01-y03", + "/OPAL_2000_I513476/d04-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"][183.0] = ["/DELPHI_2003_I620250/d70-x01-y01","/ALEPH_2004_S5765862/d122-x01-y01", + "/DELPHI_1999_I499183/d26-x01-y01","/OPAL_2000_I513476/d04-x01-y02"] +analyses["EventShapes"]["A"][189.0] = ["/DELPHI_2003_I620250/d70-x01-y02","/ALEPH_2004_S5765862/d123-x01-y01", + "/OPAL_2000_I513476/d04-x01-y03"] 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"]["1pi" ]["MC" ] = ["/MC_TAU_Decay/h_1B_xpi"] 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"]["data"] = ["/ALEPH_2014_I1267648/d03-x01-y01","/ALEPH_2014_I1267648/d05-x01-y01", + "/ALEPH_1996_I421984/d01-x01-y01","/ALEPH_1996_I421984/d02-x01-y01", + "/ALEPH_1996_I421984/d03-x01-y01","/ALEPH_1996_I421984/d06-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"] +# polarization +# rho +/- +analyses["Polarization"][213]["rho00"][91.2] = ["/OPAL_2000_I502750/d01-x01-y01"] +analyses["Polarization"][213]["cos" ][91.2] = ["/OPAL_2000_I502750/ctheta_rho_0","/OPAL_2000_I502750/ctheta_rho_1", + "/OPAL_2000_I502750/ctheta_rho_2","/OPAL_2000_I502750/ctheta_rho_3", + "/OPAL_2000_I502750/ctheta_rho_4","/OPAL_2000_I502750/ctheta_rho_all"] +# omega +analyses["Polarization"][223]["rho00"][91.2] = ["/OPAL_2000_I502750/d02-x01-y01","/OPAL_2000_I502750/d02-x02-y01"] +analyses["Polarization"][223]["cos" ][91.2] = ["/OPAL_2000_I502750/ctheta_omega_0","/OPAL_2000_I502750/ctheta_omega_1", + "/OPAL_2000_I502750/ctheta_omega_2","/OPAL_2000_I502750/ctheta_omega_3", + "/OPAL_2000_I502750/ctheta_omega_4","/OPAL_2000_I502750/ctheta_omega_all"] +# phi +analyses["Polarization"][333]["rho00"][91.2] = ["/OPAL_1997_I440103/d01-x01-y01"] +analyses["Polarization"][333]["rho10"][91.2] = ["/OPAL_1997_I440103/d01-x01-y02","/OPAL_1997_I440103/d01-x01-y04","/OPAL_1997_I440103/d01-x01-y05"] +analyses["Polarization"][333]["rho11"][91.2] = ["/OPAL_1997_I440103/d01-x01-y03"] +analyses["Polarization"][333]["cos" ][91.2] = ["/OPAL_1997_I440103/d05-x01-y01"] +analyses["Polarization"][333]["phi" ][91.2] = ["/OPAL_1997_I440103/d05-x01-y02","/OPAL_1997_I440103/d05-x01-y03"] +# K*0 +analyses["Polarization"][313]["rho00"][91.2] = ["/OPAL_1997_S3608263/d02-x01-y01"] +analyses["Polarization"][313]["rho10"][91.2] = ["/OPAL_1997_S3608263/d02-x01-y01"] +analyses["Polarization"][313]["rho11"][91.2] = ["/OPAL_1997_S3608263/d02-x01-y02","/OPAL_1997_S3608263/d03-x01-y01", + "/OPAL_1997_S3608263/d03-x02-y01","/OPAL_1997_S3608263/d04-x01-y01", + "/OPAL_1997_S3608263/d04-x01-y02","/OPAL_1997_S3608263/d04-x02-y01", + "/OPAL_1997_S3608263/d04-x02-y02"] +analyses["Polarization"][313]["cos"][91.2] = ["/OPAL_1997_S3608263/ctheta_00","/OPAL_1997_S3608263/ctheta_01", + "/OPAL_1997_S3608263/ctheta_02","/OPAL_1997_S3608263/ctheta_03", + "/OPAL_1997_S3608263/ctheta_04","/OPAL_1997_S3608263/ctheta_05", + "/OPAL_1997_S3608263/ctheta_06","/OPAL_1997_S3608263/ctheta_07", + "/OPAL_1997_S3608263/ctheta_08","/OPAL_1997_S3608263/ctheta_09", + "/OPAL_1997_S3608263/ctheta_10","/OPAL_1997_S3608263/ctheta_11", + "/OPAL_1997_S3608263/ctheta_large"] +analyses["Polarization"][313]["phi"][91.2] = ["/OPAL_1997_S3608263/alpha_00","/OPAL_1997_S3608263/alpha_01", + "/OPAL_1997_S3608263/alpha_02","/OPAL_1997_S3608263/alpha_03", + "/OPAL_1997_S3608263/alpha_04","/OPAL_1997_S3608263/alpha_05", + "/OPAL_1997_S3608263/alpha_06","/OPAL_1997_S3608263/alpha_07", + "/OPAL_1997_S3608263/alpha_08","/OPAL_1997_S3608263/alpha_09", + "/OPAL_1997_S3608263/alpha_10","/OPAL_1997_S3608263/alpha_11", + "/OPAL_1997_S3608263/alpha_high_00","/OPAL_1997_S3608263/alpha_high_01", + "/OPAL_1997_S3608263/alpha_high_02","/OPAL_1997_S3608263/alpha_high_03", + "/OPAL_1997_S3608263/alpha_low_00","/OPAL_1997_S3608263/alpha_low_01", + "/OPAL_1997_S3608263/alpha_low_02","/OPAL_1997_S3608263/alpha_low_03",] +# D* +analyses["Polarization"][413]["rho00"][10.5] = ["/CLEO_1991_I314060/d01-x01-y02","/CLEO_1998_I467595/d04-x01-y01"] +analyses["Polarization"][413]["alpha"][10.5] = ["/CLEO_1991_I314060/d01-x01-y01","/CLEO_1991_I314060/d01-x01-y03", + "/CLEO_1998_I467595/d03-x01-y01"] +analyses["Polarization"][413]["cos" ][10.5] = ["/CLEO_1991_I314060/d02-x01-y01","/CLEO_1991_I314060/d02-x01-y02", + "/CLEO_1991_I314060/d02-x01-y03","/CLEO_1991_I314060/d02-x01-y04", + "/CLEO_1991_I314060/d02-x01-y05","/CLEO_1991_I314060/d02-x01-y06", + "/CLEO_1998_I467595/d05-x01-y01","/CLEO_1998_I467595/d05-x01-y02", + "/CLEO_1998_I467595/d05-x01-y03","/CLEO_1998_I467595/d05-x01-y04", + "/CLEO_1998_I467595/d05-x01-y05","/CLEO_1998_I467595/d05-x01-y06"] +analyses["Polarization"][413]["rho00"][29.0] = ["/TPC_1991_I316132/d02-x01-y01","/TPC_1991_I316132/d02-x02-y01", + "/HRS_1987_I250823/d01-x01-y01","/HRS_1987_I250823/d01-x02-y01", + "/HRS_1987_I250823/d01-x03-y01","/HRS_1987_I250823/d02-x01-y01", + "/HRS_1987_I250823/d03-x01-y01","/HRS_1987_I250823/d03-x02-y01", + "/HRS_1987_I250823/d04-x01-y01","/HRS_1987_I250823/d05-x01-y01", + "/HRS_1987_I250823/d06-x01-y01"] +analyses["Polarization"][413]["rho10"][29.0] = ["/TPC_1991_I316132/d02-x01-y03","/TPC_1991_I316132/d02-x02-y03", + "/HRS_1987_I250823/d01-x01-y03","/HRS_1987_I250823/d01-x02-y03", + "/HRS_1987_I250823/d01-x03-y03","/HRS_1987_I250823/d02-x01-y03", + "/HRS_1987_I250823/d03-x01-y03","/HRS_1987_I250823/d03-x02-y03", + "/HRS_1987_I250823/d04-x01-y03","/HRS_1987_I250823/d05-x01-y03", + "/HRS_1987_I250823/d06-x01-y03"] +analyses["Polarization"][413]["rho11"][29.0] = ["/TPC_1991_I316132/d02-x01-y02","/TPC_1991_I316132/d02-x02-y02", + "/HRS_1987_I250823/d01-x01-y02","/HRS_1987_I250823/d01-x02-y02", + "/HRS_1987_I250823/d01-x03-y02","/HRS_1987_I250823/d02-x01-y02", + "/HRS_1987_I250823/d03-x01-y02","/HRS_1987_I250823/d03-x02-y02", + "/HRS_1987_I250823/d04-x01-y02","/HRS_1987_I250823/d05-x01-y02", + "/HRS_1987_I250823/d06-x01-y02"] +analyses["Polarization"][413]["alpha"][29.0] = ["/TPC_1991_I316132/d01-x01-y01","/TPC_1991_I316132/d01-x02-y01"] +analyses["Polarization"][413]["cos"][29.0] = ["/TPC_1991_I316132/ctheta_0","/TPC_1991_I316132/ctheta_1", + "/TPC_1991_I316132/ctheta_2","/TPC_1991_I316132/ctheta_3", + "/TPC_1991_I316132/ctheta_4","/TPC_1991_I316132/ctheta_5", + "/TPC_1991_I316132/ctheta_all",] +analyses["Polarization"][413]["phi"][29.0] = ["/TPC_1991_I316132/h_01_0","/TPC_1991_I316132/h_01_1", + "/TPC_1991_I316132/h_01_2","/TPC_1991_I316132/h_01_3", + "/TPC_1991_I316132/h_01_4","/TPC_1991_I316132/h_01_5", + "/TPC_1991_I316132/h_01_all","/TPC_1991_I316132/phi_0", + "/TPC_1991_I316132/phi_1","/TPC_1991_I316132/phi_2", + "/TPC_1991_I316132/phi_3","/TPC_1991_I316132/phi_4", + "/TPC_1991_I316132/phi_5","/TPC_1991_I316132/phi_all"] +analyses["Polarization"][413]["rho00"][91.2] = ["/OPAL_1997_I440103/d03-x01-y01"] +analyses["Polarization"][413]["rho11"][91.2] = ["/OPAL_1997_I440103/d03-x01-y02"] +analyses["Polarization"][413]["cos" ][91.2] = ["/OPAL_1997_I440103/d06-x01-y01"] +analyses["Polarization"][413]["phi" ][91.2] = ["/OPAL_1997_I440103/d07-x01-y01"] +# B* +analyses["Polarization"][513]["rho00"][91.2] = ["/ALEPH_1995_I398426/d02-x01-y01","/DELPHI_1995_I395026/d03-x01-y01", + "/OPAL_1996_I428493/d02-x01-y01","/OPAL_1997_I440103/d04-x01-y01"] +analyses["Polarization"][513]["cos" ][91.2] = ["/DELPHI_1995_I395026/d05-x01-y01","/OPAL_1996_I428493/d03-x01-y01", + "/OPAL_1997_I440103/d08-x01-y01","/ALEPH_1995_I398426/d03-x01-y01"] +# Lambda0 +analyses["Polarization"][3122]["rho11"][10.58] = ["/BELLE_2019_I1687566/d01-x01-y01","/BELLE_2019_I1687566/d01-x01-y02", + "/BELLE_2019_I1687566/d01-x02-y01","/BELLE_2019_I1687566/d01-x02-y02", + "/BELLE_2019_I1687566/d01-x03-y01","/BELLE_2019_I1687566/d01-x03-y02", + "/BELLE_2019_I1687566/d01-x04-y01","/BELLE_2019_I1687566/d01-x04-y02", + "/BELLE_2019_I1687566/d02-x01-y01","/BELLE_2019_I1687566/d02-x01-y02", + "/BELLE_2019_I1687566/d02-x01-y03","/BELLE_2019_I1687566/d02-x01-y04", + "/BELLE_2019_I1687566/d02-x01-y05","/BELLE_2019_I1687566/d02-x01-y06", + "/BELLE_2019_I1687566/d02-x01-y07","/BELLE_2019_I1687566/d02-x01-y08", + "/BELLE_2019_I1687566/d02-x02-y01","/BELLE_2019_I1687566/d02-x02-y02", + "/BELLE_2019_I1687566/d02-x02-y03","/BELLE_2019_I1687566/d02-x02-y04", + "/BELLE_2019_I1687566/d02-x02-y05","/BELLE_2019_I1687566/d02-x02-y06", + "/BELLE_2019_I1687566/d02-x02-y07","/BELLE_2019_I1687566/d02-x02-y08", + "/BELLE_2019_I1687566/d02-x03-y01","/BELLE_2019_I1687566/d02-x03-y02", + "/BELLE_2019_I1687566/d02-x03-y03","/BELLE_2019_I1687566/d02-x03-y04", + "/BELLE_2019_I1687566/d02-x03-y05","/BELLE_2019_I1687566/d02-x03-y06", + "/BELLE_2019_I1687566/d02-x03-y07","/BELLE_2019_I1687566/d02-x03-y08", + "/BELLE_2019_I1687566/d02-x04-y01","/BELLE_2019_I1687566/d02-x04-y02", + "/BELLE_2019_I1687566/d02-x04-y03","/BELLE_2019_I1687566/d02-x04-y04", + "/BELLE_2019_I1687566/d02-x04-y05","/BELLE_2019_I1687566/d02-x04-y06", + "/BELLE_2019_I1687566/d02-x04-y07","/BELLE_2019_I1687566/d02-x04-y08", + "/BELLE_2019_I1687566/d03-x01-y01","/BELLE_2019_I1687566/d03-x01-y02", + "/BELLE_2019_I1687566/d03-x01-y03","/BELLE_2019_I1687566/d03-x01-y04", + "/BELLE_2019_I1687566/d03-x01-y05","/BELLE_2019_I1687566/d03-x01-y06",] +analyses["Polarization"][3122]["rho00"][91.2] = ["/OPAL_1997_I447188/d01-x01-y01","/OPAL_1997_I447188/d01-x01-y02", + "/ALEPH_1996_I415745/d01-x01-y01","/ALEPH_1996_I415745/d01-x02-y01"] +analyses["Polarization"][3122]["rho11"][91.2] = ["/OPAL_1997_I447188/d02-x01-y01","/OPAL_1997_I447188/d02-x01-y02", + "/OPAL_1997_I447188/d02-x01-y03","/OPAL_1997_I447188/d02-x01-y04", + "/ALEPH_1996_I415745/d02-x01-y01","/ALEPH_1996_I415745/d02-x02-y01", + "/ALEPH_1996_I415745/d02-x03-y01","/ALEPH_1996_I415745/d02-x04-y01"] +analyses["Polarization"][3122]["cos" ][91.2] = ["/OPAL_1997_I447188/d04-x01-y01","/OPAL_1997_I447188/d04-x01-y02", + "/OPAL_1997_I447188/d04-x01-y03","/OPAL_1997_I447188/d04-x01-y04"] +analyses["Polarization"][3122]["phi" ][91.2] = ["/OPAL_1997_I447188/d05-x01-y01","/OPAL_1997_I447188/d05-x01-y02", + "/OPAL_1997_I447188/d05-x01-y03","/OPAL_1997_I447188/d05-x01-y04"] +# bottom baryons +analyses["Polarization"][5122]["rho00"][91.2] = ["/OPAL_1998_I474012/d01-x01-y01","/DELPHI_2000_I513614/d01-x01-y01", + "/ALEPH_1996_I402895/d01-x01-y01"] +analyses["Polarization"][5122]["Other"][91.2] = ["/DELPHI_2000_I513614/El","/DELPHI_2000_I513614/Ev", + "/OPAL_1998_I474012/El","/OPAL_1998_I474012/Ev", + "/OPAL_1998_I474012/ratio","/ALEPH_1996_I402895/El", + "/ALEPH_1996_I402895/Ev"] + +# find all the figures 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","") + name=val.replace(directory,"").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$", + names = { "1pi" : "$\\tau\\to\\nu_\\tau\\pi^-$", + "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]) + if(prod!="Charged") : + decays.write("
    Multiplicity of %s
    \n" % particleNames[prod]) + else : + decays.write("
    Multiplicity of Charged Particles
    \n") 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) + # evnet shapes + if("Shapes" in analyses["HadronDecays"][val] and + len(analyses["HadronDecays"][val]["Shapes"]) !=0) : + decays.write("
    Events Shapes
    \n") + writePlots2(analyses["HadronDecays"][val]["Shapes"],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("
    \n

    %s

    \n" % (pdgId,particleNames[pdgId])) index.write("
    %s,\n" % (pdgId,particleNames[pdgId])) # plots for val in ["x","p","xi","Ratio","Other"] : if(len(analyses["IdentifiedParticle"][pdgId][val])==0) : continue ident.write("
    \n

    %s

    \n" % (pdgId,val,latexNames[val])) writePlots(analyses["IdentifiedParticle"][pdgId][val],ident) ident.write("
    \n") +def writePolar(particles,index,pol) : + latexNames = { "rho00" : "Longitudinal polarization", + "rho10" : "Off-diagonal $(\\rho_{10}$)", + "rho11" : "Transerve polarization", + "alpha" : "Asymmetry $\\alpha$", + "cos" : "$\\cos\\theta$ distributions", + "phi" : "Azimuthal Angle distributions", + "Other" : "Other distributions"} + for pdgId in particles: + if(pdgId not in analyses["Polarization"]) : continue + sumL = len(analyses["Polarization"][pdgId]["alpha"])+len(analyses["Polarization"][pdgId]["rho00"])+\ + len(analyses["Polarization"][pdgId]["cos"])+len(analyses["Polarization"][pdgId]["phi"])+\ + len(analyses["Polarization"][pdgId]["rho10"])+len(analyses["Polarization"][pdgId]["rho11"]) + if(sumL==0) : continue + # lines in html + pol.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("
  • 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() +# output the polarization plots +def writePolarization(index) : + pol=open(os.path.join(directory,"polarization.html"),'w') + # header for page + pol.write(header.format(title="Comparisions of Herwig7 and $e^+e^-$ Polarization Observables")) + # # line for index + index.write("
  • Polarization Measurements\n") + index.write("\n") + pol.write("\n") + pol.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) +# polarization +writePolarization(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()