diff --git a/Decay/HeavyMeson/HQETStrongDecayer.cc b/Decay/HeavyMeson/HQETStrongDecayer.cc
--- a/Decay/HeavyMeson/HQETStrongDecayer.cc
+++ b/Decay/HeavyMeson/HQETStrongDecayer.cc
@@ -1,618 +1,618 @@
 // -*- C++ -*-
 //
 // This is the implementation of the non-inlined, non-templated member
 // functions of the HQETStrongDecayer class.
 //
 
 #include "HQETStrongDecayer.h"
 #include "ThePEG/Interface/ClassDocumentation.h"
 #include "ThePEG/Interface/Command.h"
 #include "ThePEG/EventRecord/Particle.h"
 #include "ThePEG/Utilities/DescribeClass.h"
 #include "ThePEG/Persistency/PersistentOStream.h"
 #include "ThePEG/Persistency/PersistentIStream.h"
 #include "ThePEG/Helicity/WaveFunction/TensorWaveFunction.h"
 #include "ThePEG/Helicity/WaveFunction/Rank3TensorWaveFunction.h"
 #include "ThePEG/Helicity/WaveFunction/VectorWaveFunction.h"
 #include "ThePEG/Helicity/WaveFunction/ScalarWaveFunction.h"
 #include "Herwig/Decay/TwoBodyDecayMatrixElement.h"
 #include "Herwig/Utilities/Kinematics.h"
 #include "ThePEG/Helicity/epsilon.h"
 #include "ThePEG/Helicity/HelicityFunctions.h"
 #include "Herwig/Decay/GeneralDecayMatrixElement.h"
 
 using namespace Herwig;
 
 HQETStrongDecayer::HQETStrongDecayer()
   : fPi_(130.2*MeV), g_(0.566), h_(0.544), hp_(0.413), k_(0.407), kp_(0.242), gtilde_(0.283),
     psiL_(0.), psiS_(0.041), deltaEta_(1./43.7), Lambda_(1.*GeV)
 {}
 
 void HQETStrongDecayer::doinit() {
   DecayIntegrator::doinit();
   // check consistence of the parameters
   unsigned int isize=incoming_.size();
   if(isize!=outgoing_.size()||isize!=maxWeight_.size())
     throw InitException() << "Inconsistent parameters in HQETStrongDecayer"
     			  << Exception::abortnow;
   // set up the integration channels
   PhaseSpaceModePtr mode;
   for(unsigned int ix=0;ix<incoming_.size();++ix) {
     tPDPtr     in = getParticleData(incoming_[ix]);
     tPDVector out = {getParticleData(outgoing_[ix].first),
 		     getParticleData(outgoing_[ix].second)};
     if(in&&out[0]&&out[1]) {
       mode=new_ptr(PhaseSpaceMode(in,out,maxWeight_[ix]));
     }
     else
       mode=PhaseSpaceModePtr();
     addMode(mode);
   }
 }
 
 void HQETStrongDecayer::doinitrun() {
   DecayIntegrator::doinitrun();
   if(initialize()) {
     for(unsigned int ix=0;ix<incoming_.size();++ix)
       if(mode(ix)) maxWeight_[ix] = mode(ix)->maxWeight();
   }
 }
 
 IBPtr HQETStrongDecayer::clone() const {
   return new_ptr(*this);
 }
 
 IBPtr HQETStrongDecayer::fullclone() const {
   return new_ptr(*this);
 }
 
 void HQETStrongDecayer::persistentOutput(PersistentOStream & os) const {
   os << ounit(fPi_,MeV) << g_ << h_ << hp_ << k_ << kp_ << gtilde_
      << psiL_ << psiS_ << deltaEta_ << ounit(Lambda_,GeV)
      << incoming_ << outgoing_ << maxWeight_;
 }
 
 void HQETStrongDecayer::persistentInput(PersistentIStream & is, int) {
   is >> iunit(fPi_,MeV) >> g_ >> h_ >> hp_ >> k_ >> kp_ >> gtilde_
      >> psiL_ >> psiS_ >> deltaEta_ >> iunit(Lambda_,GeV)
      >> incoming_ >> outgoing_ >> maxWeight_;
 }
 
 // The following static variable is needed for the type
 // description system in ThePEG.
 DescribeClass<HQETStrongDecayer,DecayIntegrator>
 describeHerwigHQETStrongDecayer("Herwig::HQETStrongDecayer", "HwHMDecay.so");
 
 void HQETStrongDecayer::Init() {
 
   static ClassDocumentation<HQETStrongDecayer> documentation
     ("The HQETStrongDecayer class performs the strong decays of excited heavy mesons using HQET results.");
   
   static Parameter<HQETStrongDecayer,Energy> interfacefPi
     ("fPi",
      "The pion decay constant",
      &HQETStrongDecayer::fPi_, MeV, 130.2*MeV, 100.0*MeV, 200.0*MeV,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfaceg
     ("g",
      "The coupling for 1S (0-,1-) decays",
      &HQETStrongDecayer::g_, 0.566, 0.0, 1.0,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfaceh
     ("h",
      "The coupling for 1P (0+,1+) decays",
      &HQETStrongDecayer::h_, 0.544, 0.0, 1.0,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacehp
     ("hp",
      "The coupling for 1P (1+,2+) decays",
      &HQETStrongDecayer::hp_, 0.413, 0.0, 1.0,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacek
     ("k",
      "The coupling for 1D (2-,3-) decays",
      &HQETStrongDecayer::k_, 0.407, 0.0, 1.0,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacekp
     ("kp",
      "The coupling for 1D (1-,2-) decays",
      &HQETStrongDecayer::kp_, 0.242, 0.0, 1.0,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacegtilde
     ("gtilde",
      "The coupling for 2S (0-,1-) decays",
      &HQETStrongDecayer::gtilde_, 0.283, 0.0, 1.0,
      false, false, Interface::limited);
 
   static ParVector<HQETStrongDecayer,double> interfaceMaxWeight
     ("MaxWeight",
      "The maximum weight for the decay mode",
      &HQETStrongDecayer::maxWeight_,
      0, 0, 0, 0., 100000., false, false, true);
 
   static Parameter<HQETStrongDecayer,double> interfaceDeltaEta
     ("DeltaEta",
      "The mixing parameter for eta-pi0 of isospin violating decays",
      &HQETStrongDecayer::deltaEta_, 1./43.7, 0.0, 1.,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,Energy> interfacefLambda
     ("Lambda",
      "Strong decays momentum scale",
      &HQETStrongDecayer::Lambda_, GeV, 1.*GeV, .1*GeV, 2.*GeV,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacefpsiL
     ("psiL",
      "D_1 mixing angle for up and down heavy mesons",
      &HQETStrongDecayer::psiL_, 0., -M_PI/2., M_PI/2.,
      false, false, Interface::limited);
 
   static Parameter<HQETStrongDecayer,double> interfacefpsiS
     ("psiS",
      "D_1 mixing angle for strange heavy mesons",
      &HQETStrongDecayer::psiS_, 0.041, -M_PI/2., M_PI/2.,
      false, false, Interface::limited);
 
   static Command<HQETStrongDecayer> interfaceSetUpDecayMode
     ("SetUpDecayMode",
      "Set up the particles, coupling(1/GeV^2) and max weight for a decay",
      &HQETStrongDecayer::setUpDecayMode, false);
 }
 
 int HQETStrongDecayer::modeNumber(bool & cc,tcPDPtr parent,
   				  const tPDVector & children) const {
   if(children.size()!=2) return -1;
   int id(parent->id());
   int idbar = parent->CC() ? parent->CC()->id() : id;
   int id1(children[0]->id());
   int id1bar = children[0]->CC() ? children[0]->CC()->id() : id1;
   int id2(children[1]->id());
   int id2bar = children[1]->CC() ? children[1]->CC()->id() : id2;
   int imode(-1);
   unsigned int ix(0);
   cc=false;
   do {
     if(id   ==incoming_[ix]) {
       if((id1   ==outgoing_[ix].first&&id2   ==outgoing_[ix].second)||
     	 (id2   ==outgoing_[ix].first&&id1   ==outgoing_[ix].second)) imode=ix;
     }
     if(idbar==incoming_[ix]) {
       if((id1bar==outgoing_[ix].first&&id2bar==outgoing_[ix].second)||
     	 (id2bar==outgoing_[ix].first&&id1bar==outgoing_[ix].second)) {
     	imode=ix;
     	cc=true;
       }
     }
     ++ix;
   }
   while(ix<incoming_.size()&&imode<0);
   return imode;
 }
 
 void HQETStrongDecayer::
 constructSpinInfo(const Particle & part, ParticleVector decay) const {
   switch (part.dataPtr()->iSpin()) {
   case PDT::Spin0:
     Helicity::ScalarWaveFunction::constructSpinInfo(const_ptr_cast<tPPtr>(&part),
 						    Helicity::incoming,true);
     break;
   case PDT::Spin1:
     Helicity::VectorWaveFunction::constructSpinInfo(vecIn_,const_ptr_cast<tPPtr>(&part),
   						    Helicity::incoming,true,false);
     break;
   case PDT::Spin2:
     Helicity::TensorWaveFunction::constructSpinInfo(tensorIn_,const_ptr_cast<tPPtr>(&part),
 						    Helicity::incoming,true,false);
     break;
   case PDT::Spin3:
     Helicity::Rank3TensorWaveFunction::constructSpinInfo(spin3In_,const_ptr_cast<tPPtr>(&part),
 							 Helicity::incoming,true,false);
     break;
   default:
     assert(false);
   }
   // set up the spin information for the decay products
   for(unsigned int ix=0;ix<decay.size();++ix) {
     switch (decay[ix]->dataPtr()->iSpin()) {
     case PDT::Spin1:
       Helicity::VectorWaveFunction::constructSpinInfo(vecOut_,decay[ix],
 						      Helicity::outgoing,true,false);
       break;
     case PDT::Spin0:
       Helicity::ScalarWaveFunction::constructSpinInfo(decay[ix],Helicity::outgoing,true);
       break;
     default:
       assert(false);
     }
   }
 }
 
 // matrix elememt for the process
 double HQETStrongDecayer::me2(const int, const Particle & part,
   			      const tPDVector & outgoing,
   			      const vector<Lorentz5Momentum> & momenta,
   			      MEOption meopt) const {
   if(!ME()) {
     if(part.data().iSpin()!=PDT::Spin3)
       ME(new_ptr(TwoBodyDecayMatrixElement(part.data().iSpin(),
 					   outgoing[0]->iSpin(),
 					   outgoing[1]->iSpin())));
     else
       ME(new_ptr(GeneralDecayMatrixElement(part.data().iSpin(),
 					   outgoing[0]->iSpin(),
 					   outgoing[1]->iSpin())));
   }
   // stuff for incoming particle
   if(meopt==Initialize) {
     switch(part.data().iSpin()) {
     case PDT::Spin0:
       rho_ = RhoDMatrix(PDT::Spin0);
       ScalarWaveFunction::
 	calculateWaveFunctions(rho_,const_ptr_cast<tPPtr>(&part), Helicity::incoming);
       break;
     case PDT::Spin1:
       rho_ = RhoDMatrix(PDT::Spin1);
       Helicity::VectorWaveFunction::calculateWaveFunctions(vecIn_,rho_,const_ptr_cast<tPPtr>(&part),
   							   Helicity::incoming,false);
       break;
     case PDT::Spin2:
       rho_ = RhoDMatrix(PDT::Spin2);
       Helicity::TensorWaveFunction::calculateWaveFunctions(tensorIn_,rho_,const_ptr_cast<tPPtr>(&part),
 							   Helicity::incoming,false);
       break;
     case PDT::Spin3:
       rho_ = RhoDMatrix(PDT::Spin3);
       Rank3TensorWaveFunction::calculateWaveFunctions(spin3In_,rho_,const_ptr_cast<tPPtr>(&part),
 						      Helicity::incoming,false);
       break;
     default:
       assert(false);
     }
   }
   // outgoing vector wavefunnctions if needed
   if(outgoing[0]->iSpin()==PDT::Spin1) {
     vecOut_={HelicityFunctions::polarizationVector(-momenta[0],0,Helicity::outgoing),
 	     HelicityFunctions::polarizationVector(-momenta[0],1,Helicity::outgoing),
 	     HelicityFunctions::polarizationVector(-momenta[0],2,Helicity::outgoing)};
   }
   // decay frame momentum
   Energy pcm = Kinematics::pstarTwoBodyDecay(part.mass(),momenta[0].mass(),
 					     momenta[1].mass());
   // identify the incoming multiplet
   unsigned int itemp = abs(part.id())-abs(part.id())%1000;
   // calculate the matrix element
   double test(0.);
   // 0- from (0-,1-)
   if     ((itemp==0 ||itemp==100000) && part.data().iSpin()==PDT::Spin0) {
     double coup = itemp==0 ? g_ : gtilde_;
     // 0- to 1- 0-
     if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy fact = -2.*coup/fPi_*sqrt(momenta[0].mass()/part.mass());
       for(unsigned int ix=0;ix<3;++ix) {
 	(*ME())(0,ix,0) = Complex(fact*(vecOut_[ix]*momenta[1]));
       }
       // analytic test of the answer
       test = 4.*sqr(coup)*part.mass()/momenta[0].mass()*sqr(pcm)/sqr(fPi_);
     }
     else
       assert(false);
   }
   // 1- from (0-,1-)
   else if((itemp==0 ||itemp==100000) && part.data().iSpin()==PDT::Spin1) {
     double coup = itemp==0 ? g_ : gtilde_;
     // 1- to 0- 0-
     if(outgoing[0]->iSpin()==PDT::Spin0) {
       InvEnergy fact = -2.*coup/fPi_*sqrt(momenta[0].mass()/part.mass());
       for(unsigned int ix=0;ix<3;++ix) {
 	(*ME())(ix,0,0) = Complex(fact*(vecIn_[ix]*momenta[1]));
       }
       // analytic test of the answer
       test = 4.*sqr(coup)*momenta[0].mass()*sqr(pcm)/3./sqr(fPi_)/part.mass();
     }
     // 1- to 1- 0-
     else if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy2 fact = -2.*coup/fPi_*sqrt(momenta[0].mass()/part.mass())/part.mass();
       for(unsigned int ix=0;ix<3;++ix) {
 	LorentzVector<complex<double> > vtemp = fact*epsilon(momenta[1],part.momentum(),vecIn_[ix]);
 	for(unsigned int iy=0;iy<3;++iy) {
 	  (*ME())(ix,iy,0) = vtemp*vecOut_[iy];
 	}
       }
       // analytic test of the answer
       test = 8.*sqr(coup)*momenta[0].mass()*sqr(pcm)/3./sqr(fPi_)/part.mass();
     }
     else
       assert(false);
   }
   // 1+ from (1+,2+) or (0+,1+)
   else if((itemp==10000||itemp==20000)  && part.data().iSpin()==PDT::Spin1) {
     if(outgoing[0]->iSpin()==PDT::Spin1) {
       // mixing
       double psi = (abs(part.id())%100)/10!=3 ? psiL_ : psiS_;
       double m1(cos(psi)),m2(sin(psi));
       if(itemp==20000) {
 	swap(m1,m2);
 	m1 *=-1.;
       }
       InvEnergy2 A = -2.*sqrt(2.*momenta[0].mass()/3./part.mass())*hp_*m1/fPi_/Lambda_;
       double     B = -h_*m2/1/fPi_*sqrt(momenta[0].mass()/part.mass())/part.mass()*
 	(sqr(part.mass())-sqr(momenta[0].mass())+sqr(momenta[1].mass()));
       B += A*sqr(pcm);
       // matrix element
       for(unsigned int ix=0;ix<3;++ix) {
 	for(unsigned int iy=0;iy<3;++iy) {
 	  (*ME())(ix,iy,0)  = B*vecOut_[iy].dot(vecIn_[ix]) + 3.*A*vecOut_[iy].dot(momenta[1])*vecIn_[ix].dot(momenta[1]);
 	}
       }
       // analytic test of the answer
       test = (3.*sqr(A*part.mass()*sqr(pcm)) +sqr(B)/3.*(3.*sqr(momenta[0].mass())+sqr(pcm))
 	      -A*B*sqr(pcm)*(sqr(part.mass())+sqr(momenta[0].mass())-sqr(momenta[1].mass())))/sqr(momenta[0].mass());
     }
     else
       assert(false);
   }
   // 2+ from (1+,2+)
   else if(itemp==0      && part.data().iSpin()==PDT::Spin2) {
     // 2+ -> 0- 0-
     if(outgoing[0]->iSpin()==PDT::Spin0) {
       InvEnergy2 fact = -4.*hp_/fPi_*sqrt(momenta[0].mass()/part.mass())/Lambda_;
       for(unsigned int ix=0;ix<5;++ix) {
 	(*ME())(ix,0,0) = Complex(fact*((tensorIn_[ix]*momenta[1])*momenta[1]));
       }
       // analytic test of the answer
       test = 32.*sqr(hp_)*momenta[0].mass()*sqr(sqr(pcm))/15./sqr(fPi_)/sqr(Lambda_)/part.mass();
     }
     // 2+ -> 1- 0-
     else if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy3 fact = -4.*hp_/fPi_*sqrt(momenta[0].mass()/part.mass())/Lambda_/part.mass();
       for(unsigned int iy=0;iy<3;++iy) {
 	LorentzVector<complex<InvEnergy> > vtemp = fact*epsilon(momenta[0],vecOut_[iy],momenta[1]);
 	for(unsigned int ix=0;ix<5;++ix) {
 	  (*ME())(ix,iy,0) = Complex((momenta[1]*tensorIn_[ix]).dot(vtemp));
 	}
       }
       // analytic test of the answer
       test = 16.*sqr(hp_)*momenta[0].mass()*sqr(sqr(pcm))/5./sqr(fPi_)/sqr(Lambda_)/part.mass();
     }
     else
       assert(false);
   }
   // 0+ from (0+,1+)
   else if(itemp==10000  && part.data().iSpin()==PDT::Spin0) {
     // 0+ -> 0- 0-
     if(outgoing[0]->iSpin()==PDT::Spin0) {
       (*ME())(0,0,0) = 2.*h_/fPi_*sqrt(momenta[0].mass()/part.mass())*(part.momentum()*momenta[1])/part.mass();
       // analytic test of the answer
       test = sqr(h_)/sqr(fPi_)*momenta[0].mass()/pow<3,1>(part.mass())*sqr(sqr(part.mass())-sqr(momenta[0].mass())+sqr(momenta[1].mass()));
     }
     else
       assert(false);
   }
   // 1- from (1-,2-)
-  else if(itemp==10000  && part.data().iSpin()==PDT::Spin1) {
+  else if(itemp==30000  && part.data().iSpin()==PDT::Spin1) {
     // 1- -> 0- 0-
     if(outgoing[0]->iSpin()==PDT::Spin0) {
       InvEnergy fact = 4.*kp_*sqrt(2.*momenta[0].mass()/3./part.mass())/part.mass()/fPi_/Lambda_*(part.momentum()*momenta[1]);
       for(unsigned int ix=0;ix<3;++ix) {
 	(*ME())(ix,0,0) = Complex(fact*(vecIn_[ix]*momenta[1]));
       }
       // analytic test of the answer
       test = 8.*momenta[0].mass()*sqr(kp_*pcm*(sqr(part.mass())-sqr(momenta[0].mass())+sqr(momenta[1].mass())))
 	/9./sqr(fPi_*Lambda_*part.mass())/part.mass();
     }
     // 1- -> 1- 0-
-    else if(outgoing[0]->iSpin()==PDT::Spin0) {
+    else if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy2 fact = -2.*kp_*sqrt(2.*momenta[0].mass()/3./part.mass())/fPi_/Lambda_*(part.momentum()*momenta[1])/sqr(part.mass());	
       for(unsigned int ix=0;ix<3;++ix) {
       	LorentzVector<complex<double> > vtemp = fact*epsilon(momenta[1],part.momentum(),vecIn_[ix]);
       	for(unsigned int iy=0;iy<3;++iy) {
       	  (*ME())(ix,iy,0) = vtemp*vecOut_[iy];
       	}
       }
       // analytic test of the answer
       test = 4.*momenta[0].mass()*sqr(kp_*pcm*(sqr(part.mass())-sqr(momenta[0].mass())+sqr(momenta[1].mass())))
 	/9./sqr(fPi_*Lambda_*part.mass())/part.mass();
     }
     else
       assert(false);
   }
   // 2- from (1-,2-)
   else if(itemp==10000 && part.data().iSpin()==PDT::Spin2) {
     // 2- -> 1- 0-
     if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy fact = 4.*kp_*sqrt(momenta[0].mass()/part.mass())/fPi_/Lambda_*(part.momentum()*momenta[1])/part.mass();
       for(unsigned int ix=0;ix<5;++ix) {
 	LorentzVector<complex<double> > vtemp = fact*(momenta[1]*tensorIn_[ix]);
 	for(unsigned int iy=0;iy<3;++iy) {
 	  (*ME())(ix,iy,0) = vecOut_[iy].dot(vtemp);
 	}
       }
       // analytic test of the answer
       test = 2.*sqr(kp_*pcm*(sqr(part.mass())-sqr(momenta[0].mass())+sqr(momenta[1].mass())))/
 	15./sqr(fPi_*Lambda_)/momenta[1].mass()/pow<5,1>(part.mass())*
 	(sqr(part.mass())*(sqr(part.mass())+8.*sqr(momenta[0].mass())-2.*sqr(momenta[1].mass()))+sqr(sqr(momenta[0].mass())-sqr(momenta[1].mass())));
     }
     else
       assert(false);
   }
   // 2- from (2-,3-)
   else if(itemp==20000  && part.data().iSpin()==PDT::Spin2) {
     // 2- -> 1- 0-
     if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy3 fact = 4.*k_*sqrt(momenta[0].mass()/part.mass())/sqrt(15.)/fPi_/sqr(Lambda_);
       for(unsigned int ix=0;ix<5;++ix) {
 	LorentzVector<complex<Energy> > vtemp = momenta[1]*tensorIn_[ix]+tensorIn_[ix]*momenta[1];
 	complex<Energy2> dot = 0.5*(vtemp*momenta[1]);
 	for(unsigned int iy=0;iy<3;++iy) {
 	  (*ME())(ix,iy,0) = Complex(fact*(sqr(pcm)*vecOut_[iy].dot(vtemp) +5.*dot*(vecOut_[iy]*momenta[1])));
 	}
       }
       // analytic test of the answer
       test = 32.*sqr(k_)*pow<6,1>(pcm)/225./sqr(fPi_*sqr(Lambda_))/momenta[0].mass()/pow<3,1>(part.mass())*
 	(sqr(part.mass())*(16.*sqr(part.mass())-2.*sqr(momenta[0].mass())+8.*sqr(momenta[1].mass()))+sqr(sqr(momenta[0].mass())-sqr(momenta[1].mass())));
     }
     else
       assert(false);
   }
   // 3- from (2-,3-)
   else if(itemp==0      && part.data().iSpin()==PDT::Spin3) {
     // 3- -> 0- 0-
     if(outgoing[0]->iSpin()==PDT::Spin0) {
       InvEnergy3 fact = -4.*k_/fPi_/sqr(Lambda_)*sqrt(momenta[0].mass()/part.mass());
       for(unsigned int ix=0;ix<7;++ix) {
 	(*ME())(ix,0,0) = Complex(fact*((spin3In_[ix].dot(momenta[1],0)*momenta[1])*momenta[1]));
       }
       // analytic test of answer
       test = 32.*sqr(k_)*momenta[0].mass()/35./part.mass()*pow<6,1>(pcm)/sqr(fPi_*sqr(Lambda_));
     }
     // 3- -> 1- 0-
     else if(outgoing[0]->iSpin()==PDT::Spin1) {
       InvEnergy4 fact = 4.*k_/fPi_/sqr(Lambda_)*sqrt(momenta[0].mass()/part.mass())/part.mass();
       for(unsigned int ix=0;ix<7;++ix) {
 	LorentzVector<complex<InvEnergy2> > vtemp = fact*(spin3In_[ix].dot(momenta[1],0)*momenta[1]);
 	for(unsigned int iy=0;iy<3;++iy) {
 	  LorentzVector<complex<Energy2> > vtemp2 =epsilon(momenta[1],part.momentum(),vecOut_[iy]);
 	  (*ME())(ix,iy,0) = Complex(vtemp*vtemp2); 
 	}
       }
       // analytic test of answer
       test = 128.*sqr(k_)*momenta[0].mass()/part.mass()*pow<6,1>(pcm)/105./sqr(fPi_*sqr(Lambda_));
     }
     else
       assert(false);
   }
   else
     assert(false);
   // spin average
   double output = ME()->contract(rho_).real();
   // testing
   double ratio = abs(output-test)/(output+test);
   if(ratio>1e-14)
     generator()->log() << "testing matrix element for " << part.PDGName() << " -> "
 		       << outgoing[0]->PDGName() << " " << outgoing[1]->PDGName() << " "
 		       << output << " " << test << " " << ratio << endl;
   // isospin factors
   if(abs(outgoing[1]->id())==ParticleID::pi0) {
     int ispect = (abs(part.id())%100)/10;
     output *= ispect<3 ? 0.5 : 0.125*sqr(deltaEta_);
   }
   // return the answer
   return output;
 }
 
 bool HQETStrongDecayer::twoBodyMEcode(const DecayMode & dm,int & mecode,
 				      double & coupling) const {
   // int imode(-1);
   // int id(dm.parent()->id());
   // int idbar = dm.parent()->CC() ? dm.parent()->CC()->id() : id;
   // ParticleMSet::const_iterator pit(dm.products().begin());
   // int id1((**pit).id());
   // int id1bar = (**pit).CC() ? (**pit).CC()->id() : id1;
   // ++pit;
   // int id2((**pit).id());
   // int id2bar = (**pit).CC() ? (**pit).CC()->id() : id2;
   // unsigned int ix(0); bool order(false);
   // do {
   //   if(id   ==incoming_[ix]) {
   //     if(id1==outgoing_[ix].first&&id2==outgoing_[ix].second) {
   // 	imode=ix;
   // 	order=true;
   //     }
   //     if(id2==outgoing_[ix].first&&id1==outgoing_[ix].second) {
   // 	imode=ix;
   // 	order=false;
   //     }
   //   }
   //   if(idbar==incoming_[ix]&&imode<0) {
   //     if(id1bar==outgoing_[ix].first&&id2bar==outgoing_[ix].second) {
   // 	imode=ix;
   // 	order=true;
   //     }
   //     if(id2bar==outgoing_[ix].first&&id1bar==outgoing_[ix].second) {
   // 	imode=ix;
   // 	order=false;
   //     }
   //   }
   //   ++ix;
   // }
   // while(ix<incoming_.size()&&imode<0);
   // coupling=_coupling[imode]*dm.parent()->mass();
   // mecode=7;
   // return order;
 }
 
 void HQETStrongDecayer::dataBaseOutput(ofstream & output,
   				       bool header) const {
   if(header) output << "update decayers set parameters=\"";
   // parameters for the DecayIntegrator base class
   DecayIntegrator::dataBaseOutput(output,false);
   // the rest of the parameters
   // couplings
   output << "newdef " << name() << ":fPi    " << fPi_/MeV    << "\n";
   output << "newdef " << name() << ":g      " << g_          << "\n";
   output << "newdef " << name() << ":h      " << h_          << "\n";
   output << "newdef " << name() << ":hp     " << hp_         << "\n";
   output << "newdef " << name() << ":k      " << k_          << "\n";
   output << "newdef " << name() << ":kp     " << kp_         << "\n";
   output << "newdef " << name() << ":gtilde " << gtilde_     << "\n";
   output << "newdef " << name() << ":Lambda " << Lambda_/GeV << "\n";
   output << "newdef " << name() << ":psiL   " << psiL_       << "\n";
   output << "newdef " << name() << ":psiS   " << psiS_       << "\n";
   output << "newdef " << name() << ":DeltaEta " << deltaEta_ << "\n";
   for(unsigned int ix=0;ix<incoming_.size();++ix) {
     output << "do " << name() << ":SetUpDecayMode "
 	   << incoming_[ix] << " " << outgoing_[ix].first << " "
 	   << outgoing_[ix].second << " " << maxWeight_[ix] << "\n";
   }
   if(header) output << "\n\" where BINARY ThePEGName=\""
   		    << fullName() << "\";" << endl;
 }
 
 string HQETStrongDecayer::setUpDecayMode(string arg) {
   // parse first bit of the string
   string stype = StringUtils::car(arg);
   arg          = StringUtils::cdr(arg);
   // extract PDG code for the incoming particle
   long in = stoi(stype);
   tcPDPtr pData = getParticleData(in);
   if(!pData)
     return "Incoming particle with id " + std::to_string(in) + "does not exist";
   if(int(pData->iSpin())%2!=1)
     return "Incoming particle with id " + std::to_string(in) + "does not integer spin";
   // and outgoing particles
   stype = StringUtils::car(arg);
   arg   = StringUtils::cdr(arg);
   pair<long,long> out;
   out.first = stoi(stype);
   pData = getParticleData(out.first);
   if(!pData)
     return "First outgoing particle with id " + std::to_string(out.first) + "does not exist";
   if(pData->iSpin()!=PDT::Spin0 && pData->iSpin()!=PDT::Spin1)
     return "First outgoing particle with id " + std::to_string(out.first) + "does not have spin 0/1";
   out.first = stoi(stype);
   stype = StringUtils::car(arg);
   arg   = StringUtils::cdr(arg);
   out.second = stoi(stype);
   pData = getParticleData(out.second);
   if(!pData)
     return "Second outgoing particle with id " + std::to_string(out.second) + "does not exist";
   if(pData->iSpin()!=PDT::Spin0)
     return "Second outgoing particle with id " + std::to_string(out.second) + "does not have spin 0";
   // and the maximum weight
   stype = StringUtils::car(arg);
   arg   = StringUtils::cdr(arg);
   double wgt = stof(stype);
   // store the information
   incoming_.push_back(in);
   outgoing_.push_back(out);
   maxWeight_.push_back(wgt);
   // success
   return "";
 }
diff --git a/src/defaults/decayers.in.in b/src/defaults/decayers.in.in
--- a/src/defaults/decayers.in.in
+++ b/src/defaults/decayers.in.in
@@ -1,23000 +1,23012 @@
 # -*- ThePEG-repository -*-
 
 #
 # This file contains the set-up of the decayers for Herwig outputted
 # from the Herwig Particles Database at 13:42:1 on the 15/11/2007.
 #
 # load libraries which are needed
 library Hw64Decay.so
 library HwPartonicDecay.so
 library HwWeakCurrents.so
 library HwFormFactors.so
 library HwSMDecay.so
 library HwVMDecay.so
 library HwTMDecay.so
 library HwHMDecay.so
 library HwMamboDecay.so
 library HwPerturbativeDecay.so
 library HwBaryonDecay.so
 library HwTauDecay.so
 #
 create Herwig::TauDecayer  Tau1Meson
 newdef Tau1Meson:Iteration 1
 newdef Tau1Meson:Ntry 500
 newdef Tau1Meson:Points 10000
 newdef Tau1Meson:GenerateIntermediates 0
 insert Tau1Meson:WeightLocation 0 0
 insert Tau1Meson:WeightLocation 1 0
 insert Tau1Meson:MaximumWeight 0 0.50
 insert Tau1Meson:MaximumWeight 1 0.02
 create Herwig::ScalarMesonCurrent Tau1MesonCurrent HwWeakCurrents.so
 newdef Tau1MesonCurrent:ThetaEtaEtaPrime -0.194
 newdef Tau1MesonCurrent:ID 0 211
 newdef Tau1MesonCurrent:Decay_Constant 0 130.7
 newdef Tau1MesonCurrent:ID 1 111
 newdef Tau1MesonCurrent:Decay_Constant 1 130.7
 newdef Tau1MesonCurrent:ID 2 111
 newdef Tau1MesonCurrent:Decay_Constant 2 130.7
 newdef Tau1MesonCurrent:ID 3 221
 newdef Tau1MesonCurrent:Decay_Constant 3 130.7
 newdef Tau1MesonCurrent:ID 4 221
 newdef Tau1MesonCurrent:Decay_Constant 4 130.7
 newdef Tau1MesonCurrent:ID 5 221
 newdef Tau1MesonCurrent:Decay_Constant 5 130.7
 newdef Tau1MesonCurrent:ID 6 331
 newdef Tau1MesonCurrent:Decay_Constant 6 130.7
 newdef Tau1MesonCurrent:ID 7 331
 newdef Tau1MesonCurrent:Decay_Constant 7 130.7
 newdef Tau1MesonCurrent:ID 8 331
 newdef Tau1MesonCurrent:Decay_Constant 8 130.7
 newdef Tau1MesonCurrent:ID 9 311
 newdef Tau1MesonCurrent:Decay_Constant 9 159.8
 newdef Tau1MesonCurrent:ID 10 321
 newdef Tau1MesonCurrent:Decay_Constant 10 159.8
 newdef Tau1MesonCurrent:ID 11 411
 newdef Tau1MesonCurrent:Decay_Constant 11 200
 newdef Tau1MesonCurrent:ID 12 421
 newdef Tau1MesonCurrent:Decay_Constant 12 200
 newdef Tau1MesonCurrent:ID 13 431
 newdef Tau1MesonCurrent:Decay_Constant 13 241
 newdef Tau1MesonCurrent:ID 14 10431
 newdef Tau1MesonCurrent:Decay_Constant 14 73.7
 newdef Tau1MesonCurrent:Quark 0  2
 newdef Tau1MesonCurrent:AntiQuark 0  -1
 newdef Tau1MesonCurrent:Quark 1  1
 newdef Tau1MesonCurrent:AntiQuark 1  -1
 newdef Tau1MesonCurrent:Quark 2  2
 newdef Tau1MesonCurrent:AntiQuark 2  -2
 newdef Tau1MesonCurrent:Quark 3  1
 newdef Tau1MesonCurrent:AntiQuark 3  -1
 newdef Tau1MesonCurrent:Quark 4  2
 newdef Tau1MesonCurrent:AntiQuark 4  -2
 newdef Tau1MesonCurrent:Quark 5  3
 newdef Tau1MesonCurrent:AntiQuark 5  -3
 newdef Tau1MesonCurrent:Quark 6  1
 newdef Tau1MesonCurrent:AntiQuark 6  -1
 newdef Tau1MesonCurrent:Quark 7  2
 newdef Tau1MesonCurrent:AntiQuark 7  -2
 newdef Tau1MesonCurrent:Quark 8  3
 newdef Tau1MesonCurrent:AntiQuark 8  -3
 newdef Tau1MesonCurrent:Quark 9  1
 newdef Tau1MesonCurrent:AntiQuark 9  -3
 newdef Tau1MesonCurrent:Quark 10  2
 newdef Tau1MesonCurrent:AntiQuark 10  -3
 newdef Tau1MesonCurrent:Quark 11  4
 newdef Tau1MesonCurrent:AntiQuark 11  -1
 newdef Tau1MesonCurrent:Quark 12  4
 newdef Tau1MesonCurrent:AntiQuark 12  -2
 newdef Tau1MesonCurrent:Quark 13  4
 newdef Tau1MesonCurrent:AntiQuark 13  -3
 newdef Tau1MesonCurrent:Quark 14  4
 newdef Tau1MesonCurrent:AntiQuark 14  -3
 newdef Tau1Meson:WeakCurrent Tau1MesonCurrent 
 #
 create Herwig::TauDecayer  Tau2Pion
 newdef Tau2Pion:Iteration 10
 newdef Tau2Pion:Ntry 500
 newdef Tau2Pion:Points 10000
 newdef Tau2Pion:GenerateIntermediates 1
 insert Tau2Pion:WeightLocation 0 0
 insert Tau2Pion:WeightLocation 1 3
 insert Tau2Pion:MaximumWeight 0 1.64338
 insert Tau2Pion:MaximumWeight 1 0.00863434
 insert Tau2Pion:Weights 0 0.812615
 insert Tau2Pion:Weights 1 0.146317
 insert Tau2Pion:Weights 2 0.0410682
 insert Tau2Pion:Weights 3 0.51195
 insert Tau2Pion:Weights 4 0.396123
 insert Tau2Pion:Weights 5 0.0919263
 
 create Herwig::TwoPionRhoCurrent Tau2PionCurrent HwWeakCurrents.so
 newdef Tau2PionCurrent:RhoMasses 0 774.6
 newdef Tau2PionCurrent:RhoMasses 1 1408
 newdef Tau2PionCurrent:RhoMasses 2 1700
 newdef Tau2PionCurrent:RhoWidths 0 149
 newdef Tau2PionCurrent:RhoWidths 1 502
 newdef Tau2PionCurrent:RhoWidths 2 235
 newdef Tau2PionCurrent:RhoParameters 1
 newdef Tau2PionCurrent:PiMagnitude 0 1
 newdef Tau2PionCurrent:PiPhase 0 0
 newdef Tau2PionCurrent:PiMagnitude 1 0.167
 newdef Tau2PionCurrent:PiPhase 1 180
 newdef Tau2PionCurrent:PiMagnitude 2 0.05
 newdef Tau2PionCurrent:PiPhase 2 0
 newdef Tau2PionCurrent:PiModel 0
 newdef Tau2PionCurrent:Quark 0  2
 newdef Tau2PionCurrent:AntiQuark 0  -1
 newdef Tau2PionCurrent:Quark 1  2
 newdef Tau2PionCurrent:AntiQuark 1  -1
 newdef Tau2Pion:WeakCurrent Tau2PionCurrent 
 #
 create Herwig::TauDecayer  TauKEta
 newdef TauKEta:Iteration 10
 newdef TauKEta:Ntry 500
 newdef TauKEta:Points 10000
 newdef TauKEta:GenerateIntermediates 1
 insert TauKEta:WeightLocation 0 0
 insert TauKEta:WeightLocation 1 3
 insert TauKEta:WeightLocation 2 6
 insert TauKEta:MaximumWeight 0 0.021307
 insert TauKEta:MaximumWeight 1 0.040893
 insert TauKEta:MaximumWeight 2 0.00107674
 insert TauKEta:Weights 0 0.842908
 insert TauKEta:Weights 1 0.0652633
 insert TauKEta:Weights 2 0.0918287
 insert TauKEta:Weights 3 0.84012
 insert TauKEta:Weights 4 0.0665051
 insert TauKEta:Weights 5 0.0933754
 insert TauKEta:Weights 6 0.549109
 insert TauKEta:Weights 7 0.196521
 insert TauKEta:Weights 8 0.254371
 
 create Herwig::KPiKStarCurrent TauKEtaCurrent HwWeakCurrents.so
 newdef TauKEtaCurrent:KstarMasses 0 892.1
 newdef TauKEtaCurrent:KstarMasses 1 1700
 insert TauKEtaCurrent:KstarMasses 2 1717
 newdef TauKEtaCurrent:KstarWidths 0 51.3
 newdef TauKEtaCurrent:KstarWidths 1 235
 insert TauKEtaCurrent:KstarWidths 2 322
 newdef TauKEtaCurrent:KstarParameters 1
 newdef TauKEtaCurrent:KMagnitude 0 1
 newdef TauKEtaCurrent:KPhase 0 0
 newdef TauKEtaCurrent:KMagnitude 1 0.038
 newdef TauKEtaCurrent:KPhase 1 180
 newdef TauKEtaCurrent:KMagnitude 2 0
 newdef TauKEtaCurrent:KPhase 2 0
 newdef TauKEtaCurrent:KModel  0
 newdef TauKEtaCurrent:Quark 0  2
 newdef TauKEtaCurrent:AntiQuark 0  -3
 newdef TauKEtaCurrent:Quark 1  2
 newdef TauKEtaCurrent:AntiQuark 1  -3
 newdef TauKEtaCurrent:Quark 2  2
 newdef TauKEtaCurrent:AntiQuark 2  -3
 newdef TauKEta:WeakCurrent TauKEtaCurrent
 #
 create Herwig::Hw64Decayer  DecayME0
 newdef DecayME0:MECode 0
 #
 create Herwig::Hw64Decayer  DecayME100
 newdef DecayME100:MECode 100
 #
 create Herwig::Hw64Decayer  DecayME101
 newdef DecayME101:MECode 101
 #
 create Herwig::a1ThreePionDecayer  a13Pi
 newdef a13Pi:Iteration 5
 newdef a13Pi:Ntry 500
 newdef a13Pi:Points 10000
 newdef a13Pi:GenerateIntermediates 1
 newdef a13Pi:LocalParameters 1
 newdef a13Pi:Coupling 90.44
 newdef a13Pi:Lambda2 1.2
 newdef a13Pi:a1mass2 1.5129
 newdef a13Pi:SigmaMass 0.8
 newdef a13Pi:SigmaWidth 0.8
 newdef a13Pi:SigmaMagnitude 1.39987
 newdef a13Pi:SigmaPhase 0.43585
 newdef    a13Pi:RhoMagnitude 0 1
 newdef    a13Pi:RhoPhase 0 0
 newdef    a13Pi:RhoMasses 0 0.7761
 newdef    a13Pi:RhoWidths 0 0.1445
 newdef a13Pi:AllNeutralWeights 0 0.339108
 newdef a13Pi:AllNeutralWeights 1 0.335601
 newdef a13Pi:AllNeutralWeights 2 0.325291
 newdef a13Pi:OneChargedWeights 0 0.19616
 newdef a13Pi:OneChargedWeights 1 0.191408
 newdef a13Pi:OneChargedWeights 2 0.12137
 newdef a13Pi:OneChargedWeights 3 0.115498
 newdef a13Pi:OneChargedWeights 4 0.12729
 newdef a13Pi:OneChargedWeights 5 0.127183
 newdef a13Pi:OneChargedWeights 6 0.12109
 newdef a13Pi:TwoChargedWeights 0 0.188163
 newdef a13Pi:TwoChargedWeights 1 0.192479
 newdef a13Pi:TwoChargedWeights 2 0.121658
 newdef a13Pi:TwoChargedWeights 3 0.12135
 newdef a13Pi:TwoChargedWeights 4 0.127298
 newdef a13Pi:TwoChargedWeights 5 0.124835
 newdef a13Pi:TwoChargedWeights 6 0.124217
 newdef a13Pi:ThreeChargedWeights 0 0.153071
 newdef a13Pi:ThreeChargedWeights 1 0.165741
 newdef a13Pi:ThreeChargedWeights 2 0.107509
 newdef a13Pi:ThreeChargedWeights 3 0.10275
 newdef a13Pi:ThreeChargedWeights 4 0.109738
 newdef a13Pi:ThreeChargedWeights 5 0.11254
 newdef a13Pi:ThreeChargedWeights 6 0.125344
 newdef a13Pi:ThreeChargedWeights 7 0.123307
 newdef a13Pi:ZeroMax 19.144
 newdef a13Pi:OneMax 7.83592
 newdef a13Pi:TwoMax 6.64804
 newdef a13Pi:ThreeMax 6.66296
 #
 create Herwig::TauDecayer  Tau4Pion
 newdef Tau4Pion:Iteration 10
 newdef Tau4Pion:Ntry 2000
 newdef Tau4Pion:Points 10000
 newdef Tau4Pion:GenerateIntermediates 1
 insert Tau4Pion:WeightLocation 0 0
 insert Tau4Pion:WeightLocation 1 12
 insert Tau4Pion:MaximumWeight 0 0.24
 insert Tau4Pion:MaximumWeight 1 2.41
 insert Tau4Pion:Weights 0  0.1058
 insert Tau4Pion:Weights 1  0.1058
 insert Tau4Pion:Weights 2  0.1058
 insert Tau4Pion:Weights 3  0.1058
 insert Tau4Pion:Weights 4  0.1058
 insert Tau4Pion:Weights 5  0.1058
 insert Tau4Pion:Weights 6  0.0668
 insert Tau4Pion:Weights 7  0.0668
 insert Tau4Pion:Weights 8  0.0668
 insert Tau4Pion:Weights 9  0.054903
 insert Tau4Pion:Weights 10 0.054903
 insert Tau4Pion:Weights 11 0.054904
 insert Tau4Pion:Weights 12 0.0659
 insert Tau4Pion:Weights 13 0.0659
 insert Tau4Pion:Weights 14 0.0659
 insert Tau4Pion:Weights 15 0.0659
 insert Tau4Pion:Weights 16 0.0659
 insert Tau4Pion:Weights 17 0.0659
 insert Tau4Pion:Weights 18 0.0558
 insert Tau4Pion:Weights 19 0.0558
 insert Tau4Pion:Weights 20 0.06175
 insert Tau4Pion:Weights 21 0.06175
 insert Tau4Pion:Weights 22 0.0781
 insert Tau4Pion:Weights 23 0.0781
 insert Tau4Pion:Weights 24 0.0550
 insert Tau4Pion:Weights 25 0.0550
 insert Tau4Pion:Weights 26 0.0517
 insert Tau4Pion:Weights 27 0.0517
 create Herwig::FourPionNovosibirskCurrent Tau4PionCurrent HwWeakCurrents.so
 newdef Tau4PionCurrent:rhoMass 0.7761
 newdef Tau4PionCurrent:a1Mass  1.23
 newdef Tau4PionCurrent:sigmaMass  0.8
 newdef Tau4PionCurrent:omegaMass  0.782
 newdef Tau4PionCurrent:rhoWidth 0.1445
 newdef Tau4PionCurrent:a1Width  0.45
 newdef Tau4PionCurrent:sigmaWidth  0.8
 newdef Tau4PionCurrent:omegaWidth  0.00841
 newdef Tau4PionCurrent:IntegrationMass 1.4
 newdef Tau4PionCurrent:IntegrationWidth 0.5
 newdef Tau4PionCurrent:SigmaMagnitude 1.39987
 newdef Tau4PionCurrent:SigmaPhase 0.43585
 newdef Tau4PionCurrent:Lambda2 1.2
 newdef Tau4PionCurrent:LocalParameters 1
 newdef Tau4PionCurrent:Initializea1 0
 newdef Tau4PionCurrent:a1RunningWidth 0 0
 newdef Tau4PionCurrent:a1RunningWidth 1 0
 newdef Tau4PionCurrent:a1RunningWidth 2 0
 newdef Tau4PionCurrent:a1RunningWidth 3 0
 newdef Tau4PionCurrent:a1RunningWidth 4 0
 newdef Tau4PionCurrent:a1RunningWidth 5 0
 newdef Tau4PionCurrent:a1RunningWidth 6 0
 newdef Tau4PionCurrent:a1RunningWidth 7 0
 newdef Tau4PionCurrent:a1RunningWidth 8 0
 newdef Tau4PionCurrent:a1RunningWidth 9 0
 newdef Tau4PionCurrent:a1RunningWidth 10 0
 newdef Tau4PionCurrent:a1RunningWidth 11 1.2668e-09
 newdef Tau4PionCurrent:a1RunningWidth 12 7.25154e-07
 newdef Tau4PionCurrent:a1RunningWidth 13 5.44727e-06
 newdef Tau4PionCurrent:a1RunningWidth 14 1.8636e-05
 newdef Tau4PionCurrent:a1RunningWidth 15 4.51749e-05
 newdef Tau4PionCurrent:a1RunningWidth 16 9.01909e-05
 newdef Tau4PionCurrent:a1RunningWidth 17 0.000159011
 newdef Tau4PionCurrent:a1RunningWidth 18 0.00025717
 newdef Tau4PionCurrent:a1RunningWidth 19 0.000390448
 newdef Tau4PionCurrent:a1RunningWidth 20 0.000564921
 newdef Tau4PionCurrent:a1RunningWidth 21 0.000787028
 newdef Tau4PionCurrent:a1RunningWidth 22 0.00106365
 newdef Tau4PionCurrent:a1RunningWidth 23 0.00140218
 newdef Tau4PionCurrent:a1RunningWidth 24 0.00181066
 newdef Tau4PionCurrent:a1RunningWidth 25 0.00229787
 newdef Tau4PionCurrent:a1RunningWidth 26 0.00287348
 newdef Tau4PionCurrent:a1RunningWidth 27 0.00354818
 newdef Tau4PionCurrent:a1RunningWidth 28 0.00433394
 newdef Tau4PionCurrent:a1RunningWidth 29 0.00524412
 newdef Tau4PionCurrent:a1RunningWidth 30 0.00629386
 newdef Tau4PionCurrent:a1RunningWidth 31 0.00750026
 newdef Tau4PionCurrent:a1RunningWidth 32 0.00888287
 newdef Tau4PionCurrent:a1RunningWidth 33 0.0104641
 newdef Tau4PionCurrent:a1RunningWidth 34 0.0122697
 newdef Tau4PionCurrent:a1RunningWidth 35 0.0143294
 newdef Tau4PionCurrent:a1RunningWidth 36 0.016678
 newdef Tau4PionCurrent:a1RunningWidth 37 0.0193556
 newdef Tau4PionCurrent:a1RunningWidth 38 0.0224095
 newdef Tau4PionCurrent:a1RunningWidth 39 0.025895
 newdef Tau4PionCurrent:a1RunningWidth 40 0.0298766
 newdef Tau4PionCurrent:a1RunningWidth 41 0.0344302
 newdef Tau4PionCurrent:a1RunningWidth 42 0.0396437
 newdef Tau4PionCurrent:a1RunningWidth 43 0.0456187
 newdef Tau4PionCurrent:a1RunningWidth 44 0.0524703
 newdef Tau4PionCurrent:a1RunningWidth 45 0.0603249
 newdef Tau4PionCurrent:a1RunningWidth 46 0.0693166
 newdef Tau4PionCurrent:a1RunningWidth 47 0.0795701
 newdef Tau4PionCurrent:a1RunningWidth 48 0.0911959
 newdef Tau4PionCurrent:a1RunningWidth 49 0.104253
 newdef Tau4PionCurrent:a1RunningWidth 50 0.118728
 newdef Tau4PionCurrent:a1RunningWidth 51 0.134509
 newdef Tau4PionCurrent:a1RunningWidth 52 0.151382
 newdef Tau4PionCurrent:a1RunningWidth 53 0.169043
 newdef Tau4PionCurrent:a1RunningWidth 54 0.187144
 newdef Tau4PionCurrent:a1RunningWidth 55 0.205332
 newdef Tau4PionCurrent:a1RunningWidth 56 0.223296
 newdef Tau4PionCurrent:a1RunningWidth 57 0.240783
 newdef Tau4PionCurrent:a1RunningWidth 58 0.257608
 newdef Tau4PionCurrent:a1RunningWidth 59 0.273644
 newdef Tau4PionCurrent:a1RunningWidth 60 0.288817
 newdef Tau4PionCurrent:a1RunningWidth 61 0.303092
 newdef Tau4PionCurrent:a1RunningWidth 62 0.316463
 newdef Tau4PionCurrent:a1RunningWidth 63 0.328939
 newdef Tau4PionCurrent:a1RunningWidth 64 0.340546
 newdef Tau4PionCurrent:a1RunningWidth 65 0.351317
 newdef Tau4PionCurrent:a1RunningWidth 66 0.36129
 newdef Tau4PionCurrent:a1RunningWidth 67 0.370505
 newdef Tau4PionCurrent:a1RunningWidth 68 0.379004
 newdef Tau4PionCurrent:a1RunningWidth 69 0.386827
 newdef Tau4PionCurrent:a1RunningWidth 70 0.394014
 newdef Tau4PionCurrent:a1RunningWidth 71 0.400604
 newdef Tau4PionCurrent:a1RunningWidth 72 0.406634
 newdef Tau4PionCurrent:a1RunningWidth 73 0.412139
 newdef Tau4PionCurrent:a1RunningWidth 74 0.417151
 newdef Tau4PionCurrent:a1RunningWidth 75 0.421702
 newdef Tau4PionCurrent:a1RunningWidth 76 0.425822
 newdef Tau4PionCurrent:a1RunningWidth 77 0.429538
 newdef Tau4PionCurrent:a1RunningWidth 78 0.432877
 newdef Tau4PionCurrent:a1RunningWidth 79 0.435862
 newdef Tau4PionCurrent:a1RunningWidth 80 0.438551
 newdef Tau4PionCurrent:a1RunningWidth 81 0.440898
 newdef Tau4PionCurrent:a1RunningWidth 82 0.442955
 newdef Tau4PionCurrent:a1RunningWidth 83 0.44475
 newdef Tau4PionCurrent:a1RunningWidth 84 0.446231
 newdef Tau4PionCurrent:a1RunningWidth 85 0.447525
 newdef Tau4PionCurrent:a1RunningWidth 86 0.448599
 newdef Tau4PionCurrent:a1RunningWidth 87 0.449464
 newdef Tau4PionCurrent:a1RunningWidth 88 0.450137
 newdef Tau4PionCurrent:a1RunningWidth 89 0.450632
 newdef Tau4PionCurrent:a1RunningWidth 90 0.450953
 newdef Tau4PionCurrent:a1RunningWidth 91 0.451115
 newdef Tau4PionCurrent:a1RunningWidth 92 0.451131
 newdef Tau4PionCurrent:a1RunningWidth 93 0.45101
 newdef Tau4PionCurrent:a1RunningWidth 94 0.450759
 newdef Tau4PionCurrent:a1RunningWidth 95 0.450388
 newdef Tau4PionCurrent:a1RunningWidth 96 0.449905
 newdef Tau4PionCurrent:a1RunningWidth 97 0.449318
 newdef Tau4PionCurrent:a1RunningWidth 98 0.448719
 newdef Tau4PionCurrent:a1RunningWidth 99 0.447944
 newdef Tau4PionCurrent:a1RunningWidth 100 0.446996
 newdef Tau4PionCurrent:a1RunningWidth 101 0.446057
 newdef Tau4PionCurrent:a1RunningWidth 102 0.445045
 newdef Tau4PionCurrent:a1RunningWidth 103 0.443964
 newdef Tau4PionCurrent:a1RunningWidth 104 0.442821
 newdef Tau4PionCurrent:a1RunningWidth 105 0.441618
 newdef Tau4PionCurrent:a1RunningWidth 106 0.440362
 newdef Tau4PionCurrent:a1RunningWidth 107 0.439058
 newdef Tau4PionCurrent:a1RunningWidth 108 0.437707
 newdef Tau4PionCurrent:a1RunningWidth 109 0.436533
 newdef Tau4PionCurrent:a1RunningWidth 110 0.434872
 newdef Tau4PionCurrent:a1RunningWidth 111 0.4334
 newdef Tau4PionCurrent:a1RunningWidth 112 0.431896
 newdef Tau4PionCurrent:a1RunningWidth 113 0.430362
 newdef Tau4PionCurrent:a1RunningWidth 114 0.428803
 newdef Tau4PionCurrent:a1RunningWidth 115 0.427213
 newdef Tau4PionCurrent:a1RunningWidth 116 0.425602
 newdef Tau4PionCurrent:a1RunningWidth 117 0.42397
 newdef Tau4PionCurrent:a1RunningWidth 118 0.422326
 newdef Tau4PionCurrent:a1RunningWidth 119 0.420655
 newdef Tau4PionCurrent:a1RunningWidth 120 0.418972
 newdef Tau4PionCurrent:a1RunningWidth 121 0.41728
 newdef Tau4PionCurrent:a1RunningWidth 122 0.415571
 newdef Tau4PionCurrent:a1RunningWidth 123 0.413857
 newdef Tau4PionCurrent:a1RunningWidth 124 0.412098
 newdef Tau4PionCurrent:a1RunningWidth 125 0.4104
 newdef Tau4PionCurrent:a1RunningWidth 126 0.408663
 newdef Tau4PionCurrent:a1RunningWidth 127 0.406921
 newdef Tau4PionCurrent:a1RunningWidth 128 0.405176
 newdef Tau4PionCurrent:a1RunningWidth 129 0.403429
 newdef Tau4PionCurrent:a1RunningWidth 130 0.40168
 newdef Tau4PionCurrent:a1RunningWidth 131 0.399931
 newdef Tau4PionCurrent:a1RunningWidth 132 0.398181
 newdef Tau4PionCurrent:a1RunningWidth 133 0.396433
 newdef Tau4PionCurrent:a1RunningWidth 134 0.394687
 newdef Tau4PionCurrent:a1RunningWidth 135 0.392944
 newdef Tau4PionCurrent:a1RunningWidth 136 0.391209
 newdef Tau4PionCurrent:a1RunningWidth 137 0.389472
 newdef Tau4PionCurrent:a1RunningWidth 138 0.38774
 newdef Tau4PionCurrent:a1RunningWidth 139 0.386011
 newdef Tau4PionCurrent:a1RunningWidth 140 0.38429
 newdef Tau4PionCurrent:a1RunningWidth 141 0.382576
 newdef Tau4PionCurrent:a1RunningWidth 142 0.380868
 newdef Tau4PionCurrent:a1RunningWidth 143 0.379168
 newdef Tau4PionCurrent:a1RunningWidth 144 0.377475
 newdef Tau4PionCurrent:a1RunningWidth 145 0.37579
 newdef Tau4PionCurrent:a1RunningWidth 146 0.374113
 newdef Tau4PionCurrent:a1RunningWidth 147 0.372446
 newdef Tau4PionCurrent:a1RunningWidth 148 0.370786
 newdef Tau4PionCurrent:a1RunningWidth 149 0.369135
 newdef Tau4PionCurrent:a1RunningWidth 150 0.367492
 newdef Tau4PionCurrent:a1RunningWidth 151 0.365861
 newdef Tau4PionCurrent:a1RunningWidth 152 0.364237
 newdef Tau4PionCurrent:a1RunningWidth 153 0.362623
 newdef Tau4PionCurrent:a1RunningWidth 154 0.361021
 newdef Tau4PionCurrent:a1RunningWidth 155 0.359431
 newdef Tau4PionCurrent:a1RunningWidth 156 0.357847
 newdef Tau4PionCurrent:a1RunningWidth 157 0.356276
 newdef Tau4PionCurrent:a1RunningWidth 158 0.354717
 newdef Tau4PionCurrent:a1RunningWidth 159 0.353165
 newdef Tau4PionCurrent:a1RunningWidth 160 0.351626
 newdef Tau4PionCurrent:a1RunningWidth 161 0.350098
 newdef Tau4PionCurrent:a1RunningWidth 162 0.348581
 newdef Tau4PionCurrent:a1RunningWidth 163 0.347074
 newdef Tau4PionCurrent:a1RunningWidth 164 0.345601
 newdef Tau4PionCurrent:a1RunningWidth 165 0.344092
 newdef Tau4PionCurrent:a1RunningWidth 166 0.342625
 newdef Tau4PionCurrent:a1RunningWidth 167 0.341161
 newdef Tau4PionCurrent:a1RunningWidth 168 0.339711
 newdef Tau4PionCurrent:a1RunningWidth 169 0.338272
 newdef Tau4PionCurrent:a1RunningWidth 170 0.336663
 newdef Tau4PionCurrent:a1RunningWidth 171 0.335428
 newdef Tau4PionCurrent:a1RunningWidth 172 0.334023
 newdef Tau4PionCurrent:a1RunningWidth 173 0.332629
 newdef Tau4PionCurrent:a1RunningWidth 174 0.331247
 newdef Tau4PionCurrent:a1RunningWidth 175 0.329873
 newdef Tau4PionCurrent:a1RunningWidth 176 0.328516
 newdef Tau4PionCurrent:a1RunningWidth 177 0.327166
 newdef Tau4PionCurrent:a1RunningWidth 178 0.325828
 newdef Tau4PionCurrent:a1RunningWidth 179 0.324499
 newdef Tau4PionCurrent:a1RunningWidth 180 0.323183
 newdef Tau4PionCurrent:a1RunningWidth 181 0.321879
 newdef Tau4PionCurrent:a1RunningWidth 182 0.320585
 newdef Tau4PionCurrent:a1RunningWidth 183 0.319302
 newdef Tau4PionCurrent:a1RunningWidth 184 0.318029
 newdef Tau4PionCurrent:a1RunningWidth 185 0.316768
 newdef Tau4PionCurrent:a1RunningWidth 186 0.31552
 newdef Tau4PionCurrent:a1RunningWidth 187 0.314277
 newdef Tau4PionCurrent:a1RunningWidth 188 0.313048
 newdef Tau4PionCurrent:a1RunningWidth 189 0.311828
 newdef Tau4PionCurrent:a1RunningWidth 190 0.31062
 newdef Tau4PionCurrent:a1RunningWidth 191 0.309424
 newdef Tau4PionCurrent:a1RunningWidth 192 0.308226
 newdef Tau4PionCurrent:a1RunningWidth 193 0.30706
 newdef Tau4PionCurrent:a1RunningWidth 194 0.305893
 newdef Tau4PionCurrent:a1RunningWidth 195 0.304738
 newdef Tau4PionCurrent:a1RunningWidth 196 0.303589
 newdef Tau4PionCurrent:a1RunningWidth 197 0.302453
 newdef Tau4PionCurrent:a1RunningWidth 198 0.301326
 newdef Tau4PionCurrent:a1RunningWidth 199 0.300207
 insert Tau4PionCurrent:a1RunningWidth 200 0.299101
 newdef Tau4PionCurrent:a1RunningQ2 0 0
 newdef Tau4PionCurrent:a1RunningQ2 1 0.0157885
 newdef Tau4PionCurrent:a1RunningQ2 2 0.0315769
 newdef Tau4PionCurrent:a1RunningQ2 3 0.0473654
 newdef Tau4PionCurrent:a1RunningQ2 4 0.0631539
 newdef Tau4PionCurrent:a1RunningQ2 5 0.0789423
 newdef Tau4PionCurrent:a1RunningQ2 6 0.0947308
 newdef Tau4PionCurrent:a1RunningQ2 7 0.110519
 newdef Tau4PionCurrent:a1RunningQ2 8 0.126308
 newdef Tau4PionCurrent:a1RunningQ2 9 0.142096
 newdef Tau4PionCurrent:a1RunningQ2 10 0.157885
 newdef Tau4PionCurrent:a1RunningQ2 11 0.173673
 newdef Tau4PionCurrent:a1RunningQ2 12 0.189462
 newdef Tau4PionCurrent:a1RunningQ2 13 0.20525
 newdef Tau4PionCurrent:a1RunningQ2 14 0.221039
 newdef Tau4PionCurrent:a1RunningQ2 15 0.236827
 newdef Tau4PionCurrent:a1RunningQ2 16 0.252615
 newdef Tau4PionCurrent:a1RunningQ2 17 0.268404
 newdef Tau4PionCurrent:a1RunningQ2 18 0.284192
 newdef Tau4PionCurrent:a1RunningQ2 19 0.299981
 newdef Tau4PionCurrent:a1RunningQ2 20 0.315769
 newdef Tau4PionCurrent:a1RunningQ2 21 0.331558
 newdef Tau4PionCurrent:a1RunningQ2 22 0.347346
 newdef Tau4PionCurrent:a1RunningQ2 23 0.363135
 newdef Tau4PionCurrent:a1RunningQ2 24 0.378923
 newdef Tau4PionCurrent:a1RunningQ2 25 0.394712
 newdef Tau4PionCurrent:a1RunningQ2 26 0.4105
 newdef Tau4PionCurrent:a1RunningQ2 27 0.426289
 newdef Tau4PionCurrent:a1RunningQ2 28 0.442077
 newdef Tau4PionCurrent:a1RunningQ2 29 0.457866
 newdef Tau4PionCurrent:a1RunningQ2 30 0.473654
 newdef Tau4PionCurrent:a1RunningQ2 31 0.489442
 newdef Tau4PionCurrent:a1RunningQ2 32 0.505231
 newdef Tau4PionCurrent:a1RunningQ2 33 0.521019
 newdef Tau4PionCurrent:a1RunningQ2 34 0.536808
 newdef Tau4PionCurrent:a1RunningQ2 35 0.552596
 newdef Tau4PionCurrent:a1RunningQ2 36 0.568385
 newdef Tau4PionCurrent:a1RunningQ2 37 0.584173
 newdef Tau4PionCurrent:a1RunningQ2 38 0.599962
 newdef Tau4PionCurrent:a1RunningQ2 39 0.61575
 newdef Tau4PionCurrent:a1RunningQ2 40 0.631539
 newdef Tau4PionCurrent:a1RunningQ2 41 0.647327
 newdef Tau4PionCurrent:a1RunningQ2 42 0.663116
 newdef Tau4PionCurrent:a1RunningQ2 43 0.678904
 newdef Tau4PionCurrent:a1RunningQ2 44 0.694693
 newdef Tau4PionCurrent:a1RunningQ2 45 0.710481
 newdef Tau4PionCurrent:a1RunningQ2 46 0.726269
 newdef Tau4PionCurrent:a1RunningQ2 47 0.742058
 newdef Tau4PionCurrent:a1RunningQ2 48 0.757846
 newdef Tau4PionCurrent:a1RunningQ2 49 0.773635
 newdef Tau4PionCurrent:a1RunningQ2 50 0.789423
 newdef Tau4PionCurrent:a1RunningQ2 51 0.805212
 newdef Tau4PionCurrent:a1RunningQ2 52 0.821
 newdef Tau4PionCurrent:a1RunningQ2 53 0.836789
 newdef Tau4PionCurrent:a1RunningQ2 54 0.852577
 newdef Tau4PionCurrent:a1RunningQ2 55 0.868366
 newdef Tau4PionCurrent:a1RunningQ2 56 0.884154
 newdef Tau4PionCurrent:a1RunningQ2 57 0.899943
 newdef Tau4PionCurrent:a1RunningQ2 58 0.915731
 newdef Tau4PionCurrent:a1RunningQ2 59 0.93152
 newdef Tau4PionCurrent:a1RunningQ2 60 0.947308
 newdef Tau4PionCurrent:a1RunningQ2 61 0.963097
 newdef Tau4PionCurrent:a1RunningQ2 62 0.978885
 newdef Tau4PionCurrent:a1RunningQ2 63 0.994673
 newdef Tau4PionCurrent:a1RunningQ2 64 1.01046
 newdef Tau4PionCurrent:a1RunningQ2 65 1.02625
 newdef Tau4PionCurrent:a1RunningQ2 66 1.04204
 newdef Tau4PionCurrent:a1RunningQ2 67 1.05783
 newdef Tau4PionCurrent:a1RunningQ2 68 1.07362
 newdef Tau4PionCurrent:a1RunningQ2 69 1.0894
 newdef Tau4PionCurrent:a1RunningQ2 70 1.10519
 newdef Tau4PionCurrent:a1RunningQ2 71 1.12098
 newdef Tau4PionCurrent:a1RunningQ2 72 1.13677
 newdef Tau4PionCurrent:a1RunningQ2 73 1.15256
 newdef Tau4PionCurrent:a1RunningQ2 74 1.16835
 newdef Tau4PionCurrent:a1RunningQ2 75 1.18414
 newdef Tau4PionCurrent:a1RunningQ2 76 1.19992
 newdef Tau4PionCurrent:a1RunningQ2 77 1.21571
 newdef Tau4PionCurrent:a1RunningQ2 78 1.2315
 newdef Tau4PionCurrent:a1RunningQ2 79 1.24729
 newdef Tau4PionCurrent:a1RunningQ2 80 1.26308
 newdef Tau4PionCurrent:a1RunningQ2 81 1.27887
 newdef Tau4PionCurrent:a1RunningQ2 82 1.29465
 newdef Tau4PionCurrent:a1RunningQ2 83 1.31044
 newdef Tau4PionCurrent:a1RunningQ2 84 1.32623
 newdef Tau4PionCurrent:a1RunningQ2 85 1.34202
 newdef Tau4PionCurrent:a1RunningQ2 86 1.35781
 newdef Tau4PionCurrent:a1RunningQ2 87 1.3736
 newdef Tau4PionCurrent:a1RunningQ2 88 1.38939
 newdef Tau4PionCurrent:a1RunningQ2 89 1.40517
 newdef Tau4PionCurrent:a1RunningQ2 90 1.42096
 newdef Tau4PionCurrent:a1RunningQ2 91 1.43675
 newdef Tau4PionCurrent:a1RunningQ2 92 1.45254
 newdef Tau4PionCurrent:a1RunningQ2 93 1.46833
 newdef Tau4PionCurrent:a1RunningQ2 94 1.48412
 newdef Tau4PionCurrent:a1RunningQ2 95 1.4999
 newdef Tau4PionCurrent:a1RunningQ2 96 1.51569
 newdef Tau4PionCurrent:a1RunningQ2 97 1.53148
 newdef Tau4PionCurrent:a1RunningQ2 98 1.54727
 newdef Tau4PionCurrent:a1RunningQ2 99 1.56306
 newdef Tau4PionCurrent:a1RunningQ2 100 1.57885
 newdef Tau4PionCurrent:a1RunningQ2 101 1.59464
 newdef Tau4PionCurrent:a1RunningQ2 102 1.61042
 newdef Tau4PionCurrent:a1RunningQ2 103 1.62621
 newdef Tau4PionCurrent:a1RunningQ2 104 1.642
 newdef Tau4PionCurrent:a1RunningQ2 105 1.65779
 newdef Tau4PionCurrent:a1RunningQ2 106 1.67358
 newdef Tau4PionCurrent:a1RunningQ2 107 1.68937
 newdef Tau4PionCurrent:a1RunningQ2 108 1.70515
 newdef Tau4PionCurrent:a1RunningQ2 109 1.72094
 newdef Tau4PionCurrent:a1RunningQ2 110 1.73673
 newdef Tau4PionCurrent:a1RunningQ2 111 1.75252
 newdef Tau4PionCurrent:a1RunningQ2 112 1.76831
 newdef Tau4PionCurrent:a1RunningQ2 113 1.7841
 newdef Tau4PionCurrent:a1RunningQ2 114 1.79989
 newdef Tau4PionCurrent:a1RunningQ2 115 1.81567
 newdef Tau4PionCurrent:a1RunningQ2 116 1.83146
 newdef Tau4PionCurrent:a1RunningQ2 117 1.84725
 newdef Tau4PionCurrent:a1RunningQ2 118 1.86304
 newdef Tau4PionCurrent:a1RunningQ2 119 1.87883
 newdef Tau4PionCurrent:a1RunningQ2 120 1.89462
 newdef Tau4PionCurrent:a1RunningQ2 121 1.9104
 newdef Tau4PionCurrent:a1RunningQ2 122 1.92619
 newdef Tau4PionCurrent:a1RunningQ2 123 1.94198
 newdef Tau4PionCurrent:a1RunningQ2 124 1.95777
 newdef Tau4PionCurrent:a1RunningQ2 125 1.97356
 newdef Tau4PionCurrent:a1RunningQ2 126 1.98935
 newdef Tau4PionCurrent:a1RunningQ2 127 2.00514
 newdef Tau4PionCurrent:a1RunningQ2 128 2.02092
 newdef Tau4PionCurrent:a1RunningQ2 129 2.03671
 newdef Tau4PionCurrent:a1RunningQ2 130 2.0525
 newdef Tau4PionCurrent:a1RunningQ2 131 2.06829
 newdef Tau4PionCurrent:a1RunningQ2 132 2.08408
 newdef Tau4PionCurrent:a1RunningQ2 133 2.09987
 newdef Tau4PionCurrent:a1RunningQ2 134 2.11565
 newdef Tau4PionCurrent:a1RunningQ2 135 2.13144
 newdef Tau4PionCurrent:a1RunningQ2 136 2.14723
 newdef Tau4PionCurrent:a1RunningQ2 137 2.16302
 newdef Tau4PionCurrent:a1RunningQ2 138 2.17881
 newdef Tau4PionCurrent:a1RunningQ2 139 2.1946
 newdef Tau4PionCurrent:a1RunningQ2 140 2.21039
 newdef Tau4PionCurrent:a1RunningQ2 141 2.22617
 newdef Tau4PionCurrent:a1RunningQ2 142 2.24196
 newdef Tau4PionCurrent:a1RunningQ2 143 2.25775
 newdef Tau4PionCurrent:a1RunningQ2 144 2.27354
 newdef Tau4PionCurrent:a1RunningQ2 145 2.28933
 newdef Tau4PionCurrent:a1RunningQ2 146 2.30512
 newdef Tau4PionCurrent:a1RunningQ2 147 2.3209
 newdef Tau4PionCurrent:a1RunningQ2 148 2.33669
 newdef Tau4PionCurrent:a1RunningQ2 149 2.35248
 newdef Tau4PionCurrent:a1RunningQ2 150 2.36827
 newdef Tau4PionCurrent:a1RunningQ2 151 2.38406
 newdef Tau4PionCurrent:a1RunningQ2 152 2.39985
 newdef Tau4PionCurrent:a1RunningQ2 153 2.41564
 newdef Tau4PionCurrent:a1RunningQ2 154 2.43142
 newdef Tau4PionCurrent:a1RunningQ2 155 2.44721
 newdef Tau4PionCurrent:a1RunningQ2 156 2.463
 newdef Tau4PionCurrent:a1RunningQ2 157 2.47879
 newdef Tau4PionCurrent:a1RunningQ2 158 2.49458
 newdef Tau4PionCurrent:a1RunningQ2 159 2.51037
 newdef Tau4PionCurrent:a1RunningQ2 160 2.52615
 newdef Tau4PionCurrent:a1RunningQ2 161 2.54194
 newdef Tau4PionCurrent:a1RunningQ2 162 2.55773
 newdef Tau4PionCurrent:a1RunningQ2 163 2.57352
 newdef Tau4PionCurrent:a1RunningQ2 164 2.58931
 newdef Tau4PionCurrent:a1RunningQ2 165 2.6051
 newdef Tau4PionCurrent:a1RunningQ2 166 2.62089
 newdef Tau4PionCurrent:a1RunningQ2 167 2.63667
 newdef Tau4PionCurrent:a1RunningQ2 168 2.65246
 newdef Tau4PionCurrent:a1RunningQ2 169 2.66825
 newdef Tau4PionCurrent:a1RunningQ2 170 2.68404
 newdef Tau4PionCurrent:a1RunningQ2 171 2.69983
 newdef Tau4PionCurrent:a1RunningQ2 172 2.71562
 newdef Tau4PionCurrent:a1RunningQ2 173 2.7314
 newdef Tau4PionCurrent:a1RunningQ2 174 2.74719
 newdef Tau4PionCurrent:a1RunningQ2 175 2.76298
 newdef Tau4PionCurrent:a1RunningQ2 176 2.77877
 newdef Tau4PionCurrent:a1RunningQ2 177 2.79456
 newdef Tau4PionCurrent:a1RunningQ2 178 2.81035
 newdef Tau4PionCurrent:a1RunningQ2 179 2.82614
 newdef Tau4PionCurrent:a1RunningQ2 180 2.84192
 newdef Tau4PionCurrent:a1RunningQ2 181 2.85771
 newdef Tau4PionCurrent:a1RunningQ2 182 2.8735
 newdef Tau4PionCurrent:a1RunningQ2 183 2.88929
 newdef Tau4PionCurrent:a1RunningQ2 184 2.90508
 newdef Tau4PionCurrent:a1RunningQ2 185 2.92087
 newdef Tau4PionCurrent:a1RunningQ2 186 2.93665
 newdef Tau4PionCurrent:a1RunningQ2 187 2.95244
 newdef Tau4PionCurrent:a1RunningQ2 188 2.96823
 newdef Tau4PionCurrent:a1RunningQ2 189 2.98402
 newdef Tau4PionCurrent:a1RunningQ2 190 2.99981
 newdef Tau4PionCurrent:a1RunningQ2 191 3.0156
 newdef Tau4PionCurrent:a1RunningQ2 192 3.03139
 newdef Tau4PionCurrent:a1RunningQ2 193 3.04717
 newdef Tau4PionCurrent:a1RunningQ2 194 3.06296
 newdef Tau4PionCurrent:a1RunningQ2 195 3.07875
 newdef Tau4PionCurrent:a1RunningQ2 196 3.09454
 newdef Tau4PionCurrent:a1RunningQ2 197 3.11033
 newdef Tau4PionCurrent:a1RunningQ2 198 3.12612
 newdef Tau4PionCurrent:a1RunningQ2 199 3.1419
 insert Tau4PionCurrent:a1RunningQ2 200 3.15769
 newdef Tau4PionCurrent:Quark 0  2
 newdef Tau4PionCurrent:AntiQuark 0  -1
 newdef Tau4PionCurrent:Quark 1  2
 newdef Tau4PionCurrent:AntiQuark 1  -1
 newdef Tau4Pion:WeakCurrent Tau4PionCurrent 
 #
 create Herwig::TauDecayer  Tau2MesonPhoton
 newdef Tau2MesonPhoton:Iteration 10
 newdef Tau2MesonPhoton:Ntry 500
 newdef Tau2MesonPhoton:Points 10000
 newdef Tau2MesonPhoton:GenerateIntermediates 1
 insert Tau2MesonPhoton:WeightLocation 0 0
 insert Tau2MesonPhoton:MaximumWeight 0 0.0107705
 insert Tau2MesonPhoton:Weights 0 1
 create Herwig::TwoPionPhotonCurrent Tau2MesonPhotonCurrent HwWeakCurrents.so
 newdef Tau2MesonPhotonCurrent:omegamass 0.782
 newdef Tau2MesonPhotonCurrent:omegawidth 0.0085
 newdef Tau2MesonPhotonCurrent:grho 0.112389
 newdef Tau2MesonPhotonCurrent:grhoomegapi 12.924
 newdef Tau2MesonPhotonCurrent:IntegrationMass 1.2
 newdef Tau2MesonPhotonCurrent:IntegrationWidth 0.35
 newdef Tau2MesonPhotonCurrent:Weights 0 1
 newdef Tau2MesonPhotonCurrent:Weights 1 -0.1
 newdef Tau2MesonPhotonCurrent:RhoMasses 0 773
 newdef Tau2MesonPhotonCurrent:RhoMasses 1 1700
 newdef Tau2MesonPhotonCurrent:RhoWidths 0 145
 newdef Tau2MesonPhotonCurrent:RhoWidths 1 260
 newdef Tau2MesonPhotonCurrent:Quark 0  2
 newdef Tau2MesonPhotonCurrent:AntiQuark 0  -1
 newdef Tau2MesonPhoton:WeakCurrent Tau2MesonPhotonCurrent
 #
 create Herwig::VectorMesonVectorPScalarDecayer  VectorVP
 newdef VectorVP:Iteration 1
 newdef VectorVP:Ntry 1000
 newdef VectorVP:Points 10000
 newdef VectorVP:GenerateIntermediates 0 
 do VectorVP:SetUpDecayMode 113 22 111 0.0002527 1.60721
 do VectorVP:SetUpDecayMode 213 22 211 0.000221 1.62841
 do VectorVP:SetUpDecayMode 113 22 221 0.000492 1.6601
 do VectorVP:SetUpDecayMode 223 22 111 0.000727947 1.6066
 do VectorVP:SetUpDecayMode 223 22 221 0.000143 1.61151
 do VectorVP:SetUpDecayMode 333 22 111 3.97e-05 1.57772
 do VectorVP:SetUpDecayMode 333 22 221 0.000212 1.59018
 do VectorVP:SetUpDecayMode 333 22 331 0.000219 1.75157
 do VectorVP:SetUpDecayMode 333 223 111 4.17e-05 1.82785
 do VectorVP:SetUpDecayMode 100333 323 -321 0.003934 4.69434
 do VectorVP:SetUpDecayMode 100333 313 -311 0.004011 4.43694
 do VectorVP:SetUpDecayMode 313 22 311 0.000384 1.60146
 do VectorVP:SetUpDecayMode 323 22 321 0.000253 1.59626
 do VectorVP:SetUpDecayMode 423 22 421 0.000616 1.60404
 do VectorVP:SetUpDecayMode 413 22 411 0.000152 1.5979
 do VectorVP:SetUpDecayMode 433 22 431 0.000764 1.60184
 do VectorVP:SetUpDecayMode 533 22 531 0.000248 1.59746
 do VectorVP:SetUpDecayMode 543 22 541 0.000266 1.59608
 do VectorVP:SetUpDecayMode 523 22 521 0.000553 1.59875
 do VectorVP:SetUpDecayMode 513 22 511 0.00031 1.59075
 do VectorVP:SetUpDecayMode 30113 113 221 0.002663 3.81111
 do VectorVP:SetUpDecayMode 30213 213 221 0.002663 3.83583
 do VectorVP:SetUpDecayMode 30113 323 -321 0.000894 4.7074
 do VectorVP:SetUpDecayMode 30113 313 -311 0.000908 4.7438
 do VectorVP:SetUpDecayMode 30213 323 -311 0.001265 4.62484
 do VectorVP:SetUpDecayMode 30213 -313 321 0.001273 4.88974
 do VectorVP:SetUpDecayMode 30223 213 -211 0.002996 3.32873
 do VectorVP:SetUpDecayMode 30223 113 111 0.002996 3.33537
 do VectorVP:SetUpDecayMode 100223 213 -211 0.004507 3.88723
 do VectorVP:SetUpDecayMode 100223 113 111 0.004507 3.71504
 do VectorVP:SetUpDecayMode 30313 323 -211 0.00336 3.81291
 do VectorVP:SetUpDecayMode 30313 313 111 0.00238 3.50939
 do VectorVP:SetUpDecayMode 30323 313 211 0.00336 3.33937
 do VectorVP:SetUpDecayMode 30323 323 111 0.00238 3.17369
 do VectorVP:SetUpDecayMode 30313 -213 321 0.004159 2.90637
 do VectorVP:SetUpDecayMode 30313 113 311 0.002939 2.94708
 do VectorVP:SetUpDecayMode 30323 213 311 0.004159 2.95133
 do VectorVP:SetUpDecayMode 30323 113 321 0.002939 2.9179
 do VectorVP:SetUpDecayMode 100313 323 -211 0.009469 5.36672
 do VectorVP:SetUpDecayMode 100313 313 111 0.006781 5.47961
 do VectorVP:SetUpDecayMode 100323 313 211 0.009469 5.37021
 do VectorVP:SetUpDecayMode 100323 323 111 0.006781 5.34432
 do VectorVP:SetUpDecayMode 443 22 441 0.000149 28.2694
 do VectorVP:SetUpDecayMode 443 22 331 2.5e-06 1.64689
 do VectorVP:SetUpDecayMode 443 213 -211 2.74e-06 3.14147
 do VectorVP:SetUpDecayMode 443 113 111 2.74e-06 3.15398
 do VectorVP:SetUpDecayMode 443 323 -321 1.8e-06 5.49223
 do VectorVP:SetUpDecayMode 443 313 -311 1.8e-06 5.30256
 do VectorVP:SetUpDecayMode 443 223 221 1.54e-06 5.62993
 do VectorVP:SetUpDecayMode 443 22 221 1.03e-06 1.60784
 do VectorVP:SetUpDecayMode 443 333 221 1.1e-06 5.27399
 do VectorVP:SetUpDecayMode 443 333 331 8.5e-07 5.15443
 do VectorVP:SetUpDecayMode 443 223 111 7.3e-07 5.67454
 do VectorVP:SetUpDecayMode 443 113 221 5.4e-07 2.95976
 do VectorVP:SetUpDecayMode 443 113 331 4.5e-07 2.58819
 do VectorVP:SetUpDecayMode 443 223 331 5.8e-07 5.78299
 do VectorVP:SetUpDecayMode 443 22 111 1.77e-07 1.59256
 do VectorVP:SetUpDecayMode 100443 443 221 0.00023 1.66072
 do VectorVP:SetUpDecayMode 100443 22 441 1.14e-05 3.23618
 do VectorVP:SetUpDecayMode 100443 22 331 6.2e-07 1.63014
 do VectorVP:SetUpDecayMode 100443 443 111 1.06e-05 1.6029
 do VectorVP:SetUpDecayMode 30443 443 221 0.000135 1.61494
 do VectorVP:SetUpDecayMode 30443 333 221 7.6e-06 5.31316
 do VectorVP:SetUpDecayMode 100443 323 -321 2.1e-07 6.27385
 do VectorVP:SetUpDecayMode 100443 313 -311 5.4e-07 6.24771
 do VectorVP:SetUpDecayMode 100443 333 221 2.9e-07 5.36123
 do VectorVP:SetUpDecayMode 100443 333 331 3.3e-07 5.16099
 do VectorVP:SetUpDecayMode 100443 213 -211 1.7e-07 3.45613
 do VectorVP:SetUpDecayMode 100443 113 111 1.7e-07 3.47115
 do VectorVP:SetUpDecayMode 100443 223 331 3.2e-07 5.80649
 do VectorVP:SetUpDecayMode 100443 113 221 2.5e-07 3.31378
 do VectorVP:SetUpDecayMode 100443 223 111 2.2e-07 5.54156
 do VectorVP:SetUpDecayMode 100443 113 331 2.6e-07 3.3628
 do VectorVP:SetUpDecayMode 9000553 -533 531 0.000149 1.54526
 do VectorVP:SetUpDecayMode 9000553 -513 511 0.000195 1.55437
 do VectorVP:SetUpDecayMode 9000553 -523 521 0.000195 1.55739
 #
 create Herwig::TauDecayer  Tau2Leptons
 newdef Tau2Leptons:Iteration 1
 newdef Tau2Leptons:Ntry 500
 newdef Tau2Leptons:Points 10000
 newdef Tau2Leptons:GenerateIntermediates 0
 insert Tau2Leptons:WeightLocation 0 0
 insert Tau2Leptons:WeightLocation 1 1
 insert Tau2Leptons:MaximumWeight 0 1.4
 insert Tau2Leptons:MaximumWeight 1 1.35
 insert Tau2Leptons:Weights 0 1
 insert Tau2Leptons:Weights 1 1
 create Herwig::LeptonNeutrinoCurrent Tau2LeptonCurrent  HwWeakCurrents.so
 newdef Tau2LeptonCurrent:Quark 0  11
 newdef Tau2LeptonCurrent:AntiQuark 0  -12
 newdef Tau2LeptonCurrent:Quark 1  13
 newdef Tau2LeptonCurrent:AntiQuark 1  -15
 newdef Tau2LeptonCurrent:Quark 2  15
 newdef Tau2LeptonCurrent:AntiQuark 2  -16
 newdef Tau2Leptons:WeakCurrent Tau2LeptonCurrent
 #
 create Herwig::VectorMeson2MesonDecayer  Vector2Meson
 newdef Vector2Meson:Iteration 1
 newdef Vector2Meson:Ntry 500
 newdef Vector2Meson:Points 10000
 newdef Vector2Meson:GenerateIntermediates 0 
 do Vector2Meson:SetUpDecayMode 113 211 -211 6 3.2
 do Vector2Meson:SetUpDecayMode 213 111 211 6 3.2
 do Vector2Meson:SetUpDecayMode 100113 211 -211 2.082 3.
 do Vector2Meson:SetUpDecayMode 100213 111 211 2.082 1.60125
 do Vector2Meson:SetUpDecayMode 30113 211 -211 1.655 1.60103
 do Vector2Meson:SetUpDecayMode 30213 111 211 1.655 1.60314
 do Vector2Meson:SetUpDecayMode 30113 321 -321 0.194 1.61146
 do Vector2Meson:SetUpDecayMode 30113 311 -311 0.194 1.59231
 do Vector2Meson:SetUpDecayMode 30213 321 -311 0.274 1.5977
 do Vector2Meson:SetUpDecayMode 30113 100211 -211 7.828 3.96846
 do Vector2Meson:SetUpDecayMode 30213 100111 211 7.828 3.96787
 do Vector2Meson:SetUpDecayMode 30213 111 100211 7.828 4.01174
 do Vector2Meson:SetUpDecayMode 100113 100211 -211 17.9 3.92182
 do Vector2Meson:SetUpDecayMode 100213 100111 211 17.9 3.89871
 do Vector2Meson:SetUpDecayMode 100213 111 100211 17.9 4.05484
 do Vector2Meson:SetUpDecayMode 223 211 -211 0.1847 3.2
 do Vector2Meson:SetUpDecayMode 313 321 -211 4.57 3.2
 do Vector2Meson:SetUpDecayMode 313 311 111 3.23 3.2
 do Vector2Meson:SetUpDecayMode 323 311 211 4.57 3.
 do Vector2Meson:SetUpDecayMode 323 321 111 3.23 3.
 do Vector2Meson:SetUpDecayMode 100313 321 -211 1.296 1.60116
 do Vector2Meson:SetUpDecayMode 100313 311 111 0.916 1.59304
 do Vector2Meson:SetUpDecayMode 100323 311 211 1.296 1.58997
 do Vector2Meson:SetUpDecayMode 100323 321 111 0.916 1.60422
 do Vector2Meson:SetUpDecayMode 30313 321 -211 3.114 1.59993
 do Vector2Meson:SetUpDecayMode 30313 311 111 2.201 1.5941
 do Vector2Meson:SetUpDecayMode 30323 311 211 3.114 1.59278
 do Vector2Meson:SetUpDecayMode 30323 321 111 2.201 1.60125
 do Vector2Meson:SetUpDecayMode 333 321 -321 4.48 3.2
 do Vector2Meson:SetUpDecayMode 333 311 -311 4.59 3.2
 do Vector2Meson:SetUpDecayMode 333 211 -211 0.008986 3.2
 do Vector2Meson:SetUpDecayMode 100333 321 -321 0.912 1.60035
 do Vector2Meson:SetUpDecayMode 100333 311 -311 0.918 0.0762376
 do Vector2Meson:SetUpDecayMode 30443 411 -411 12.83 1.60934
 do Vector2Meson:SetUpDecayMode 30443 421 -421 12.83 1.5897
 do Vector2Meson:SetUpDecayMode 423 421 111 6.309 3.2
 do Vector2Meson:SetUpDecayMode 413 411 111 6.313 3.2
 do Vector2Meson:SetUpDecayMode 413 421 211 8.938 3.2
 do Vector2Meson:SetUpDecayMode 433 431 111 1.398 3.2
 do Vector2Meson:SetUpDecayMode 10323 10321 111 14.45 12.4
 do Vector2Meson:SetUpDecayMode 10323 10311 211 20.46 12.4
 do Vector2Meson:SetUpDecayMode 10313 10311 111 14.27 12.4
 do Vector2Meson:SetUpDecayMode 10313 10321 -211 20.43 12.4
 do Vector2Meson:SetUpDecayMode 10323 321 10221 20 0
 do Vector2Meson:SetUpDecayMode 10313 311 10221 20 0
 do Vector2Meson:SetUpDecayMode 20323 321 10221 23.34 0.0623979
 do Vector2Meson:SetUpDecayMode 20313 311 10221 23.34 0.0596804
 do Vector2Meson:SetUpDecayMode 300553 521 -521 24.188 1.62728
 do Vector2Meson:SetUpDecayMode 300553 511 -511 24.188 1.57433
 do Vector2Meson:SetUpDecayMode 443 211 -211 0.002568 3.
 do Vector2Meson:SetUpDecayMode 443 321 -321 0.001111 3.00
 do Vector2Meson:SetUpDecayMode 443 311 -311 0.000873 0.000227768
 do Vector2Meson:SetUpDecayMode 100443 211 -211 0.001055 3.2
 do Vector2Meson:SetUpDecayMode 100443 321 -321 0.000905 3.2
 do Vector2Meson:SetUpDecayMode 100443 311 -311 0.000905 8.49446e-05
 do Vector2Meson:SetUpDecayMode 20223 9000111 111 4.169 6.7
 do Vector2Meson:SetUpDecayMode 20223 9000211 -211 4.169 5.5
 do Vector2Meson:SetUpDecayMode 20333 9000111 111 0.968 4.30758
 do Vector2Meson:SetUpDecayMode 20333 9000211 -211 0.968 4.32395
 do Vector2Meson:SetUpDecayMode 443 130 310 0.000873 3.00
 do Vector2Meson:SetUpDecayMode 100443 130 310 0.000905 3.
 do Vector2Meson:SetUpDecayMode 333 130 310 4.59 3.2
 do Vector2Meson:SetUpDecayMode 100333 130 310 0.918 1.6008
 do Vector2Meson:SetUpDecayMode 9000553 511 -511 1.33 1.60538
 do Vector2Meson:SetUpDecayMode 9000553 521 -521 1.33 1.60989
 do Vector2Meson:SetUpDecayMode 9000553 531 -531 0.75 1.57946
 #
 create Herwig::TauDecayer  Tau3Pion
 newdef Tau3Pion:Iteration 10
 newdef Tau3Pion:Ntry 1000
 newdef Tau3Pion:Points 10000
 newdef Tau3Pion:GenerateIntermediates 1
 insert Tau3Pion:WeightLocation 0 0
 insert Tau3Pion:WeightLocation 1 12
 insert Tau3Pion:MaximumWeight 0 2.3
 insert Tau3Pion:MaximumWeight 1 2.45
 insert Tau3Pion:Weights 0 0.13068
 insert Tau3Pion:Weights 1 0.131829
 insert Tau3Pion:Weights 2 0.0729247
 insert Tau3Pion:Weights 3 0.0729963
 insert Tau3Pion:Weights 4 0.0763421
 insert Tau3Pion:Weights 5 0.076501
 insert Tau3Pion:Weights 6 0.0824364
 insert Tau3Pion:Weights 7 0.0827193
 insert Tau3Pion:Weights 8 0.0675151
 insert Tau3Pion:Weights 9 0.0677209
 insert Tau3Pion:Weights 10 0.0696064
 insert Tau3Pion:Weights 11 0.0687289
 insert Tau3Pion:Weights 12 0.182751
 insert Tau3Pion:Weights 13 0.183206
 insert Tau3Pion:Weights 14 0.107469
 insert Tau3Pion:Weights 15 0.106478
 insert Tau3Pion:Weights 16 0.109374
 insert Tau3Pion:Weights 17 0.109834
 insert Tau3Pion:Weights 18 0.08196
 insert Tau3Pion:Weights 19 0.0597712
 insert Tau3Pion:Weights 20 0.0591571
 create Herwig::ThreePionCLEOCurrent Tau3PionCurrent HwWeakCurrents.so
 newdef    Tau3PionCurrent:RhoMasses 0 774.3
 newdef    Tau3PionCurrent:RhoMasses 1 1370
 insert Tau3PionCurrent:RhoMasses 2 1720
 newdef    Tau3PionCurrent:RhoWidths 0 149.1
 newdef    Tau3PionCurrent:RhoWidths 1 386
 insert Tau3PionCurrent:RhoWidths 2 250
 newdef Tau3PionCurrent:f_2Mass 1.275
 newdef Tau3PionCurrent:f_2Width 0.185
 newdef Tau3PionCurrent:f_0Mass 1.186
 newdef Tau3PionCurrent:f_0Width 0.35
 newdef Tau3PionCurrent:sigmaMass 0.86
 newdef Tau3PionCurrent:sigmaWidth 0.88
 newdef Tau3PionCurrent:a1Mass 1.331
 newdef Tau3PionCurrent:a1Width 0.814
 newdef Tau3PionCurrent:KaonMass 0.496
 newdef Tau3PionCurrent:KStarMass 0.894
 newdef Tau3PionCurrent:KaonCoupling 3.32
 newdef Tau3PionCurrent:Fpi 92.4189
 newdef Tau3PionCurrent:a1WidthOption 0
 newdef    Tau3PionCurrent:RhoPWaveMagnitude 0 1
 newdef    Tau3PionCurrent:RhoPWaveMagnitude 1 0.12
 newdef    Tau3PionCurrent:RhoPWavePhase 0 0
 newdef    Tau3PionCurrent:RhoPWavePhase 1 3.11018
 newdef    Tau3PionCurrent:RhoDWaveMagnitude 0 3.7e-07
 newdef    Tau3PionCurrent:RhoDWaveMagnitude 1 8.7e-07
 newdef    Tau3PionCurrent:RhoDWavePhase 0 -0.471239
 newdef    Tau3PionCurrent:RhoDWavePhase 1 1.66504
 newdef Tau3PionCurrent:f0Phase -1.69646
 newdef Tau3PionCurrent:f2Phase 1.75929
 newdef Tau3PionCurrent:sigmaPhase 0.722566
 newdef Tau3PionCurrent:f0Magnitude 0.77
 newdef Tau3PionCurrent:f2Magnitude 0.71
 newdef Tau3PionCurrent:sigmaMagnitude 2.1
 newdef Tau3PionCurrent:Initializea1 0
 newdef    Tau3PionCurrent:a1RunningWidth 0 0
 newdef    Tau3PionCurrent:a1RunningWidth 1 0
 newdef    Tau3PionCurrent:a1RunningWidth 2 0
 newdef    Tau3PionCurrent:a1RunningWidth 3 0
 newdef    Tau3PionCurrent:a1RunningWidth 4 0
 newdef    Tau3PionCurrent:a1RunningWidth 5 0
 newdef    Tau3PionCurrent:a1RunningWidth 6 0
 newdef    Tau3PionCurrent:a1RunningWidth 7 0
 newdef    Tau3PionCurrent:a1RunningWidth 8 0
 newdef    Tau3PionCurrent:a1RunningWidth 9 0
 newdef    Tau3PionCurrent:a1RunningWidth 10 0
 newdef    Tau3PionCurrent:a1RunningWidth 11 0.000212435
 newdef    Tau3PionCurrent:a1RunningWidth 12 0.01073
 newdef    Tau3PionCurrent:a1RunningWidth 13 0.0555214
 newdef    Tau3PionCurrent:a1RunningWidth 14 0.150291
 newdef    Tau3PionCurrent:a1RunningWidth 15 0.304161
 newdef    Tau3PionCurrent:a1RunningWidth 16 0.523206
 newdef    Tau3PionCurrent:a1RunningWidth 17 0.812079
 newdef    Tau3PionCurrent:a1RunningWidth 18 1.17487
 newdef    Tau3PionCurrent:a1RunningWidth 19 1.61557
 newdef    Tau3PionCurrent:a1RunningWidth 20 2.1384
 newdef    Tau3PionCurrent:a1RunningWidth 21 2.74801
 newdef    Tau3PionCurrent:a1RunningWidth 22 3.44963
 newdef    Tau3PionCurrent:a1RunningWidth 23 4.24924
 newdef    Tau3PionCurrent:a1RunningWidth 24 5.15367
 newdef    Tau3PionCurrent:a1RunningWidth 25 6.17076
 newdef    Tau3PionCurrent:a1RunningWidth 26 7.30953
 newdef    Tau3PionCurrent:a1RunningWidth 27 8.58034
 newdef    Tau3PionCurrent:a1RunningWidth 28 9.99512
 newdef    Tau3PionCurrent:a1RunningWidth 29 11.5676
 newdef    Tau3PionCurrent:a1RunningWidth 30 13.3136
 newdef    Tau3PionCurrent:a1RunningWidth 31 15.2514
 newdef    Tau3PionCurrent:a1RunningWidth 32 17.4021
 newdef    Tau3PionCurrent:a1RunningWidth 33 19.7904
 newdef    Tau3PionCurrent:a1RunningWidth 34 22.4445
 newdef    Tau3PionCurrent:a1RunningWidth 35 25.3978
 newdef    Tau3PionCurrent:a1RunningWidth 36 28.6887
 newdef    Tau3PionCurrent:a1RunningWidth 37 32.3625
 newdef    Tau3PionCurrent:a1RunningWidth 38 36.4717
 newdef    Tau3PionCurrent:a1RunningWidth 39 41.0778
 newdef    Tau3PionCurrent:a1RunningWidth 40 46.2524
 newdef    Tau3PionCurrent:a1RunningWidth 41 52.078
 newdef    Tau3PionCurrent:a1RunningWidth 42 58.6497
 newdef    Tau3PionCurrent:a1RunningWidth 43 66.0744
 newdef    Tau3PionCurrent:a1RunningWidth 44 74.4694
 newdef    Tau3PionCurrent:a1RunningWidth 45 83.9592
 newdef    Tau3PionCurrent:a1RunningWidth 46 94.6658
 newdef    Tau3PionCurrent:a1RunningWidth 47 106.696
 newdef    Tau3PionCurrent:a1RunningWidth 48 120.121
 newdef    Tau3PionCurrent:a1RunningWidth 49 134.956
 newdef    Tau3PionCurrent:a1RunningWidth 50 151.134
 newdef    Tau3PionCurrent:a1RunningWidth 51 168.502
 newdef    Tau3PionCurrent:a1RunningWidth 52 186.822
 newdef    Tau3PionCurrent:a1RunningWidth 53 205.804
 newdef    Tau3PionCurrent:a1RunningWidth 54 225.143
 newdef    Tau3PionCurrent:a1RunningWidth 55 244.553
 newdef    Tau3PionCurrent:a1RunningWidth 56 263.794
 newdef    Tau3PionCurrent:a1RunningWidth 57 282.682
 newdef    Tau3PionCurrent:a1RunningWidth 58 301.088
 newdef    Tau3PionCurrent:a1RunningWidth 59 318.93
 newdef    Tau3PionCurrent:a1RunningWidth 60 336.162
 newdef    Tau3PionCurrent:a1RunningWidth 61 352.768
 newdef    Tau3PionCurrent:a1RunningWidth 62 368.747
 newdef    Tau3PionCurrent:a1RunningWidth 63 384.115
 newdef    Tau3PionCurrent:a1RunningWidth 64 398.894
 newdef    Tau3PionCurrent:a1RunningWidth 65 413.111
 newdef    Tau3PionCurrent:a1RunningWidth 66 426.795
 newdef    Tau3PionCurrent:a1RunningWidth 67 439.978
 newdef    Tau3PionCurrent:a1RunningWidth 68 452.687
 newdef    Tau3PionCurrent:a1RunningWidth 69 464.956
 newdef    Tau3PionCurrent:a1RunningWidth 70 476.812
 newdef    Tau3PionCurrent:a1RunningWidth 71 488.281
 newdef    Tau3PionCurrent:a1RunningWidth 72 499.391
 newdef    Tau3PionCurrent:a1RunningWidth 73 510.164
 newdef    Tau3PionCurrent:a1RunningWidth 74 520.625
 newdef    Tau3PionCurrent:a1RunningWidth 75 530.792
 newdef    Tau3PionCurrent:a1RunningWidth 76 540.688
 newdef    Tau3PionCurrent:a1RunningWidth 77 550.329
 newdef    Tau3PionCurrent:a1RunningWidth 78 560.254
 newdef    Tau3PionCurrent:a1RunningWidth 79 568.918
 newdef    Tau3PionCurrent:a1RunningWidth 80 577.897
 newdef    Tau3PionCurrent:a1RunningWidth 81 586.684
 newdef    Tau3PionCurrent:a1RunningWidth 82 595.292
 newdef    Tau3PionCurrent:a1RunningWidth 83 603.735
 newdef    Tau3PionCurrent:a1RunningWidth 84 612.022
 newdef    Tau3PionCurrent:a1RunningWidth 85 620.165
 newdef    Tau3PionCurrent:a1RunningWidth 86 628.174
 newdef    Tau3PionCurrent:a1RunningWidth 87 636.058
 newdef    Tau3PionCurrent:a1RunningWidth 88 643.827
 newdef    Tau3PionCurrent:a1RunningWidth 89 651.491
 newdef    Tau3PionCurrent:a1RunningWidth 90 659.052
 newdef    Tau3PionCurrent:a1RunningWidth 91 666.522
 newdef    Tau3PionCurrent:a1RunningWidth 92 673.909
 newdef    Tau3PionCurrent:a1RunningWidth 93 681.217
 newdef    Tau3PionCurrent:a1RunningWidth 94 688.454
 newdef    Tau3PionCurrent:a1RunningWidth 95 695.626
 newdef    Tau3PionCurrent:a1RunningWidth 96 702.739
 newdef    Tau3PionCurrent:a1RunningWidth 97 709.799
 newdef    Tau3PionCurrent:a1RunningWidth 98 716.81
 newdef    Tau3PionCurrent:a1RunningWidth 99 723.784
 newdef    Tau3PionCurrent:a1RunningWidth 100 730.71
 newdef    Tau3PionCurrent:a1RunningWidth 101 737.611
 newdef    Tau3PionCurrent:a1RunningWidth 102 744.479
 newdef    Tau3PionCurrent:a1RunningWidth 103 751.327
 newdef    Tau3PionCurrent:a1RunningWidth 104 758.151
 newdef    Tau3PionCurrent:a1RunningWidth 105 764.964
 newdef    Tau3PionCurrent:a1RunningWidth 106 771.772
 newdef    Tau3PionCurrent:a1RunningWidth 107 778.567
 newdef    Tau3PionCurrent:a1RunningWidth 108 785.357
 newdef    Tau3PionCurrent:a1RunningWidth 109 792.152
 newdef    Tau3PionCurrent:a1RunningWidth 110 798.959
 newdef    Tau3PionCurrent:a1RunningWidth 111 805.774
 newdef    Tau3PionCurrent:a1RunningWidth 112 812.592
 newdef    Tau3PionCurrent:a1RunningWidth 113 819.435
 newdef    Tau3PionCurrent:a1RunningWidth 114 826.3
 newdef    Tau3PionCurrent:a1RunningWidth 115 833.19
 newdef    Tau3PionCurrent:a1RunningWidth 116 840.11
 newdef    Tau3PionCurrent:a1RunningWidth 117 847.061
 newdef    Tau3PionCurrent:a1RunningWidth 118 854.054
 newdef    Tau3PionCurrent:a1RunningWidth 119 861.078
 newdef    Tau3PionCurrent:a1RunningWidth 120 868.15
 newdef    Tau3PionCurrent:a1RunningWidth 121 875.265
 newdef    Tau3PionCurrent:a1RunningWidth 122 882.432
 newdef    Tau3PionCurrent:a1RunningWidth 123 920.524
 newdef    Tau3PionCurrent:a1RunningWidth 124 946.31
 newdef    Tau3PionCurrent:a1RunningWidth 125 966.538
 newdef    Tau3PionCurrent:a1RunningWidth 126 984.278
 newdef    Tau3PionCurrent:a1RunningWidth 127 1000.56
 newdef    Tau3PionCurrent:a1RunningWidth 128 1015.75
 newdef    Tau3PionCurrent:a1RunningWidth 129 1030.24
 newdef    Tau3PionCurrent:a1RunningWidth 130 1044.15
 newdef    Tau3PionCurrent:a1RunningWidth 131 1057.56
 newdef    Tau3PionCurrent:a1RunningWidth 132 1070.66
 newdef    Tau3PionCurrent:a1RunningWidth 133 1083.47
 newdef    Tau3PionCurrent:a1RunningWidth 134 1095.99
 newdef    Tau3PionCurrent:a1RunningWidth 135 1108.33
 newdef    Tau3PionCurrent:a1RunningWidth 136 1120.51
 newdef    Tau3PionCurrent:a1RunningWidth 137 1132.55
 newdef    Tau3PionCurrent:a1RunningWidth 138 1144.48
 newdef    Tau3PionCurrent:a1RunningWidth 139 1156.32
 newdef    Tau3PionCurrent:a1RunningWidth 140 1168.08
 newdef    Tau3PionCurrent:a1RunningWidth 141 1179.79
 newdef    Tau3PionCurrent:a1RunningWidth 142 1191.47
 newdef    Tau3PionCurrent:a1RunningWidth 143 1203.12
 newdef    Tau3PionCurrent:a1RunningWidth 144 1214.76
 newdef    Tau3PionCurrent:a1RunningWidth 145 1226.4
 newdef    Tau3PionCurrent:a1RunningWidth 146 1238.05
 newdef    Tau3PionCurrent:a1RunningWidth 147 1249.69
 newdef    Tau3PionCurrent:a1RunningWidth 148 1261.41
 newdef    Tau3PionCurrent:a1RunningWidth 149 1273.14
 newdef    Tau3PionCurrent:a1RunningWidth 150 1284.93
 newdef    Tau3PionCurrent:a1RunningWidth 151 1296.77
 newdef    Tau3PionCurrent:a1RunningWidth 152 1308.67
 newdef    Tau3PionCurrent:a1RunningWidth 153 1320.7
 newdef    Tau3PionCurrent:a1RunningWidth 154 1332.68
 newdef    Tau3PionCurrent:a1RunningWidth 155 1344.79
 newdef    Tau3PionCurrent:a1RunningWidth 156 1357.01
 newdef    Tau3PionCurrent:a1RunningWidth 157 1369.3
 newdef    Tau3PionCurrent:a1RunningWidth 158 1381.69
 newdef    Tau3PionCurrent:a1RunningWidth 159 1394.16
 newdef    Tau3PionCurrent:a1RunningWidth 160 1406.76
 newdef    Tau3PionCurrent:a1RunningWidth 161 1419.49
 newdef    Tau3PionCurrent:a1RunningWidth 162 1432.27
 newdef    Tau3PionCurrent:a1RunningWidth 163 1445.19
 newdef    Tau3PionCurrent:a1RunningWidth 164 1458.24
 newdef    Tau3PionCurrent:a1RunningWidth 165 1471.41
 newdef    Tau3PionCurrent:a1RunningWidth 166 1484.71
 newdef    Tau3PionCurrent:a1RunningWidth 167 1498.14
 newdef    Tau3PionCurrent:a1RunningWidth 168 1511.69
 newdef    Tau3PionCurrent:a1RunningWidth 169 1525.39
 newdef    Tau3PionCurrent:a1RunningWidth 170 1539.22
 newdef    Tau3PionCurrent:a1RunningWidth 171 1553.19
 newdef    Tau3PionCurrent:a1RunningWidth 172 1567.32
 newdef    Tau3PionCurrent:a1RunningWidth 173 1581.58
 newdef    Tau3PionCurrent:a1RunningWidth 174 1595.99
 newdef    Tau3PionCurrent:a1RunningWidth 175 1610.55
 newdef    Tau3PionCurrent:a1RunningWidth 176 1625.27
 newdef    Tau3PionCurrent:a1RunningWidth 177 1640.14
 newdef    Tau3PionCurrent:a1RunningWidth 178 1655.18
 newdef    Tau3PionCurrent:a1RunningWidth 179 1670.37
 newdef    Tau3PionCurrent:a1RunningWidth 180 1685.73
 newdef    Tau3PionCurrent:a1RunningWidth 181 1701.25
 newdef    Tau3PionCurrent:a1RunningWidth 182 1716.94
 newdef    Tau3PionCurrent:a1RunningWidth 183 1732.79
 newdef    Tau3PionCurrent:a1RunningWidth 184 1748.85
 newdef    Tau3PionCurrent:a1RunningWidth 185 1765.02
 newdef    Tau3PionCurrent:a1RunningWidth 186 1781.39
 newdef    Tau3PionCurrent:a1RunningWidth 187 1797.94
 newdef    Tau3PionCurrent:a1RunningWidth 188 1814.68
 newdef    Tau3PionCurrent:a1RunningWidth 189 1831.58
 newdef    Tau3PionCurrent:a1RunningWidth 190 1848.67
 newdef    Tau3PionCurrent:a1RunningWidth 191 1865.94
 newdef    Tau3PionCurrent:a1RunningWidth 192 1883.41
 newdef    Tau3PionCurrent:a1RunningWidth 193 1901.05
 newdef    Tau3PionCurrent:a1RunningWidth 194 1918.89
 newdef    Tau3PionCurrent:a1RunningWidth 195 1936.92
 newdef    Tau3PionCurrent:a1RunningWidth 196 1955.13
 newdef    Tau3PionCurrent:a1RunningWidth 197 1973.64
 newdef    Tau3PionCurrent:a1RunningWidth 198 1992.16
 newdef    Tau3PionCurrent:a1RunningWidth 199 2010.95
 insert Tau3PionCurrent:a1RunningWidth 200 2029.97
 newdef    Tau3PionCurrent:a1RunningQ2 0 0
 newdef    Tau3PionCurrent:a1RunningQ2 1 15788.5
 newdef    Tau3PionCurrent:a1RunningQ2 2 31576.9
 newdef    Tau3PionCurrent:a1RunningQ2 3 47365.4
 newdef    Tau3PionCurrent:a1RunningQ2 4 63153.9
 newdef    Tau3PionCurrent:a1RunningQ2 5 78942.3
 newdef    Tau3PionCurrent:a1RunningQ2 6 94730.8
 newdef    Tau3PionCurrent:a1RunningQ2 7 110519
 newdef    Tau3PionCurrent:a1RunningQ2 8 126308
 newdef    Tau3PionCurrent:a1RunningQ2 9 142096
 newdef    Tau3PionCurrent:a1RunningQ2 10 157885
 newdef    Tau3PionCurrent:a1RunningQ2 11 173673
 newdef    Tau3PionCurrent:a1RunningQ2 12 189462
 newdef    Tau3PionCurrent:a1RunningQ2 13 205250
 newdef    Tau3PionCurrent:a1RunningQ2 14 221039
 newdef    Tau3PionCurrent:a1RunningQ2 15 236827
 newdef    Tau3PionCurrent:a1RunningQ2 16 252615
 newdef    Tau3PionCurrent:a1RunningQ2 17 268404
 newdef    Tau3PionCurrent:a1RunningQ2 18 284192
 newdef    Tau3PionCurrent:a1RunningQ2 19 299981
 newdef    Tau3PionCurrent:a1RunningQ2 20 315769
 newdef    Tau3PionCurrent:a1RunningQ2 21 331558
 newdef    Tau3PionCurrent:a1RunningQ2 22 347346
 newdef    Tau3PionCurrent:a1RunningQ2 23 363135
 newdef    Tau3PionCurrent:a1RunningQ2 24 378923
 newdef    Tau3PionCurrent:a1RunningQ2 25 394712
 newdef    Tau3PionCurrent:a1RunningQ2 26 410500
 newdef    Tau3PionCurrent:a1RunningQ2 27 426289
 newdef    Tau3PionCurrent:a1RunningQ2 28 442077
 newdef    Tau3PionCurrent:a1RunningQ2 29 457866
 newdef    Tau3PionCurrent:a1RunningQ2 30 473654
 newdef    Tau3PionCurrent:a1RunningQ2 31 489442
 newdef    Tau3PionCurrent:a1RunningQ2 32 505231
 newdef    Tau3PionCurrent:a1RunningQ2 33 521019
 newdef    Tau3PionCurrent:a1RunningQ2 34 536808
 newdef    Tau3PionCurrent:a1RunningQ2 35 552596
 newdef    Tau3PionCurrent:a1RunningQ2 36 568385
 newdef    Tau3PionCurrent:a1RunningQ2 37 584173
 newdef    Tau3PionCurrent:a1RunningQ2 38 599962
 newdef    Tau3PionCurrent:a1RunningQ2 39 615750
 newdef    Tau3PionCurrent:a1RunningQ2 40 631539
 newdef    Tau3PionCurrent:a1RunningQ2 41 647327
 newdef    Tau3PionCurrent:a1RunningQ2 42 663116
 newdef    Tau3PionCurrent:a1RunningQ2 43 678904
 newdef    Tau3PionCurrent:a1RunningQ2 44 694693
 newdef    Tau3PionCurrent:a1RunningQ2 45 710481
 newdef    Tau3PionCurrent:a1RunningQ2 46 726269
 newdef    Tau3PionCurrent:a1RunningQ2 47 742058
 newdef    Tau3PionCurrent:a1RunningQ2 48 757846
 newdef    Tau3PionCurrent:a1RunningQ2 49 773635
 newdef    Tau3PionCurrent:a1RunningQ2 50 789423
 newdef    Tau3PionCurrent:a1RunningQ2 51 805212
 newdef    Tau3PionCurrent:a1RunningQ2 52 821000
 newdef    Tau3PionCurrent:a1RunningQ2 53 836789
 newdef    Tau3PionCurrent:a1RunningQ2 54 852577
 newdef    Tau3PionCurrent:a1RunningQ2 55 868366
 newdef    Tau3PionCurrent:a1RunningQ2 56 884154
 newdef    Tau3PionCurrent:a1RunningQ2 57 899943
 newdef    Tau3PionCurrent:a1RunningQ2 58 915731
 newdef    Tau3PionCurrent:a1RunningQ2 59 931520
 newdef    Tau3PionCurrent:a1RunningQ2 60 947308
 newdef    Tau3PionCurrent:a1RunningQ2 61 963097
 newdef    Tau3PionCurrent:a1RunningQ2 62 978885
 newdef    Tau3PionCurrent:a1RunningQ2 63 994673
 newdef    Tau3PionCurrent:a1RunningQ2 64 1.01046e+06
 newdef    Tau3PionCurrent:a1RunningQ2 65 1.02625e+06
 newdef    Tau3PionCurrent:a1RunningQ2 66 1.04204e+06
 newdef    Tau3PionCurrent:a1RunningQ2 67 1.05783e+06
 newdef    Tau3PionCurrent:a1RunningQ2 68 1.07362e+06
 newdef    Tau3PionCurrent:a1RunningQ2 69 1.0894e+06
 newdef    Tau3PionCurrent:a1RunningQ2 70 1.10519e+06
 newdef    Tau3PionCurrent:a1RunningQ2 71 1.12098e+06
 newdef    Tau3PionCurrent:a1RunningQ2 72 1.13677e+06
 newdef    Tau3PionCurrent:a1RunningQ2 73 1.15256e+06
 newdef    Tau3PionCurrent:a1RunningQ2 74 1.16835e+06
 newdef    Tau3PionCurrent:a1RunningQ2 75 1.18414e+06
 newdef    Tau3PionCurrent:a1RunningQ2 76 1.19992e+06
 newdef    Tau3PionCurrent:a1RunningQ2 77 1.21571e+06
 newdef    Tau3PionCurrent:a1RunningQ2 78 1.2315e+06
 newdef    Tau3PionCurrent:a1RunningQ2 79 1.24729e+06
 newdef    Tau3PionCurrent:a1RunningQ2 80 1.26308e+06
 newdef    Tau3PionCurrent:a1RunningQ2 81 1.27887e+06
 newdef    Tau3PionCurrent:a1RunningQ2 82 1.29465e+06
 newdef    Tau3PionCurrent:a1RunningQ2 83 1.31044e+06
 newdef    Tau3PionCurrent:a1RunningQ2 84 1.32623e+06
 newdef    Tau3PionCurrent:a1RunningQ2 85 1.34202e+06
 newdef    Tau3PionCurrent:a1RunningQ2 86 1.35781e+06
 newdef    Tau3PionCurrent:a1RunningQ2 87 1.3736e+06
 newdef    Tau3PionCurrent:a1RunningQ2 88 1.38939e+06
 newdef    Tau3PionCurrent:a1RunningQ2 89 1.40517e+06
 newdef    Tau3PionCurrent:a1RunningQ2 90 1.42096e+06
 newdef    Tau3PionCurrent:a1RunningQ2 91 1.43675e+06
 newdef    Tau3PionCurrent:a1RunningQ2 92 1.45254e+06
 newdef    Tau3PionCurrent:a1RunningQ2 93 1.46833e+06
 newdef    Tau3PionCurrent:a1RunningQ2 94 1.48412e+06
 newdef    Tau3PionCurrent:a1RunningQ2 95 1.4999e+06
 newdef    Tau3PionCurrent:a1RunningQ2 96 1.51569e+06
 newdef    Tau3PionCurrent:a1RunningQ2 97 1.53148e+06
 newdef    Tau3PionCurrent:a1RunningQ2 98 1.54727e+06
 newdef    Tau3PionCurrent:a1RunningQ2 99 1.56306e+06
 newdef    Tau3PionCurrent:a1RunningQ2 100 1.57885e+06
 newdef    Tau3PionCurrent:a1RunningQ2 101 1.59464e+06
 newdef    Tau3PionCurrent:a1RunningQ2 102 1.61042e+06
 newdef    Tau3PionCurrent:a1RunningQ2 103 1.62621e+06
 newdef    Tau3PionCurrent:a1RunningQ2 104 1.642e+06
 newdef    Tau3PionCurrent:a1RunningQ2 105 1.65779e+06
 newdef    Tau3PionCurrent:a1RunningQ2 106 1.67358e+06
 newdef    Tau3PionCurrent:a1RunningQ2 107 1.68937e+06
 newdef    Tau3PionCurrent:a1RunningQ2 108 1.70515e+06
 newdef    Tau3PionCurrent:a1RunningQ2 109 1.72094e+06
 newdef    Tau3PionCurrent:a1RunningQ2 110 1.73673e+06
 newdef    Tau3PionCurrent:a1RunningQ2 111 1.75252e+06
 newdef    Tau3PionCurrent:a1RunningQ2 112 1.76831e+06
 newdef    Tau3PionCurrent:a1RunningQ2 113 1.7841e+06
 newdef    Tau3PionCurrent:a1RunningQ2 114 1.79989e+06
 newdef    Tau3PionCurrent:a1RunningQ2 115 1.81567e+06
 newdef    Tau3PionCurrent:a1RunningQ2 116 1.83146e+06
 newdef    Tau3PionCurrent:a1RunningQ2 117 1.84725e+06
 newdef    Tau3PionCurrent:a1RunningQ2 118 1.86304e+06
 newdef    Tau3PionCurrent:a1RunningQ2 119 1.87883e+06
 newdef    Tau3PionCurrent:a1RunningQ2 120 1.89462e+06
 newdef    Tau3PionCurrent:a1RunningQ2 121 1.9104e+06
 newdef    Tau3PionCurrent:a1RunningQ2 122 1.92619e+06
 newdef    Tau3PionCurrent:a1RunningQ2 123 1.94198e+06
 newdef    Tau3PionCurrent:a1RunningQ2 124 1.95777e+06
 newdef    Tau3PionCurrent:a1RunningQ2 125 1.97356e+06
 newdef    Tau3PionCurrent:a1RunningQ2 126 1.98935e+06
 newdef    Tau3PionCurrent:a1RunningQ2 127 2.00514e+06
 newdef    Tau3PionCurrent:a1RunningQ2 128 2.02092e+06
 newdef    Tau3PionCurrent:a1RunningQ2 129 2.03671e+06
 newdef    Tau3PionCurrent:a1RunningQ2 130 2.0525e+06
 newdef    Tau3PionCurrent:a1RunningQ2 131 2.06829e+06
 newdef    Tau3PionCurrent:a1RunningQ2 132 2.08408e+06
 newdef    Tau3PionCurrent:a1RunningQ2 133 2.09987e+06
 newdef    Tau3PionCurrent:a1RunningQ2 134 2.11565e+06
 newdef    Tau3PionCurrent:a1RunningQ2 135 2.13144e+06
 newdef    Tau3PionCurrent:a1RunningQ2 136 2.14723e+06
 newdef    Tau3PionCurrent:a1RunningQ2 137 2.16302e+06
 newdef    Tau3PionCurrent:a1RunningQ2 138 2.17881e+06
 newdef    Tau3PionCurrent:a1RunningQ2 139 2.1946e+06
 newdef    Tau3PionCurrent:a1RunningQ2 140 2.21039e+06
 newdef    Tau3PionCurrent:a1RunningQ2 141 2.22617e+06
 newdef    Tau3PionCurrent:a1RunningQ2 142 2.24196e+06
 newdef    Tau3PionCurrent:a1RunningQ2 143 2.25775e+06
 newdef    Tau3PionCurrent:a1RunningQ2 144 2.27354e+06
 newdef    Tau3PionCurrent:a1RunningQ2 145 2.28933e+06
 newdef    Tau3PionCurrent:a1RunningQ2 146 2.30512e+06
 newdef    Tau3PionCurrent:a1RunningQ2 147 2.3209e+06
 newdef    Tau3PionCurrent:a1RunningQ2 148 2.33669e+06
 newdef    Tau3PionCurrent:a1RunningQ2 149 2.35248e+06
 newdef    Tau3PionCurrent:a1RunningQ2 150 2.36827e+06
 newdef    Tau3PionCurrent:a1RunningQ2 151 2.38406e+06
 newdef    Tau3PionCurrent:a1RunningQ2 152 2.39985e+06
 newdef    Tau3PionCurrent:a1RunningQ2 153 2.41564e+06
 newdef    Tau3PionCurrent:a1RunningQ2 154 2.43142e+06
 newdef    Tau3PionCurrent:a1RunningQ2 155 2.44721e+06
 newdef    Tau3PionCurrent:a1RunningQ2 156 2.463e+06
 newdef    Tau3PionCurrent:a1RunningQ2 157 2.47879e+06
 newdef    Tau3PionCurrent:a1RunningQ2 158 2.49458e+06
 newdef    Tau3PionCurrent:a1RunningQ2 159 2.51037e+06
 newdef    Tau3PionCurrent:a1RunningQ2 160 2.52615e+06
 newdef    Tau3PionCurrent:a1RunningQ2 161 2.54194e+06
 newdef    Tau3PionCurrent:a1RunningQ2 162 2.55773e+06
 newdef    Tau3PionCurrent:a1RunningQ2 163 2.57352e+06
 newdef    Tau3PionCurrent:a1RunningQ2 164 2.58931e+06
 newdef    Tau3PionCurrent:a1RunningQ2 165 2.6051e+06
 newdef    Tau3PionCurrent:a1RunningQ2 166 2.62089e+06
 newdef    Tau3PionCurrent:a1RunningQ2 167 2.63667e+06
 newdef    Tau3PionCurrent:a1RunningQ2 168 2.65246e+06
 newdef    Tau3PionCurrent:a1RunningQ2 169 2.66825e+06
 newdef    Tau3PionCurrent:a1RunningQ2 170 2.68404e+06
 newdef    Tau3PionCurrent:a1RunningQ2 171 2.69983e+06
 newdef    Tau3PionCurrent:a1RunningQ2 172 2.71562e+06
 newdef    Tau3PionCurrent:a1RunningQ2 173 2.7314e+06
 newdef    Tau3PionCurrent:a1RunningQ2 174 2.74719e+06
 newdef    Tau3PionCurrent:a1RunningQ2 175 2.76298e+06
 newdef    Tau3PionCurrent:a1RunningQ2 176 2.77877e+06
 newdef    Tau3PionCurrent:a1RunningQ2 177 2.79456e+06
 newdef    Tau3PionCurrent:a1RunningQ2 178 2.81035e+06
 newdef    Tau3PionCurrent:a1RunningQ2 179 2.82614e+06
 newdef    Tau3PionCurrent:a1RunningQ2 180 2.84192e+06
 newdef    Tau3PionCurrent:a1RunningQ2 181 2.85771e+06
 newdef    Tau3PionCurrent:a1RunningQ2 182 2.8735e+06
 newdef    Tau3PionCurrent:a1RunningQ2 183 2.88929e+06
 newdef    Tau3PionCurrent:a1RunningQ2 184 2.90508e+06
 newdef    Tau3PionCurrent:a1RunningQ2 185 2.92087e+06
 newdef    Tau3PionCurrent:a1RunningQ2 186 2.93665e+06
 newdef    Tau3PionCurrent:a1RunningQ2 187 2.95244e+06
 newdef    Tau3PionCurrent:a1RunningQ2 188 2.96823e+06
 newdef    Tau3PionCurrent:a1RunningQ2 189 2.98402e+06
 newdef    Tau3PionCurrent:a1RunningQ2 190 2.99981e+06
 newdef    Tau3PionCurrent:a1RunningQ2 191 3.0156e+06
 newdef    Tau3PionCurrent:a1RunningQ2 192 3.03139e+06
 newdef    Tau3PionCurrent:a1RunningQ2 193 3.04717e+06
 newdef    Tau3PionCurrent:a1RunningQ2 194 3.06296e+06
 newdef    Tau3PionCurrent:a1RunningQ2 195 3.07875e+06
 newdef    Tau3PionCurrent:a1RunningQ2 196 3.09454e+06
 newdef    Tau3PionCurrent:a1RunningQ2 197 3.11033e+06
 newdef    Tau3PionCurrent:a1RunningQ2 198 3.12612e+06
 newdef    Tau3PionCurrent:a1RunningQ2 199 3.1419e+06
 insert Tau3PionCurrent:a1RunningQ2 200 3.15769e+06
 newdef Tau3Pion:WeakCurrent Tau3PionCurrent
 #
 create Herwig::TauDecayer  TauEtaPiPi
 create Herwig::EtaPiPiDefaultCurrent TauEtaPiPiCurrent HwWeakCurrents.so
 newdef TauEtaPiPi:WeakCurrent TauEtaPiPiCurrent
 newdef TauEtaPiPi:Ntry 500
 newdef TauEtaPiPi:Points 10000
 newdef TauEtaPiPi:GenerateIntermediates 1
 insert TauEtaPiPi:WeightLocation 0 0
 insert TauEtaPiPi:MaximumWeight 0 0.03
 insert TauEtaPiPi:Weights 0 0.0233
 insert TauEtaPiPi:Weights 1 0.0172228
 insert TauEtaPiPi:Weights 2 0.0177817
 insert TauEtaPiPi:Weights 3 0.348627
 insert TauEtaPiPi:Weights 4 0.225423
 insert TauEtaPiPi:Weights 5 0.22759
 insert TauEtaPiPi:Weights 6 0.0645809
 insert TauEtaPiPi:Weights 7 0.0373083
 insert TauEtaPiPi:Weights 8 0.0381665
 #
 create Herwig::HQETStrongDecayer HQETMeson
 newdef HQETMeson:Iteration 10
 newdef HQETMeson:Ntry 500
 newdef HQETMeson:Points 10000
 newdef HQETMeson:GenerateIntermediates 0
 newdef HQETMeson:fPi    130.2
 newdef HQETMeson:g      0.566
 newdef HQETMeson:h      0.544
 newdef HQETMeson:hp     0.413
 newdef HQETMeson:k      0.407
 newdef HQETMeson:kp     0.242
 newdef HQETMeson:gtilde 0.283
 newdef HQETMeson:Lambda 1
 newdef HQETMeson:psiL   0
 newdef HQETMeson:psiS   0.041
 newdef HQETMeson:DeltaEta 0.0228833
 do HQETMeson:SetUpDecayMode 413 421 211 1.31861
 do HQETMeson:SetUpDecayMode 413 411 111 1.31029
 do HQETMeson:SetUpDecayMode 423 421 111 1.33047
 do HQETMeson:SetUpDecayMode 433 431 111 0.00421025
 do HQETMeson:SetUpDecayMode 415 411 111 2.88287
 do HQETMeson:SetUpDecayMode 415 421 211 2.95662
 do HQETMeson:SetUpDecayMode 425 411 -211 1.94659
 do HQETMeson:SetUpDecayMode 425 421 111 2.03457
 do HQETMeson:SetUpDecayMode 435 411 311 2.42643
 do HQETMeson:SetUpDecayMode 435 421 321 2.42032
 do HQETMeson:SetUpDecayMode 415 413 111 3.41396
 do HQETMeson:SetUpDecayMode 415 423 211 2.69729
 do HQETMeson:SetUpDecayMode 425 413 -211 2.34226
 do HQETMeson:SetUpDecayMode 425 423 111 1.87924
 do HQETMeson:SetUpDecayMode 435 413 311 1.75845
 do HQETMeson:SetUpDecayMode 435 423 321 1.31503
 do HQETMeson:SetUpDecayMode 10413 413 111 4.52314
 do HQETMeson:SetUpDecayMode 10413 423 211 3.47116
 do HQETMeson:SetUpDecayMode 10423 413 -211 5.22341
 do HQETMeson:SetUpDecayMode 10423 423 111 4.3453
 do HQETMeson:SetUpDecayMode 10433 413 311 1.57906
 do HQETMeson:SetUpDecayMode 10433 423 321 1.43562
 do HQETMeson:SetUpDecayMode 10411 411 111 6.57442
 do HQETMeson:SetUpDecayMode 10411 421 211 6.61319
 do HQETMeson:SetUpDecayMode 10421 411 -211 6.5581
 do HQETMeson:SetUpDecayMode 10421 421 111 6.65623
 do HQETMeson:SetUpDecayMode 10431 431 111 0.23295
 do HQETMeson:SetUpDecayMode 20413 413 111 5.06988
 do HQETMeson:SetUpDecayMode 20413 423 211 3.89552
 do HQETMeson:SetUpDecayMode 20423 413 -211 4.7005
 do HQETMeson:SetUpDecayMode 20423 423 111 3.81833
 do HQETMeson:SetUpDecayMode 20433 433 111 0.312448
 do HQETMeson:SetUpDecayMode 100411 423 211 0.702697
 do HQETMeson:SetUpDecayMode 100411 413 111 0.459932
 do HQETMeson:SetUpDecayMode 100421 413 -211 0.91423
 do HQETMeson:SetUpDecayMode 100421 423 111 0.353773
 do HQETMeson:SetUpDecayMode 100431 413 311 0.312344
 do HQETMeson:SetUpDecayMode 100431 423 321 0.268127
 do HQETMeson:SetUpDecayMode 100413 421 211 0.529936
 do HQETMeson:SetUpDecayMode 100413 411 111 0.262229
 do HQETMeson:SetUpDecayMode 100423 411 -211 0.522623
 do HQETMeson:SetUpDecayMode 100423 421 111 0.265886
 do HQETMeson:SetUpDecayMode 100433 411 311 0.425155
 do HQETMeson:SetUpDecayMode 100433 421 321 0.439374
 do HQETMeson:SetUpDecayMode 100413 423 211 0.709016
 do HQETMeson:SetUpDecayMode 100413 413 111 0.466036
 do HQETMeson:SetUpDecayMode 100423 413 -211 0.927575
 do HQETMeson:SetUpDecayMode 100423 423 111 0.356375
 do HQETMeson:SetUpDecayMode 100433 413 311 0.555473
 do HQETMeson:SetUpDecayMode 100433 423 321 0.439498
 do HQETMeson:SetUpDecayMode 20415 423 211 0.875288
 do HQETMeson:SetUpDecayMode 20415 413 111 0.567836
 do HQETMeson:SetUpDecayMode 20425 413 -211 1.1261
 do HQETMeson:SetUpDecayMode 20425 423 111 0.441275
 do HQETMeson:SetUpDecayMode 20435 413 311 1.0999
 do HQETMeson:SetUpDecayMode 20435 423 321 0.889948
 do HQETMeson:SetUpDecayMode 417 421 211 0.725507
 do HQETMeson:SetUpDecayMode 417 411 111 0.354557
 do HQETMeson:SetUpDecayMode 427 411 -211 0.704963
 do HQETMeson:SetUpDecayMode 427 421 111 0.364866
 do HQETMeson:SetUpDecayMode 437 411 311 0.604124
 do HQETMeson:SetUpDecayMode 437 421 321 0.637948
 do HQETMeson:SetUpDecayMode 417 423 211 0.400638
 do HQETMeson:SetUpDecayMode 417 413 111 0.259993
 do HQETMeson:SetUpDecayMode 427 413 -211 0.517613
 do HQETMeson:SetUpDecayMode 427 423 111 0.201602
 do HQETMeson:SetUpDecayMode 437 413 311 0.331208
 do HQETMeson:SetUpDecayMode 437 423 321 0.266494
+do HQETMeson:SetUpDecayMode 30413 421 211 0.756428
+do HQETMeson:SetUpDecayMode 30413 411 111 0.371794
+do HQETMeson:SetUpDecayMode 30423 411 -211 0.742232
+do HQETMeson:SetUpDecayMode 30423 421 111 0.378897
+do HQETMeson:SetUpDecayMode 30433 411 311 0.834109
+do HQETMeson:SetUpDecayMode 30433 421 321 0.857459
+do HQETMeson:SetUpDecayMode 30413 423 211 0.216795
+do HQETMeson:SetUpDecayMode 30413 413 111 0.141882
+do HQETMeson:SetUpDecayMode 30423 413 -211 0.283003
+do HQETMeson:SetUpDecayMode 30423 423 111 0.108743
+do HQETMeson:SetUpDecayMode 30433 413 311 0.288347
+do HQETMeson:SetUpDecayMode 30433 423 321 0.224403
 #
 create Herwig::HQETRadiativeDecayer HQETMesonEM
 newdef HQETMesonEM:Iteration 10
 newdef HQETMesonEM:Ntry 500
 newdef HQETMesonEM:Points 10000
 newdef HQETMesonEM:GenerateIntermediates 0 
 newdef HQETMesonEM:Ch     -1.05845
 newdef HQETMesonEM:Lambda 1
 newdef HQETMesonEM:MaxWeight 0 13.2433
 newdef HQETMesonEM:MaxWeight 1 2.73716
 newdef HQETMesonEM:MaxWeight 2 0.530229
 newdef HQETMesonEM:MaxWeight 3 3.34656
 newdef HQETMesonEM:MaxWeight 4 3.55541
 newdef HQETMesonEM:MaxWeight 5 5.55942
 #
 create Herwig::VectorMeson2FermionDecayer  Vector2Leptons
 newdef Vector2Leptons:Iteration 1
 newdef Vector2Leptons:Ntry 500
 newdef Vector2Leptons:Points 10000
 newdef Vector2Leptons:GenerateIntermediates 0 
 do Vector2Leptons:SetUpDecayMode 113 11 -11 0.018524 1.60839
 do Vector2Leptons:SetUpDecayMode 113 13 -13 0.018524 1.60498
 do Vector2Leptons:SetUpDecayMode 223 11 -11 0.005429 1.60161
 do Vector2Leptons:SetUpDecayMode 223 13 -13 0.005429 1.59833
 do Vector2Leptons:SetUpDecayMode 333 11 -11 0.006852 1.60556
 do Vector2Leptons:SetUpDecayMode 333 13 -13 0.006852 1.60986
 do Vector2Leptons:SetUpDecayMode 30443 11 -11 0.00159 1.5993
 do Vector2Leptons:SetUpDecayMode 30443 13 -13 0.001509 1.4405
 do Vector2Leptons:SetUpDecayMode 30443 15 -15 0.001509 1.53038
 do Vector2Leptons:SetUpDecayMode 443 11 -11 0.008215 1.60017
 do Vector2Leptons:SetUpDecayMode 443 13 -13 0.008215 1.60016
 do Vector2Leptons:SetUpDecayMode 100443 11 -11 0.005031 1.59862
 do Vector2Leptons:SetUpDecayMode 100443 13 -13 0.005031 1.6008
 do Vector2Leptons:SetUpDecayMode 100443 15 -15 0.005031 1.60219
 do Vector2Leptons:SetUpDecayMode 553 11 -11 0.002315 1.6003
 do Vector2Leptons:SetUpDecayMode 553 13 -13 0.002315 1.6003
 do Vector2Leptons:SetUpDecayMode 553 15 -15 0.002315 1.6006
 do Vector2Leptons:SetUpDecayMode 100553 11 -11 0.00152 1.60068
 do Vector2Leptons:SetUpDecayMode 100553 13 -13 0.00152 1.60068
 do Vector2Leptons:SetUpDecayMode 100553 15 -15 0.00152 1.60751
 do Vector2Leptons:SetUpDecayMode 200553 11 -11 0.00127 1.6002
 do Vector2Leptons:SetUpDecayMode 200553 13 -13 0.00127 1.6002
 do Vector2Leptons:SetUpDecayMode 200553 15 -15 0.00127 1.60626
 do Vector2Leptons:SetUpDecayMode 300553 11 -11 0.001081 1.59966
 do Vector2Leptons:SetUpDecayMode 300553 13 -13 0.001081 1.59966
 do Vector2Leptons:SetUpDecayMode 300553 15 -15 0.001081 1.59171
 do Vector2Leptons:SetUpDecayMode 9000553 11 -11 0.001 1.56074
 do Vector2Leptons:SetUpDecayMode 9000553 13 -13 0.001 1.56074
 do Vector2Leptons:SetUpDecayMode 9000553 15 -15 0.001 1.55385
 do Vector2Leptons:SetUpDecayMode 443 3112 -3112 0.001342 1.5934
 do Vector2Leptons:SetUpDecayMode 100443 3112 -3112 0.0009273 1.5978
 #
 create Herwig::VectorMeson2SpinThreeHalfBaryonsDecayer  Vector2Baryons3Half
 newdef Vector2Baryons3Half:Iteration 1
 newdef Vector2Baryons3Half:Ntry 500
 newdef Vector2Baryons3Half:Points 10000
 newdef Vector2Baryons3Half:GenerateIntermediates 0 
 do Vector2Baryons3Half:SetUpDecayMode 443 3114 -3114 0.00150640470181 0.00093350341391 0. 5.
 do Vector2Baryons3Half:SetUpDecayMode 443 3224 -3224 0.00153402258271 0.00107528142563 0. 7.  
 do Vector2Baryons3Half:SetUpDecayMode 443 3214 -3214 0.0015323974485 0.000860759359361 0. 5.5
 do Vector2Baryons3Half:SetUpDecayMode 100443 3114 -3114 0.000260326162249 0.000561082932891 0. 5.   
 do Vector2Baryons3Half:SetUpDecayMode 100443 3224 -3224 0.000362882855521 0.000526423800011 0. 5.
 do Vector2Baryons3Half:SetUpDecayMode 100443 3214 -3214 0.00025226758188 0.000500391020504 0. 4.5  
 do Vector2Baryons3Half:SetUpDecayMode 100443 3314 -3314 0.000397805035356 0.000678994938986 0. 0.0012  
 #
 create Herwig::WeakPartonicDecayer  WeakPartonic0
 newdef  WeakPartonic0:PartonSplitter /Herwig/Hadronization/PartonSplitter
 newdef  WeakPartonic0:ClusterFinder /Herwig/Hadronization/ClusterFinder
 newdef  WeakPartonic0:ClusterFissioner /Herwig/Hadronization/ClusterFissioner
 newdef  WeakPartonic0:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer
 newdef  WeakPartonic0:ClusterDecayer /Herwig/Hadronization/ClusterDecayer
 newdef  WeakPartonic0:Exclusive 1
 newdef  WeakPartonic0:Intermediates 0
 newdef  WeakPartonic0:Partonic_Tries 100
 newdef WeakPartonic0:MECode 0
 
 #
 create Herwig::WeakPartonicDecayer  WeakPartonic100
 newdef  WeakPartonic100:PartonSplitter /Herwig/Hadronization/PartonSplitter
 newdef  WeakPartonic100:ClusterFinder /Herwig/Hadronization/ClusterFinder
 newdef  WeakPartonic100:ClusterFissioner /Herwig/Hadronization/ClusterFissioner
 newdef  WeakPartonic100:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer
 newdef  WeakPartonic100:ClusterDecayer /Herwig/Hadronization/ClusterDecayer
 newdef  WeakPartonic100:Exclusive 1
 newdef  WeakPartonic100:Intermediates 0
 newdef  WeakPartonic100:Partonic_Tries 100
 newdef WeakPartonic100:MECode 100
 
 #
 create Herwig::VectorMesonPScalarFermionsDecayer  VectorVPff
 newdef VectorVPff:Iteration 5
 newdef VectorVPff:Ntry 500
 newdef VectorVPff:Points 10000
 newdef VectorVPff:GenerateIntermediates 0
 do VectorVPff:SetUpDecayMode 223 111 11  0.2179 2 113 0.7758 0.1503 5.2618 0.273309
 do VectorVPff:SetUpDecayMode 223 111 13  0.2179 2 113 0.7758 0.1503 26.8941 1
 do VectorVPff:SetUpDecayMode 333 221 11  0.0643 2 113 0.7758 0.1503 4.3391 0.215086
 do VectorVPff:SetUpDecayMode 333 221 13  0.0643 2 113 0.7758 0.1503 3.31309 0.375026
 do VectorVPff:SetUpDecayMode 333 111 11  0.0120094 2 113 0.7758 0.1503 4.83188 0.218805
 do VectorVPff:SetUpDecayMode 333 111 13  0.0120094 2 113 0.7758 0.1503 3.16628 0.327872
 do VectorVPff:SetUpDecayMode 443 221 11  0.0643 2 443 3.0969 9.29e-05 2.34926 0.189627
 do VectorVPff:SetUpDecayMode 443 221 13  0.0643 2 443 3.0969 9.29e-05 0.420516 0.200787
 #
 create Herwig::VectorMeson3PionDecayer  Vector3Pion
 newdef Vector3Pion:Iteration 5
 newdef Vector3Pion:Ntry 500
 newdef Vector3Pion:Points 10000
 newdef Vector3Pion:GenerateIntermediates 1
 newdef Vector3Pion:Incoming 0 223
 newdef Vector3Pion:Coupling 0 178.71
 newdef Vector3Pion:DirectCoupling 0 0
 newdef Vector3Pion:Rho2Coupling 0 0
 newdef Vector3Pion:Rho3Coupling 0 0
 newdef Vector3Pion:DirectPhase 0 0
 newdef Vector3Pion:Rho2Phase 0 0
 newdef Vector3Pion:Rho3Phase 0 0
 newdef Vector3Pion:MaxWeight 0 16.
 newdef Vector3Pion:Rho1Weight 0 0.333333
 newdef Vector3Pion:Rho2Weight 0 -1
 newdef Vector3Pion:Rho3Weight 0 -1
 newdef Vector3Pion:Rho1Mass 0 0.7755
 newdef Vector3Pion:Rho2Mass 0 1.459
 newdef Vector3Pion:Rho3Mass 0 1.72
 newdef Vector3Pion:Rho1Width 0 0.1494
 newdef Vector3Pion:Rho2Width 0 0.147
 newdef Vector3Pion:Rho3Width 0 0.25
 newdef Vector3Pion:DefaultParameters 0 1
 newdef Vector3Pion:Incoming 1 333
 newdef Vector3Pion:Coupling 1 8.788
 newdef Vector3Pion:DirectCoupling 1 0.78
 newdef Vector3Pion:Rho2Coupling 1 0
 newdef Vector3Pion:Rho3Coupling 1 0
 newdef Vector3Pion:DirectPhase 1 -2.47
 newdef Vector3Pion:Rho2Phase 1 0
 newdef Vector3Pion:Rho3Phase 1 0
 newdef Vector3Pion:MaxWeight 1 16.
 newdef Vector3Pion:Rho1Weight 1 0.333333
 newdef Vector3Pion:Rho2Weight 1 -1
 newdef Vector3Pion:Rho3Weight 1 -1
 newdef Vector3Pion:Rho1Mass 1 0.7758
 newdef Vector3Pion:Rho2Mass 1 1.45
 newdef Vector3Pion:Rho3Mass 1 1.7
 newdef Vector3Pion:Rho1Width 1 0.1439
 newdef Vector3Pion:Rho2Width 1 0.31
 newdef Vector3Pion:Rho3Width 1 0.24
 newdef Vector3Pion:DefaultParameters 1 0
 #
 create Herwig::a1ThreePionCLEODecayer  a1CLEO
 newdef a1CLEO:Iteration 5
 newdef a1CLEO:Ntry 500
 newdef a1CLEO:Points 10000
 newdef a1CLEO:GenerateIntermediates 1
 newdef a1CLEO:f_2Mass 1.275
 newdef a1CLEO:f_2Width 0.185
 newdef a1CLEO:f_0Mass 1.186
 newdef a1CLEO:f_0Width 0.35
 newdef a1CLEO:sigmaMass 0.86
 newdef a1CLEO:sigmaWidth 0.88
 newdef    a1CLEO:RhoMasses 0 0.7743
 newdef    a1CLEO:RhoMasses 1 1.37
 insert a1CLEO:RhoMasses 2 1.72
 newdef    a1CLEO:RhoWidths 0 0.1491
 newdef    a1CLEO:RhoWidths 1 0.386
 insert a1CLEO:RhoWidths 2 0.25
 newdef a1CLEO:f0Phase -1.69646
 newdef a1CLEO:f2Phase 1.75929
 newdef a1CLEO:sigmaPhase 0.722566
 newdef a1CLEO:f0Magnitude 0.77
 newdef a1CLEO:f2Magnitude 0.71
 newdef a1CLEO:sigmaMagnitude 2.1
 newdef a1CLEO:Coupling 45.57
 newdef    a1CLEO:RhoPWaveMagnitude 0 1
 newdef    a1CLEO:RhoPWaveMagnitude 1 0.12
 newdef    a1CLEO:RhoPWavePhase 0 0
 newdef    a1CLEO:RhoPWavePhase 1 3.11018
 newdef    a1CLEO:RhoDWaveMagnitude 0 3.7e-07
 newdef    a1CLEO:RhoDWaveMagnitude 1 8.7e-07
 newdef    a1CLEO:RhoDWavePhase 0 -0.471239
 newdef    a1CLEO:RhoDWavePhase 1 1.66504
 newdef a1CLEO:LocalParameters 1
 newdef a1CLEO:AllNeutralWeights 0 0.132162
 newdef a1CLEO:AllNeutralWeights 1 0.116638
 newdef a1CLEO:AllNeutralWeights 2 0.121088
 newdef a1CLEO:AllNeutralWeights 3 0.10656
 newdef a1CLEO:AllNeutralWeights 4 0.102577
 newdef a1CLEO:AllNeutralWeights 5 0.101169
 newdef a1CLEO:AllNeutralWeights 6 0.104587
 newdef a1CLEO:AllNeutralWeights 7 0.104663
 newdef a1CLEO:AllNeutralWeights 8 0.110557
 newdef a1CLEO:OneChargedWeights 0 0.177017
 newdef a1CLEO:OneChargedWeights 1 0.176011
 newdef a1CLEO:OneChargedWeights 2 0.110129
 newdef a1CLEO:OneChargedWeights 3 0.108023
 newdef a1CLEO:OneChargedWeights 4 0.110553
 newdef a1CLEO:OneChargedWeights 5 0.109976
 newdef a1CLEO:OneChargedWeights 6 0.0886337
 newdef a1CLEO:OneChargedWeights 7 0.0591042
 newdef a1CLEO:OneChargedWeights 8 0.0605533
 newdef a1CLEO:TwoChargedWeights 0 0.173357
 newdef a1CLEO:TwoChargedWeights 1 0.172283
 newdef a1CLEO:TwoChargedWeights 2 0.116031
 newdef a1CLEO:TwoChargedWeights 3 0.114642
 newdef a1CLEO:TwoChargedWeights 4 0.109058
 newdef a1CLEO:TwoChargedWeights 5 0.114073
 newdef a1CLEO:TwoChargedWeights 6 0.0809455
 newdef a1CLEO:TwoChargedWeights 7 0.0601352
 newdef a1CLEO:TwoChargedWeights 8 0.059477
 newdef a1CLEO:ThreeChargedWeights 0 0.125022
 newdef a1CLEO:ThreeChargedWeights 1 0.129911
 newdef a1CLEO:ThreeChargedWeights 2 0.0741652
 newdef a1CLEO:ThreeChargedWeights 3 0.0758126
 newdef a1CLEO:ThreeChargedWeights 4 0.0711541
 newdef a1CLEO:ThreeChargedWeights 5 0.0777299
 newdef a1CLEO:ThreeChargedWeights 6 0.0822551
 newdef a1CLEO:ThreeChargedWeights 7 0.0867606
 newdef a1CLEO:ThreeChargedWeights 8 0.0671056
 newdef a1CLEO:ThreeChargedWeights 9 0.0701714
 newdef a1CLEO:ThreeChargedWeights 10 0.0701456
 newdef a1CLEO:ThreeChargedWeights 11 0.0697667
 newdef a1CLEO:ZeroMax 13.0704
 newdef a1CLEO:OneMax 6.91104
 newdef a1CLEO:TwoMax 6.94654
 newdef a1CLEO:ThreeMax 6.40086
 #
 create Herwig::PScalarVectorVectorDecayer  PVV
 newdef PVV:Iteration 1
 newdef PVV:Ntry 500
 newdef PVV:Points 10000
 newdef PVV:GenerateIntermediates 0 
 do PVV:SetUpDecayMode 331 223 22 0.1412 1.17937
 do PVV:SetUpDecayMode 111 22 22 0.0178 1.08444
 do PVV:SetUpDecayMode 221 22 22 0.0176 1.08656
 do PVV:SetUpDecayMode 331 22 22 0.0221 1.09105
 do PVV:SetUpDecayMode 441 213 -213 0.0525 2.6
 do PVV:SetUpDecayMode 441 113 113 0.0371 2.63569
 do PVV:SetUpDecayMode 441 333 333 0.0267 8.54466
 do PVV:SetUpDecayMode 441 22 22 0.00521 1.10127
 do PVV:SetUpDecayMode 441 323 -323 0.0308 5.0763
 do PVV:SetUpDecayMode 441 313 -313 0.0308 5.22846
 #
 create Herwig::PScalarVectorFermionsDecayer  PVff
 newdef PVff:Iteration 1
 newdef PVff:Ntry 500
 newdef PVff:Points 10000
 newdef PVff:GenerateIntermediates 0
 do PVff:SetUpDecayMode 111 22 11 0.00761872 2 113 0.7758 0.1503 0.0270172
 do PVff:SetUpDecayMode 221 22 11 0.00755416 2 113 0.707 0 2.82505
 do PVff:SetUpDecayMode 221 22 13 0.00755416 2 113 0.707 0 2.19738
 do PVff:SetUpDecayMode 331 22 11 0.0104 2 113 0.7758 0.1503 5.19839
 do PVff:SetUpDecayMode 331 22 13 0.0104 2 113 0.7758 0.1503 3.01441
 #
 create Herwig::EtaPiPiGammaDecayer  Etapipigamma
 newdef Etapipigamma:Iteration 1
 newdef Etapipigamma:Ntry 500
 newdef Etapipigamma:Points 10000
 newdef Etapipigamma:GenerateIntermediates 0
 newdef Etapipigamma:fpi             130.7
 newdef Etapipigamma:RhoMass         771.1
 newdef Etapipigamma:RhoWidth        149.2
 newdef Etapipigamma:LocalParameters 1
 newdef Etapipigamma:OmnesC          1
 newdef Etapipigamma:OmnesA          0.840908
 newdef Etapipigamma:InitializeOmnes 0
 newdef Etapipigamma:OmnesPoints     100
 newdef Etapipigamma:OmnesCut        0.4
 newdef Etapipigamma:Incoming    0  221
 newdef Etapipigamma:Coupling    0  0.00506
 newdef Etapipigamma:MaxWeight   0  3.95071
 newdef Etapipigamma:Option      0  3
 newdef Etapipigamma:Incoming    1  331
 newdef Etapipigamma:Coupling    1  0.004278
 newdef Etapipigamma:MaxWeight   1  3.53141
 newdef Etapipigamma:Option      1  3
 newdef Etapipigamma:Phase_Energy 0  300
 newdef Etapipigamma:Phase_Shift  0  0.1
 newdef Etapipigamma:Phase_Energy 1  320
 newdef Etapipigamma:Phase_Shift  1  0.4
 newdef Etapipigamma:Phase_Energy 2  340
 newdef Etapipigamma:Phase_Shift  2  0.7
 newdef Etapipigamma:Phase_Energy 3  360
 newdef Etapipigamma:Phase_Shift  3  1
 newdef Etapipigamma:Phase_Energy 4  380
 newdef Etapipigamma:Phase_Shift  4  1.5
 newdef Etapipigamma:Phase_Energy 5  400
 newdef Etapipigamma:Phase_Shift  5  2
 newdef Etapipigamma:Phase_Energy 6  420
 newdef Etapipigamma:Phase_Shift  6  2.5
 newdef Etapipigamma:Phase_Energy 7  440
 newdef Etapipigamma:Phase_Shift  7  3.2
 newdef Etapipigamma:Phase_Energy 8  460
 newdef Etapipigamma:Phase_Shift  8  4
 newdef Etapipigamma:Phase_Energy 9  480
 newdef Etapipigamma:Phase_Shift  9  4.9
 newdef Etapipigamma:Phase_Energy 10  500
 newdef Etapipigamma:Phase_Shift  10  5.9
 newdef Etapipigamma:Phase_Energy 11  520
 newdef Etapipigamma:Phase_Shift  11  7.1
 newdef Etapipigamma:Phase_Energy 12  540
 newdef Etapipigamma:Phase_Shift  12  8.5
 newdef Etapipigamma:Phase_Energy 13  560
 newdef Etapipigamma:Phase_Shift  13  10.1
 newdef Etapipigamma:Phase_Energy 14  580
 newdef Etapipigamma:Phase_Shift  14  12.1
 newdef Etapipigamma:Phase_Energy 15  600
 newdef Etapipigamma:Phase_Shift  15  14.4
 newdef Etapipigamma:Phase_Energy 16  620
 newdef Etapipigamma:Phase_Shift  16  17.3
 newdef Etapipigamma:Phase_Energy 17  640
 newdef Etapipigamma:Phase_Shift  17  20.9
 newdef Etapipigamma:Phase_Energy 18  660
 newdef Etapipigamma:Phase_Shift  18  25.4
 newdef Etapipigamma:Phase_Energy 19  680
 newdef Etapipigamma:Phase_Shift  19  31.2
 newdef Etapipigamma:Phase_Energy 20  700
 newdef Etapipigamma:Phase_Shift  20  38.7
 newdef Etapipigamma:Phase_Energy 21  720
 newdef Etapipigamma:Phase_Shift  21  48.4
 newdef Etapipigamma:Phase_Energy 22  740
 newdef Etapipigamma:Phase_Shift  22  60.6
 newdef Etapipigamma:Phase_Energy 23  760
 newdef Etapipigamma:Phase_Shift  23  74.9
 newdef Etapipigamma:Phase_Energy 24  780
 newdef Etapipigamma:Phase_Shift  24  90
 newdef Etapipigamma:Phase_Energy 25  800
 newdef Etapipigamma:Phase_Shift  25  103.8
 newdef Etapipigamma:Phase_Energy 26  820
 newdef Etapipigamma:Phase_Shift  26  115.3
 newdef Etapipigamma:Phase_Energy 27  840
 newdef Etapipigamma:Phase_Shift  27  124.3
 newdef Etapipigamma:Phase_Energy 28  860
 newdef Etapipigamma:Phase_Shift  28  131.3
 newdef Etapipigamma:Phase_Energy 29  880
 newdef Etapipigamma:Phase_Shift  29  136.7
 newdef Etapipigamma:Phase_Energy 30  900
 newdef Etapipigamma:Phase_Shift  30  141
 newdef Etapipigamma:Phase_Energy 31  920
 newdef Etapipigamma:Phase_Shift  31  144.5
 newdef Etapipigamma:Phase_Energy 32  940
 newdef Etapipigamma:Phase_Shift  32  147.3
 newdef Etapipigamma:Phase_Energy 33  960
 newdef Etapipigamma:Phase_Shift  33  149.7
 newdef Etapipigamma:Phase_Energy 34  980
 newdef Etapipigamma:Phase_Shift  34  151.8
 newdef Etapipigamma:OmnesEnergy 0  282.534
 newdef Etapipigamma:OmnesReal 0  0.860715
 newdef Etapipigamma:OmnesImag 0  0.00243357
 newdef Etapipigamma:OmnesEnergy 1  289.32
 newdef Etapipigamma:OmnesReal 1  0.851815
 newdef Etapipigamma:OmnesImag 1  0.000895003
 newdef Etapipigamma:OmnesEnergy 2  296.106
 newdef Etapipigamma:OmnesReal 2  0.843733
 newdef Etapipigamma:OmnesImag 2  -0.000612528
 newdef Etapipigamma:OmnesEnergy 3  302.893
 newdef Etapipigamma:OmnesReal 3  0.835875
 newdef Etapipigamma:OmnesImag 3  -0.00209191
 newdef Etapipigamma:OmnesEnergy 4  309.679
 newdef Etapipigamma:OmnesReal 4  0.828085
 newdef Etapipigamma:OmnesImag 4  -0.00354367
 newdef Etapipigamma:OmnesEnergy 5  316.466
 newdef Etapipigamma:OmnesReal 5  0.820288
 newdef Etapipigamma:OmnesImag 5  -0.00496772
 newdef Etapipigamma:OmnesEnergy 6  323.252
 newdef Etapipigamma:OmnesReal 6  0.812438
 newdef Etapipigamma:OmnesImag 6  -0.00636369
 newdef Etapipigamma:OmnesEnergy 7  330.038
 newdef Etapipigamma:OmnesReal 7  0.804502
 newdef Etapipigamma:OmnesImag 7  -0.00773098
 newdef Etapipigamma:OmnesEnergy 8  336.825
 newdef Etapipigamma:OmnesReal 8  0.796459
 newdef Etapipigamma:OmnesImag 8  -0.0090689
 newdef Etapipigamma:OmnesEnergy 9  343.611
 newdef Etapipigamma:OmnesReal 9  0.788299
 newdef Etapipigamma:OmnesImag 9  -0.0102966
 newdef Etapipigamma:OmnesEnergy 10  350.398
 newdef Etapipigamma:OmnesReal 10  0.77978
 newdef Etapipigamma:OmnesImag 10  -0.0114782
 newdef Etapipigamma:OmnesEnergy 11  357.184
 newdef Etapipigamma:OmnesReal 11  0.770922
 newdef Etapipigamma:OmnesImag 11  -0.0127871
 newdef Etapipigamma:OmnesEnergy 12  363.97
 newdef Etapipigamma:OmnesReal 12  0.761747
 newdef Etapipigamma:OmnesImag 12  -0.0144893
 newdef Etapipigamma:OmnesEnergy 13  370.757
 newdef Etapipigamma:OmnesReal 13  0.752726
 newdef Etapipigamma:OmnesImag 13  -0.016514
 newdef Etapipigamma:OmnesEnergy 14  377.543
 newdef Etapipigamma:OmnesReal 14  0.743834
 newdef Etapipigamma:OmnesImag 14  -0.0186276
 newdef Etapipigamma:OmnesEnergy 15  384.33
 newdef Etapipigamma:OmnesReal 15  0.735054
 newdef Etapipigamma:OmnesImag 15  -0.0206377
 newdef Etapipigamma:OmnesEnergy 16  391.116
 newdef Etapipigamma:OmnesReal 16  0.726157
 newdef Etapipigamma:OmnesImag 16  -0.02254
 newdef Etapipigamma:OmnesEnergy 17  397.902
 newdef Etapipigamma:OmnesReal 17  0.717152
 newdef Etapipigamma:OmnesImag 17  -0.0243863
 newdef Etapipigamma:OmnesEnergy 18  404.689
 newdef Etapipigamma:OmnesReal 18  0.70801
 newdef Etapipigamma:OmnesImag 18  -0.0260832
 newdef Etapipigamma:OmnesEnergy 19  411.475
 newdef Etapipigamma:OmnesReal 19  0.698521
 newdef Etapipigamma:OmnesImag 19  -0.0277386
 newdef Etapipigamma:OmnesEnergy 20  418.261
 newdef Etapipigamma:OmnesReal 20  0.688707
 newdef Etapipigamma:OmnesImag 20  -0.0294852
 newdef Etapipigamma:OmnesEnergy 21  425.048
 newdef Etapipigamma:OmnesReal 21  0.678618
 newdef Etapipigamma:OmnesImag 21  -0.0315487
 newdef Etapipigamma:OmnesEnergy 22  431.834
 newdef Etapipigamma:OmnesReal 22  0.668556
 newdef Etapipigamma:OmnesImag 22  -0.033826
 newdef Etapipigamma:OmnesEnergy 23  438.621
 newdef Etapipigamma:OmnesReal 23  0.658497
 newdef Etapipigamma:OmnesImag 23  -0.0362089
 newdef Etapipigamma:OmnesEnergy 24  445.407
 newdef Etapipigamma:OmnesReal 24  0.64843
 newdef Etapipigamma:OmnesImag 24  -0.0385967
 newdef Etapipigamma:OmnesEnergy 25  452.193
 newdef Etapipigamma:OmnesReal 25  0.638272
 newdef Etapipigamma:OmnesImag 25  -0.041005
 newdef Etapipigamma:OmnesEnergy 26  458.98
 newdef Etapipigamma:OmnesReal 26  0.628033
 newdef Etapipigamma:OmnesImag 26  -0.0434403
 newdef Etapipigamma:OmnesEnergy 27  465.766
 newdef Etapipigamma:OmnesReal 27  0.61771
 newdef Etapipigamma:OmnesImag 27  -0.0458954
 newdef Etapipigamma:OmnesEnergy 28  472.553
 newdef Etapipigamma:OmnesReal 28  0.607297
 newdef Etapipigamma:OmnesImag 28  -0.0483626
 newdef Etapipigamma:OmnesEnergy 29  479.339
 newdef Etapipigamma:OmnesReal 29  0.596791
 newdef Etapipigamma:OmnesImag 29  -0.0508342
 newdef Etapipigamma:OmnesEnergy 30  486.125
 newdef Etapipigamma:OmnesReal 30  0.586171
 newdef Etapipigamma:OmnesImag 30  -0.0532531
 newdef Etapipigamma:OmnesEnergy 31  492.912
 newdef Etapipigamma:OmnesReal 31  0.575358
 newdef Etapipigamma:OmnesImag 31  -0.0556832
 newdef Etapipigamma:OmnesEnergy 32  499.698
 newdef Etapipigamma:OmnesReal 32  0.564361
 newdef Etapipigamma:OmnesImag 32  -0.0581586
 newdef Etapipigamma:OmnesEnergy 33  506.485
 newdef Etapipigamma:OmnesReal 33  0.553215
 newdef Etapipigamma:OmnesImag 33  -0.0607546
 newdef Etapipigamma:OmnesEnergy 34  513.271
 newdef Etapipigamma:OmnesReal 34  0.541985
 newdef Etapipigamma:OmnesImag 34  -0.0634187
 newdef Etapipigamma:OmnesEnergy 35  520.057
 newdef Etapipigamma:OmnesReal 35  0.530668
 newdef Etapipigamma:OmnesImag 35  -0.0661333
 newdef Etapipigamma:OmnesEnergy 36  526.844
 newdef Etapipigamma:OmnesReal 36  0.519264
 newdef Etapipigamma:OmnesImag 36  -0.068884
 newdef Etapipigamma:OmnesEnergy 37  533.63
 newdef Etapipigamma:OmnesReal 37  0.507775
 newdef Etapipigamma:OmnesImag 37  -0.071656
 newdef Etapipigamma:OmnesEnergy 38  540.417
 newdef Etapipigamma:OmnesReal 38  0.496219
 newdef Etapipigamma:OmnesImag 38  -0.0744313
 newdef Etapipigamma:OmnesEnergy 39  547.203
 newdef Etapipigamma:OmnesReal 39  0.484506
 newdef Etapipigamma:OmnesImag 39  -0.0771089
 newdef Etapipigamma:OmnesEnergy 40  553.989
 newdef Etapipigamma:OmnesReal 40  0.472569
 newdef Etapipigamma:OmnesImag 40  -0.0798123
 newdef Etapipigamma:OmnesEnergy 41  560.776
 newdef Etapipigamma:OmnesReal 41  0.460391
 newdef Etapipigamma:OmnesImag 41  -0.082595
 newdef Etapipigamma:OmnesEnergy 42  567.562
 newdef Etapipigamma:OmnesReal 42  0.448121
 newdef Etapipigamma:OmnesImag 42  -0.0856019
 newdef Etapipigamma:OmnesEnergy 43  574.349
 newdef Etapipigamma:OmnesReal 43  0.43585
 newdef Etapipigamma:OmnesImag 43  -0.0886756
 newdef Etapipigamma:OmnesEnergy 44  581.135
 newdef Etapipigamma:OmnesReal 44  0.423613
 newdef Etapipigamma:OmnesImag 44  -0.0917406
 newdef Etapipigamma:OmnesEnergy 45  587.921
 newdef Etapipigamma:OmnesReal 45  0.411225
 newdef Etapipigamma:OmnesImag 45  -0.0946243
 newdef Etapipigamma:OmnesEnergy 46  594.708
 newdef Etapipigamma:OmnesReal 46  0.398597
 newdef Etapipigamma:OmnesImag 46  -0.0975016
 newdef Etapipigamma:OmnesEnergy 47  601.494
 newdef Etapipigamma:OmnesReal 47  0.385723
 newdef Etapipigamma:OmnesImag 47  -0.100435
 newdef Etapipigamma:OmnesEnergy 48  608.281
 newdef Etapipigamma:OmnesReal 48  0.372705
 newdef Etapipigamma:OmnesImag 48  -0.103516
 newdef Etapipigamma:OmnesEnergy 49  615.067
 newdef Etapipigamma:OmnesReal 49  0.35959
 newdef Etapipigamma:OmnesImag 49  -0.106676
 newdef Etapipigamma:OmnesEnergy 50  621.853
 newdef Etapipigamma:OmnesReal 50  0.3464
 newdef Etapipigamma:OmnesImag 50  -0.109892
 newdef Etapipigamma:OmnesEnergy 51  628.64
 newdef Etapipigamma:OmnesReal 51  0.333099
 newdef Etapipigamma:OmnesImag 51  -0.113121
 newdef Etapipigamma:OmnesEnergy 52  635.426
 newdef Etapipigamma:OmnesReal 52  0.319687
 newdef Etapipigamma:OmnesImag 52  -0.116385
 newdef Etapipigamma:OmnesEnergy 53  642.213
 newdef Etapipigamma:OmnesReal 53  0.306191
 newdef Etapipigamma:OmnesImag 53  -0.119664
 newdef Etapipigamma:OmnesEnergy 54  648.999
 newdef Etapipigamma:OmnesReal 54  0.292542
 newdef Etapipigamma:OmnesImag 54  -0.12291
 newdef Etapipigamma:OmnesEnergy 55  655.785
 newdef Etapipigamma:OmnesReal 55  0.278725
 newdef Etapipigamma:OmnesImag 55  -0.126183
 newdef Etapipigamma:OmnesEnergy 56  662.572
 newdef Etapipigamma:OmnesReal 56  0.264753
 newdef Etapipigamma:OmnesImag 56  -0.129498
 newdef Etapipigamma:OmnesEnergy 57  669.358
 newdef Etapipigamma:OmnesReal 57  0.250639
 newdef Etapipigamma:OmnesImag 57  -0.132862
 newdef Etapipigamma:OmnesEnergy 58  676.145
 newdef Etapipigamma:OmnesReal 58  0.236391
 newdef Etapipigamma:OmnesImag 58  -0.136272
 newdef Etapipigamma:OmnesEnergy 59  682.931
 newdef Etapipigamma:OmnesReal 59  0.222033
 newdef Etapipigamma:OmnesImag 59  -0.139718
 newdef Etapipigamma:OmnesEnergy 60  689.717
 newdef Etapipigamma:OmnesReal 60  0.207536
 newdef Etapipigamma:OmnesImag 60  -0.143173
 newdef Etapipigamma:OmnesEnergy 61  696.504
 newdef Etapipigamma:OmnesReal 61  0.192894
 newdef Etapipigamma:OmnesImag 61  -0.14665
 newdef Etapipigamma:OmnesEnergy 62  703.29
 newdef Etapipigamma:OmnesReal 62  0.178088
 newdef Etapipigamma:OmnesImag 62  -0.150158
 newdef Etapipigamma:OmnesEnergy 63  710.077
 newdef Etapipigamma:OmnesReal 63  0.163157
 newdef Etapipigamma:OmnesImag 63  -0.153716
 newdef Etapipigamma:OmnesEnergy 64  716.863
 newdef Etapipigamma:OmnesReal 64  0.148099
 newdef Etapipigamma:OmnesImag 64  -0.157273
 newdef Etapipigamma:OmnesEnergy 65  723.649
 newdef Etapipigamma:OmnesReal 65  0.132821
 newdef Etapipigamma:OmnesImag 65  -0.160847
 newdef Etapipigamma:OmnesEnergy 66  730.436
 newdef Etapipigamma:OmnesReal 66  0.117442
 newdef Etapipigamma:OmnesImag 66  -0.164521
 newdef Etapipigamma:OmnesEnergy 67  737.222
 newdef Etapipigamma:OmnesReal 67  0.101967
 newdef Etapipigamma:OmnesImag 67  -0.168175
 newdef Etapipigamma:OmnesEnergy 68  744.009
 newdef Etapipigamma:OmnesReal 68  0.0862561
 newdef Etapipigamma:OmnesImag 68  -0.171796
 newdef Etapipigamma:OmnesEnergy 69  750.795
 newdef Etapipigamma:OmnesReal 69  0.0704108
 newdef Etapipigamma:OmnesImag 69  -0.17551
 newdef Etapipigamma:OmnesEnergy 70  757.581
 newdef Etapipigamma:OmnesReal 70  0.0544367
 newdef Etapipigamma:OmnesImag 70  -0.179198
 newdef Etapipigamma:OmnesEnergy 71  764.368
 newdef Etapipigamma:OmnesReal 71  0.0381921
 newdef Etapipigamma:OmnesImag 71  -0.182849
 newdef Etapipigamma:OmnesEnergy 72  771.154
 newdef Etapipigamma:OmnesReal 72  0.0217339
 newdef Etapipigamma:OmnesImag 72  -0.186618
 newdef Etapipigamma:OmnesEnergy 73  777.94
 newdef Etapipigamma:OmnesReal 73  0.00508946
 newdef Etapipigamma:OmnesImag 73  -0.190478
 newdef Etapipigamma:OmnesEnergy 74  784.727
 newdef Etapipigamma:OmnesReal 74  -0.0116072
 newdef Etapipigamma:OmnesImag 74  -0.19445
 newdef Etapipigamma:OmnesEnergy 75  791.513
 newdef Etapipigamma:OmnesReal 75  -0.0284628
 newdef Etapipigamma:OmnesImag 75  -0.198325
 newdef Etapipigamma:OmnesEnergy 76  798.3
 newdef Etapipigamma:OmnesReal 76  -0.0455793
 newdef Etapipigamma:OmnesImag 76  -0.202216
 newdef Etapipigamma:OmnesEnergy 77  805.086
 newdef Etapipigamma:OmnesReal 77  -0.0628504
 newdef Etapipigamma:OmnesImag 77  -0.206211
 newdef Etapipigamma:OmnesEnergy 78  811.872
 newdef Etapipigamma:OmnesReal 78  -0.0803254
 newdef Etapipigamma:OmnesImag 78  -0.210165
 newdef Etapipigamma:OmnesEnergy 79  818.659
 newdef Etapipigamma:OmnesReal 79  -0.0980794
 newdef Etapipigamma:OmnesImag 79  -0.214176
 newdef Etapipigamma:OmnesEnergy 80  825.445
 newdef Etapipigamma:OmnesReal 80  -0.115981
 newdef Etapipigamma:OmnesImag 80  -0.218339
 newdef Etapipigamma:OmnesEnergy 81  832.232
 newdef Etapipigamma:OmnesReal 81  -0.134042
 newdef Etapipigamma:OmnesImag 81  -0.222474
 newdef Etapipigamma:OmnesEnergy 82  839.018
 newdef Etapipigamma:OmnesReal 82  -0.15233
 newdef Etapipigamma:OmnesImag 82  -0.226615
 newdef Etapipigamma:OmnesEnergy 83  845.804
 newdef Etapipigamma:OmnesReal 83  -0.170883
 newdef Etapipigamma:OmnesImag 83  -0.230769
 newdef Etapipigamma:OmnesEnergy 84  852.591
 newdef Etapipigamma:OmnesReal 84  -0.18971
 newdef Etapipigamma:OmnesImag 84  -0.234988
 newdef Etapipigamma:OmnesEnergy 85  859.377
 newdef Etapipigamma:OmnesReal 85  -0.208805
 newdef Etapipigamma:OmnesImag 85  -0.239288
 newdef Etapipigamma:OmnesEnergy 86  866.164
 newdef Etapipigamma:OmnesReal 86  -0.228131
 newdef Etapipigamma:OmnesImag 86  -0.243689
 newdef Etapipigamma:OmnesEnergy 87  872.95
 newdef Etapipigamma:OmnesReal 87  -0.247688
 newdef Etapipigamma:OmnesImag 87  -0.24814
 newdef Etapipigamma:OmnesEnergy 88  879.736
 newdef Etapipigamma:OmnesReal 88  -0.267484
 newdef Etapipigamma:OmnesImag 88  -0.25262
 newdef Etapipigamma:OmnesEnergy 89  886.523
 newdef Etapipigamma:OmnesReal 89  -0.287624
 newdef Etapipigamma:OmnesImag 89  -0.257087
 newdef Etapipigamma:OmnesEnergy 90  893.309
 newdef Etapipigamma:OmnesReal 90  -0.308122
 newdef Etapipigamma:OmnesImag 90  -0.261627
 newdef Etapipigamma:OmnesEnergy 91  900.096
 newdef Etapipigamma:OmnesReal 91  -0.328979
 newdef Etapipigamma:OmnesImag 91  -0.266226
 newdef Etapipigamma:OmnesEnergy 92  906.882
 newdef Etapipigamma:OmnesReal 92  -0.350331
 newdef Etapipigamma:OmnesImag 92  -0.270868
 newdef Etapipigamma:OmnesEnergy 93  913.668
 newdef Etapipigamma:OmnesReal 93  -0.372196
 newdef Etapipigamma:OmnesImag 93  -0.275687
 newdef Etapipigamma:OmnesEnergy 94  920.455
 newdef Etapipigamma:OmnesReal 94  -0.394596
 newdef Etapipigamma:OmnesImag 94  -0.280733
 newdef Etapipigamma:OmnesEnergy 95  927.241
 newdef Etapipigamma:OmnesReal 95  -0.417471
 newdef Etapipigamma:OmnesImag 95  -0.286075
 newdef Etapipigamma:OmnesEnergy 96  934.028
 newdef Etapipigamma:OmnesReal 96  -0.440914
 newdef Etapipigamma:OmnesImag 96  -0.291621
 newdef Etapipigamma:OmnesEnergy 97  940.814
 newdef Etapipigamma:OmnesReal 97  -0.465088
 newdef Etapipigamma:OmnesImag 97  -0.297381
 newdef Etapipigamma:OmnesEnergy 98  947.6
 newdef Etapipigamma:OmnesReal 98  -0.490461
 newdef Etapipigamma:OmnesImag 98  -0.303462
 newdef Etapipigamma:OmnesEnergy 99  954.387
 newdef Etapipigamma:OmnesReal 99  -0.51781
 newdef Etapipigamma:OmnesImag 99  -0.310381
 #
 create Herwig::EtaPiGammaGammaDecayer  Etapigammagamma
 newdef Etapigammagamma:Iteration 1
 newdef Etapigammagamma:Ntry 500
 newdef Etapigammagamma:Points 10000
 newdef Etapigammagamma:GenerateIntermediates 0
 newdef Etapigammagamma:grhoomega 12.924
 newdef Etapigammagamma:Fpi 130.7
 newdef Etapigammagamma:grho 5.89977
 newdef Etapigammagamma:RhoMass 771.1
 newdef Etapigammagamma:RhoWidth 149.2
 newdef Etapigammagamma:RatioFpiF8 0.769231
 newdef Etapigammagamma:RatioFpiF0 0.961538
 newdef Etapigammagamma:Theta -0.349066
 newdef Etapigammagamma:EtaMax 2.36858
 newdef Etapigammagamma:EtaPrimeMax 0.00597214
 newdef Etapigammagamma:LocalParameters 1
 #
 create Herwig::EtaPiPiPiDecayer  Etapipipi
 newdef Etapipipi:Iteration 1
 newdef Etapipipi:Ntry 500
 newdef Etapipipi:Points 10000
 newdef Etapipipi:GenerateIntermediates 0
 newdef Etapipipi:Incoming   0 221
 newdef Etapipipi:Outgoing  0 111
 newdef Etapipipi:Charged 0 1
 newdef Etapipipi:Prefactor 0 0.06477
 newdef Etapipipi:a 0 -1.17
 newdef Etapipipi:b 0 0.21
 newdef Etapipipi:c 0 0.06
 newdef Etapipipi:MaxWeight  0 1.72861
 newdef Etapipipi:Incoming   1 221
 newdef Etapipipi:Outgoing  1 111
 newdef Etapipipi:Charged 1 0
 newdef Etapipipi:Prefactor 1 0.0883547
 newdef Etapipipi:a 1 0
 newdef Etapipipi:b 1 -0.062
 newdef Etapipipi:c 1 -0.062
 newdef Etapipipi:MaxWeight  1 1.45813
 newdef Etapipipi:Incoming   2 331
 newdef Etapipipi:Outgoing  2 111
 newdef Etapipipi:Charged 2 1
 newdef Etapipipi:Prefactor 2 0.037165
 newdef Etapipipi:a 2 -3.08
 newdef Etapipipi:b 2 0.13
 newdef Etapipipi:c 2 0.62
 newdef Etapipipi:MaxWeight  2 0.0153201
 newdef Etapipipi:Incoming   3 331
 newdef Etapipipi:Outgoing  3 111
 newdef Etapipipi:Charged 3 0
 newdef Etapipipi:Prefactor 3 0.016203
 newdef Etapipipi:a 3 0
 newdef Etapipipi:b 3 -0.86
 newdef Etapipipi:c 3 -0.86
 newdef Etapipipi:MaxWeight  3 2.52411
 newdef Etapipipi:Incoming   4 331
 newdef Etapipipi:Outgoing  4 221
 newdef Etapipipi:Charged 4 1
 newdef Etapipipi:Prefactor 4 49.42
 newdef Etapipipi:a 4 -0.093
 newdef Etapipipi:b 4 -0.059
 newdef Etapipipi:c 4 -0.003
 newdef Etapipipi:MaxWeight  4 1.421
 newdef Etapipipi:Incoming   5 331
 newdef Etapipipi:Outgoing  5 221
 newdef Etapipipi:Charged 5 0
 newdef Etapipipi:Prefactor 5 20.62
 newdef Etapipipi:a 5 -0.105
 newdef Etapipipi:b 5 -0.065
 newdef Etapipipi:c 5 -0.004
 newdef Etapipipi:MaxWeight  5 1.42649
 #
 create Herwig::TensorMeson2PScalarDecayer  Tensor2PScalar
 newdef Tensor2PScalar:Iteration 1
 newdef Tensor2PScalar:Ntry 3000
 newdef Tensor2PScalar:Points 10000
 newdef Tensor2PScalar:GenerateIntermediates 0
 newdef Tensor2PScalar:Incoming 0 115
 newdef Tensor2PScalar:FirstOutgoing 0 221
 newdef Tensor2PScalar:SecondOutgoing 0 111
 newdef Tensor2PScalar:Coupling 0 10.9
 newdef Tensor2PScalar:MaxWeight 0 4.5
 newdef Tensor2PScalar:Incoming 1 215
 newdef Tensor2PScalar:FirstOutgoing 1 221
 newdef Tensor2PScalar:SecondOutgoing 1 211
 newdef Tensor2PScalar:Coupling 1 10.9
 newdef Tensor2PScalar:MaxWeight 1 4.5
 newdef Tensor2PScalar:Incoming 2 115
 newdef Tensor2PScalar:FirstOutgoing 2 331
 newdef Tensor2PScalar:SecondOutgoing 2 111
 newdef Tensor2PScalar:Coupling 2 9.92
 newdef Tensor2PScalar:MaxWeight 2 4.2
 newdef Tensor2PScalar:Incoming 3 215
 newdef Tensor2PScalar:FirstOutgoing 3 331
 newdef Tensor2PScalar:SecondOutgoing 3 211
 newdef Tensor2PScalar:Coupling 3 9.92
 newdef Tensor2PScalar:MaxWeight 3 4.2
 newdef Tensor2PScalar:Incoming 4 115
 newdef Tensor2PScalar:FirstOutgoing 4 311
 newdef Tensor2PScalar:SecondOutgoing 4 -311
 newdef Tensor2PScalar:Coupling 4 7.36
 newdef Tensor2PScalar:MaxWeight 4 1.54249
 newdef Tensor2PScalar:Incoming 5 115
 newdef Tensor2PScalar:FirstOutgoing 5 321
 newdef Tensor2PScalar:SecondOutgoing 5 -321
 newdef Tensor2PScalar:Coupling 5 7.36
 newdef Tensor2PScalar:MaxWeight 5 1.62503
 newdef Tensor2PScalar:Incoming 6 215
 newdef Tensor2PScalar:FirstOutgoing 6 321
 newdef Tensor2PScalar:SecondOutgoing 6 -311
 newdef Tensor2PScalar:Coupling 6 10.41
 newdef Tensor2PScalar:MaxWeight 6 4.5
 newdef Tensor2PScalar:Incoming 7 225
 newdef Tensor2PScalar:FirstOutgoing 7 211
 newdef Tensor2PScalar:SecondOutgoing 7 -211
 newdef Tensor2PScalar:Coupling 7 18.73
 newdef Tensor2PScalar:MaxWeight 7 5.5
 newdef Tensor2PScalar:Incoming 8 225
 newdef Tensor2PScalar:FirstOutgoing 8 111
 newdef Tensor2PScalar:SecondOutgoing 8 111
 newdef Tensor2PScalar:Coupling 8 13.24
 newdef Tensor2PScalar:MaxWeight 8 5.5
 newdef Tensor2PScalar:Incoming 9 225
 newdef Tensor2PScalar:FirstOutgoing 9 221
 newdef Tensor2PScalar:SecondOutgoing 9 221
 newdef Tensor2PScalar:Coupling 9 8.362
 newdef Tensor2PScalar:MaxWeight 9 5.4
 newdef Tensor2PScalar:Incoming 10 225
 newdef Tensor2PScalar:FirstOutgoing 10 321
 newdef Tensor2PScalar:SecondOutgoing 10 -321
 newdef Tensor2PScalar:Coupling 10 11.03
 newdef Tensor2PScalar:MaxWeight 10 5.
 newdef Tensor2PScalar:Incoming 11 225
 newdef Tensor2PScalar:FirstOutgoing 11 311
 newdef Tensor2PScalar:SecondOutgoing 11 -311
 newdef Tensor2PScalar:Coupling 11 11.38
 newdef Tensor2PScalar:MaxWeight 11 5.
 newdef Tensor2PScalar:Incoming 12 335
 newdef Tensor2PScalar:FirstOutgoing 12 321
 newdef Tensor2PScalar:SecondOutgoing 12 -321
 newdef Tensor2PScalar:Coupling 12 14.65
 newdef Tensor2PScalar:MaxWeight 12 1.60028
 newdef Tensor2PScalar:Incoming 13 335
 newdef Tensor2PScalar:FirstOutgoing 13 311
 newdef Tensor2PScalar:SecondOutgoing 13 -311
 newdef Tensor2PScalar:Coupling 13 14.65
 newdef Tensor2PScalar:MaxWeight 13 1.55404
 newdef Tensor2PScalar:Incoming 14 335
 newdef Tensor2PScalar:FirstOutgoing 14 221
 newdef Tensor2PScalar:SecondOutgoing 14 221
 newdef Tensor2PScalar:Coupling 14 9.15
 newdef Tensor2PScalar:MaxWeight 14 1.60254
 newdef Tensor2PScalar:Incoming 15 335
 newdef Tensor2PScalar:FirstOutgoing 15 211
 newdef Tensor2PScalar:SecondOutgoing 15 -211
 newdef Tensor2PScalar:Coupling 15 0.86
 newdef Tensor2PScalar:MaxWeight 15 1.60017
 newdef Tensor2PScalar:Incoming 16 335
 newdef Tensor2PScalar:FirstOutgoing 16 111
 newdef Tensor2PScalar:SecondOutgoing 16 111
 newdef Tensor2PScalar:Coupling 16 0.608
 newdef Tensor2PScalar:MaxWeight 16 1.60798
 newdef Tensor2PScalar:Incoming 17 325
 newdef Tensor2PScalar:FirstOutgoing 17 321
 newdef Tensor2PScalar:SecondOutgoing 17 221
 newdef Tensor2PScalar:Coupling 17 1.52
 newdef Tensor2PScalar:MaxWeight 17 5.1
 newdef Tensor2PScalar:Incoming 18 315
 newdef Tensor2PScalar:FirstOutgoing 18 311
 newdef Tensor2PScalar:SecondOutgoing 18 221
 newdef Tensor2PScalar:Coupling 18 1.52
 newdef Tensor2PScalar:MaxWeight 18 5.1
 newdef Tensor2PScalar:Incoming 19 325
 newdef Tensor2PScalar:FirstOutgoing 19 321
 newdef Tensor2PScalar:SecondOutgoing 19 111
 newdef Tensor2PScalar:Coupling 19 8.3
 newdef Tensor2PScalar:MaxWeight 19 5.1
 newdef Tensor2PScalar:Incoming 20 325
 newdef Tensor2PScalar:FirstOutgoing 20 311
 newdef Tensor2PScalar:SecondOutgoing 20 211
 newdef Tensor2PScalar:Coupling 20 11.74
 newdef Tensor2PScalar:MaxWeight 20 5.1
 newdef Tensor2PScalar:Incoming 21 315
 newdef Tensor2PScalar:FirstOutgoing 21 311
 newdef Tensor2PScalar:SecondOutgoing 21 111
 newdef Tensor2PScalar:Coupling 21 8.68
 newdef Tensor2PScalar:MaxWeight 21 5.1
 newdef Tensor2PScalar:Incoming 22 315
 newdef Tensor2PScalar:FirstOutgoing 22 321
 newdef Tensor2PScalar:SecondOutgoing 22 -211
 newdef Tensor2PScalar:Coupling 22 12.28
 newdef Tensor2PScalar:MaxWeight 22 5.1
 newdef Tensor2PScalar:Incoming 23 525
 newdef Tensor2PScalar:FirstOutgoing 23 521
 newdef Tensor2PScalar:SecondOutgoing 23 111
 newdef Tensor2PScalar:Coupling 23 27.23
 newdef Tensor2PScalar:MaxWeight 23 1.61546
 newdef Tensor2PScalar:Incoming 24 525
 newdef Tensor2PScalar:FirstOutgoing 24 511
 newdef Tensor2PScalar:SecondOutgoing 24 211
 newdef Tensor2PScalar:Coupling 24 38.52
 newdef Tensor2PScalar:MaxWeight 24 1.5839
 newdef Tensor2PScalar:Incoming 25 515
 newdef Tensor2PScalar:FirstOutgoing 25 511
 newdef Tensor2PScalar:SecondOutgoing 25 111
 newdef Tensor2PScalar:Coupling 25 27.16
 newdef Tensor2PScalar:MaxWeight 25 1.59996
 newdef Tensor2PScalar:Incoming 26 515
 newdef Tensor2PScalar:FirstOutgoing 26 521
 newdef Tensor2PScalar:SecondOutgoing 26 -211
 newdef Tensor2PScalar:Coupling 26 38.62
 newdef Tensor2PScalar:MaxWeight 26 1.59933
 newdef Tensor2PScalar:Incoming 27 425
 newdef Tensor2PScalar:FirstOutgoing 27 421
 newdef Tensor2PScalar:SecondOutgoing 27 111
 newdef Tensor2PScalar:Coupling 27 18.07
 newdef Tensor2PScalar:MaxWeight 27 6.
 newdef Tensor2PScalar:Incoming 28 425
 newdef Tensor2PScalar:FirstOutgoing 28 411
 newdef Tensor2PScalar:SecondOutgoing 28 -211
 newdef Tensor2PScalar:Coupling 28 25.56
 newdef Tensor2PScalar:MaxWeight 28 6.
 newdef Tensor2PScalar:Incoming 29 415
 newdef Tensor2PScalar:FirstOutgoing 29 411
 newdef Tensor2PScalar:SecondOutgoing 29 111
 newdef Tensor2PScalar:Coupling 29 14.91
 newdef Tensor2PScalar:MaxWeight 29 6.
 newdef Tensor2PScalar:Incoming 30 415
 newdef Tensor2PScalar:FirstOutgoing 30 421
 newdef Tensor2PScalar:SecondOutgoing 30 211
 newdef Tensor2PScalar:Coupling 30 21.09
 newdef Tensor2PScalar:MaxWeight 30 6.
 newdef Tensor2PScalar:Incoming 31 435
 newdef Tensor2PScalar:FirstOutgoing 31 421
 newdef Tensor2PScalar:SecondOutgoing 31 321
 newdef Tensor2PScalar:Coupling 31 23.39
 newdef Tensor2PScalar:MaxWeight 31 6.
 newdef Tensor2PScalar:Incoming 32 435
 newdef Tensor2PScalar:FirstOutgoing 32 411
 newdef Tensor2PScalar:SecondOutgoing 32 311
 newdef Tensor2PScalar:Coupling 32 23.39
 newdef Tensor2PScalar:MaxWeight 32 6.
 newdef Tensor2PScalar:Incoming 33 535
 newdef Tensor2PScalar:FirstOutgoing 33 521
 newdef Tensor2PScalar:SecondOutgoing 33 -321
 newdef Tensor2PScalar:Coupling 33 45.43
 newdef Tensor2PScalar:MaxWeight 33 1.60661
 newdef Tensor2PScalar:Incoming 34 535
 newdef Tensor2PScalar:FirstOutgoing 34 511
 newdef Tensor2PScalar:SecondOutgoing 34 -311
 newdef Tensor2PScalar:Coupling 34 48.84
 newdef Tensor2PScalar:MaxWeight 34 1.58181
 newdef Tensor2PScalar:Incoming 35 445
 newdef Tensor2PScalar:FirstOutgoing 35 211
 newdef Tensor2PScalar:SecondOutgoing 35 -211
 newdef Tensor2PScalar:Coupling 35 0.02
 newdef Tensor2PScalar:MaxWeight 35 1.5984
 newdef Tensor2PScalar:Incoming 36 445
 newdef Tensor2PScalar:FirstOutgoing 36 111
 newdef Tensor2PScalar:SecondOutgoing 36 111
 newdef Tensor2PScalar:Coupling 36 0.0141
 newdef Tensor2PScalar:MaxWeight 36 1.5916
 newdef Tensor2PScalar:Incoming 37 445
 newdef Tensor2PScalar:FirstOutgoing 37 321
 newdef Tensor2PScalar:SecondOutgoing 37 -321
 newdef Tensor2PScalar:Coupling 37 0.056
 newdef Tensor2PScalar:MaxWeight 37 1.59793
 newdef Tensor2PScalar:Incoming 38 445
 newdef Tensor2PScalar:FirstOutgoing 38 311
 newdef Tensor2PScalar:SecondOutgoing 38 -311
 newdef Tensor2PScalar:Coupling 38 0.056
 newdef Tensor2PScalar:MaxWeight 38 1.59254
 newdef Tensor2PScalar:Incoming 39 225
 newdef Tensor2PScalar:FirstOutgoing 39 9000221
 newdef Tensor2PScalar:SecondOutgoing 39 9000221
 newdef Tensor2PScalar:Coupling 39 104.1
 newdef Tensor2PScalar:MaxWeight 39 140.
 newdef Tensor2PScalar:Incoming 40 10115
 newdef Tensor2PScalar:FirstOutgoing 40 9000221
 newdef Tensor2PScalar:SecondOutgoing 40 111
 newdef Tensor2PScalar:Coupling 40 15.3
 newdef Tensor2PScalar:MaxWeight 40 8.14835
 newdef Tensor2PScalar:Incoming 41 10215
 newdef Tensor2PScalar:FirstOutgoing 41 9000221
 newdef Tensor2PScalar:SecondOutgoing 41 211
 newdef Tensor2PScalar:Coupling 41 15.3
 newdef Tensor2PScalar:MaxWeight 41 8.211
 newdef Tensor2PScalar:Incoming 42 10225
 newdef Tensor2PScalar:FirstOutgoing 42 9000111
 newdef Tensor2PScalar:SecondOutgoing 42 111
 newdef Tensor2PScalar:Coupling 42 11.3
 newdef Tensor2PScalar:MaxWeight 42 8.34671
 newdef Tensor2PScalar:Incoming 43 10225
 newdef Tensor2PScalar:FirstOutgoing 43 9000211
 newdef Tensor2PScalar:SecondOutgoing 43 -211
 newdef Tensor2PScalar:Coupling 43 11.3
 newdef Tensor2PScalar:MaxWeight 43 8.2342
 newdef Tensor2PScalar:Incoming 44 10335
 newdef Tensor2PScalar:FirstOutgoing 44 9000111
 newdef Tensor2PScalar:SecondOutgoing 44 111
 newdef Tensor2PScalar:Coupling 44 4.43
 newdef Tensor2PScalar:MaxWeight 44 7.81454
 newdef Tensor2PScalar:Incoming 45 10335
 newdef Tensor2PScalar:FirstOutgoing 45 9000211
 newdef Tensor2PScalar:SecondOutgoing 45 -211
 newdef Tensor2PScalar:Coupling 45 4.43
 newdef Tensor2PScalar:MaxWeight 45 8.54955
 newdef Tensor2PScalar:Incoming 46 100445
 newdef Tensor2PScalar:FirstOutgoing 46 411
 newdef Tensor2PScalar:SecondOutgoing 46 -411
 newdef Tensor2PScalar:Coupling 46 22.3
 newdef Tensor2PScalar:MaxWeight 46 1.6114
 newdef Tensor2PScalar:Incoming 47 100445
 newdef Tensor2PScalar:FirstOutgoing 47 421
 newdef Tensor2PScalar:SecondOutgoing 47 -421
 newdef Tensor2PScalar:Coupling 47 22.3
 newdef Tensor2PScalar:MaxWeight 47 1.61675
 #
 create Herwig::TensorMesonVectorPScalarDecayer  TensorVP
 newdef TensorVP:Iteration 1
 newdef TensorVP:Ntry 2000
 newdef TensorVP:Points 10000
 newdef TensorVP:GenerateIntermediates 0
 newdef TensorVP:Incoming 0 115
 newdef TensorVP:OutgoingVector 0 213
 newdef TensorVP:OutgoingScalar 0 -211
 newdef TensorVP:Coupling 0 21.1
 newdef TensorVP:MaxWeight 0 4.68304
 newdef TensorVP:Incoming 1 215
 newdef TensorVP:OutgoingVector 1 113
 newdef TensorVP:OutgoingScalar 1 211
 newdef TensorVP:Coupling 1 21.1
 newdef TensorVP:MaxWeight 1 4.71348
 newdef TensorVP:Incoming 2 215
 newdef TensorVP:OutgoingVector 2 213
 newdef TensorVP:OutgoingScalar 2 111
 newdef TensorVP:Coupling 2 21.1
 newdef TensorVP:MaxWeight 2 4.73233
 newdef TensorVP:Incoming 3 215
 newdef TensorVP:OutgoingVector 3 22
 newdef TensorVP:OutgoingScalar 3 211
 newdef TensorVP:Coupling 3 0.551
 newdef TensorVP:MaxWeight 3 1.7
 newdef TensorVP:Incoming 4 315
 newdef TensorVP:OutgoingVector 4 223
 newdef TensorVP:OutgoingScalar 4 311
 newdef TensorVP:Coupling 4 11.66
 newdef TensorVP:MaxWeight 4 40.
 newdef TensorVP:Incoming 5 325
 newdef TensorVP:OutgoingVector 5 223
 newdef TensorVP:OutgoingScalar 5 321
 newdef TensorVP:Coupling 5 11.66
 newdef TensorVP:MaxWeight 5 40.
 newdef TensorVP:Incoming 6 325
 newdef TensorVP:OutgoingVector 6 22
 newdef TensorVP:OutgoingScalar 6 321
 newdef TensorVP:Coupling 6 0.553
 newdef TensorVP:MaxWeight 6 1.9
 newdef TensorVP:Incoming 7 545
 newdef TensorVP:OutgoingVector 7 22
 newdef TensorVP:OutgoingScalar 7 541
 newdef TensorVP:Coupling 7 0.651
 newdef TensorVP:MaxWeight 7 1.63579
 newdef TensorVP:Incoming 8 325
 newdef TensorVP:OutgoingVector 8 113
 newdef TensorVP:OutgoingScalar 8 321
 newdef TensorVP:Coupling 8 10.14
 newdef TensorVP:MaxWeight 8 7.09367
 newdef TensorVP:Incoming 9 325
 newdef TensorVP:OutgoingVector 9 213
 newdef TensorVP:OutgoingScalar 9 311
 newdef TensorVP:Coupling 9 14.33
 newdef TensorVP:MaxWeight 9 6.86114
 newdef TensorVP:Incoming 10 315
 newdef TensorVP:OutgoingVector 10 113
 newdef TensorVP:OutgoingScalar 10 311
 newdef TensorVP:Coupling 10 10.14
 newdef TensorVP:MaxWeight 10 6.65245
 newdef TensorVP:Incoming 11 315
 newdef TensorVP:OutgoingVector 11 -213
 newdef TensorVP:OutgoingScalar 11 321
 newdef TensorVP:Coupling 11 14.33
 newdef TensorVP:MaxWeight 11 8.1
 newdef TensorVP:Incoming 12 325
 newdef TensorVP:OutgoingVector 12 323
 newdef TensorVP:OutgoingScalar 12 111
 newdef TensorVP:Coupling 12 9.733
 newdef TensorVP:MaxWeight 12 2.9
 newdef TensorVP:Incoming 13 325
 newdef TensorVP:OutgoingVector 13 313
 newdef TensorVP:OutgoingScalar 13 211
 newdef TensorVP:Coupling 13 13.77
 newdef TensorVP:MaxWeight 13 2.796
 newdef TensorVP:Incoming 14 315
 newdef TensorVP:OutgoingVector 14 313
 newdef TensorVP:OutgoingScalar 14 111
 newdef TensorVP:Coupling 14 9.733
 newdef TensorVP:MaxWeight 14 3.
 newdef TensorVP:Incoming 15 315
 newdef TensorVP:OutgoingVector 15 323
 newdef TensorVP:OutgoingScalar 15 -211
 newdef TensorVP:Coupling 15 13.77
 newdef TensorVP:MaxWeight 15 3.
 newdef TensorVP:Incoming 16 425
 newdef TensorVP:OutgoingVector 16 423
 newdef TensorVP:OutgoingScalar 16 111
 newdef TensorVP:Coupling 16 8.035
 newdef TensorVP:MaxWeight 16 6.
 newdef TensorVP:Incoming 17 425
 newdef TensorVP:OutgoingVector 17 413
 newdef TensorVP:OutgoingScalar 17 -211
 newdef TensorVP:Coupling 17 11.67
 newdef TensorVP:MaxWeight 17 6.
 newdef TensorVP:Incoming 18 415
 newdef TensorVP:OutgoingVector 18 413
 newdef TensorVP:OutgoingScalar 18 111
 newdef TensorVP:Coupling 18 6.801
 newdef TensorVP:MaxWeight 18 6.
 newdef TensorVP:Incoming 19 415
 newdef TensorVP:OutgoingVector 19 423
 newdef TensorVP:OutgoingScalar 19 211
 newdef TensorVP:Coupling 19 9.527
 newdef TensorVP:MaxWeight 19 6.
 newdef TensorVP:Incoming 20 435
 newdef TensorVP:OutgoingVector 20 423
 newdef TensorVP:OutgoingScalar 20 321
 newdef TensorVP:Coupling 20 13.1
 newdef TensorVP:MaxWeight 20 5.
 newdef TensorVP:Incoming 21 435
 newdef TensorVP:OutgoingVector 21 413
 newdef TensorVP:OutgoingScalar 21 311
 newdef TensorVP:Coupling 21 13.1
 newdef TensorVP:MaxWeight 21 5.
 newdef TensorVP:Incoming 22 525
 newdef TensorVP:OutgoingVector 22 523
 newdef TensorVP:OutgoingScalar 22 111
 newdef TensorVP:Coupling 22 4.99
 newdef TensorVP:MaxWeight 22 1.61535
 newdef TensorVP:Incoming 23 525
 newdef TensorVP:OutgoingVector 23 513
 newdef TensorVP:OutgoingScalar 23 211
 newdef TensorVP:Coupling 23 7.059
 newdef TensorVP:MaxWeight 23 1.5842
 newdef TensorVP:Incoming 24 515
 newdef TensorVP:OutgoingVector 24 513
 newdef TensorVP:OutgoingScalar 24 111
 newdef TensorVP:Coupling 24 4.99
 newdef TensorVP:MaxWeight 24 1.61501
 newdef TensorVP:Incoming 25 515
 newdef TensorVP:OutgoingVector 25 523
 newdef TensorVP:OutgoingScalar 25 -211
 newdef TensorVP:Coupling 25 7.059
 newdef TensorVP:MaxWeight 25 1.58463
 newdef TensorVP:Incoming 26 435
 newdef TensorVP:OutgoingVector 26 423
 newdef TensorVP:OutgoingScalar 26 321
 newdef TensorVP:Coupling 26 13.09
 newdef TensorVP:MaxWeight 26 1.78925
 newdef TensorVP:Incoming 27 435
 newdef TensorVP:OutgoingVector 27 413
 newdef TensorVP:OutgoingScalar 27 311
 newdef TensorVP:Coupling 27 13.09
 newdef TensorVP:MaxWeight 27 2.06728
 newdef TensorVP:Incoming 28 535
 newdef TensorVP:OutgoingVector 28 523
 newdef TensorVP:OutgoingScalar 28 -321
 newdef TensorVP:Coupling 28 7.29
 newdef TensorVP:MaxWeight 28 1.60271
 newdef TensorVP:Incoming 29 535
 newdef TensorVP:OutgoingVector 29 513
 newdef TensorVP:OutgoingScalar 29 -311
 newdef TensorVP:Coupling 29 9.43
 newdef TensorVP:MaxWeight 29 1.59959
 newdef TensorVP:Incoming 30 20555
 newdef TensorVP:OutgoingVector 30 22
 newdef TensorVP:OutgoingScalar 30 10551
 newdef TensorVP:Coupling 30 1.11
 newdef TensorVP:MaxWeight 30 1.82265
 #
 create Herwig::TensorMesonVectorVectorDecayer  TVV
 newdef TVV:Iteration 1
 newdef TVV:Ntry 1000
 newdef TVV:Points 10000
 newdef TVV:GenerateIntermediates 0
 newdef TVV:Incoming 0 115
 newdef TVV:FirstOutgoing 0 22
 newdef TVV:SecondOutgoing 0 22
 newdef TVV:Coupling 0 0.00727
 newdef TVV:MaxWeight 0 1.60102
 newdef TVV:Incoming 1 225
 newdef TVV:FirstOutgoing 1 22
 newdef TVV:SecondOutgoing 1 22
 newdef TVV:Coupling 1 0.01253
 newdef TVV:MaxWeight 1 1.9
 newdef TVV:Incoming 2 335
 newdef TVV:FirstOutgoing 2 22
 newdef TVV:SecondOutgoing 2 22
 newdef TVV:Coupling 2 0.00161
 newdef TVV:MaxWeight 2 1.60342
 newdef TVV:Incoming 3 100555
 newdef TVV:FirstOutgoing 3 553
 newdef TVV:SecondOutgoing 3 223
 newdef TVV:Coupling 3 0.0118
 newdef TVV:MaxWeight 3 1.80247
 newdef TVV:Incoming 4 100555
 newdef TVV:FirstOutgoing 4 553
 newdef TVV:SecondOutgoing 4 22
 newdef TVV:Coupling 4 0.0172
 newdef TVV:MaxWeight 4 1.61188
 newdef TVV:Incoming 5 100555
 newdef TVV:FirstOutgoing 5 100553
 newdef TVV:SecondOutgoing 5 22
 newdef TVV:Coupling 5 0.145
 newdef TVV:MaxWeight 5 1.61121
 newdef TVV:Incoming 6 100555
 newdef TVV:FirstOutgoing 6 333
 newdef TVV:SecondOutgoing 6 333
 newdef TVV:Coupling 6 0.00483
 newdef TVV:MaxWeight 6 17.0515
 newdef TVV:Incoming 7 445
 newdef TVV:FirstOutgoing 7 443
 newdef TVV:SecondOutgoing 7 22
 newdef TVV:Coupling 7 0.243
 newdef TVV:MaxWeight 7 1.64486
 newdef TVV:Incoming 8 445
 newdef TVV:FirstOutgoing 8 323
 newdef TVV:SecondOutgoing 8 -323
 newdef TVV:Coupling 8 0.0056
 newdef TVV:MaxWeight 8 15.
 newdef TVV:Incoming 9 445
 newdef TVV:FirstOutgoing 9 313
 newdef TVV:SecondOutgoing 9 -313
 newdef TVV:Coupling 9 0.0056
 newdef TVV:MaxWeight 9 18.9725
 newdef TVV:Incoming 10 445
 newdef TVV:FirstOutgoing 10 333
 newdef TVV:SecondOutgoing 10 333
 newdef TVV:Coupling 10 0.00418
 newdef TVV:MaxWeight 10 10.6
 newdef TVV:Incoming 11 445
 newdef TVV:FirstOutgoing 11 22
 newdef TVV:SecondOutgoing 11 22
 newdef TVV:Coupling 11 0.00122
 newdef TVV:MaxWeight 11 1.59743
 newdef TVV:Incoming 12 555
 newdef TVV:FirstOutgoing 12 553
 newdef TVV:SecondOutgoing 12 22
 newdef TVV:Coupling 12 0.0683
 newdef TVV:MaxWeight 12 1.69405
 newdef TVV:Incoming 13 115
 newdef TVV:FirstOutgoing 13 223
 newdef TVV:SecondOutgoing 13 113
 newdef TVV:Coupling 13 23.1
 newdef TVV:MaxWeight 13 25.
 newdef TVV:Incoming 14 215
 newdef TVV:FirstOutgoing 14 223
 newdef TVV:SecondOutgoing 14 213
 newdef TVV:Coupling 14 23.1
 newdef TVV:MaxWeight 14 25.
 newdef TVV:Incoming 15 225
 newdef TVV:FirstOutgoing 15 113
 newdef TVV:SecondOutgoing 15 113
 newdef TVV:Coupling 15 11.7
 newdef TVV:MaxWeight 15 24.5803
 newdef TVV:Incoming 16 225
 newdef TVV:FirstOutgoing 16 213
 newdef TVV:SecondOutgoing 16 -213
 newdef TVV:Coupling 16 16.5
 newdef TVV:MaxWeight 16 25.1912
 newdef TVV:Incoming 17 315
 newdef TVV:FirstOutgoing 17 113
 newdef TVV:SecondOutgoing 17 313
 newdef TVV:Coupling 17 13.42
 newdef TVV:MaxWeight 17 25.1576
 newdef TVV:Incoming 18 315
 newdef TVV:FirstOutgoing 18 -213
 newdef TVV:SecondOutgoing 18 323
 newdef TVV:Coupling 18 18.98
 newdef TVV:MaxWeight 18 28.0583
 newdef TVV:Incoming 19 325
 newdef TVV:FirstOutgoing 19 113
 newdef TVV:SecondOutgoing 19 323
 newdef TVV:Coupling 19 13.42
 newdef TVV:MaxWeight 19 26.8526
 newdef TVV:Incoming 20 325
 newdef TVV:FirstOutgoing 20 213
 newdef TVV:SecondOutgoing 20 313
 newdef TVV:Coupling 20 18.98
 newdef TVV:MaxWeight 20 24.8093
 newdef TVV:Incoming 21 445
 newdef TVV:FirstOutgoing 21 223
 newdef TVV:SecondOutgoing 21 223
 newdef TVV:Coupling 21 0.00389
 newdef TVV:MaxWeight 21 10.2336
 #
 create Herwig::SemiLeptonicScalarDecayer  ISGW
 newdef ISGW:Iteration 1
 newdef ISGW:Ntry 500
 newdef ISGW:Points 10000
 newdef ISGW:GenerateIntermediates 0
 insert ISGW:MaximumWeight 0 5.424e-05
 insert ISGW:MaximumWeight 1 5.41804e-05
 insert ISGW:MaximumWeight 2 3.893e-05
 insert ISGW:MaximumWeight 3 7.59854e-05
 insert ISGW:MaximumWeight 4 7.74351e-05
 insert ISGW:MaximumWeight 5 5.13206e-05
 insert ISGW:MaximumWeight 6 0.00136557
 insert ISGW:MaximumWeight 7 0.00142736
 insert ISGW:MaximumWeight 8 0.000823295
 insert ISGW:MaximumWeight 9 3.0946e-05
 insert ISGW:MaximumWeight 10 3.02772e-05
 insert ISGW:MaximumWeight 11 1.1885e-05
 insert ISGW:MaximumWeight 12 0.000139391
 insert ISGW:MaximumWeight 13 0.000138853
 insert ISGW:MaximumWeight 14 7.29822e-05
 insert ISGW:MaximumWeight 15 0.000449845
 insert ISGW:MaximumWeight 16 0.000482517
 insert ISGW:MaximumWeight 17 0.000210263
 insert ISGW:MaximumWeight 18 1.81584e-05
 insert ISGW:MaximumWeight 19 1.8153e-05
 insert ISGW:MaximumWeight 20 9.3705e-06
 insert ISGW:MaximumWeight 21 6.15054e-05
 insert ISGW:MaximumWeight 22 6.14914e-05
 insert ISGW:MaximumWeight 23 4.59853e-05
 insert ISGW:MaximumWeight 24 0.000997071
 insert ISGW:MaximumWeight 25 0.000975911
 insert ISGW:MaximumWeight 26 0.000445402
 insert ISGW:MaximumWeight 27 3.33599e-05
 insert ISGW:MaximumWeight 28 3.31068e-05
 insert ISGW:MaximumWeight 29 1.27265e-05
 insert ISGW:MaximumWeight 30 0.000309993
 insert ISGW:MaximumWeight 31 0.000308636
 insert ISGW:MaximumWeight 32 8.9226e-05
 insert ISGW:MaximumWeight 33 0.000200307
 insert ISGW:MaximumWeight 34 0.000200465
 insert ISGW:MaximumWeight 35 0.000127083
 insert ISGW:MaximumWeight 36 1.6939e-05
 insert ISGW:MaximumWeight 37 1.72911e-05
 insert ISGW:MaximumWeight 38 7.4697e-06
 insert ISGW:MaximumWeight 39 0.120635
 insert ISGW:MaximumWeight 40 0.11301
 insert ISGW:MaximumWeight 41 0.0231386
 insert ISGW:MaximumWeight 42 0.146282
 insert ISGW:MaximumWeight 43 0.140715
 insert ISGW:MaximumWeight 44 0.0370693
 insert ISGW:MaximumWeight 45 0.00853693
 insert ISGW:MaximumWeight 46 0.00852123
 insert ISGW:MaximumWeight 47 0.000300696
 insert ISGW:MaximumWeight 48 0.0229497
 insert ISGW:MaximumWeight 49 0.0209246
 insert ISGW:MaximumWeight 50 0.00104239
 insert ISGW:MaximumWeight 51 0.00909127
 insert ISGW:MaximumWeight 52 0.00891799
 insert ISGW:MaximumWeight 53 0.000961694
 insert ISGW:MaximumWeight 54 0.0048722
 insert ISGW:MaximumWeight 55 0.00455352
 insert ISGW:MaximumWeight 56 0.000321721
 insert ISGW:MaximumWeight 57 0.00011395
 insert ISGW:MaximumWeight 58 0.000113855
 insert ISGW:MaximumWeight 59 8.51126e-05
 insert ISGW:MaximumWeight 60 0.00150609
 insert ISGW:MaximumWeight 61 0.00153757
 insert ISGW:MaximumWeight 62 0.000747443
 insert ISGW:MaximumWeight 63 6.09267e-05
 insert ISGW:MaximumWeight 64 6.23095e-05
 insert ISGW:MaximumWeight 65 2.30318e-05
 insert ISGW:MaximumWeight 66 0.000552937
 insert ISGW:MaximumWeight 67 0.000559378
 insert ISGW:MaximumWeight 68 0.000162807
 insert ISGW:MaximumWeight 69 0.000365874
 insert ISGW:MaximumWeight 70 0.000364205
 insert ISGW:MaximumWeight 71 0.000233785
 insert ISGW:MaximumWeight 72 3.16293e-05
 insert ISGW:MaximumWeight 73 3.18219e-05
 insert ISGW:MaximumWeight 74 1.37143e-05
 insert ISGW:MaximumWeight 75 0.110313
 insert ISGW:MaximumWeight 76 0.103445
 insert ISGW:MaximumWeight 77 0.0210801
 insert ISGW:MaximumWeight 78 0.147362
 insert ISGW:MaximumWeight 79 0.147419
 insert ISGW:MaximumWeight 80 0.0384639
 insert ISGW:MaximumWeight 81 0.0111543
 insert ISGW:MaximumWeight 82 0.0103842
 insert ISGW:MaximumWeight 83 0.000319557
 insert ISGW:MaximumWeight 84 0.0211162
 insert ISGW:MaximumWeight 85 0.0193068
 insert ISGW:MaximumWeight 86 0.000966967
 insert ISGW:MaximumWeight 87 0.00819478
 insert ISGW:MaximumWeight 88 0.00823409
 insert ISGW:MaximumWeight 89 0.000922852
 insert ISGW:MaximumWeight 90 0.00451283
 insert ISGW:MaximumWeight 91 0.00419498
 insert ISGW:MaximumWeight 92 0.000294157
 insert ISGW:MaximumWeight 93 0.00578922
 insert ISGW:MaximumWeight 94 0.00516882
 insert ISGW:MaximumWeight 95 0.00492885
 insert ISGW:MaximumWeight 96 0.00482429
 insert ISGW:MaximumWeight 97 2.25872e-06
 insert ISGW:MaximumWeight 98 1.87372e-06
 insert ISGW:MaximumWeight 99 0.000308952
 insert ISGW:MaximumWeight 100 0.000227327
 insert ISGW:MaximumWeight 101 0.000319546
 insert ISGW:MaximumWeight 102 0.000269116
 insert ISGW:MaximumWeight 103 3.55367e-05
 insert ISGW:MaximumWeight 104 2.49126e-05
 insert ISGW:MaximumWeight 105 0.127728
 insert ISGW:MaximumWeight 106 0.107291
 insert ISGW:MaximumWeight 107 0.0670801
 insert ISGW:MaximumWeight 108 0.0655003
 insert ISGW:MaximumWeight 109 3.5304e-05
 insert ISGW:MaximumWeight 110 2.5821e-05
 insert ISGW:MaximumWeight 111 0.0023046
 insert ISGW:MaximumWeight 112 0.00152967
 insert ISGW:MaximumWeight 113 0.000513018
 insert ISGW:MaximumWeight 114 0.000456772
 insert ISGW:MaximumWeight 115 0.00229334
 insert ISGW:MaximumWeight 116 0.00182456
 insert ISGW:MaximumWeight 117 0.00357344
 insert ISGW:MaximumWeight 118 0.00305374
 insert ISGW:MaximumWeight 119 0.00155629
 insert ISGW:MaximumWeight 120 0.00121146
 insert ISGW:MaximumWeight 121 0.0129117
 insert ISGW:MaximumWeight 122 0.0127254
 insert ISGW:MaximumWeight 123 8.71673e-06
 insert ISGW:MaximumWeight 124 8.13552e-06
 insert ISGW:MaximumWeight 125 0.000669791
 insert ISGW:MaximumWeight 126 0.000503811
 insert ISGW:MaximumWeight 127 0.000192319
 insert ISGW:MaximumWeight 128 0.000174441
 insert ISGW:MaximumWeight 129 3.41743e-05
 insert ISGW:MaximumWeight 130 2.08608e-05
 insert ISGW:MaximumWeight 131 0.00733276
 insert ISGW:MaximumWeight 132 0.00655274
 insert ISGW:MaximumWeight 133 0.00633683
 insert ISGW:MaximumWeight 134 0.00619396
 insert ISGW:MaximumWeight 135 3.00359e-06
 insert ISGW:MaximumWeight 136 2.49679e-06
 insert ISGW:MaximumWeight 137 0.000406841
 insert ISGW:MaximumWeight 138 0.000300569
 insert ISGW:MaximumWeight 139 0.000419858
 insert ISGW:MaximumWeight 140 0.000352772
 insert ISGW:MaximumWeight 141 4.70378e-05
 insert ISGW:MaximumWeight 142 3.28597e-05
 insert ISGW:MaximumWeight 143 0.325353
 insert ISGW:MaximumWeight 144 0.27348
 insert ISGW:MaximumWeight 145 0.169488
 insert ISGW:MaximumWeight 146 0.165556
 insert ISGW:MaximumWeight 147 9.51603e-05
 insert ISGW:MaximumWeight 148 7.10445e-05
 insert ISGW:MaximumWeight 149 0.00591948
 insert ISGW:MaximumWeight 150 0.00402664
 insert ISGW:MaximumWeight 151 0.00135309
 insert ISGW:MaximumWeight 152 0.00118354
 insert ISGW:MaximumWeight 153 0.00575264
 insert ISGW:MaximumWeight 154 0.0045926
 create Herwig::LeptonNeutrinoCurrent ISGWCurrent  HwWeakCurrents.so
 newdef ISGWCurrent:Quark 0  11
 newdef ISGWCurrent:AntiQuark 0  -12
 newdef ISGWCurrent:Quark 1  13
 newdef ISGWCurrent:AntiQuark 1  -15
 newdef ISGWCurrent:Quark 2  15
 newdef ISGWCurrent:AntiQuark 2  -16
 newdef ISGW:Current ISGWCurrent
 create Herwig::ISGWFormFactor ISGWFormFactor
 newdef ISGWFormFactor:Kappa    0.7
 newdef ISGWFormFactor:DownMass 0.33
 newdef ISGWFormFactor:UpMass 0.33
 newdef ISGWFormFactor:StrangeMass 0.55
 newdef ISGWFormFactor:CharmMass 1.82
 newdef ISGWFormFactor:BottomMass 5.12
 newdef ISGWFormFactor:BetaSud 0.31
 newdef ISGWFormFactor:BetaSus 0.34
 newdef ISGWFormFactor:BetaSuc 0.39
 newdef ISGWFormFactor:BetaSub 0.41
 newdef ISGWFormFactor:BetaPud 0.27
 newdef ISGWFormFactor:BetaPus 0.3
 newdef ISGWFormFactor:BetaPuc 0.34
 newdef ISGWFormFactor:ThetaEtaEtaPrime -0.174533
 newdef ISGWFormFactor:Incoming 0 -521
 newdef ISGWFormFactor:Outgoing 0 -211
 newdef ISGWFormFactor:Spin 0 0
 newdef ISGWFormFactor:Spectator 0 -2
 newdef ISGWFormFactor:InQuark 0 5
 newdef ISGWFormFactor:OutQuark 0 1
 newdef ISGWFormFactor:Incoming 1 -521
 newdef ISGWFormFactor:Outgoing 1 -213
 newdef ISGWFormFactor:Spin 1 1
 newdef ISGWFormFactor:Spectator 1 -2
 newdef ISGWFormFactor:InQuark 1 5
 newdef ISGWFormFactor:OutQuark 1 1
 newdef ISGWFormFactor:Incoming 2 -521
 newdef ISGWFormFactor:Outgoing 2 -215
 newdef ISGWFormFactor:Spin 2 2
 newdef ISGWFormFactor:Spectator 2 -2
 newdef ISGWFormFactor:InQuark 2 5
 newdef ISGWFormFactor:OutQuark 2 1
 newdef ISGWFormFactor:Incoming 3 -521
 newdef ISGWFormFactor:Outgoing 3 -10213
 newdef ISGWFormFactor:Spin 3 1
 newdef ISGWFormFactor:Spectator 3 -2
 newdef ISGWFormFactor:InQuark 3 5
 newdef ISGWFormFactor:OutQuark 3 1
 newdef ISGWFormFactor:Incoming 4 -521
 newdef ISGWFormFactor:Outgoing 4 -20213
 newdef ISGWFormFactor:Spin 4 1
 newdef ISGWFormFactor:Spectator 4 -2
 newdef ISGWFormFactor:InQuark 4 5
 newdef ISGWFormFactor:OutQuark 4 1
 newdef ISGWFormFactor:Incoming 5 -521
 newdef ISGWFormFactor:Outgoing 5 -10211
 newdef ISGWFormFactor:Spin 5 0
 newdef ISGWFormFactor:Spectator 5 -2
 newdef ISGWFormFactor:InQuark 5 5
 newdef ISGWFormFactor:OutQuark 5 1
 newdef ISGWFormFactor:Incoming 6 -521
 newdef ISGWFormFactor:Outgoing 6 221
 newdef ISGWFormFactor:Spin 6 0
 newdef ISGWFormFactor:Spectator 6 -2
 newdef ISGWFormFactor:InQuark 6 5
 newdef ISGWFormFactor:OutQuark 6 2
 newdef ISGWFormFactor:Incoming 7 -521
 newdef ISGWFormFactor:Outgoing 7 331
 newdef ISGWFormFactor:Spin 7 0
 newdef ISGWFormFactor:Spectator 7 -2
 newdef ISGWFormFactor:InQuark 7 5
 newdef ISGWFormFactor:OutQuark 7 2
 newdef ISGWFormFactor:Incoming 8 -521
 newdef ISGWFormFactor:Outgoing 8 223
 newdef ISGWFormFactor:Spin 8 1
 newdef ISGWFormFactor:Spectator 8 -2
 newdef ISGWFormFactor:InQuark 8 5
 newdef ISGWFormFactor:OutQuark 8 2
 newdef ISGWFormFactor:Incoming 9 -521
 newdef ISGWFormFactor:Outgoing 9 225
 newdef ISGWFormFactor:Spin 9 2
 newdef ISGWFormFactor:Spectator 9 -2
 newdef ISGWFormFactor:InQuark 9 5
 newdef ISGWFormFactor:OutQuark 9 2
 newdef ISGWFormFactor:Incoming 10 -521
 newdef ISGWFormFactor:Outgoing 10 10223
 newdef ISGWFormFactor:Spin 10 1
 newdef ISGWFormFactor:Spectator 10 -2
 newdef ISGWFormFactor:InQuark 10 5
 newdef ISGWFormFactor:OutQuark 10 2
 newdef ISGWFormFactor:Incoming 11 -521
 newdef ISGWFormFactor:Outgoing 11 20223
 newdef ISGWFormFactor:Spin 11 1
 newdef ISGWFormFactor:Spectator 11 -2
 newdef ISGWFormFactor:InQuark 11 5
 newdef ISGWFormFactor:OutQuark 11 2
 newdef ISGWFormFactor:Incoming 12 -521
 newdef ISGWFormFactor:Outgoing 12 10221
 newdef ISGWFormFactor:Spin 12 0
 newdef ISGWFormFactor:Spectator 12 -2
 newdef ISGWFormFactor:InQuark 12 5
 newdef ISGWFormFactor:OutQuark 12 2
 newdef ISGWFormFactor:Incoming 13 -521
 newdef ISGWFormFactor:Outgoing 13 111
 newdef ISGWFormFactor:Spin 13 0
 newdef ISGWFormFactor:Spectator 13 -2
 newdef ISGWFormFactor:InQuark 13 5
 newdef ISGWFormFactor:OutQuark 13 2
 newdef ISGWFormFactor:Incoming 14 -521
 newdef ISGWFormFactor:Outgoing 14 113
 newdef ISGWFormFactor:Spin 14 1
 newdef ISGWFormFactor:Spectator 14 -2
 newdef ISGWFormFactor:InQuark 14 5
 newdef ISGWFormFactor:OutQuark 14 2
 newdef ISGWFormFactor:Incoming 15 -521
 newdef ISGWFormFactor:Outgoing 15 115
 newdef ISGWFormFactor:Spin 15 2
 newdef ISGWFormFactor:Spectator 15 -2
 newdef ISGWFormFactor:InQuark 15 5
 newdef ISGWFormFactor:OutQuark 15 2
 newdef ISGWFormFactor:Incoming 16 -521
 newdef ISGWFormFactor:Outgoing 16 10113
 newdef ISGWFormFactor:Spin 16 1
 newdef ISGWFormFactor:Spectator 16 -2
 newdef ISGWFormFactor:InQuark 16 5
 newdef ISGWFormFactor:OutQuark 16 2
 newdef ISGWFormFactor:Incoming 17 -521
 newdef ISGWFormFactor:Outgoing 17 20113
 newdef ISGWFormFactor:Spin 17 1
 newdef ISGWFormFactor:Spectator 17 -2
 newdef ISGWFormFactor:InQuark 17 5
 newdef ISGWFormFactor:OutQuark 17 2
 newdef ISGWFormFactor:Incoming 18 -521
 newdef ISGWFormFactor:Outgoing 18 10111
 newdef ISGWFormFactor:Spin 18 0
 newdef ISGWFormFactor:Spectator 18 -2
 newdef ISGWFormFactor:InQuark 18 5
 newdef ISGWFormFactor:OutQuark 18 2
 newdef ISGWFormFactor:Incoming 19 -521
 newdef ISGWFormFactor:Outgoing 19 -321
 newdef ISGWFormFactor:Spin 19 0
 newdef ISGWFormFactor:Spectator 19 -2
 newdef ISGWFormFactor:InQuark 19 5
 newdef ISGWFormFactor:OutQuark 19 3
 newdef ISGWFormFactor:Incoming 20 -521
 newdef ISGWFormFactor:Outgoing 20 -323
 newdef ISGWFormFactor:Spin 20 1
 newdef ISGWFormFactor:Spectator 20 -2
 newdef ISGWFormFactor:InQuark 20 5
 newdef ISGWFormFactor:OutQuark 20 3
 newdef ISGWFormFactor:Incoming 21 -521
 newdef ISGWFormFactor:Outgoing 21 -325
 newdef ISGWFormFactor:Spin 21 2
 newdef ISGWFormFactor:Spectator 21 -2
 newdef ISGWFormFactor:InQuark 21 5
 newdef ISGWFormFactor:OutQuark 21 3
 newdef ISGWFormFactor:Incoming 22 -521
 newdef ISGWFormFactor:Outgoing 22 -10323
 newdef ISGWFormFactor:Spin 22 1
 newdef ISGWFormFactor:Spectator 22 -2
 newdef ISGWFormFactor:InQuark 22 5
 newdef ISGWFormFactor:OutQuark 22 3
 newdef ISGWFormFactor:Incoming 23 -521
 newdef ISGWFormFactor:Outgoing 23 -20323
 newdef ISGWFormFactor:Spin 23 1
 newdef ISGWFormFactor:Spectator 23 -2
 newdef ISGWFormFactor:InQuark 23 5
 newdef ISGWFormFactor:OutQuark 23 3
 newdef ISGWFormFactor:Incoming 24 -521
 newdef ISGWFormFactor:Outgoing 24 -10321
 newdef ISGWFormFactor:Spin 24 0
 newdef ISGWFormFactor:Spectator 24 -2
 newdef ISGWFormFactor:InQuark 24 5
 newdef ISGWFormFactor:OutQuark 24 3
 newdef ISGWFormFactor:Incoming 25 -521
 newdef ISGWFormFactor:Outgoing 25 421
 newdef ISGWFormFactor:Spin 25 0
 newdef ISGWFormFactor:Spectator 25 -2
 newdef ISGWFormFactor:InQuark 25 5
 newdef ISGWFormFactor:OutQuark 25 4
 newdef ISGWFormFactor:Incoming 26 -521
 newdef ISGWFormFactor:Outgoing 26 423
 newdef ISGWFormFactor:Spin 26 1
 newdef ISGWFormFactor:Spectator 26 -2
 newdef ISGWFormFactor:InQuark 26 5
 newdef ISGWFormFactor:OutQuark 26 4
 newdef ISGWFormFactor:Incoming 27 -521
 newdef ISGWFormFactor:Outgoing 27 425
 newdef ISGWFormFactor:Spin 27 2
 newdef ISGWFormFactor:Spectator 27 -2
 newdef ISGWFormFactor:InQuark 27 5
 newdef ISGWFormFactor:OutQuark 27 4
 newdef ISGWFormFactor:Incoming 28 -521
 newdef ISGWFormFactor:Outgoing 28 10423
 newdef ISGWFormFactor:Spin 28 1
 newdef ISGWFormFactor:Spectator 28 -2
 newdef ISGWFormFactor:InQuark 28 5
 newdef ISGWFormFactor:OutQuark 28 4
 newdef ISGWFormFactor:Incoming 29 -521
 newdef ISGWFormFactor:Outgoing 29 20423
 newdef ISGWFormFactor:Spin 29 1
 newdef ISGWFormFactor:Spectator 29 -2
 newdef ISGWFormFactor:InQuark 29 5
 newdef ISGWFormFactor:OutQuark 29 4
 newdef ISGWFormFactor:Incoming 30 -521
 newdef ISGWFormFactor:Outgoing 30 10421
 newdef ISGWFormFactor:Spin 30 0
 newdef ISGWFormFactor:Spectator 30 -2
 newdef ISGWFormFactor:InQuark 30 5
 newdef ISGWFormFactor:OutQuark 30 4
 newdef ISGWFormFactor:Incoming 31 -511
 newdef ISGWFormFactor:Outgoing 31 221
 newdef ISGWFormFactor:Spin 31 0
 newdef ISGWFormFactor:Spectator 31 1
 newdef ISGWFormFactor:InQuark 31 -5
 newdef ISGWFormFactor:OutQuark 31 -1
 newdef ISGWFormFactor:Incoming 32 -511
 newdef ISGWFormFactor:Outgoing 32 331
 newdef ISGWFormFactor:Spin 32 0
 newdef ISGWFormFactor:Spectator 32 1
 newdef ISGWFormFactor:InQuark 32 -5
 newdef ISGWFormFactor:OutQuark 32 -1
 newdef ISGWFormFactor:Incoming 33 -511
 newdef ISGWFormFactor:Outgoing 33 223
 newdef ISGWFormFactor:Spin 33 1
 newdef ISGWFormFactor:Spectator 33 1
 newdef ISGWFormFactor:InQuark 33 -5
 newdef ISGWFormFactor:OutQuark 33 -1
 newdef ISGWFormFactor:Incoming 34 -511
 newdef ISGWFormFactor:Outgoing 34 225
 newdef ISGWFormFactor:Spin 34 2
 newdef ISGWFormFactor:Spectator 34 1
 newdef ISGWFormFactor:InQuark 34 -5
 newdef ISGWFormFactor:OutQuark 34 -1
 newdef ISGWFormFactor:Incoming 35 -511
 newdef ISGWFormFactor:Outgoing 35 10223
 newdef ISGWFormFactor:Spin 35 1
 newdef ISGWFormFactor:Spectator 35 1
 newdef ISGWFormFactor:InQuark 35 -5
 newdef ISGWFormFactor:OutQuark 35 -1
 newdef ISGWFormFactor:Incoming 36 -511
 newdef ISGWFormFactor:Outgoing 36 20223
 newdef ISGWFormFactor:Spin 36 1
 newdef ISGWFormFactor:Spectator 36 1
 newdef ISGWFormFactor:InQuark 36 -5
 newdef ISGWFormFactor:OutQuark 36 -1
 newdef ISGWFormFactor:Incoming 37 -511
 newdef ISGWFormFactor:Outgoing 37 10221
 newdef ISGWFormFactor:Spin 37 0
 newdef ISGWFormFactor:Spectator 37 1
 newdef ISGWFormFactor:InQuark 37 -5
 newdef ISGWFormFactor:OutQuark 37 -1
 newdef ISGWFormFactor:Incoming 38 -511
 newdef ISGWFormFactor:Outgoing 38 111
 newdef ISGWFormFactor:Spin 38 0
 newdef ISGWFormFactor:Spectator 38 1
 newdef ISGWFormFactor:InQuark 38 -5
 newdef ISGWFormFactor:OutQuark 38 -1
 newdef ISGWFormFactor:Incoming 39 -511
 newdef ISGWFormFactor:Outgoing 39 113
 newdef ISGWFormFactor:Spin 39 1
 newdef ISGWFormFactor:Spectator 39 1
 newdef ISGWFormFactor:InQuark 39 -5
 newdef ISGWFormFactor:OutQuark 39 -1
 newdef ISGWFormFactor:Incoming 40 -511
 newdef ISGWFormFactor:Outgoing 40 115
 newdef ISGWFormFactor:Spin 40 2
 newdef ISGWFormFactor:Spectator 40 1
 newdef ISGWFormFactor:InQuark 40 -5
 newdef ISGWFormFactor:OutQuark 40 -1
 newdef ISGWFormFactor:Incoming 41 -511
 newdef ISGWFormFactor:Outgoing 41 10113
 newdef ISGWFormFactor:Spin 41 1
 newdef ISGWFormFactor:Spectator 41 1
 newdef ISGWFormFactor:InQuark 41 -5
 newdef ISGWFormFactor:OutQuark 41 -1
 newdef ISGWFormFactor:Incoming 42 -511
 newdef ISGWFormFactor:Outgoing 42 20113
 newdef ISGWFormFactor:Spin 42 1
 newdef ISGWFormFactor:Spectator 42 1
 newdef ISGWFormFactor:InQuark 42 -5
 newdef ISGWFormFactor:OutQuark 42 -1
 newdef ISGWFormFactor:Incoming 43 -511
 newdef ISGWFormFactor:Outgoing 43 10111
 newdef ISGWFormFactor:Spin 43 0
 newdef ISGWFormFactor:Spectator 43 1
 newdef ISGWFormFactor:InQuark 43 -5
 newdef ISGWFormFactor:OutQuark 43 -1
 newdef ISGWFormFactor:Incoming 44 -511
 newdef ISGWFormFactor:Outgoing 44 211
 newdef ISGWFormFactor:Spin 44 0
 newdef ISGWFormFactor:Spectator 44 1
 newdef ISGWFormFactor:InQuark 44 -5
 newdef ISGWFormFactor:OutQuark 44 -2
 newdef ISGWFormFactor:Incoming 45 -511
 newdef ISGWFormFactor:Outgoing 45 213
 newdef ISGWFormFactor:Spin 45 1
 newdef ISGWFormFactor:Spectator 45 1
 newdef ISGWFormFactor:InQuark 45 -5
 newdef ISGWFormFactor:OutQuark 45 -2
 newdef ISGWFormFactor:Incoming 46 -511
 newdef ISGWFormFactor:Outgoing 46 215
 newdef ISGWFormFactor:Spin 46 2
 newdef ISGWFormFactor:Spectator 46 1
 newdef ISGWFormFactor:InQuark 46 -5
 newdef ISGWFormFactor:OutQuark 46 -2
 newdef ISGWFormFactor:Incoming 47 -511
 newdef ISGWFormFactor:Outgoing 47 10213
 newdef ISGWFormFactor:Spin 47 1
 newdef ISGWFormFactor:Spectator 47 1
 newdef ISGWFormFactor:InQuark 47 -5
 newdef ISGWFormFactor:OutQuark 47 -2
 newdef ISGWFormFactor:Incoming 48 -511
 newdef ISGWFormFactor:Outgoing 48 20213
 newdef ISGWFormFactor:Spin 48 1
 newdef ISGWFormFactor:Spectator 48 1
 newdef ISGWFormFactor:InQuark 48 -5
 newdef ISGWFormFactor:OutQuark 48 -2
 newdef ISGWFormFactor:Incoming 49 -511
 newdef ISGWFormFactor:Outgoing 49 10211
 newdef ISGWFormFactor:Spin 49 0
 newdef ISGWFormFactor:Spectator 49 1
 newdef ISGWFormFactor:InQuark 49 -5
 newdef ISGWFormFactor:OutQuark 49 -2
 newdef ISGWFormFactor:Incoming 50 -511
 newdef ISGWFormFactor:Outgoing 50 311
 newdef ISGWFormFactor:Spin 50 0
 newdef ISGWFormFactor:Spectator 50 1
 newdef ISGWFormFactor:InQuark 50 -5
 newdef ISGWFormFactor:OutQuark 50 -3
 newdef ISGWFormFactor:Incoming 51 -511
 newdef ISGWFormFactor:Outgoing 51 313
 newdef ISGWFormFactor:Spin 51 1
 newdef ISGWFormFactor:Spectator 51 1
 newdef ISGWFormFactor:InQuark 51 -5
 newdef ISGWFormFactor:OutQuark 51 -3
 newdef ISGWFormFactor:Incoming 52 -511
 newdef ISGWFormFactor:Outgoing 52 315
 newdef ISGWFormFactor:Spin 52 2
 newdef ISGWFormFactor:Spectator 52 1
 newdef ISGWFormFactor:InQuark 52 -5
 newdef ISGWFormFactor:OutQuark 52 -3
 newdef ISGWFormFactor:Incoming 53 -511
 newdef ISGWFormFactor:Outgoing 53 10313
 newdef ISGWFormFactor:Spin 53 1
 newdef ISGWFormFactor:Spectator 53 1
 newdef ISGWFormFactor:InQuark 53 -5
 newdef ISGWFormFactor:OutQuark 53 -3
 newdef ISGWFormFactor:Incoming 54 -511
 newdef ISGWFormFactor:Outgoing 54 20313
 newdef ISGWFormFactor:Spin 54 1
 newdef ISGWFormFactor:Spectator 54 1
 newdef ISGWFormFactor:InQuark 54 -5
 newdef ISGWFormFactor:OutQuark 54 -3
 newdef ISGWFormFactor:Incoming 55 -511
 newdef ISGWFormFactor:Outgoing 55 10311
 newdef ISGWFormFactor:Spin 55 0
 newdef ISGWFormFactor:Spectator 55 1
 newdef ISGWFormFactor:InQuark 55 -5
 newdef ISGWFormFactor:OutQuark 55 -3
 newdef ISGWFormFactor:Incoming 56 -511
 newdef ISGWFormFactor:Outgoing 56 411
 newdef ISGWFormFactor:Spin 56 0
 newdef ISGWFormFactor:Spectator 56 1
 newdef ISGWFormFactor:InQuark 56 -5
 newdef ISGWFormFactor:OutQuark 56 -4
 newdef ISGWFormFactor:Incoming 57 -511
 newdef ISGWFormFactor:Outgoing 57 413
 newdef ISGWFormFactor:Spin 57 1
 newdef ISGWFormFactor:Spectator 57 1
 newdef ISGWFormFactor:InQuark 57 -5
 newdef ISGWFormFactor:OutQuark 57 -4
 newdef ISGWFormFactor:Incoming 58 -511
 newdef ISGWFormFactor:Outgoing 58 415
 newdef ISGWFormFactor:Spin 58 2
 newdef ISGWFormFactor:Spectator 58 1
 newdef ISGWFormFactor:InQuark 58 -5
 newdef ISGWFormFactor:OutQuark 58 -4
 newdef ISGWFormFactor:Incoming 59 -511
 newdef ISGWFormFactor:Outgoing 59 10413
 newdef ISGWFormFactor:Spin 59 1
 newdef ISGWFormFactor:Spectator 59 1
 newdef ISGWFormFactor:InQuark 59 -5
 newdef ISGWFormFactor:OutQuark 59 -4
 newdef ISGWFormFactor:Incoming 60 -511
 newdef ISGWFormFactor:Outgoing 60 20413
 newdef ISGWFormFactor:Spin 60 1
 newdef ISGWFormFactor:Spectator 60 1
 newdef ISGWFormFactor:InQuark 60 -5
 newdef ISGWFormFactor:OutQuark 60 -4
 newdef ISGWFormFactor:Incoming 61 -511
 newdef ISGWFormFactor:Outgoing 61 10411
 newdef ISGWFormFactor:Spin 61 0
 newdef ISGWFormFactor:Spectator 61 1
 newdef ISGWFormFactor:InQuark 61 -5
 newdef ISGWFormFactor:OutQuark 61 -4
 newdef ISGWFormFactor:Incoming 62 421
 newdef ISGWFormFactor:Outgoing 62 -211
 newdef ISGWFormFactor:Spin 62 0
 newdef ISGWFormFactor:Spectator 62 -2
 newdef ISGWFormFactor:InQuark 62 4
 newdef ISGWFormFactor:OutQuark 62 1
 newdef ISGWFormFactor:Incoming 63 421
 newdef ISGWFormFactor:Outgoing 63 -213
 newdef ISGWFormFactor:Spin 63 1
 newdef ISGWFormFactor:Spectator 63 -2
 newdef ISGWFormFactor:InQuark 63 4
 newdef ISGWFormFactor:OutQuark 63 1
 newdef ISGWFormFactor:Incoming 64 421
 newdef ISGWFormFactor:Outgoing 64 -215
 newdef ISGWFormFactor:Spin 64 2
 newdef ISGWFormFactor:Spectator 64 -2
 newdef ISGWFormFactor:InQuark 64 4
 newdef ISGWFormFactor:OutQuark 64 1
 newdef ISGWFormFactor:Incoming 65 421
 newdef ISGWFormFactor:Outgoing 65 -10213
 newdef ISGWFormFactor:Spin 65 1
 newdef ISGWFormFactor:Spectator 65 -2
 newdef ISGWFormFactor:InQuark 65 4
 newdef ISGWFormFactor:OutQuark 65 1
 newdef ISGWFormFactor:Incoming 66 421
 newdef ISGWFormFactor:Outgoing 66 -20213
 newdef ISGWFormFactor:Spin 66 1
 newdef ISGWFormFactor:Spectator 66 -2
 newdef ISGWFormFactor:InQuark 66 4
 newdef ISGWFormFactor:OutQuark 66 1
 newdef ISGWFormFactor:Incoming 67 421
 newdef ISGWFormFactor:Outgoing 67 -10211
 newdef ISGWFormFactor:Spin 67 0
 newdef ISGWFormFactor:Spectator 67 -2
 newdef ISGWFormFactor:InQuark 67 4
 newdef ISGWFormFactor:OutQuark 67 1
 newdef ISGWFormFactor:Incoming 68 421
 newdef ISGWFormFactor:Outgoing 68 111
 newdef ISGWFormFactor:Spin 68 0
 newdef ISGWFormFactor:Spectator 68 -2
 newdef ISGWFormFactor:InQuark 68 4
 newdef ISGWFormFactor:OutQuark 68 2
 newdef ISGWFormFactor:Incoming 69 421
 newdef ISGWFormFactor:Outgoing 69 113
 newdef ISGWFormFactor:Spin 69 1
 newdef ISGWFormFactor:Spectator 69 -2
 newdef ISGWFormFactor:InQuark 69 4
 newdef ISGWFormFactor:OutQuark 69 2
 newdef ISGWFormFactor:Incoming 70 421
 newdef ISGWFormFactor:Outgoing 70 115
 newdef ISGWFormFactor:Spin 70 2
 newdef ISGWFormFactor:Spectator 70 -2
 newdef ISGWFormFactor:InQuark 70 4
 newdef ISGWFormFactor:OutQuark 70 2
 newdef ISGWFormFactor:Incoming 71 421
 newdef ISGWFormFactor:Outgoing 71 10113
 newdef ISGWFormFactor:Spin 71 1
 newdef ISGWFormFactor:Spectator 71 -2
 newdef ISGWFormFactor:InQuark 71 4
 newdef ISGWFormFactor:OutQuark 71 2
 newdef ISGWFormFactor:Incoming 72 421
 newdef ISGWFormFactor:Outgoing 72 20113
 newdef ISGWFormFactor:Spin 72 1
 newdef ISGWFormFactor:Spectator 72 -2
 newdef ISGWFormFactor:InQuark 72 4
 newdef ISGWFormFactor:OutQuark 72 2
 newdef ISGWFormFactor:Incoming 73 421
 newdef ISGWFormFactor:Outgoing 73 10111
 newdef ISGWFormFactor:Spin 73 0
 newdef ISGWFormFactor:Spectator 73 -2
 newdef ISGWFormFactor:InQuark 73 4
 newdef ISGWFormFactor:OutQuark 73 2
 newdef ISGWFormFactor:Incoming 74 421
 newdef ISGWFormFactor:Outgoing 74 221
 newdef ISGWFormFactor:Spin 74 0
 newdef ISGWFormFactor:Spectator 74 -2
 newdef ISGWFormFactor:InQuark 74 4
 newdef ISGWFormFactor:OutQuark 74 2
 newdef ISGWFormFactor:Incoming 75 421
 newdef ISGWFormFactor:Outgoing 75 331
 newdef ISGWFormFactor:Spin 75 0
 newdef ISGWFormFactor:Spectator 75 -2
 newdef ISGWFormFactor:InQuark 75 4
 newdef ISGWFormFactor:OutQuark 75 2
 newdef ISGWFormFactor:Incoming 76 421
 newdef ISGWFormFactor:Outgoing 76 223
 newdef ISGWFormFactor:Spin 76 1
 newdef ISGWFormFactor:Spectator 76 -2
 newdef ISGWFormFactor:InQuark 76 4
 newdef ISGWFormFactor:OutQuark 76 2
 newdef ISGWFormFactor:Incoming 77 421
 newdef ISGWFormFactor:Outgoing 77 225
 newdef ISGWFormFactor:Spin 77 2
 newdef ISGWFormFactor:Spectator 77 -2
 newdef ISGWFormFactor:InQuark 77 4
 newdef ISGWFormFactor:OutQuark 77 2
 newdef ISGWFormFactor:Incoming 78 421
 newdef ISGWFormFactor:Outgoing 78 10223
 newdef ISGWFormFactor:Spin 78 1
 newdef ISGWFormFactor:Spectator 78 -2
 newdef ISGWFormFactor:InQuark 78 4
 newdef ISGWFormFactor:OutQuark 78 2
 newdef ISGWFormFactor:Incoming 79 421
 newdef ISGWFormFactor:Outgoing 79 20223
 newdef ISGWFormFactor:Spin 79 1
 newdef ISGWFormFactor:Spectator 79 -2
 newdef ISGWFormFactor:InQuark 79 4
 newdef ISGWFormFactor:OutQuark 79 2
 newdef ISGWFormFactor:Incoming 80 421
 newdef ISGWFormFactor:Outgoing 80 10221
 newdef ISGWFormFactor:Spin 80 0
 newdef ISGWFormFactor:Spectator 80 -2
 newdef ISGWFormFactor:InQuark 80 4
 newdef ISGWFormFactor:OutQuark 80 2
 newdef ISGWFormFactor:Incoming 81 421
 newdef ISGWFormFactor:Outgoing 81 -321
 newdef ISGWFormFactor:Spin 81 0
 newdef ISGWFormFactor:Spectator 81 -2
 newdef ISGWFormFactor:InQuark 81 4
 newdef ISGWFormFactor:OutQuark 81 3
 newdef ISGWFormFactor:Incoming 82 421
 newdef ISGWFormFactor:Outgoing 82 -323
 newdef ISGWFormFactor:Spin 82 1
 newdef ISGWFormFactor:Spectator 82 -2
 newdef ISGWFormFactor:InQuark 82 4
 newdef ISGWFormFactor:OutQuark 82 3
 newdef ISGWFormFactor:Incoming 83 421
 newdef ISGWFormFactor:Outgoing 83 -325
 newdef ISGWFormFactor:Spin 83 2
 newdef ISGWFormFactor:Spectator 83 -2
 newdef ISGWFormFactor:InQuark 83 4
 newdef ISGWFormFactor:OutQuark 83 3
 newdef ISGWFormFactor:Incoming 84 421
 newdef ISGWFormFactor:Outgoing 84 -10323
 newdef ISGWFormFactor:Spin 84 1
 newdef ISGWFormFactor:Spectator 84 -2
 newdef ISGWFormFactor:InQuark 84 4
 newdef ISGWFormFactor:OutQuark 84 3
 newdef ISGWFormFactor:Incoming 85 421
 newdef ISGWFormFactor:Outgoing 85 -20323
 newdef ISGWFormFactor:Spin 85 1
 newdef ISGWFormFactor:Spectator 85 -2
 newdef ISGWFormFactor:InQuark 85 4
 newdef ISGWFormFactor:OutQuark 85 3
 newdef ISGWFormFactor:Incoming 86 421
 newdef ISGWFormFactor:Outgoing 86 -10321
 newdef ISGWFormFactor:Spin 86 0
 newdef ISGWFormFactor:Spectator 86 -2
 newdef ISGWFormFactor:InQuark 86 4
 newdef ISGWFormFactor:OutQuark 86 3
 newdef ISGWFormFactor:Incoming 87 411
 newdef ISGWFormFactor:Outgoing 87 221
 newdef ISGWFormFactor:Spin 87 0
 newdef ISGWFormFactor:Spectator 87 -1
 newdef ISGWFormFactor:InQuark 87 4
 newdef ISGWFormFactor:OutQuark 87 1
 newdef ISGWFormFactor:Incoming 88 411
 newdef ISGWFormFactor:Outgoing 88 331
 newdef ISGWFormFactor:Spin 88 0
 newdef ISGWFormFactor:Spectator 88 -1
 newdef ISGWFormFactor:InQuark 88 4
 newdef ISGWFormFactor:OutQuark 88 1
 newdef ISGWFormFactor:Incoming 89 411
 newdef ISGWFormFactor:Outgoing 89 223
 newdef ISGWFormFactor:Spin 89 1
 newdef ISGWFormFactor:Spectator 89 -1
 newdef ISGWFormFactor:InQuark 89 4
 newdef ISGWFormFactor:OutQuark 89 1
 newdef ISGWFormFactor:Incoming 90 411
 newdef ISGWFormFactor:Outgoing 90 225
 newdef ISGWFormFactor:Spin 90 2
 newdef ISGWFormFactor:Spectator 90 -1
 newdef ISGWFormFactor:InQuark 90 4
 newdef ISGWFormFactor:OutQuark 90 1
 newdef ISGWFormFactor:Incoming 91 411
 newdef ISGWFormFactor:Outgoing 91 10223
 newdef ISGWFormFactor:Spin 91 1
 newdef ISGWFormFactor:Spectator 91 -1
 newdef ISGWFormFactor:InQuark 91 4
 newdef ISGWFormFactor:OutQuark 91 1
 newdef ISGWFormFactor:Incoming 92 411
 newdef ISGWFormFactor:Outgoing 92 20223
 newdef ISGWFormFactor:Spin 92 1
 newdef ISGWFormFactor:Spectator 92 -1
 newdef ISGWFormFactor:InQuark 92 4
 newdef ISGWFormFactor:OutQuark 92 1
 newdef ISGWFormFactor:Incoming 93 411
 newdef ISGWFormFactor:Outgoing 93 10221
 newdef ISGWFormFactor:Spin 93 0
 newdef ISGWFormFactor:Spectator 93 -1
 newdef ISGWFormFactor:InQuark 93 4
 newdef ISGWFormFactor:OutQuark 93 1
 newdef ISGWFormFactor:Incoming 94 411
 newdef ISGWFormFactor:Outgoing 94 111
 newdef ISGWFormFactor:Spin 94 0
 newdef ISGWFormFactor:Spectator 94 -1
 newdef ISGWFormFactor:InQuark 94 4
 newdef ISGWFormFactor:OutQuark 94 1
 newdef ISGWFormFactor:Incoming 95 411
 newdef ISGWFormFactor:Outgoing 95 113
 newdef ISGWFormFactor:Spin 95 1
 newdef ISGWFormFactor:Spectator 95 -1
 newdef ISGWFormFactor:InQuark 95 4
 newdef ISGWFormFactor:OutQuark 95 1
 newdef ISGWFormFactor:Incoming 96 411
 newdef ISGWFormFactor:Outgoing 96 115
 newdef ISGWFormFactor:Spin 96 2
 newdef ISGWFormFactor:Spectator 96 -1
 newdef ISGWFormFactor:InQuark 96 4
 newdef ISGWFormFactor:OutQuark 96 1
 newdef ISGWFormFactor:Incoming 97 411
 newdef ISGWFormFactor:Outgoing 97 10113
 newdef ISGWFormFactor:Spin 97 1
 newdef ISGWFormFactor:Spectator 97 -1
 newdef ISGWFormFactor:InQuark 97 4
 newdef ISGWFormFactor:OutQuark 97 1
 newdef ISGWFormFactor:Incoming 98 411
 newdef ISGWFormFactor:Outgoing 98 20113
 newdef ISGWFormFactor:Spin 98 1
 newdef ISGWFormFactor:Spectator 98 -1
 newdef ISGWFormFactor:InQuark 98 4
 newdef ISGWFormFactor:OutQuark 98 1
 newdef ISGWFormFactor:Incoming 99 411
 newdef ISGWFormFactor:Outgoing 99 10111
 newdef ISGWFormFactor:Spin 99 0
 newdef ISGWFormFactor:Spectator 99 -1
 newdef ISGWFormFactor:InQuark 99 4
 newdef ISGWFormFactor:OutQuark 99 1
 newdef ISGWFormFactor:Incoming 100 411
 newdef ISGWFormFactor:Outgoing 100 211
 newdef ISGWFormFactor:Spin 100 0
 newdef ISGWFormFactor:Spectator 100 -1
 newdef ISGWFormFactor:InQuark 100 4
 newdef ISGWFormFactor:OutQuark 100 2
 newdef ISGWFormFactor:Incoming 101 411
 newdef ISGWFormFactor:Outgoing 101 213
 newdef ISGWFormFactor:Spin 101 1
 newdef ISGWFormFactor:Spectator 101 -1
 newdef ISGWFormFactor:InQuark 101 4
 newdef ISGWFormFactor:OutQuark 101 2
 newdef ISGWFormFactor:Incoming 102 411
 newdef ISGWFormFactor:Outgoing 102 215
 newdef ISGWFormFactor:Spin 102 2
 newdef ISGWFormFactor:Spectator 102 -1
 newdef ISGWFormFactor:InQuark 102 4
 newdef ISGWFormFactor:OutQuark 102 2
 newdef ISGWFormFactor:Incoming 103 411
 newdef ISGWFormFactor:Outgoing 103 10213
 newdef ISGWFormFactor:Spin 103 1
 newdef ISGWFormFactor:Spectator 103 -1
 newdef ISGWFormFactor:InQuark 103 4
 newdef ISGWFormFactor:OutQuark 103 2
 newdef ISGWFormFactor:Incoming 104 411
 newdef ISGWFormFactor:Outgoing 104 20213
 newdef ISGWFormFactor:Spin 104 1
 newdef ISGWFormFactor:Spectator 104 -1
 newdef ISGWFormFactor:InQuark 104 4
 newdef ISGWFormFactor:OutQuark 104 2
 newdef ISGWFormFactor:Incoming 105 411
 newdef ISGWFormFactor:Outgoing 105 10211
 newdef ISGWFormFactor:Spin 105 0
 newdef ISGWFormFactor:Spectator 105 -1
 newdef ISGWFormFactor:InQuark 105 4
 newdef ISGWFormFactor:OutQuark 105 2
 newdef ISGWFormFactor:Incoming 106 411
 newdef ISGWFormFactor:Outgoing 106 -311
 newdef ISGWFormFactor:Spin 106 0
 newdef ISGWFormFactor:Spectator 106 -1
 newdef ISGWFormFactor:InQuark 106 4
 newdef ISGWFormFactor:OutQuark 106 3
 newdef ISGWFormFactor:Incoming 107 411
 newdef ISGWFormFactor:Outgoing 107 -313
 newdef ISGWFormFactor:Spin 107 1
 newdef ISGWFormFactor:Spectator 107 -1
 newdef ISGWFormFactor:InQuark 107 4
 newdef ISGWFormFactor:OutQuark 107 3
 newdef ISGWFormFactor:Incoming 108 411
 newdef ISGWFormFactor:Outgoing 108 -315
 newdef ISGWFormFactor:Spin 108 2
 newdef ISGWFormFactor:Spectator 108 -1
 newdef ISGWFormFactor:InQuark 108 4
 newdef ISGWFormFactor:OutQuark 108 3
 newdef ISGWFormFactor:Incoming 109 411
 newdef ISGWFormFactor:Outgoing 109 -10313
 newdef ISGWFormFactor:Spin 109 1
 newdef ISGWFormFactor:Spectator 109 -1
 newdef ISGWFormFactor:InQuark 109 4
 newdef ISGWFormFactor:OutQuark 109 3
 newdef ISGWFormFactor:Incoming 110 411
 newdef ISGWFormFactor:Outgoing 110 -20313
 newdef ISGWFormFactor:Spin 110 1
 newdef ISGWFormFactor:Spectator 110 -1
 newdef ISGWFormFactor:InQuark 110 4
 newdef ISGWFormFactor:OutQuark 110 3
 newdef ISGWFormFactor:Incoming 111 411
 newdef ISGWFormFactor:Outgoing 111 -10311
 newdef ISGWFormFactor:Spin 111 0
 newdef ISGWFormFactor:Spectator 111 -1
 newdef ISGWFormFactor:InQuark 111 4
 newdef ISGWFormFactor:OutQuark 111 3
 newdef ISGW:FormFactor ISGWFormFactor
 #
 create Herwig::SemiLeptonicScalarDecayer  ISGW2
 newdef ISGW2:Iteration 1
 newdef ISGW2:Ntry 500
 newdef ISGW2:Points 10000
 newdef ISGW2:GenerateIntermediates 0
 insert ISGW2:MaximumWeight 0 3.95005e-05
 insert ISGW2:MaximumWeight 1 3.94637e-05
 insert ISGW2:MaximumWeight 2 2.93349e-05
 insert ISGW2:MaximumWeight 3 0.000150493
 insert ISGW2:MaximumWeight 4 0.000150827
 insert ISGW2:MaximumWeight 5 8.10329e-05
 insert ISGW2:MaximumWeight 6 2.3802e-05
 insert ISGW2:MaximumWeight 7 2.26572e-05
 insert ISGW2:MaximumWeight 8 7.1564e-06
 insert ISGW2:MaximumWeight 9 9.89996e-05
 insert ISGW2:MaximumWeight 10 9.64194e-05
 insert ISGW2:MaximumWeight 11 4.2888e-05
 insert ISGW2:MaximumWeight 12 9.44215e-06
 insert ISGW2:MaximumWeight 13 9.51828e-06
 insert ISGW2:MaximumWeight 14 4.50299e-06
 insert ISGW2:MaximumWeight 15 2.20544e-06
 insert ISGW2:MaximumWeight 16 2.24693e-06
 insert ISGW2:MaximumWeight 17 6.73668e-07
 insert ISGW2:MaximumWeight 18 0.021715
 insert ISGW2:MaximumWeight 19 0.0208858
 insert ISGW2:MaximumWeight 20 0.00664402
 insert ISGW2:MaximumWeight 21 0.0255404
 insert ISGW2:MaximumWeight 22 0.025497
 insert ISGW2:MaximumWeight 23 0.00658113
 insert ISGW2:MaximumWeight 24 0.00185728
 insert ISGW2:MaximumWeight 25 0.00183174
 insert ISGW2:MaximumWeight 26 0.000111333
 insert ISGW2:MaximumWeight 27 0.00524991
 insert ISGW2:MaximumWeight 28 0.00484557
 insert ISGW2:MaximumWeight 29 0.000352201
 insert ISGW2:MaximumWeight 30 0.00227392
 insert ISGW2:MaximumWeight 31 0.00224978
 insert ISGW2:MaximumWeight 32 0.000208191
 insert ISGW2:MaximumWeight 33 0.00099356
 insert ISGW2:MaximumWeight 34 0.000945282
 insert ISGW2:MaximumWeight 35 7.59346e-05
 insert ISGW2:MaximumWeight 36 0.00132341
 insert ISGW2:MaximumWeight 37 0.00111119
 insert ISGW2:MaximumWeight 38 0.00169353
 insert ISGW2:MaximumWeight 39 0.00164428
 insert ISGW2:MaximumWeight 40 3.15924e-06
 insert ISGW2:MaximumWeight 41 2.25269e-06
 insert ISGW2:MaximumWeight 42 0.00026745
 insert ISGW2:MaximumWeight 43 0.000246837
 insert ISGW2:MaximumWeight 44 8.41891e-06
 insert ISGW2:MaximumWeight 45 7.91348e-06
 insert ISGW2:MaximumWeight 46 3.28996e-06
 insert ISGW2:MaximumWeight 47 2.30262e-06
 insert ISGW2:MaximumWeight 48 0.0362303
 insert ISGW2:MaximumWeight 49 0.0288704
 insert ISGW2:MaximumWeight 50 0.0365415
 insert ISGW2:MaximumWeight 51 0.0353279
 insert ISGW2:MaximumWeight 52 3.53069e-05
 insert ISGW2:MaximumWeight 53 2.15061e-05
 insert ISGW2:MaximumWeight 54 0.00110415
 insert ISGW2:MaximumWeight 55 0.000809087
 insert ISGW2:MaximumWeight 56 7.615e-06
 insert ISGW2:MaximumWeight 57 5.52131e-06
 insert ISGW2:MaximumWeight 58 2.05362e-05
 insert ISGW2:MaximumWeight 59 1.08796e-05
 insert ISGW2:MaximumWeight 60 0.000383419
 insert ISGW2:MaximumWeight 61 0.000379941
 insert ISGW2:MaximumWeight 62 0.000216721
 insert ISGW2:MaximumWeight 63 0.00290645
 insert ISGW2:MaximumWeight 64 0.00319323
 insert ISGW2:MaximumWeight 65 0.00142608
 insert ISGW2:MaximumWeight 66 0.000114956
 insert ISGW2:MaximumWeight 67 0.000115039
 insert ISGW2:MaximumWeight 68 3.64242e-05
 insert ISGW2:MaximumWeight 69 0.000783639
 insert ISGW2:MaximumWeight 70 0.00078457
 insert ISGW2:MaximumWeight 71 0.000339043
 insert ISGW2:MaximumWeight 72 7.63314e-05
 insert ISGW2:MaximumWeight 73 7.5e-05
 insert ISGW2:MaximumWeight 74 2.61161e-05
 insert ISGW2:MaximumWeight 75 1.9627e-05
 insert ISGW2:MaximumWeight 76 1.93806e-05
 insert ISGW2:MaximumWeight 77 6.61598e-06
 insert ISGW2:MaximumWeight 78 0.0983649
 insert ISGW2:MaximumWeight 79 0.0923127
 insert ISGW2:MaximumWeight 80 0.019695
 insert ISGW2:MaximumWeight 81 0.104439
 insert ISGW2:MaximumWeight 82 0.103932
 insert ISGW2:MaximumWeight 83 0.0256158
 insert ISGW2:MaximumWeight 84 0.03
 insert ISGW2:MaximumWeight 85 0.025
 insert ISGW2:MaximumWeight 86 0.000845781
 insert ISGW2:MaximumWeight 87 0.0212356
 insert ISGW2:MaximumWeight 88 0.0194916
 insert ISGW2:MaximumWeight 89 0.0012394
 insert ISGW2:MaximumWeight 90 0.00345276
 insert ISGW2:MaximumWeight 91 0.00325754
 insert ISGW2:MaximumWeight 92 0.000199332
 insert ISGW2:MaximumWeight 93 0.0040565
 insert ISGW2:MaximumWeight 94 0.00376841
 insert ISGW2:MaximumWeight 95 0.000258548
 insert ISGW2:MaximumWeight 96 0.000260051
 insert ISGW2:MaximumWeight 97 0.000254568
 insert ISGW2:MaximumWeight 98 0.00012644
 insert ISGW2:MaximumWeight 99 0.00014772
 insert ISGW2:MaximumWeight 100 0.000144913
 insert ISGW2:MaximumWeight 101 6.99968e-05
 insert ISGW2:MaximumWeight 102 0.00211882
 insert ISGW2:MaximumWeight 103 0.00173084
 insert ISGW2:MaximumWeight 104 0.00100721
 insert ISGW2:MaximumWeight 105 9.99083e-05
 insert ISGW2:MaximumWeight 106 9.76224e-05
 insert ISGW2:MaximumWeight 107 2.53588e-05
 insert ISGW2:MaximumWeight 108 0.000336413
 insert ISGW2:MaximumWeight 109 0.000331348
 insert ISGW2:MaximumWeight 110 0.00012059
 insert ISGW2:MaximumWeight 111 0.000397433
 insert ISGW2:MaximumWeight 112 0.000454929
 insert ISGW2:MaximumWeight 113 0.000157429
 insert ISGW2:MaximumWeight 114 1.26452e-05
 insert ISGW2:MaximumWeight 115 1.25165e-05
 insert ISGW2:MaximumWeight 116 4.22398e-06
 insert ISGW2:MaximumWeight 117 0.000325529
 insert ISGW2:MaximumWeight 118 0.000317369
 insert ISGW2:MaximumWeight 119 0.000151852
 insert ISGW2:MaximumWeight 120 0.0010775
 insert ISGW2:MaximumWeight 121 0.00123644
 insert ISGW2:MaximumWeight 122 0.000527677
 insert ISGW2:MaximumWeight 123 9.54949e-05
 insert ISGW2:MaximumWeight 124 9.31059e-05
 insert ISGW2:MaximumWeight 125 2.4608e-05
 insert ISGW2:MaximumWeight 126 0.000453889
 insert ISGW2:MaximumWeight 127 0.000481848
 insert ISGW2:MaximumWeight 128 0.00011418
 insert ISGW2:MaximumWeight 129 0.000178262
 insert ISGW2:MaximumWeight 130 0.000177812
 insert ISGW2:MaximumWeight 131 8.26077e-05
 insert ISGW2:MaximumWeight 132 1.11824e-05
 insert ISGW2:MaximumWeight 133 1.11997e-05
 insert ISGW2:MaximumWeight 134 3.32397e-06
 insert ISGW2:MaximumWeight 135 0.127942
 insert ISGW2:MaximumWeight 136 0.119623
 insert ISGW2:MaximumWeight 137 0.0238566
 insert ISGW2:MaximumWeight 138 0.142655
 insert ISGW2:MaximumWeight 139 0.140889
 insert ISGW2:MaximumWeight 140 0.0340506
 insert ISGW2:MaximumWeight 141 0.0134676
 insert ISGW2:MaximumWeight 142 0.0126132
 insert ISGW2:MaximumWeight 143 0.000340657
 insert ISGW2:MaximumWeight 144 0.0174635
 insert ISGW2:MaximumWeight 145 0.0159783
 insert ISGW2:MaximumWeight 146 0.000864979
 insert ISGW2:MaximumWeight 147 0.00297466
 insert ISGW2:MaximumWeight 148 0.0027692
 insert ISGW2:MaximumWeight 149 0.00019588
 insert ISGW2:MaximumWeight 150 0.00298341
 insert ISGW2:MaximumWeight 151 0.00277861
 insert ISGW2:MaximumWeight 152 0.00016309
 insert ISGW2:MaximumWeight 153 0.000600003
 insert ISGW2:MaximumWeight 154 0.000584006
 insert ISGW2:MaximumWeight 155 0.000279706
 insert ISGW2:MaximumWeight 156 0.00220229
 insert ISGW2:MaximumWeight 157 0.00211059
 insert ISGW2:MaximumWeight 158 0.000841777
 insert ISGW2:MaximumWeight 159 0.000174515
 insert ISGW2:MaximumWeight 160 0.000171267
 insert ISGW2:MaximumWeight 161 4.5077e-05
 insert ISGW2:MaximumWeight 162 0.000911064
 insert ISGW2:MaximumWeight 163 0.000879918
 insert ISGW2:MaximumWeight 164 0.000212121
 insert ISGW2:MaximumWeight 165 0.000328061
 insert ISGW2:MaximumWeight 166 0.000327529
 insert ISGW2:MaximumWeight 167 0.000152402
 insert ISGW2:MaximumWeight 168 2.10645e-05
 insert ISGW2:MaximumWeight 169 2.03215e-05
 insert ISGW2:MaximumWeight 170 6.1047e-06
 insert ISGW2:MaximumWeight 171 0.117102
 insert ISGW2:MaximumWeight 172 0.109383
 insert ISGW2:MaximumWeight 173 0.0217237
 insert ISGW2:MaximumWeight 174 0.143488
 insert ISGW2:MaximumWeight 175 0.144097
 insert ISGW2:MaximumWeight 176 0.0335686
 insert ISGW2:MaximumWeight 177 0.0170693
 insert ISGW2:MaximumWeight 178 0.0153559
 insert ISGW2:MaximumWeight 179 0.000359761
 insert ISGW2:MaximumWeight 180 0.0160343
 insert ISGW2:MaximumWeight 181 0.0146767
 insert ISGW2:MaximumWeight 182 0.000791707
 insert ISGW2:MaximumWeight 183 0.00273854
 insert ISGW2:MaximumWeight 184 0.0025512
 insert ISGW2:MaximumWeight 185 0.000181231
 insert ISGW2:MaximumWeight 186 0.00272446
 insert ISGW2:MaximumWeight 187 0.00254633
 insert ISGW2:MaximumWeight 188 0.000149885
 insert ISGW2:MaximumWeight 189 0.00735218
 insert ISGW2:MaximumWeight 190 0.00640181
 insert ISGW2:MaximumWeight 191 0.00289181
 insert ISGW2:MaximumWeight 192 0.00280707
 insert ISGW2:MaximumWeight 193 7.22655e-06
 insert ISGW2:MaximumWeight 194 5.71371e-06
 insert ISGW2:MaximumWeight 195 0.00086489
 insert ISGW2:MaximumWeight 196 0.000689459
 insert ISGW2:MaximumWeight 197 9.66759e-06
 insert ISGW2:MaximumWeight 198 9.21125e-06
 insert ISGW2:MaximumWeight 199 2.21916e-05
 insert ISGW2:MaximumWeight 200 1.67084e-05
 insert ISGW2:MaximumWeight 201 0.0618348
 insert ISGW2:MaximumWeight 202 0.052149
 insert ISGW2:MaximumWeight 203 0.0557922
 insert ISGW2:MaximumWeight 204 0.0438118
 insert ISGW2:MaximumWeight 205 0.116
 insert ISGW2:MaximumWeight 206 0.116357
 insert ISGW2:MaximumWeight 207 0.000106906
 insert ISGW2:MaximumWeight 208 8.05859e-05
 insert ISGW2:MaximumWeight 209 0.00374456
 insert ISGW2:MaximumWeight 210 0.00268945
 insert ISGW2:MaximumWeight 211 0.000780993
 insert ISGW2:MaximumWeight 212 0.000765418
 insert ISGW2:MaximumWeight 213 0.000122102
 insert ISGW2:MaximumWeight 214 8.68203e-05
 insert ISGW2:MaximumWeight 215 0.00809387
 insert ISGW2:MaximumWeight 216 0.00701118
 insert ISGW2:MaximumWeight 217 0.00303307
 insert ISGW2:MaximumWeight 218 0.00292443
 insert ISGW2:MaximumWeight 219 4.67003e-06
 insert ISGW2:MaximumWeight 220 3.16221e-06
 insert ISGW2:MaximumWeight 221 0.000394407
 insert ISGW2:MaximumWeight 222 0.000303672
 insert ISGW2:MaximumWeight 223 0.000436069
 insert ISGW2:MaximumWeight 224 0.000379057
 insert ISGW2:MaximumWeight 225 2.72813e-06
 insert ISGW2:MaximumWeight 226 1.70894e-06
 insert ISGW2:MaximumWeight 227 0.158135
 insert ISGW2:MaximumWeight 228 0.131371
 insert ISGW2:MaximumWeight 229 0.0481235
 insert ISGW2:MaximumWeight 230 0.0467254
 insert ISGW2:MaximumWeight 231 4.57786e-05
 insert ISGW2:MaximumWeight 232 3.12143e-05
 insert ISGW2:MaximumWeight 233 0.00330961
 insert ISGW2:MaximumWeight 234 0.00240096
 insert ISGW2:MaximumWeight 235 2.847e-05
 insert ISGW2:MaximumWeight 236 2.09826e-05
 insert ISGW2:MaximumWeight 237 0.000239374
 insert ISGW2:MaximumWeight 238 0.000174513
 insert ISGW2:MaximumWeight 239 0.00554538
 insert ISGW2:MaximumWeight 240 0.00466466
 insert ISGW2:MaximumWeight 241 0.00109984
 insert ISGW2:MaximumWeight 242 0.000842737
 insert ISGW2:MaximumWeight 243 0.0075
 insert ISGW2:MaximumWeight 244 0.0072
 insert ISGW2:MaximumWeight 245 1.91206e-05
 insert ISGW2:MaximumWeight 246 1.58666e-05
 insert ISGW2:MaximumWeight 247 0.000832562
 insert ISGW2:MaximumWeight 248 0.000669596
 insert ISGW2:MaximumWeight 249 0.000256716
 insert ISGW2:MaximumWeight 250 0.000250306
 insert ISGW2:MaximumWeight 251 2.53586e-06
 insert ISGW2:MaximumWeight 252 1.48864e-06
 insert ISGW2:MaximumWeight 253 0.0103666
 insert ISGW2:MaximumWeight 254 0.00895946
 insert ISGW2:MaximumWeight 255 0.00395922
 insert ISGW2:MaximumWeight 256 0.00378779
 insert ISGW2:MaximumWeight 257 6.20415e-06
 insert ISGW2:MaximumWeight 258 4.24016e-06
 insert ISGW2:MaximumWeight 259 0.0005196
 insert ISGW2:MaximumWeight 260 0.00039878
 insert ISGW2:MaximumWeight 261 0.000567317
 insert ISGW2:MaximumWeight 262 0.000489709
 insert ISGW2:MaximumWeight 263 3.57757e-06
 insert ISGW2:MaximumWeight 264 2.37409e-06
 insert ISGW2:MaximumWeight 265 0.402115
 insert ISGW2:MaximumWeight 266 0.334931
 insert ISGW2:MaximumWeight 267 0.122752
 insert ISGW2:MaximumWeight 268 0.118601
 insert ISGW2:MaximumWeight 269 0.000113546
 insert ISGW2:MaximumWeight 270 9.35595e-05
 insert ISGW2:MaximumWeight 271 0.00851783
 insert ISGW2:MaximumWeight 272 0.00630654
 insert ISGW2:MaximumWeight 273 7.51719e-05
 insert ISGW2:MaximumWeight 274 5.56299e-05
 insert ISGW2:MaximumWeight 275 0.000606862
 insert ISGW2:MaximumWeight 276 0.000454977
 create Herwig::LeptonNeutrinoCurrent ISGW2Current  HwWeakCurrents.so
 newdef ISGW2Current:Quark 0  11
 newdef ISGW2Current:AntiQuark 0  -12
 newdef ISGW2Current:Quark 1  13
 newdef ISGW2Current:AntiQuark 1  -15
 newdef ISGW2Current:Quark 2  15
 newdef ISGW2Current:AntiQuark 2  -16
 newdef ISGW2:Current ISGW2Current
 create Herwig::ISGW2FormFactor ISGW2FormFactor
 newdef ISGW2FormFactor:DownMass 0.33
 newdef ISGW2FormFactor:UpMass 0.33
 newdef ISGW2FormFactor:StrangeMass 0.55
 newdef ISGW2FormFactor:CharmMass 1.82
 newdef ISGW2FormFactor:BottomMass 5.2
 newdef ISGW2FormFactor:Beta1S0ud 0.41
 newdef ISGW2FormFactor:Beta1S0us 0.44
 newdef ISGW2FormFactor:Beta1S0ss 0.53
 newdef ISGW2FormFactor:Beta1S0cu 0.45
 newdef ISGW2FormFactor:Beta1S0cs 0.56
 newdef ISGW2FormFactor:Beta1S0ub 0.43
 newdef ISGW2FormFactor:Beta1S0sb 0.54
 newdef ISGW2FormFactor:Beta1S0cc 0.88
 newdef ISGW2FormFactor:Beta1S0bc 0.92
 newdef ISGW2FormFactor:Beta1Pud  0.28
 newdef ISGW2FormFactor:Beta1Pus  0.3
 newdef ISGW2FormFactor:Beta1Pss  0.33
 newdef ISGW2FormFactor:Beta1Pcu  0.33
 newdef ISGW2FormFactor:Beta1Pcs  0.38
 newdef ISGW2FormFactor:Beta1Pub  0.35
 newdef ISGW2FormFactor:Beta1Psb  0.41
 newdef ISGW2FormFactor:Beta1Pcc  0.52
 newdef ISGW2FormFactor:Beta1Pbc  0.6
 newdef ISGW2FormFactor:Beta3S1ud 0.3
 newdef ISGW2FormFactor:Beta3S1us 0.33
 newdef ISGW2FormFactor:Beta3S1ss 0.37
 newdef ISGW2FormFactor:Beta3S1cu 0.38
 newdef ISGW2FormFactor:Beta3S1cs 0.44
 newdef ISGW2FormFactor:Beta3S1ub 0.4
 newdef ISGW2FormFactor:Beta3S1sb 0.49
 newdef ISGW2FormFactor:Beta3S1cc 0.62
 newdef ISGW2FormFactor:Beta3S1bc 0.75
 newdef ISGW2FormFactor:AlphaCutOff 0.6
 newdef ISGW2FormFactor:CfDrho 0.889
 newdef ISGW2FormFactor:CfDKstar 0.928
 newdef ISGW2FormFactor:CfDsKstar 0.873
 newdef ISGW2FormFactor:CfDsphi 0.911
 newdef ISGW2FormFactor:CfBrho 0.905
 newdef ISGW2FormFactor:CfBDstar 0.989
 newdef ISGW2FormFactor:CfBsKstar 0.892
 newdef ISGW2FormFactor:CfBsDstar 0.984
 newdef ISGW2FormFactor:CfBcDstar 0.868
 newdef ISGW2FormFactor:CfBcpsi 0.967
 newdef ISGW2FormFactor:CfBcBsstar 1
 newdef ISGW2FormFactor:CfBcBstar 1
 newdef ISGW2FormFactor:ThetaEtaEtaPrime -0.349066
 newdef ISGW2FormFactor:Incoming 0 -541
 newdef ISGW2FormFactor:Outgoing 0 -411
 newdef ISGW2FormFactor:Spin 0 0
 newdef ISGW2FormFactor:Spectator 0 -4
 newdef ISGW2FormFactor:InQuark 0 5
 newdef ISGW2FormFactor:OutQuark 0 1
 newdef ISGW2FormFactor:Incoming 1 -541
 newdef ISGW2FormFactor:Outgoing 1 -413
 newdef ISGW2FormFactor:Spin 1 1
 newdef ISGW2FormFactor:Spectator 1 -4
 newdef ISGW2FormFactor:InQuark 1 5
 newdef ISGW2FormFactor:OutQuark 1 1
 newdef ISGW2FormFactor:Incoming 2 -541
 newdef ISGW2FormFactor:Outgoing 2 -415
 newdef ISGW2FormFactor:Spin 2 2
 newdef ISGW2FormFactor:Spectator 2 -4
 newdef ISGW2FormFactor:InQuark 2 5
 newdef ISGW2FormFactor:OutQuark 2 1
 newdef ISGW2FormFactor:Incoming 3 -541
 newdef ISGW2FormFactor:Outgoing 3 10413
 newdef ISGW2FormFactor:Spin 3 1
 newdef ISGW2FormFactor:Spectator 3 -2
 newdef ISGW2FormFactor:InQuark 3 5
 newdef ISGW2FormFactor:OutQuark 3 1
 newdef ISGW2FormFactor:Incoming 4 -541
 newdef ISGW2FormFactor:Outgoing 4 -20413
 newdef ISGW2FormFactor:Spin 4 1
 newdef ISGW2FormFactor:Spectator 4 -4
 newdef ISGW2FormFactor:InQuark 4 5
 newdef ISGW2FormFactor:OutQuark 4 1
 newdef ISGW2FormFactor:Incoming 5 -541
 newdef ISGW2FormFactor:Outgoing 5 10411
 newdef ISGW2FormFactor:Spin 5 0
 newdef ISGW2FormFactor:Spectator 5 4
 newdef ISGW2FormFactor:InQuark 5 5
 newdef ISGW2FormFactor:OutQuark 5 1
 newdef ISGW2FormFactor:Incoming 6 -541
 newdef ISGW2FormFactor:Outgoing 6 -421
 newdef ISGW2FormFactor:Spin 6 0
 newdef ISGW2FormFactor:Spectator 6 -4
 newdef ISGW2FormFactor:InQuark 6 5
 newdef ISGW2FormFactor:OutQuark 6 2
 newdef ISGW2FormFactor:Incoming 7 -541
 newdef ISGW2FormFactor:Outgoing 7 -423
 newdef ISGW2FormFactor:Spin 7 1
 newdef ISGW2FormFactor:Spectator 7 -4
 newdef ISGW2FormFactor:InQuark 7 5
 newdef ISGW2FormFactor:OutQuark 7 2
 newdef ISGW2FormFactor:Incoming 8 -541
 newdef ISGW2FormFactor:Outgoing 8 -425
 newdef ISGW2FormFactor:Spin 8 2
 newdef ISGW2FormFactor:Spectator 8 -4
 newdef ISGW2FormFactor:InQuark 8 5
 newdef ISGW2FormFactor:OutQuark 8 2
 newdef ISGW2FormFactor:Incoming 9 -541
 newdef ISGW2FormFactor:Outgoing 9 -10423
 newdef ISGW2FormFactor:Spin 9 1
 newdef ISGW2FormFactor:Spectator 9 -4
 newdef ISGW2FormFactor:InQuark 9 5
 newdef ISGW2FormFactor:OutQuark 9 2
 newdef ISGW2FormFactor:Incoming 10 -541
 newdef ISGW2FormFactor:Outgoing 10 -20423
 newdef ISGW2FormFactor:Spin 10 1
 newdef ISGW2FormFactor:Spectator 10 -4
 newdef ISGW2FormFactor:InQuark 10 5
 newdef ISGW2FormFactor:OutQuark 10 2
 newdef ISGW2FormFactor:Incoming 11 -541
 newdef ISGW2FormFactor:Outgoing 11 -10421
 newdef ISGW2FormFactor:Spin 11 0
 newdef ISGW2FormFactor:Spectator 11 -4
 newdef ISGW2FormFactor:InQuark 11 5
 newdef ISGW2FormFactor:OutQuark 11 2
 newdef ISGW2FormFactor:Incoming 12 -541
 newdef ISGW2FormFactor:Outgoing 12 -431
 newdef ISGW2FormFactor:Spin 12 0
 newdef ISGW2FormFactor:Spectator 12 -4
 newdef ISGW2FormFactor:InQuark 12 5
 newdef ISGW2FormFactor:OutQuark 12 3
 newdef ISGW2FormFactor:Incoming 13 -541
 newdef ISGW2FormFactor:Outgoing 13 -433
 newdef ISGW2FormFactor:Spin 13 1
 newdef ISGW2FormFactor:Spectator 13 -4
 newdef ISGW2FormFactor:InQuark 13 5
 newdef ISGW2FormFactor:OutQuark 13 3
 newdef ISGW2FormFactor:Incoming 14 -541
 newdef ISGW2FormFactor:Outgoing 14 -435
 newdef ISGW2FormFactor:Spin 14 2
 newdef ISGW2FormFactor:Spectator 14 -4
 newdef ISGW2FormFactor:InQuark 14 5
 newdef ISGW2FormFactor:OutQuark 14 3
 newdef ISGW2FormFactor:Incoming 15 -541
 newdef ISGW2FormFactor:Outgoing 15 -10433
 newdef ISGW2FormFactor:Spin 15 1
 newdef ISGW2FormFactor:Spectator 15 -4
 newdef ISGW2FormFactor:InQuark 15 5
 newdef ISGW2FormFactor:OutQuark 15 3
 newdef ISGW2FormFactor:Incoming 16 -541
 newdef ISGW2FormFactor:Outgoing 16 -20433
 newdef ISGW2FormFactor:Spin 16 1
 newdef ISGW2FormFactor:Spectator 16 -4
 newdef ISGW2FormFactor:InQuark 16 5
 newdef ISGW2FormFactor:OutQuark 16 3
 newdef ISGW2FormFactor:Incoming 17 -541
 newdef ISGW2FormFactor:Outgoing 17 -10431
 newdef ISGW2FormFactor:Spin 17 0
 newdef ISGW2FormFactor:Spectator 17 4
 newdef ISGW2FormFactor:InQuark 17 5
 newdef ISGW2FormFactor:OutQuark 17 3
 newdef ISGW2FormFactor:Incoming 18 -541
 newdef ISGW2FormFactor:Outgoing 18 441
 newdef ISGW2FormFactor:Spin 18 0
 newdef ISGW2FormFactor:Spectator 18 -4
 newdef ISGW2FormFactor:InQuark 18 5
 newdef ISGW2FormFactor:OutQuark 18 4
 newdef ISGW2FormFactor:Incoming 19 -541
 newdef ISGW2FormFactor:Outgoing 19 443
 newdef ISGW2FormFactor:Spin 19 1
 newdef ISGW2FormFactor:Spectator 19 -4
 newdef ISGW2FormFactor:InQuark 19 5
 newdef ISGW2FormFactor:OutQuark 19 4
 newdef ISGW2FormFactor:Incoming 20 -541
 newdef ISGW2FormFactor:Outgoing 20 445
 newdef ISGW2FormFactor:Spin 20 2
 newdef ISGW2FormFactor:Spectator 20 -4
 newdef ISGW2FormFactor:InQuark 20 5
 newdef ISGW2FormFactor:OutQuark 20 4
 newdef ISGW2FormFactor:Incoming 21 -541
 newdef ISGW2FormFactor:Outgoing 21 10443
 newdef ISGW2FormFactor:Spin 21 1
 newdef ISGW2FormFactor:Spectator 21 -4
 newdef ISGW2FormFactor:InQuark 21 5
 newdef ISGW2FormFactor:OutQuark 21 4
 newdef ISGW2FormFactor:Incoming 22 -541
 newdef ISGW2FormFactor:Outgoing 22 20443
 newdef ISGW2FormFactor:Spin 22 1
 newdef ISGW2FormFactor:Spectator 22 -4
 newdef ISGW2FormFactor:InQuark 22 5
 newdef ISGW2FormFactor:OutQuark 22 4
 newdef ISGW2FormFactor:Incoming 23 -541
 newdef ISGW2FormFactor:Outgoing 23 10441
 newdef ISGW2FormFactor:Spin 23 0
 newdef ISGW2FormFactor:Spectator 23 4
 newdef ISGW2FormFactor:InQuark 23 5
 newdef ISGW2FormFactor:OutQuark 23 4
 newdef ISGW2FormFactor:Incoming 24 541
 newdef ISGW2FormFactor:Outgoing 24 511
 newdef ISGW2FormFactor:Spin 24 0
 newdef ISGW2FormFactor:Spectator 24 5
 newdef ISGW2FormFactor:InQuark 24 -4
 newdef ISGW2FormFactor:OutQuark 24 -1
 newdef ISGW2FormFactor:Incoming 25 541
 newdef ISGW2FormFactor:Outgoing 25 513
 newdef ISGW2FormFactor:Spin 25 1
 newdef ISGW2FormFactor:Spectator 25 5
 newdef ISGW2FormFactor:InQuark 25 -4
 newdef ISGW2FormFactor:OutQuark 25 -1
 newdef ISGW2FormFactor:Incoming 26 541
 newdef ISGW2FormFactor:Outgoing 26 515
 newdef ISGW2FormFactor:Spin 26 2
 newdef ISGW2FormFactor:Spectator 26 5
 newdef ISGW2FormFactor:InQuark 26 -4
 newdef ISGW2FormFactor:OutQuark 26 -1
 newdef ISGW2FormFactor:Incoming 27 541
 newdef ISGW2FormFactor:Outgoing 27 10513
 newdef ISGW2FormFactor:Spin 27 1
 newdef ISGW2FormFactor:Spectator 27 5
 newdef ISGW2FormFactor:InQuark 27 -4
 newdef ISGW2FormFactor:OutQuark 27 -1
 newdef ISGW2FormFactor:Incoming 28 541
 newdef ISGW2FormFactor:Outgoing 28 20513
 newdef ISGW2FormFactor:Spin 28 1
 newdef ISGW2FormFactor:Spectator 28 5
 newdef ISGW2FormFactor:InQuark 28 -4
 newdef ISGW2FormFactor:OutQuark 28 -1
 newdef ISGW2FormFactor:Incoming 29 541
 newdef ISGW2FormFactor:Outgoing 29 10511
 newdef ISGW2FormFactor:Spin 29 0
 newdef ISGW2FormFactor:Spectator 29 5
 newdef ISGW2FormFactor:InQuark 29 -4
 newdef ISGW2FormFactor:OutQuark 29 -1
 newdef ISGW2FormFactor:Incoming 30 541
 newdef ISGW2FormFactor:Outgoing 30 521
 newdef ISGW2FormFactor:Spin 30 0
 newdef ISGW2FormFactor:Spectator 30 5
 newdef ISGW2FormFactor:InQuark 30 -4
 newdef ISGW2FormFactor:OutQuark 30 -2
 newdef ISGW2FormFactor:Incoming 31 541
 newdef ISGW2FormFactor:Outgoing 31 523
 newdef ISGW2FormFactor:Spin 31 1
 newdef ISGW2FormFactor:Spectator 31 5
 newdef ISGW2FormFactor:InQuark 31 -4
 newdef ISGW2FormFactor:OutQuark 31 -2
 newdef ISGW2FormFactor:Incoming 32 541
 newdef ISGW2FormFactor:Outgoing 32 525
 newdef ISGW2FormFactor:Spin 32 2
 newdef ISGW2FormFactor:Spectator 32 5
 newdef ISGW2FormFactor:InQuark 32 -4
 newdef ISGW2FormFactor:OutQuark 32 -2
 newdef ISGW2FormFactor:Incoming 33 541
 newdef ISGW2FormFactor:Outgoing 33 10523
 newdef ISGW2FormFactor:Spin 33 1
 newdef ISGW2FormFactor:Spectator 33 5
 newdef ISGW2FormFactor:InQuark 33 -4
 newdef ISGW2FormFactor:OutQuark 33 -2
 newdef ISGW2FormFactor:Incoming 34 541
 newdef ISGW2FormFactor:Outgoing 34 20523
 newdef ISGW2FormFactor:Spin 34 1
 newdef ISGW2FormFactor:Spectator 34 5
 newdef ISGW2FormFactor:InQuark 34 -4
 newdef ISGW2FormFactor:OutQuark 34 -2
 newdef ISGW2FormFactor:Incoming 35 541
 newdef ISGW2FormFactor:Outgoing 35 10521
 newdef ISGW2FormFactor:Spin 35 0
 newdef ISGW2FormFactor:Spectator 35 5
 newdef ISGW2FormFactor:InQuark 35 -4
 newdef ISGW2FormFactor:OutQuark 35 -2
 newdef ISGW2FormFactor:Incoming 36 541
 newdef ISGW2FormFactor:Outgoing 36 531
 newdef ISGW2FormFactor:Spin 36 0
 newdef ISGW2FormFactor:Spectator 36 5
 newdef ISGW2FormFactor:InQuark 36 -4
 newdef ISGW2FormFactor:OutQuark 36 -3
 newdef ISGW2FormFactor:Incoming 37 541
 newdef ISGW2FormFactor:Outgoing 37 533
 newdef ISGW2FormFactor:Spin 37 1
 newdef ISGW2FormFactor:Spectator 37 5
 newdef ISGW2FormFactor:InQuark 37 -4
 newdef ISGW2FormFactor:OutQuark 37 -3
 newdef ISGW2FormFactor:Incoming 38 541
 newdef ISGW2FormFactor:Outgoing 38 535
 newdef ISGW2FormFactor:Spin 38 2
 newdef ISGW2FormFactor:Spectator 38 5
 newdef ISGW2FormFactor:InQuark 38 -4
 newdef ISGW2FormFactor:OutQuark 38 -3
 newdef ISGW2FormFactor:Incoming 39 541
 newdef ISGW2FormFactor:Outgoing 39 10533
 newdef ISGW2FormFactor:Spin 39 1
 newdef ISGW2FormFactor:Spectator 39 5
 newdef ISGW2FormFactor:InQuark 39 -4
 newdef ISGW2FormFactor:OutQuark 39 -3
 newdef ISGW2FormFactor:Incoming 40 541
 newdef ISGW2FormFactor:Outgoing 40 20533
 newdef ISGW2FormFactor:Spin 40 1
 newdef ISGW2FormFactor:Spectator 40 5
 newdef ISGW2FormFactor:InQuark 40 -4
 newdef ISGW2FormFactor:OutQuark 40 -3
 newdef ISGW2FormFactor:Incoming 41 541
 newdef ISGW2FormFactor:Outgoing 41 10531
 newdef ISGW2FormFactor:Spin 41 0
 newdef ISGW2FormFactor:Spectator 41 5
 newdef ISGW2FormFactor:InQuark 41 -4
 newdef ISGW2FormFactor:OutQuark 41 -3
 newdef ISGW2FormFactor:Incoming 42 -531
 newdef ISGW2FormFactor:Outgoing 42 311
 newdef ISGW2FormFactor:Spin 42 0
 newdef ISGW2FormFactor:Spectator 42 3
 newdef ISGW2FormFactor:InQuark 42 -5
 newdef ISGW2FormFactor:OutQuark 42 -1
 newdef ISGW2FormFactor:Incoming 43 -531
 newdef ISGW2FormFactor:Outgoing 43 313
 newdef ISGW2FormFactor:Spin 43 1
 newdef ISGW2FormFactor:Spectator 43 3
 newdef ISGW2FormFactor:InQuark 43 -5
 newdef ISGW2FormFactor:OutQuark 43 -1
 newdef ISGW2FormFactor:Incoming 44 -531
 newdef ISGW2FormFactor:Outgoing 44 315
 newdef ISGW2FormFactor:Spin 44 2
 newdef ISGW2FormFactor:Spectator 44 3
 newdef ISGW2FormFactor:InQuark 44 -5
 newdef ISGW2FormFactor:OutQuark 44 -1
 newdef ISGW2FormFactor:Incoming 45 -531
 newdef ISGW2FormFactor:Outgoing 45 10313
 newdef ISGW2FormFactor:Spin 45 1
 newdef ISGW2FormFactor:Spectator 45 3
 newdef ISGW2FormFactor:InQuark 45 -5
 newdef ISGW2FormFactor:OutQuark 45 -1
 newdef ISGW2FormFactor:Incoming 46 -531
 newdef ISGW2FormFactor:Outgoing 46 20313
 newdef ISGW2FormFactor:Spin 46 1
 newdef ISGW2FormFactor:Spectator 46 3
 newdef ISGW2FormFactor:InQuark 46 -5
 newdef ISGW2FormFactor:OutQuark 46 -1
 newdef ISGW2FormFactor:Incoming 47 -531
 newdef ISGW2FormFactor:Outgoing 47 10311
 newdef ISGW2FormFactor:Spin 47 0
 newdef ISGW2FormFactor:Spectator 47 3
 newdef ISGW2FormFactor:InQuark 47 -5
 newdef ISGW2FormFactor:OutQuark 47 -1
 newdef ISGW2FormFactor:Incoming 48 -531
 newdef ISGW2FormFactor:Outgoing 48 321
 newdef ISGW2FormFactor:Spin 48 0
 newdef ISGW2FormFactor:Spectator 48 3
 newdef ISGW2FormFactor:InQuark 48 -5
 newdef ISGW2FormFactor:OutQuark 48 -2
 newdef ISGW2FormFactor:Incoming 49 -531
 newdef ISGW2FormFactor:Outgoing 49 323
 newdef ISGW2FormFactor:Spin 49 1
 newdef ISGW2FormFactor:Spectator 49 3
 newdef ISGW2FormFactor:InQuark 49 -5
 newdef ISGW2FormFactor:OutQuark 49 -2
 newdef ISGW2FormFactor:Incoming 50 -531
 newdef ISGW2FormFactor:Outgoing 50 325
 newdef ISGW2FormFactor:Spin 50 2
 newdef ISGW2FormFactor:Spectator 50 3
 newdef ISGW2FormFactor:InQuark 50 -5
 newdef ISGW2FormFactor:OutQuark 50 -2
 newdef ISGW2FormFactor:Incoming 51 -531
 newdef ISGW2FormFactor:Outgoing 51 10323
 newdef ISGW2FormFactor:Spin 51 1
 newdef ISGW2FormFactor:Spectator 51 3
 newdef ISGW2FormFactor:InQuark 51 -5
 newdef ISGW2FormFactor:OutQuark 51 -2
 newdef ISGW2FormFactor:Incoming 52 -531
 newdef ISGW2FormFactor:Outgoing 52 20323
 newdef ISGW2FormFactor:Spin 52 1
 newdef ISGW2FormFactor:Spectator 52 3
 newdef ISGW2FormFactor:InQuark 52 -5
 newdef ISGW2FormFactor:OutQuark 52 -2
 newdef ISGW2FormFactor:Incoming 53 -531
 newdef ISGW2FormFactor:Outgoing 53 10321
 newdef ISGW2FormFactor:Spin 53 0
 newdef ISGW2FormFactor:Spectator 53 3
 newdef ISGW2FormFactor:InQuark 53 -5
 newdef ISGW2FormFactor:OutQuark 53 -2
 newdef ISGW2FormFactor:Incoming 54 -531
 newdef ISGW2FormFactor:Outgoing 54 221
 newdef ISGW2FormFactor:Spin 54 0
 newdef ISGW2FormFactor:Spectator 54 3
 newdef ISGW2FormFactor:InQuark 54 -5
 newdef ISGW2FormFactor:OutQuark 54 -3
 newdef ISGW2FormFactor:Incoming 55 -531
 newdef ISGW2FormFactor:Outgoing 55 331
 newdef ISGW2FormFactor:Spin 55 0
 newdef ISGW2FormFactor:Spectator 55 3
 newdef ISGW2FormFactor:InQuark 55 -5
 newdef ISGW2FormFactor:OutQuark 55 -3
 newdef ISGW2FormFactor:Incoming 56 -531
 newdef ISGW2FormFactor:Outgoing 56 333
 newdef ISGW2FormFactor:Spin 56 1
 newdef ISGW2FormFactor:Spectator 56 3
 newdef ISGW2FormFactor:InQuark 56 -5
 newdef ISGW2FormFactor:OutQuark 56 -3
 newdef ISGW2FormFactor:Incoming 57 -531
 newdef ISGW2FormFactor:Outgoing 57 335
 newdef ISGW2FormFactor:Spin 57 2
 newdef ISGW2FormFactor:Spectator 57 3
 newdef ISGW2FormFactor:InQuark 57 -5
 newdef ISGW2FormFactor:OutQuark 57 -3
 newdef ISGW2FormFactor:Incoming 58 -531
 newdef ISGW2FormFactor:Outgoing 58 10333
 newdef ISGW2FormFactor:Spin 58 1
 newdef ISGW2FormFactor:Spectator 58 3
 newdef ISGW2FormFactor:InQuark 58 -5
 newdef ISGW2FormFactor:OutQuark 58 -3
 newdef ISGW2FormFactor:Incoming 59 -531
 newdef ISGW2FormFactor:Outgoing 59 20333
 newdef ISGW2FormFactor:Spin 59 1
 newdef ISGW2FormFactor:Spectator 59 3
 newdef ISGW2FormFactor:InQuark 59 -5
 newdef ISGW2FormFactor:OutQuark 59 -3
 newdef ISGW2FormFactor:Incoming 60 -531
 newdef ISGW2FormFactor:Outgoing 60 10331
 newdef ISGW2FormFactor:Spin 60 0
 newdef ISGW2FormFactor:Spectator 60 3
 newdef ISGW2FormFactor:InQuark 60 -5
 newdef ISGW2FormFactor:OutQuark 60 -3
 newdef ISGW2FormFactor:Incoming 61 -531
 newdef ISGW2FormFactor:Outgoing 61 431
 newdef ISGW2FormFactor:Spin 61 0
 newdef ISGW2FormFactor:Spectator 61 3
 newdef ISGW2FormFactor:InQuark 61 -5
 newdef ISGW2FormFactor:OutQuark 61 -4
 newdef ISGW2FormFactor:Incoming 62 -531
 newdef ISGW2FormFactor:Outgoing 62 433
 newdef ISGW2FormFactor:Spin 62 1
 newdef ISGW2FormFactor:Spectator 62 3
 newdef ISGW2FormFactor:InQuark 62 -5
 newdef ISGW2FormFactor:OutQuark 62 -4
 newdef ISGW2FormFactor:Incoming 63 -531
 newdef ISGW2FormFactor:Outgoing 63 435
 newdef ISGW2FormFactor:Spin 63 2
 newdef ISGW2FormFactor:Spectator 63 3
 newdef ISGW2FormFactor:InQuark 63 -5
 newdef ISGW2FormFactor:OutQuark 63 -4
 newdef ISGW2FormFactor:Incoming 64 -531
 newdef ISGW2FormFactor:Outgoing 64 10433
 newdef ISGW2FormFactor:Spin 64 1
 newdef ISGW2FormFactor:Spectator 64 3
 newdef ISGW2FormFactor:InQuark 64 -5
 newdef ISGW2FormFactor:OutQuark 64 -4
 newdef ISGW2FormFactor:Incoming 65 -531
 newdef ISGW2FormFactor:Outgoing 65 20433
 newdef ISGW2FormFactor:Spin 65 1
 newdef ISGW2FormFactor:Spectator 65 3
 newdef ISGW2FormFactor:InQuark 65 -5
 newdef ISGW2FormFactor:OutQuark 65 -4
 newdef ISGW2FormFactor:Incoming 66 -531
 newdef ISGW2FormFactor:Outgoing 66 10431
 newdef ISGW2FormFactor:Spin 66 0
 newdef ISGW2FormFactor:Spectator 66 3
 newdef ISGW2FormFactor:InQuark 66 -5
 newdef ISGW2FormFactor:OutQuark 66 -4
 newdef ISGW2FormFactor:Incoming 67 -521
 newdef ISGW2FormFactor:Outgoing 67 -211
 newdef ISGW2FormFactor:Spin 67 0
 newdef ISGW2FormFactor:Spectator 67 -2
 newdef ISGW2FormFactor:InQuark 67 5
 newdef ISGW2FormFactor:OutQuark 67 1
 newdef ISGW2FormFactor:Incoming 68 -521
 newdef ISGW2FormFactor:Outgoing 68 -213
 newdef ISGW2FormFactor:Spin 68 1
 newdef ISGW2FormFactor:Spectator 68 -2
 newdef ISGW2FormFactor:InQuark 68 5
 newdef ISGW2FormFactor:OutQuark 68 1
 newdef ISGW2FormFactor:Incoming 69 -521
 newdef ISGW2FormFactor:Outgoing 69 -215
 newdef ISGW2FormFactor:Spin 69 2
 newdef ISGW2FormFactor:Spectator 69 -2
 newdef ISGW2FormFactor:InQuark 69 5
 newdef ISGW2FormFactor:OutQuark 69 1
 newdef ISGW2FormFactor:Incoming 70 -521
 newdef ISGW2FormFactor:Outgoing 70 -10213
 newdef ISGW2FormFactor:Spin 70 1
 newdef ISGW2FormFactor:Spectator 70 -2
 newdef ISGW2FormFactor:InQuark 70 5
 newdef ISGW2FormFactor:OutQuark 70 1
 newdef ISGW2FormFactor:Incoming 71 -521
 newdef ISGW2FormFactor:Outgoing 71 -20213
 newdef ISGW2FormFactor:Spin 71 1
 newdef ISGW2FormFactor:Spectator 71 -2
 newdef ISGW2FormFactor:InQuark 71 5
 newdef ISGW2FormFactor:OutQuark 71 1
 newdef ISGW2FormFactor:Incoming 72 -521
 newdef ISGW2FormFactor:Outgoing 72 -10211
 newdef ISGW2FormFactor:Spin 72 0
 newdef ISGW2FormFactor:Spectator 72 -2
 newdef ISGW2FormFactor:InQuark 72 5
 newdef ISGW2FormFactor:OutQuark 72 1
 newdef ISGW2FormFactor:Incoming 73 -521
 newdef ISGW2FormFactor:Outgoing 73 221
 newdef ISGW2FormFactor:Spin 73 0
 newdef ISGW2FormFactor:Spectator 73 -2
 newdef ISGW2FormFactor:InQuark 73 5
 newdef ISGW2FormFactor:OutQuark 73 2
 newdef ISGW2FormFactor:Incoming 74 -521
 newdef ISGW2FormFactor:Outgoing 74 331
 newdef ISGW2FormFactor:Spin 74 0
 newdef ISGW2FormFactor:Spectator 74 -2
 newdef ISGW2FormFactor:InQuark 74 5
 newdef ISGW2FormFactor:OutQuark 74 2
 newdef ISGW2FormFactor:Incoming 75 -521
 newdef ISGW2FormFactor:Outgoing 75 223
 newdef ISGW2FormFactor:Spin 75 1
 newdef ISGW2FormFactor:Spectator 75 -2
 newdef ISGW2FormFactor:InQuark 75 5
 newdef ISGW2FormFactor:OutQuark 75 2
 newdef ISGW2FormFactor:Incoming 76 -521
 newdef ISGW2FormFactor:Outgoing 76 225
 newdef ISGW2FormFactor:Spin 76 2
 newdef ISGW2FormFactor:Spectator 76 -2
 newdef ISGW2FormFactor:InQuark 76 5
 newdef ISGW2FormFactor:OutQuark 76 2
 newdef ISGW2FormFactor:Incoming 77 -521
 newdef ISGW2FormFactor:Outgoing 77 10223
 newdef ISGW2FormFactor:Spin 77 1
 newdef ISGW2FormFactor:Spectator 77 -2
 newdef ISGW2FormFactor:InQuark 77 5
 newdef ISGW2FormFactor:OutQuark 77 2
 newdef ISGW2FormFactor:Incoming 78 -521
 newdef ISGW2FormFactor:Outgoing 78 20223
 newdef ISGW2FormFactor:Spin 78 1
 newdef ISGW2FormFactor:Spectator 78 -2
 newdef ISGW2FormFactor:InQuark 78 5
 newdef ISGW2FormFactor:OutQuark 78 2
 newdef ISGW2FormFactor:Incoming 79 -521
 newdef ISGW2FormFactor:Outgoing 79 10221
 newdef ISGW2FormFactor:Spin 79 0
 newdef ISGW2FormFactor:Spectator 79 -2
 newdef ISGW2FormFactor:InQuark 79 5
 newdef ISGW2FormFactor:OutQuark 79 2
 newdef ISGW2FormFactor:Incoming 80 -521
 newdef ISGW2FormFactor:Outgoing 80 111
 newdef ISGW2FormFactor:Spin 80 0
 newdef ISGW2FormFactor:Spectator 80 -2
 newdef ISGW2FormFactor:InQuark 80 5
 newdef ISGW2FormFactor:OutQuark 80 2
 newdef ISGW2FormFactor:Incoming 81 -521
 newdef ISGW2FormFactor:Outgoing 81 113
 newdef ISGW2FormFactor:Spin 81 1
 newdef ISGW2FormFactor:Spectator 81 -2
 newdef ISGW2FormFactor:InQuark 81 5
 newdef ISGW2FormFactor:OutQuark 81 2
 newdef ISGW2FormFactor:Incoming 82 -521
 newdef ISGW2FormFactor:Outgoing 82 115
 newdef ISGW2FormFactor:Spin 82 2
 newdef ISGW2FormFactor:Spectator 82 -2
 newdef ISGW2FormFactor:InQuark 82 5
 newdef ISGW2FormFactor:OutQuark 82 2
 newdef ISGW2FormFactor:Incoming 83 -521
 newdef ISGW2FormFactor:Outgoing 83 10113
 newdef ISGW2FormFactor:Spin 83 1
 newdef ISGW2FormFactor:Spectator 83 -2
 newdef ISGW2FormFactor:InQuark 83 5
 newdef ISGW2FormFactor:OutQuark 83 2
 newdef ISGW2FormFactor:Incoming 84 -521
 newdef ISGW2FormFactor:Outgoing 84 20113
 newdef ISGW2FormFactor:Spin 84 1
 newdef ISGW2FormFactor:Spectator 84 -2
 newdef ISGW2FormFactor:InQuark 84 5
 newdef ISGW2FormFactor:OutQuark 84 2
 newdef ISGW2FormFactor:Incoming 85 -521
 newdef ISGW2FormFactor:Outgoing 85 10111
 newdef ISGW2FormFactor:Spin 85 0
 newdef ISGW2FormFactor:Spectator 85 -2
 newdef ISGW2FormFactor:InQuark 85 5
 newdef ISGW2FormFactor:OutQuark 85 2
 newdef ISGW2FormFactor:Incoming 86 -521
 newdef ISGW2FormFactor:Outgoing 86 -321
 newdef ISGW2FormFactor:Spin 86 0
 newdef ISGW2FormFactor:Spectator 86 -2
 newdef ISGW2FormFactor:InQuark 86 5
 newdef ISGW2FormFactor:OutQuark 86 3
 newdef ISGW2FormFactor:Incoming 87 -521
 newdef ISGW2FormFactor:Outgoing 87 -323
 newdef ISGW2FormFactor:Spin 87 1
 newdef ISGW2FormFactor:Spectator 87 -2
 newdef ISGW2FormFactor:InQuark 87 5
 newdef ISGW2FormFactor:OutQuark 87 3
 newdef ISGW2FormFactor:Incoming 88 -521
 newdef ISGW2FormFactor:Outgoing 88 -325
 newdef ISGW2FormFactor:Spin 88 2
 newdef ISGW2FormFactor:Spectator 88 -2
 newdef ISGW2FormFactor:InQuark 88 5
 newdef ISGW2FormFactor:OutQuark 88 3
 newdef ISGW2FormFactor:Incoming 89 -521
 newdef ISGW2FormFactor:Outgoing 89 -10323
 newdef ISGW2FormFactor:Spin 89 1
 newdef ISGW2FormFactor:Spectator 89 -2
 newdef ISGW2FormFactor:InQuark 89 5
 newdef ISGW2FormFactor:OutQuark 89 3
 newdef ISGW2FormFactor:Incoming 90 -521
 newdef ISGW2FormFactor:Outgoing 90 -20323
 newdef ISGW2FormFactor:Spin 90 1
 newdef ISGW2FormFactor:Spectator 90 -2
 newdef ISGW2FormFactor:InQuark 90 5
 newdef ISGW2FormFactor:OutQuark 90 3
 newdef ISGW2FormFactor:Incoming 91 -521
 newdef ISGW2FormFactor:Outgoing 91 -10321
 newdef ISGW2FormFactor:Spin 91 0
 newdef ISGW2FormFactor:Spectator 91 -2
 newdef ISGW2FormFactor:InQuark 91 5
 newdef ISGW2FormFactor:OutQuark 91 3
 newdef ISGW2FormFactor:Incoming 92 -521
 newdef ISGW2FormFactor:Outgoing 92 421
 newdef ISGW2FormFactor:Spin 92 0
 newdef ISGW2FormFactor:Spectator 92 -2
 newdef ISGW2FormFactor:InQuark 92 5
 newdef ISGW2FormFactor:OutQuark 92 4
 newdef ISGW2FormFactor:Incoming 93 -521
 newdef ISGW2FormFactor:Outgoing 93 423
 newdef ISGW2FormFactor:Spin 93 1
 newdef ISGW2FormFactor:Spectator 93 -2
 newdef ISGW2FormFactor:InQuark 93 5
 newdef ISGW2FormFactor:OutQuark 93 4
 newdef ISGW2FormFactor:Incoming 94 -521
 newdef ISGW2FormFactor:Outgoing 94 425
 newdef ISGW2FormFactor:Spin 94 2
 newdef ISGW2FormFactor:Spectator 94 -2
 newdef ISGW2FormFactor:InQuark 94 5
 newdef ISGW2FormFactor:OutQuark 94 4
 newdef ISGW2FormFactor:Incoming 95 -521
 newdef ISGW2FormFactor:Outgoing 95 10423
 newdef ISGW2FormFactor:Spin 95 1
 newdef ISGW2FormFactor:Spectator 95 -2
 newdef ISGW2FormFactor:InQuark 95 5
 newdef ISGW2FormFactor:OutQuark 95 4
 newdef ISGW2FormFactor:Incoming 96 -521
 newdef ISGW2FormFactor:Outgoing 96 20423
 newdef ISGW2FormFactor:Spin 96 1
 newdef ISGW2FormFactor:Spectator 96 -2
 newdef ISGW2FormFactor:InQuark 96 5
 newdef ISGW2FormFactor:OutQuark 96 4
 newdef ISGW2FormFactor:Incoming 97 -521
 newdef ISGW2FormFactor:Outgoing 97 10421
 newdef ISGW2FormFactor:Spin 97 0
 newdef ISGW2FormFactor:Spectator 97 -2
 newdef ISGW2FormFactor:InQuark 97 5
 newdef ISGW2FormFactor:OutQuark 97 4
 newdef ISGW2FormFactor:Incoming 98 -511
 newdef ISGW2FormFactor:Outgoing 98 221
 newdef ISGW2FormFactor:Spin 98 0
 newdef ISGW2FormFactor:Spectator 98 1
 newdef ISGW2FormFactor:InQuark 98 -5
 newdef ISGW2FormFactor:OutQuark 98 -1
 newdef ISGW2FormFactor:Incoming 99 -511
 newdef ISGW2FormFactor:Outgoing 99 331
 newdef ISGW2FormFactor:Spin 99 0
 newdef ISGW2FormFactor:Spectator 99 1
 newdef ISGW2FormFactor:InQuark 99 -5
 newdef ISGW2FormFactor:OutQuark 99 -1
 newdef ISGW2FormFactor:Incoming 100 -511
 newdef ISGW2FormFactor:Outgoing 100 223
 newdef ISGW2FormFactor:Spin 100 1
 newdef ISGW2FormFactor:Spectator 100 1
 newdef ISGW2FormFactor:InQuark 100 -5
 newdef ISGW2FormFactor:OutQuark 100 -1
 newdef ISGW2FormFactor:Incoming 101 -511
 newdef ISGW2FormFactor:Outgoing 101 225
 newdef ISGW2FormFactor:Spin 101 2
 newdef ISGW2FormFactor:Spectator 101 1
 newdef ISGW2FormFactor:InQuark 101 -5
 newdef ISGW2FormFactor:OutQuark 101 -1
 newdef ISGW2FormFactor:Incoming 102 -511
 newdef ISGW2FormFactor:Outgoing 102 10223
 newdef ISGW2FormFactor:Spin 102 1
 newdef ISGW2FormFactor:Spectator 102 1
 newdef ISGW2FormFactor:InQuark 102 -5
 newdef ISGW2FormFactor:OutQuark 102 -1
 newdef ISGW2FormFactor:Incoming 103 -511
 newdef ISGW2FormFactor:Outgoing 103 20223
 newdef ISGW2FormFactor:Spin 103 1
 newdef ISGW2FormFactor:Spectator 103 1
 newdef ISGW2FormFactor:InQuark 103 -5
 newdef ISGW2FormFactor:OutQuark 103 -1
 newdef ISGW2FormFactor:Incoming 104 -511
 newdef ISGW2FormFactor:Outgoing 104 10221
 newdef ISGW2FormFactor:Spin 104 0
 newdef ISGW2FormFactor:Spectator 104 1
 newdef ISGW2FormFactor:InQuark 104 -5
 newdef ISGW2FormFactor:OutQuark 104 -1
 newdef ISGW2FormFactor:Incoming 105 -511
 newdef ISGW2FormFactor:Outgoing 105 111
 newdef ISGW2FormFactor:Spin 105 0
 newdef ISGW2FormFactor:Spectator 105 1
 newdef ISGW2FormFactor:InQuark 105 -5
 newdef ISGW2FormFactor:OutQuark 105 -1
 newdef ISGW2FormFactor:Incoming 106 -511
 newdef ISGW2FormFactor:Outgoing 106 113
 newdef ISGW2FormFactor:Spin 106 1
 newdef ISGW2FormFactor:Spectator 106 1
 newdef ISGW2FormFactor:InQuark 106 -5
 newdef ISGW2FormFactor:OutQuark 106 -1
 newdef ISGW2FormFactor:Incoming 107 -511
 newdef ISGW2FormFactor:Outgoing 107 115
 newdef ISGW2FormFactor:Spin 107 2
 newdef ISGW2FormFactor:Spectator 107 1
 newdef ISGW2FormFactor:InQuark 107 -5
 newdef ISGW2FormFactor:OutQuark 107 -1
 newdef ISGW2FormFactor:Incoming 108 -511
 newdef ISGW2FormFactor:Outgoing 108 10113
 newdef ISGW2FormFactor:Spin 108 1
 newdef ISGW2FormFactor:Spectator 108 1
 newdef ISGW2FormFactor:InQuark 108 -5
 newdef ISGW2FormFactor:OutQuark 108 -1
 newdef ISGW2FormFactor:Incoming 109 -511
 newdef ISGW2FormFactor:Outgoing 109 20113
 newdef ISGW2FormFactor:Spin 109 1
 newdef ISGW2FormFactor:Spectator 109 1
 newdef ISGW2FormFactor:InQuark 109 -5
 newdef ISGW2FormFactor:OutQuark 109 -1
 newdef ISGW2FormFactor:Incoming 110 -511
 newdef ISGW2FormFactor:Outgoing 110 10111
 newdef ISGW2FormFactor:Spin 110 0
 newdef ISGW2FormFactor:Spectator 110 1
 newdef ISGW2FormFactor:InQuark 110 -5
 newdef ISGW2FormFactor:OutQuark 110 -1
 newdef ISGW2FormFactor:Incoming 111 -511
 newdef ISGW2FormFactor:Outgoing 111 211
 newdef ISGW2FormFactor:Spin 111 0
 newdef ISGW2FormFactor:Spectator 111 1
 newdef ISGW2FormFactor:InQuark 111 -5
 newdef ISGW2FormFactor:OutQuark 111 -2
 newdef ISGW2FormFactor:Incoming 112 -511
 newdef ISGW2FormFactor:Outgoing 112 213
 newdef ISGW2FormFactor:Spin 112 1
 newdef ISGW2FormFactor:Spectator 112 1
 newdef ISGW2FormFactor:InQuark 112 -5
 newdef ISGW2FormFactor:OutQuark 112 -2
 newdef ISGW2FormFactor:Incoming 113 -511
 newdef ISGW2FormFactor:Outgoing 113 215
 newdef ISGW2FormFactor:Spin 113 2
 newdef ISGW2FormFactor:Spectator 113 1
 newdef ISGW2FormFactor:InQuark 113 -5
 newdef ISGW2FormFactor:OutQuark 113 -2
 newdef ISGW2FormFactor:Incoming 114 -511
 newdef ISGW2FormFactor:Outgoing 114 10213
 newdef ISGW2FormFactor:Spin 114 1
 newdef ISGW2FormFactor:Spectator 114 1
 newdef ISGW2FormFactor:InQuark 114 -5
 newdef ISGW2FormFactor:OutQuark 114 -2
 newdef ISGW2FormFactor:Incoming 115 -511
 newdef ISGW2FormFactor:Outgoing 115 20213
 newdef ISGW2FormFactor:Spin 115 1
 newdef ISGW2FormFactor:Spectator 115 1
 newdef ISGW2FormFactor:InQuark 115 -5
 newdef ISGW2FormFactor:OutQuark 115 -2
 newdef ISGW2FormFactor:Incoming 116 -511
 newdef ISGW2FormFactor:Outgoing 116 10211
 newdef ISGW2FormFactor:Spin 116 0
 newdef ISGW2FormFactor:Spectator 116 1
 newdef ISGW2FormFactor:InQuark 116 -5
 newdef ISGW2FormFactor:OutQuark 116 -2
 newdef ISGW2FormFactor:Incoming 117 -511
 newdef ISGW2FormFactor:Outgoing 117 311
 newdef ISGW2FormFactor:Spin 117 0
 newdef ISGW2FormFactor:Spectator 117 1
 newdef ISGW2FormFactor:InQuark 117 -5
 newdef ISGW2FormFactor:OutQuark 117 -3
 newdef ISGW2FormFactor:Incoming 118 -511
 newdef ISGW2FormFactor:Outgoing 118 313
 newdef ISGW2FormFactor:Spin 118 1
 newdef ISGW2FormFactor:Spectator 118 1
 newdef ISGW2FormFactor:InQuark 118 -5
 newdef ISGW2FormFactor:OutQuark 118 -3
 newdef ISGW2FormFactor:Incoming 119 -511
 newdef ISGW2FormFactor:Outgoing 119 315
 newdef ISGW2FormFactor:Spin 119 2
 newdef ISGW2FormFactor:Spectator 119 1
 newdef ISGW2FormFactor:InQuark 119 -5
 newdef ISGW2FormFactor:OutQuark 119 -3
 newdef ISGW2FormFactor:Incoming 120 -511
 newdef ISGW2FormFactor:Outgoing 120 10313
 newdef ISGW2FormFactor:Spin 120 1
 newdef ISGW2FormFactor:Spectator 120 1
 newdef ISGW2FormFactor:InQuark 120 -5
 newdef ISGW2FormFactor:OutQuark 120 -3
 newdef ISGW2FormFactor:Incoming 121 -511
 newdef ISGW2FormFactor:Outgoing 121 20313
 newdef ISGW2FormFactor:Spin 121 1
 newdef ISGW2FormFactor:Spectator 121 1
 newdef ISGW2FormFactor:InQuark 121 -5
 newdef ISGW2FormFactor:OutQuark 121 -3
 newdef ISGW2FormFactor:Incoming 122 -511
 newdef ISGW2FormFactor:Outgoing 122 10311
 newdef ISGW2FormFactor:Spin 122 0
 newdef ISGW2FormFactor:Spectator 122 1
 newdef ISGW2FormFactor:InQuark 122 -5
 newdef ISGW2FormFactor:OutQuark 122 -3
 newdef ISGW2FormFactor:Incoming 123 -511
 newdef ISGW2FormFactor:Outgoing 123 411
 newdef ISGW2FormFactor:Spin 123 0
 newdef ISGW2FormFactor:Spectator 123 1
 newdef ISGW2FormFactor:InQuark 123 -5
 newdef ISGW2FormFactor:OutQuark 123 -4
 newdef ISGW2FormFactor:Incoming 124 -511
 newdef ISGW2FormFactor:Outgoing 124 413
 newdef ISGW2FormFactor:Spin 124 1
 newdef ISGW2FormFactor:Spectator 124 1
 newdef ISGW2FormFactor:InQuark 124 -5
 newdef ISGW2FormFactor:OutQuark 124 -4
 newdef ISGW2FormFactor:Incoming 125 -511
 newdef ISGW2FormFactor:Outgoing 125 415
 newdef ISGW2FormFactor:Spin 125 2
 newdef ISGW2FormFactor:Spectator 125 1
 newdef ISGW2FormFactor:InQuark 125 -5
 newdef ISGW2FormFactor:OutQuark 125 -4
 newdef ISGW2FormFactor:Incoming 126 -511
 newdef ISGW2FormFactor:Outgoing 126 10413
 newdef ISGW2FormFactor:Spin 126 1
 newdef ISGW2FormFactor:Spectator 126 1
 newdef ISGW2FormFactor:InQuark 126 -5
 newdef ISGW2FormFactor:OutQuark 126 -4
 newdef ISGW2FormFactor:Incoming 127 -511
 newdef ISGW2FormFactor:Outgoing 127 20413
 newdef ISGW2FormFactor:Spin 127 1
 newdef ISGW2FormFactor:Spectator 127 1
 newdef ISGW2FormFactor:InQuark 127 -5
 newdef ISGW2FormFactor:OutQuark 127 -4
 newdef ISGW2FormFactor:Incoming 128 -511
 newdef ISGW2FormFactor:Outgoing 128 10411
 newdef ISGW2FormFactor:Spin 128 0
 newdef ISGW2FormFactor:Spectator 128 1
 newdef ISGW2FormFactor:InQuark 128 -5
 newdef ISGW2FormFactor:OutQuark 128 -4
 newdef ISGW2FormFactor:Incoming 129 431
 newdef ISGW2FormFactor:Outgoing 129 311
 newdef ISGW2FormFactor:Spin 129 0
 newdef ISGW2FormFactor:Spectator 129 -3
 newdef ISGW2FormFactor:InQuark 129 4
 newdef ISGW2FormFactor:OutQuark 129 1
 newdef ISGW2FormFactor:Incoming 130 431
 newdef ISGW2FormFactor:Outgoing 130 313
 newdef ISGW2FormFactor:Spin 130 1
 newdef ISGW2FormFactor:Spectator 130 -3
 newdef ISGW2FormFactor:InQuark 130 4
 newdef ISGW2FormFactor:OutQuark 130 1
 newdef ISGW2FormFactor:Incoming 131 431
 newdef ISGW2FormFactor:Outgoing 131 315
 newdef ISGW2FormFactor:Spin 131 2
 newdef ISGW2FormFactor:Spectator 131 -3
 newdef ISGW2FormFactor:InQuark 131 4
 newdef ISGW2FormFactor:OutQuark 131 1
 newdef ISGW2FormFactor:Incoming 132 431
 newdef ISGW2FormFactor:Outgoing 132 10313
 newdef ISGW2FormFactor:Spin 132 1
 newdef ISGW2FormFactor:Spectator 132 -3
 newdef ISGW2FormFactor:InQuark 132 4
 newdef ISGW2FormFactor:OutQuark 132 1
 newdef ISGW2FormFactor:Incoming 133 431
 newdef ISGW2FormFactor:Outgoing 133 20313
 newdef ISGW2FormFactor:Spin 133 1
 newdef ISGW2FormFactor:Spectator 133 -3
 newdef ISGW2FormFactor:InQuark 133 4
 newdef ISGW2FormFactor:OutQuark 133 1
 newdef ISGW2FormFactor:Incoming 134 431
 newdef ISGW2FormFactor:Outgoing 134 10311
 newdef ISGW2FormFactor:Spin 134 0
 newdef ISGW2FormFactor:Spectator 134 -3
 newdef ISGW2FormFactor:InQuark 134 4
 newdef ISGW2FormFactor:OutQuark 134 1
 newdef ISGW2FormFactor:Incoming 135 431
 newdef ISGW2FormFactor:Outgoing 135 321
 newdef ISGW2FormFactor:Spin 135 0
 newdef ISGW2FormFactor:Spectator 135 -3
 newdef ISGW2FormFactor:InQuark 135 4
 newdef ISGW2FormFactor:OutQuark 135 2
 newdef ISGW2FormFactor:Incoming 136 431
 newdef ISGW2FormFactor:Outgoing 136 323
 newdef ISGW2FormFactor:Spin 136 1
 newdef ISGW2FormFactor:Spectator 136 -3
 newdef ISGW2FormFactor:InQuark 136 4
 newdef ISGW2FormFactor:OutQuark 136 2
 newdef ISGW2FormFactor:Incoming 137 431
 newdef ISGW2FormFactor:Outgoing 137 325
 newdef ISGW2FormFactor:Spin 137 2
 newdef ISGW2FormFactor:Spectator 137 -3
 newdef ISGW2FormFactor:InQuark 137 4
 newdef ISGW2FormFactor:OutQuark 137 2
 newdef ISGW2FormFactor:Incoming 138 431
 newdef ISGW2FormFactor:Outgoing 138 10323
 newdef ISGW2FormFactor:Spin 138 1
 newdef ISGW2FormFactor:Spectator 138 -3
 newdef ISGW2FormFactor:InQuark 138 4
 newdef ISGW2FormFactor:OutQuark 138 2
 newdef ISGW2FormFactor:Incoming 139 431
 newdef ISGW2FormFactor:Outgoing 139 20323
 newdef ISGW2FormFactor:Spin 139 1
 newdef ISGW2FormFactor:Spectator 139 -3
 newdef ISGW2FormFactor:InQuark 139 4
 newdef ISGW2FormFactor:OutQuark 139 2
 newdef ISGW2FormFactor:Incoming 140 431
 newdef ISGW2FormFactor:Outgoing 140 10321
 newdef ISGW2FormFactor:Spin 140 0
 newdef ISGW2FormFactor:Spectator 140 -3
 newdef ISGW2FormFactor:InQuark 140 4
 newdef ISGW2FormFactor:OutQuark 140 2
 newdef ISGW2FormFactor:Incoming 141 431
 newdef ISGW2FormFactor:Outgoing 141 221
 newdef ISGW2FormFactor:Spin 141 0
 newdef ISGW2FormFactor:Spectator 141 -3
 newdef ISGW2FormFactor:InQuark 141 4
 newdef ISGW2FormFactor:OutQuark 141 3
 newdef ISGW2FormFactor:Incoming 142 431
 newdef ISGW2FormFactor:Outgoing 142 331
 newdef ISGW2FormFactor:Spin 142 0
 newdef ISGW2FormFactor:Spectator 142 -3
 newdef ISGW2FormFactor:InQuark 142 4
 newdef ISGW2FormFactor:OutQuark 142 3
 newdef ISGW2FormFactor:Incoming 143 431
 newdef ISGW2FormFactor:Outgoing 143 333
 newdef ISGW2FormFactor:Spin 143 1
 newdef ISGW2FormFactor:Spectator 143 -3
 newdef ISGW2FormFactor:InQuark 143 4
 newdef ISGW2FormFactor:OutQuark 143 3
 newdef ISGW2FormFactor:Incoming 144 431
 newdef ISGW2FormFactor:Outgoing 144 335
 newdef ISGW2FormFactor:Spin 144 2
 newdef ISGW2FormFactor:Spectator 144 -3
 newdef ISGW2FormFactor:InQuark 144 4
 newdef ISGW2FormFactor:OutQuark 144 3
 newdef ISGW2FormFactor:Incoming 145 431
 newdef ISGW2FormFactor:Outgoing 145 10333
 newdef ISGW2FormFactor:Spin 145 1
 newdef ISGW2FormFactor:Spectator 145 -3
 newdef ISGW2FormFactor:InQuark 145 4
 newdef ISGW2FormFactor:OutQuark 145 3
 newdef ISGW2FormFactor:Incoming 146 431
 newdef ISGW2FormFactor:Outgoing 146 20333
 newdef ISGW2FormFactor:Spin 146 1
 newdef ISGW2FormFactor:Spectator 146 -3
 newdef ISGW2FormFactor:InQuark 146 4
 newdef ISGW2FormFactor:OutQuark 146 3
 newdef ISGW2FormFactor:Incoming 147 431
 newdef ISGW2FormFactor:Outgoing 147 10331
 newdef ISGW2FormFactor:Spin 147 0
 newdef ISGW2FormFactor:Spectator 147 -3
 newdef ISGW2FormFactor:InQuark 147 4
 newdef ISGW2FormFactor:OutQuark 147 3
 newdef ISGW2FormFactor:Incoming 148 421
 newdef ISGW2FormFactor:Outgoing 148 -211
 newdef ISGW2FormFactor:Spin 148 0
 newdef ISGW2FormFactor:Spectator 148 -2
 newdef ISGW2FormFactor:InQuark 148 4
 newdef ISGW2FormFactor:OutQuark 148 1
 newdef ISGW2FormFactor:Incoming 149 421
 newdef ISGW2FormFactor:Outgoing 149 -213
 newdef ISGW2FormFactor:Spin 149 1
 newdef ISGW2FormFactor:Spectator 149 -2
 newdef ISGW2FormFactor:InQuark 149 4
 newdef ISGW2FormFactor:OutQuark 149 1
 newdef ISGW2FormFactor:Incoming 150 421
 newdef ISGW2FormFactor:Outgoing 150 -215
 newdef ISGW2FormFactor:Spin 150 2
 newdef ISGW2FormFactor:Spectator 150 -2
 newdef ISGW2FormFactor:InQuark 150 4
 newdef ISGW2FormFactor:OutQuark 150 1
 newdef ISGW2FormFactor:Incoming 151 421
 newdef ISGW2FormFactor:Outgoing 151 -10213
 newdef ISGW2FormFactor:Spin 151 1
 newdef ISGW2FormFactor:Spectator 151 -2
 newdef ISGW2FormFactor:InQuark 151 4
 newdef ISGW2FormFactor:OutQuark 151 1
 newdef ISGW2FormFactor:Incoming 152 421
 newdef ISGW2FormFactor:Outgoing 152 -20213
 newdef ISGW2FormFactor:Spin 152 1
 newdef ISGW2FormFactor:Spectator 152 -2
 newdef ISGW2FormFactor:InQuark 152 4
 newdef ISGW2FormFactor:OutQuark 152 1
 newdef ISGW2FormFactor:Incoming 153 421
 newdef ISGW2FormFactor:Outgoing 153 -10211
 newdef ISGW2FormFactor:Spin 153 0
 newdef ISGW2FormFactor:Spectator 153 -2
 newdef ISGW2FormFactor:InQuark 153 4
 newdef ISGW2FormFactor:OutQuark 153 1
 newdef ISGW2FormFactor:Incoming 154 421
 newdef ISGW2FormFactor:Outgoing 154 111
 newdef ISGW2FormFactor:Spin 154 0
 newdef ISGW2FormFactor:Spectator 154 -2
 newdef ISGW2FormFactor:InQuark 154 4
 newdef ISGW2FormFactor:OutQuark 154 2
 newdef ISGW2FormFactor:Incoming 155 421
 newdef ISGW2FormFactor:Outgoing 155 113
 newdef ISGW2FormFactor:Spin 155 1
 newdef ISGW2FormFactor:Spectator 155 -2
 newdef ISGW2FormFactor:InQuark 155 4
 newdef ISGW2FormFactor:OutQuark 155 2
 newdef ISGW2FormFactor:Incoming 156 421
 newdef ISGW2FormFactor:Outgoing 156 115
 newdef ISGW2FormFactor:Spin 156 2
 newdef ISGW2FormFactor:Spectator 156 -2
 newdef ISGW2FormFactor:InQuark 156 4
 newdef ISGW2FormFactor:OutQuark 156 2
 newdef ISGW2FormFactor:Incoming 157 421
 newdef ISGW2FormFactor:Outgoing 157 10113
 newdef ISGW2FormFactor:Spin 157 1
 newdef ISGW2FormFactor:Spectator 157 -2
 newdef ISGW2FormFactor:InQuark 157 4
 newdef ISGW2FormFactor:OutQuark 157 2
 newdef ISGW2FormFactor:Incoming 158 421
 newdef ISGW2FormFactor:Outgoing 158 20113
 newdef ISGW2FormFactor:Spin 158 1
 newdef ISGW2FormFactor:Spectator 158 -2
 newdef ISGW2FormFactor:InQuark 158 4
 newdef ISGW2FormFactor:OutQuark 158 2
 newdef ISGW2FormFactor:Incoming 159 421
 newdef ISGW2FormFactor:Outgoing 159 10111
 newdef ISGW2FormFactor:Spin 159 0
 newdef ISGW2FormFactor:Spectator 159 -2
 newdef ISGW2FormFactor:InQuark 159 4
 newdef ISGW2FormFactor:OutQuark 159 2
 newdef ISGW2FormFactor:Incoming 160 421
 newdef ISGW2FormFactor:Outgoing 160 221
 newdef ISGW2FormFactor:Spin 160 0
 newdef ISGW2FormFactor:Spectator 160 -2
 newdef ISGW2FormFactor:InQuark 160 4
 newdef ISGW2FormFactor:OutQuark 160 2
 newdef ISGW2FormFactor:Incoming 161 421
 newdef ISGW2FormFactor:Outgoing 161 331
 newdef ISGW2FormFactor:Spin 161 0
 newdef ISGW2FormFactor:Spectator 161 -2
 newdef ISGW2FormFactor:InQuark 161 4
 newdef ISGW2FormFactor:OutQuark 161 2
 newdef ISGW2FormFactor:Incoming 162 421
 newdef ISGW2FormFactor:Outgoing 162 223
 newdef ISGW2FormFactor:Spin 162 1
 newdef ISGW2FormFactor:Spectator 162 -2
 newdef ISGW2FormFactor:InQuark 162 4
 newdef ISGW2FormFactor:OutQuark 162 2
 newdef ISGW2FormFactor:Incoming 163 421
 newdef ISGW2FormFactor:Outgoing 163 225
 newdef ISGW2FormFactor:Spin 163 2
 newdef ISGW2FormFactor:Spectator 163 -2
 newdef ISGW2FormFactor:InQuark 163 4
 newdef ISGW2FormFactor:OutQuark 163 2
 newdef ISGW2FormFactor:Incoming 164 421
 newdef ISGW2FormFactor:Outgoing 164 10223
 newdef ISGW2FormFactor:Spin 164 1
 newdef ISGW2FormFactor:Spectator 164 -2
 newdef ISGW2FormFactor:InQuark 164 4
 newdef ISGW2FormFactor:OutQuark 164 2
 newdef ISGW2FormFactor:Incoming 165 421
 newdef ISGW2FormFactor:Outgoing 165 20223
 newdef ISGW2FormFactor:Spin 165 1
 newdef ISGW2FormFactor:Spectator 165 -2
 newdef ISGW2FormFactor:InQuark 165 4
 newdef ISGW2FormFactor:OutQuark 165 2
 newdef ISGW2FormFactor:Incoming 166 421
 newdef ISGW2FormFactor:Outgoing 166 10221
 newdef ISGW2FormFactor:Spin 166 0
 newdef ISGW2FormFactor:Spectator 166 -2
 newdef ISGW2FormFactor:InQuark 166 4
 newdef ISGW2FormFactor:OutQuark 166 2
 newdef ISGW2FormFactor:Incoming 167 421
 newdef ISGW2FormFactor:Outgoing 167 -321
 newdef ISGW2FormFactor:Spin 167 0
 newdef ISGW2FormFactor:Spectator 167 -2
 newdef ISGW2FormFactor:InQuark 167 4
 newdef ISGW2FormFactor:OutQuark 167 3
 newdef ISGW2FormFactor:Incoming 168 421
 newdef ISGW2FormFactor:Outgoing 168 -323
 newdef ISGW2FormFactor:Spin 168 1
 newdef ISGW2FormFactor:Spectator 168 -2
 newdef ISGW2FormFactor:InQuark 168 4
 newdef ISGW2FormFactor:OutQuark 168 3
 newdef ISGW2FormFactor:Incoming 169 421
 newdef ISGW2FormFactor:Outgoing 169 -325
 newdef ISGW2FormFactor:Spin 169 2
 newdef ISGW2FormFactor:Spectator 169 -2
 newdef ISGW2FormFactor:InQuark 169 4
 newdef ISGW2FormFactor:OutQuark 169 3
 newdef ISGW2FormFactor:Incoming 170 421
 newdef ISGW2FormFactor:Outgoing 170 -10323
 newdef ISGW2FormFactor:Spin 170 1
 newdef ISGW2FormFactor:Spectator 170 -2
 newdef ISGW2FormFactor:InQuark 170 4
 newdef ISGW2FormFactor:OutQuark 170 3
 newdef ISGW2FormFactor:Incoming 171 421
 newdef ISGW2FormFactor:Outgoing 171 -20323
 newdef ISGW2FormFactor:Spin 171 1
 newdef ISGW2FormFactor:Spectator 171 -2
 newdef ISGW2FormFactor:InQuark 171 4
 newdef ISGW2FormFactor:OutQuark 171 3
 newdef ISGW2FormFactor:Incoming 172 421
 newdef ISGW2FormFactor:Outgoing 172 -10321
 newdef ISGW2FormFactor:Spin 172 0
 newdef ISGW2FormFactor:Spectator 172 -2
 newdef ISGW2FormFactor:InQuark 172 4
 newdef ISGW2FormFactor:OutQuark 172 3
 newdef ISGW2FormFactor:Incoming 173 411
 newdef ISGW2FormFactor:Outgoing 173 221
 newdef ISGW2FormFactor:Spin 173 0
 newdef ISGW2FormFactor:Spectator 173 -1
 newdef ISGW2FormFactor:InQuark 173 4
 newdef ISGW2FormFactor:OutQuark 173 1
 newdef ISGW2FormFactor:Incoming 174 411
 newdef ISGW2FormFactor:Outgoing 174 331
 newdef ISGW2FormFactor:Spin 174 0
 newdef ISGW2FormFactor:Spectator 174 -1
 newdef ISGW2FormFactor:InQuark 174 4
 newdef ISGW2FormFactor:OutQuark 174 1
 newdef ISGW2FormFactor:Incoming 175 411
 newdef ISGW2FormFactor:Outgoing 175 223
 newdef ISGW2FormFactor:Spin 175 1
 newdef ISGW2FormFactor:Spectator 175 -1
 newdef ISGW2FormFactor:InQuark 175 4
 newdef ISGW2FormFactor:OutQuark 175 1
 newdef ISGW2FormFactor:Incoming 176 411
 newdef ISGW2FormFactor:Outgoing 176 225
 newdef ISGW2FormFactor:Spin 176 2
 newdef ISGW2FormFactor:Spectator 176 -1
 newdef ISGW2FormFactor:InQuark 176 4
 newdef ISGW2FormFactor:OutQuark 176 1
 newdef ISGW2FormFactor:Incoming 177 411
 newdef ISGW2FormFactor:Outgoing 177 10223
 newdef ISGW2FormFactor:Spin 177 1
 newdef ISGW2FormFactor:Spectator 177 -1
 newdef ISGW2FormFactor:InQuark 177 4
 newdef ISGW2FormFactor:OutQuark 177 1
 newdef ISGW2FormFactor:Incoming 178 411
 newdef ISGW2FormFactor:Outgoing 178 20223
 newdef ISGW2FormFactor:Spin 178 1
 newdef ISGW2FormFactor:Spectator 178 -1
 newdef ISGW2FormFactor:InQuark 178 4
 newdef ISGW2FormFactor:OutQuark 178 1
 newdef ISGW2FormFactor:Incoming 179 411
 newdef ISGW2FormFactor:Outgoing 179 10221
 newdef ISGW2FormFactor:Spin 179 0
 newdef ISGW2FormFactor:Spectator 179 -1
 newdef ISGW2FormFactor:InQuark 179 4
 newdef ISGW2FormFactor:OutQuark 179 1
 newdef ISGW2FormFactor:Incoming 180 411
 newdef ISGW2FormFactor:Outgoing 180 111
 newdef ISGW2FormFactor:Spin 180 0
 newdef ISGW2FormFactor:Spectator 180 -1
 newdef ISGW2FormFactor:InQuark 180 4
 newdef ISGW2FormFactor:OutQuark 180 1
 newdef ISGW2FormFactor:Incoming 181 411
 newdef ISGW2FormFactor:Outgoing 181 113
 newdef ISGW2FormFactor:Spin 181 1
 newdef ISGW2FormFactor:Spectator 181 -1
 newdef ISGW2FormFactor:InQuark 181 4
 newdef ISGW2FormFactor:OutQuark 181 1
 newdef ISGW2FormFactor:Incoming 182 411
 newdef ISGW2FormFactor:Outgoing 182 115
 newdef ISGW2FormFactor:Spin 182 2
 newdef ISGW2FormFactor:Spectator 182 -1
 newdef ISGW2FormFactor:InQuark 182 4
 newdef ISGW2FormFactor:OutQuark 182 1
 newdef ISGW2FormFactor:Incoming 183 411
 newdef ISGW2FormFactor:Outgoing 183 10113
 newdef ISGW2FormFactor:Spin 183 1
 newdef ISGW2FormFactor:Spectator 183 -1
 newdef ISGW2FormFactor:InQuark 183 4
 newdef ISGW2FormFactor:OutQuark 183 1
 newdef ISGW2FormFactor:Incoming 184 411
 newdef ISGW2FormFactor:Outgoing 184 20113
 newdef ISGW2FormFactor:Spin 184 1
 newdef ISGW2FormFactor:Spectator 184 -1
 newdef ISGW2FormFactor:InQuark 184 4
 newdef ISGW2FormFactor:OutQuark 184 1
 newdef ISGW2FormFactor:Incoming 185 411
 newdef ISGW2FormFactor:Outgoing 185 10111
 newdef ISGW2FormFactor:Spin 185 0
 newdef ISGW2FormFactor:Spectator 185 -1
 newdef ISGW2FormFactor:InQuark 185 4
 newdef ISGW2FormFactor:OutQuark 185 1
 newdef ISGW2FormFactor:Incoming 186 411
 newdef ISGW2FormFactor:Outgoing 186 211
 newdef ISGW2FormFactor:Spin 186 0
 newdef ISGW2FormFactor:Spectator 186 -1
 newdef ISGW2FormFactor:InQuark 186 4
 newdef ISGW2FormFactor:OutQuark 186 2
 newdef ISGW2FormFactor:Incoming 187 411
 newdef ISGW2FormFactor:Outgoing 187 213
 newdef ISGW2FormFactor:Spin 187 1
 newdef ISGW2FormFactor:Spectator 187 -1
 newdef ISGW2FormFactor:InQuark 187 4
 newdef ISGW2FormFactor:OutQuark 187 2
 newdef ISGW2FormFactor:Incoming 188 411
 newdef ISGW2FormFactor:Outgoing 188 215
 newdef ISGW2FormFactor:Spin 188 2
 newdef ISGW2FormFactor:Spectator 188 -1
 newdef ISGW2FormFactor:InQuark 188 4
 newdef ISGW2FormFactor:OutQuark 188 2
 newdef ISGW2FormFactor:Incoming 189 411
 newdef ISGW2FormFactor:Outgoing 189 10213
 newdef ISGW2FormFactor:Spin 189 1
 newdef ISGW2FormFactor:Spectator 189 -1
 newdef ISGW2FormFactor:InQuark 189 4
 newdef ISGW2FormFactor:OutQuark 189 2
 newdef ISGW2FormFactor:Incoming 190 411
 newdef ISGW2FormFactor:Outgoing 190 20213
 newdef ISGW2FormFactor:Spin 190 1
 newdef ISGW2FormFactor:Spectator 190 -1
 newdef ISGW2FormFactor:InQuark 190 4
 newdef ISGW2FormFactor:OutQuark 190 2
 newdef ISGW2FormFactor:Incoming 191 411
 newdef ISGW2FormFactor:Outgoing 191 10211
 newdef ISGW2FormFactor:Spin 191 0
 newdef ISGW2FormFactor:Spectator 191 -1
 newdef ISGW2FormFactor:InQuark 191 4
 newdef ISGW2FormFactor:OutQuark 191 2
 newdef ISGW2FormFactor:Incoming 192 411
 newdef ISGW2FormFactor:Outgoing 192 -311
 newdef ISGW2FormFactor:Spin 192 0
 newdef ISGW2FormFactor:Spectator 192 -1
 newdef ISGW2FormFactor:InQuark 192 4
 newdef ISGW2FormFactor:OutQuark 192 3
 newdef ISGW2FormFactor:Incoming 193 411
 newdef ISGW2FormFactor:Outgoing 193 -313
 newdef ISGW2FormFactor:Spin 193 1
 newdef ISGW2FormFactor:Spectator 193 -1
 newdef ISGW2FormFactor:InQuark 193 4
 newdef ISGW2FormFactor:OutQuark 193 3
 newdef ISGW2FormFactor:Incoming 194 411
 newdef ISGW2FormFactor:Outgoing 194 -315
 newdef ISGW2FormFactor:Spin 194 2
 newdef ISGW2FormFactor:Spectator 194 -1
 newdef ISGW2FormFactor:InQuark 194 4
 newdef ISGW2FormFactor:OutQuark 194 3
 newdef ISGW2FormFactor:Incoming 195 411
 newdef ISGW2FormFactor:Outgoing 195 -10313
 newdef ISGW2FormFactor:Spin 195 1
 newdef ISGW2FormFactor:Spectator 195 -1
 newdef ISGW2FormFactor:InQuark 195 4
 newdef ISGW2FormFactor:OutQuark 195 3
 newdef ISGW2FormFactor:Incoming 196 411
 newdef ISGW2FormFactor:Outgoing 196 -20313
 newdef ISGW2FormFactor:Spin 196 1
 newdef ISGW2FormFactor:Spectator 196 -1
 newdef ISGW2FormFactor:InQuark 196 4
 newdef ISGW2FormFactor:OutQuark 196 3
 newdef ISGW2FormFactor:Incoming 197 411
 newdef ISGW2FormFactor:Outgoing 197 -10311
 newdef ISGW2FormFactor:Spin 197 0
 newdef ISGW2FormFactor:Spectator 197 -1
 newdef ISGW2FormFactor:InQuark 197 4
 newdef ISGW2FormFactor:OutQuark 197 3
 newdef ISGW2:FormFactor ISGW2FormFactor
 
 #
 create Herwig::SMZDecayer  ZDecayer
 newdef ZDecayer:AlphaS  /Herwig/Shower/AlphaQCD
 newdef ZDecayer:AlphaEM /Herwig/Shower/AlphaQED
 newdef ZDecayer:QuarkMax 0 3.
 newdef ZDecayer:QuarkMax 1 3.
 newdef ZDecayer:QuarkMax 2 3.
 newdef ZDecayer:QuarkMax 3 3.
 newdef ZDecayer:QuarkMax 4 3.
 newdef ZDecayer:LeptonMax 0 3.
 newdef ZDecayer:LeptonMax 1 3.
 newdef ZDecayer:LeptonMax 2 3.
 newdef ZDecayer:LeptonMax 3 3.
 newdef ZDecayer:LeptonMax 4 3.
 newdef ZDecayer:LeptonMax 5 3.
 newdef ZDecayer:Iteration 1
 newdef ZDecayer:Ntry 500
 newdef ZDecayer:Points 10000
 newdef ZDecayer:GenerateIntermediates 0
 newdef ZDecayer:PhotonGenerator /Herwig/QEDRadiation/SOPHTY
 #
 create Herwig::PVectorMesonVectorPScalarDecayer  PVectorVP
 newdef PVectorVP:Iteration 1
 newdef PVectorVP:Ntry 2500
 newdef PVectorVP:Points 10000
 newdef PVectorVP:GenerateIntermediates 0
 newdef PVectorVP:Incoming 0 10333
 newdef PVectorVP:OutgoingVector 0 313
 newdef PVectorVP:OutgoingPScalar 0 -311
 newdef PVectorVP:Coupling 0 4.889
 newdef PVectorVP:MaxWeight 0 2.44776
 newdef PVectorVP:Incoming 1 10333
 newdef PVectorVP:OutgoingVector 1 323
 newdef PVectorVP:OutgoingPScalar 1 -321
 newdef PVectorVP:Coupling 1 4.156
 newdef PVectorVP:MaxWeight 1 2.51169
 newdef PVectorVP:Incoming 2 10223
 newdef PVectorVP:OutgoingVector 2 113
 newdef PVectorVP:OutgoingPScalar 2 111
 newdef PVectorVP:Coupling 2 4.411
 newdef PVectorVP:MaxWeight 2 3.29541
 newdef PVectorVP:Incoming 3 10223
 newdef PVectorVP:OutgoingVector 3 -213
 newdef PVectorVP:OutgoingPScalar 3 211
 newdef PVectorVP:Coupling 3 4.411
 newdef PVectorVP:MaxWeight 3 3.32547
 newdef PVectorVP:Incoming 4 10113
 newdef PVectorVP:OutgoingVector 4 223
 newdef PVectorVP:OutgoingPScalar 4 111
 newdef PVectorVP:Coupling 4 3.862
 newdef PVectorVP:MaxWeight 4 5.9555
 newdef PVectorVP:Incoming 5 10213
 newdef PVectorVP:OutgoingVector 5 223
 newdef PVectorVP:OutgoingPScalar 5 211
 newdef PVectorVP:Coupling 5 3.862
 newdef PVectorVP:MaxWeight 5 5.6102
 newdef PVectorVP:Incoming 6 10213
 newdef PVectorVP:OutgoingVector 6 22
 newdef PVectorVP:OutgoingPScalar 6 211
 newdef PVectorVP:Coupling 6 0.195
 newdef PVectorVP:MaxWeight 6 1.58726
 newdef PVectorVP:Incoming 7 10433
 newdef PVectorVP:OutgoingVector 7 413
 newdef PVectorVP:OutgoingPScalar 7 311
 newdef PVectorVP:Coupling 7 0.161
 newdef PVectorVP:MaxWeight 7 2.09271
 newdef PVectorVP:Incoming 8 10433
 newdef PVectorVP:OutgoingVector 8 423
 newdef PVectorVP:OutgoingPScalar 8 321
 newdef PVectorVP:Coupling 8 0.161
 newdef PVectorVP:MaxWeight 8 1.62303
 newdef PVectorVP:Incoming 9 20533
 newdef PVectorVP:OutgoingVector 9 513
 newdef PVectorVP:OutgoingPScalar 9 -311
 newdef PVectorVP:Coupling 9 0.389
 newdef PVectorVP:MaxWeight 9 1.57892
 newdef PVectorVP:Incoming 10 20533
 newdef PVectorVP:OutgoingVector 10 523
 newdef PVectorVP:OutgoingPScalar 10 -321
 newdef PVectorVP:Coupling 10 0.389
 newdef PVectorVP:MaxWeight 10 1.65181
 newdef PVectorVP:Incoming 11 10323
 newdef PVectorVP:OutgoingVector 11 213
 newdef PVectorVP:OutgoingPScalar 11 311
 newdef PVectorVP:Coupling 11 4.98
 newdef PVectorVP:MaxWeight 11 2.21683
 newdef PVectorVP:Incoming 12 10323
 newdef PVectorVP:OutgoingVector 12 113
 newdef PVectorVP:OutgoingPScalar 12 321
 newdef PVectorVP:Coupling 12 3.4
 newdef PVectorVP:MaxWeight 12 2.22014
 newdef PVectorVP:Incoming 13 10313
 newdef PVectorVP:OutgoingVector 13 -213
 newdef PVectorVP:OutgoingPScalar 13 321
 newdef PVectorVP:Coupling 13 4.87
 newdef PVectorVP:MaxWeight 13 2.21695
 newdef PVectorVP:Incoming 14 10313
 newdef PVectorVP:OutgoingVector 14 113
 newdef PVectorVP:OutgoingPScalar 14 311
 newdef PVectorVP:Coupling 14 3.55
 newdef PVectorVP:MaxWeight 14 2.21985
 newdef PVectorVP:Incoming 15 20323
 newdef PVectorVP:OutgoingVector 15 213
 newdef PVectorVP:OutgoingPScalar 15 311
 newdef PVectorVP:Coupling 15 0.97
 newdef PVectorVP:MaxWeight 15 2.5873
 newdef PVectorVP:Incoming 16 20323
 newdef PVectorVP:OutgoingVector 16 113
 newdef PVectorVP:OutgoingPScalar 16 321
 newdef PVectorVP:Coupling 16 0.69
 newdef PVectorVP:MaxWeight 16 2.67905
 newdef PVectorVP:Incoming 17 20313
 newdef PVectorVP:OutgoingVector 17 -213
 newdef PVectorVP:OutgoingPScalar 17 321
 newdef PVectorVP:Coupling 17 0.97
 newdef PVectorVP:MaxWeight 17 2.62517
 newdef PVectorVP:Incoming 18 20313
 newdef PVectorVP:OutgoingVector 18 113
 newdef PVectorVP:OutgoingPScalar 18 311
 newdef PVectorVP:Coupling 18 0.707
 newdef PVectorVP:MaxWeight 18 2.67986
 newdef PVectorVP:Incoming 19 10323
 newdef PVectorVP:OutgoingVector 19 223
 newdef PVectorVP:OutgoingPScalar 19 321
 newdef PVectorVP:Coupling 19 4.76
 newdef PVectorVP:MaxWeight 19 3.5592
 newdef PVectorVP:Incoming 20 10313
 newdef PVectorVP:OutgoingVector 20 223
 newdef PVectorVP:OutgoingPScalar 20 311
 newdef PVectorVP:Coupling 20 6
 newdef PVectorVP:MaxWeight 20 3.13577
 newdef PVectorVP:Incoming 21 20323
 newdef PVectorVP:OutgoingVector 21 223
 newdef PVectorVP:OutgoingPScalar 21 321
 newdef PVectorVP:Coupling 21 0.6
 newdef PVectorVP:MaxWeight 21 5.60103
 newdef PVectorVP:Incoming 22 20313
 newdef PVectorVP:OutgoingVector 22 223
 newdef PVectorVP:OutgoingPScalar 22 311
 newdef PVectorVP:Coupling 22 0.6
 newdef PVectorVP:MaxWeight 22 5.65356
 newdef PVectorVP:Incoming 23 10323
 newdef PVectorVP:OutgoingVector 23 313
 newdef PVectorVP:OutgoingPScalar 23 211
 newdef PVectorVP:Coupling 23 0.941
 newdef PVectorVP:MaxWeight 23 3.34513
 newdef PVectorVP:Incoming 24 10323
 newdef PVectorVP:OutgoingVector 24 323
 newdef PVectorVP:OutgoingPScalar 24 111
 newdef PVectorVP:Coupling 24 0.656
 newdef PVectorVP:MaxWeight 24 3.44165
 newdef PVectorVP:Incoming 25 10313
 newdef PVectorVP:OutgoingVector 25 323
 newdef PVectorVP:OutgoingPScalar 25 -211
 newdef PVectorVP:Coupling 25 0.932
 newdef PVectorVP:MaxWeight 25 3.52483
 newdef PVectorVP:Incoming 26 10313
 newdef PVectorVP:OutgoingVector 26 313
 newdef PVectorVP:OutgoingPScalar 26 111
 newdef PVectorVP:Coupling 26 0.658
 newdef PVectorVP:MaxWeight 26 3.35878
 newdef PVectorVP:Incoming 27 20323
 newdef PVectorVP:OutgoingVector 27 313
 newdef PVectorVP:OutgoingPScalar 27 211
 newdef PVectorVP:Coupling 27 2.845
 newdef PVectorVP:MaxWeight 27 6.20364
 newdef PVectorVP:Incoming 28 20323
 newdef PVectorVP:OutgoingVector 28 323
 newdef PVectorVP:OutgoingPScalar 28 111
 newdef PVectorVP:Coupling 28 1.99
 newdef PVectorVP:MaxWeight 28 7.14694
 newdef PVectorVP:Incoming 29 20313
 newdef PVectorVP:OutgoingVector 29 323
 newdef PVectorVP:OutgoingPScalar 29 -211
 newdef PVectorVP:Coupling 29 2.84
 newdef PVectorVP:MaxWeight 29 6.18289
 newdef PVectorVP:Incoming 30 20313
 newdef PVectorVP:OutgoingVector 30 313
 newdef PVectorVP:OutgoingPScalar 30 111
 newdef PVectorVP:Coupling 30 2
 newdef PVectorVP:MaxWeight 30 6.27914
 newdef PVectorVP:Incoming 31 10423
 newdef PVectorVP:OutgoingVector 31 413
 newdef PVectorVP:OutgoingPScalar 31 -211
 newdef PVectorVP:Coupling 31 0.489
 newdef PVectorVP:MaxWeight 31 1.97898
 newdef PVectorVP:Incoming 32 10423
 newdef PVectorVP:OutgoingVector 32 423
 newdef PVectorVP:OutgoingPScalar 32 111
 newdef PVectorVP:Coupling 32 0.347
 newdef PVectorVP:MaxWeight 32 1.76435
 newdef PVectorVP:Incoming 33 10413
 newdef PVectorVP:OutgoingVector 33 423
 newdef PVectorVP:OutgoingPScalar 33 211
 newdef PVectorVP:Coupling 33 0.542
 newdef PVectorVP:MaxWeight 33 1.75368
 newdef PVectorVP:Incoming 34 10413
 newdef PVectorVP:OutgoingVector 34 413
 newdef PVectorVP:OutgoingPScalar 34 111
 newdef PVectorVP:Coupling 34 0.383
 newdef PVectorVP:MaxWeight 34 2.00289
 newdef PVectorVP:Incoming 35 20423
 newdef PVectorVP:OutgoingVector 35 413
 newdef PVectorVP:OutgoingPScalar 35 -211
 newdef PVectorVP:Coupling 35 1.933
 newdef PVectorVP:MaxWeight 35 3.82352
 newdef PVectorVP:Incoming 36 20423
 newdef PVectorVP:OutgoingVector 36 423
 newdef PVectorVP:OutgoingPScalar 36 111
 newdef PVectorVP:Coupling 36 1.367
 newdef PVectorVP:MaxWeight 36 1.81635
 newdef PVectorVP:Incoming 37 20413
 newdef PVectorVP:OutgoingVector 37 423
 newdef PVectorVP:OutgoingPScalar 37 211
 newdef PVectorVP:Coupling 37 1.926
 newdef PVectorVP:MaxWeight 37 1.91055
 newdef PVectorVP:Incoming 38 20413
 newdef PVectorVP:OutgoingVector 38 413
 newdef PVectorVP:OutgoingPScalar 38 111
 newdef PVectorVP:Coupling 38 1.367
 newdef PVectorVP:MaxWeight 38 2.01247
 newdef PVectorVP:Incoming 39 10523
 newdef PVectorVP:OutgoingVector 39 513
 newdef PVectorVP:OutgoingPScalar 39 211
 newdef PVectorVP:Coupling 39 0.13
 newdef PVectorVP:MaxWeight 39 1.5882
 newdef PVectorVP:Incoming 40 10523
 newdef PVectorVP:OutgoingVector 40 523
 newdef PVectorVP:OutgoingPScalar 40 111
 newdef PVectorVP:Coupling 40 0.0924
 newdef PVectorVP:MaxWeight 40 1.61264
 newdef PVectorVP:Incoming 41 10513
 newdef PVectorVP:OutgoingVector 41 523
 newdef PVectorVP:OutgoingPScalar 41 -211
 newdef PVectorVP:Coupling 41 0.13
 newdef PVectorVP:MaxWeight 41 1.58872
 newdef PVectorVP:Incoming 42 10513
 newdef PVectorVP:OutgoingVector 42 513
 newdef PVectorVP:OutgoingPScalar 42 111
 newdef PVectorVP:Coupling 42 0.0924
 newdef PVectorVP:MaxWeight 42 1.61211
 newdef PVectorVP:Incoming 43 20523
 newdef PVectorVP:OutgoingVector 43 513
 newdef PVectorVP:OutgoingPScalar 43 211
 newdef PVectorVP:Coupling 43 0.445
 newdef PVectorVP:MaxWeight 43 1.59926
 newdef PVectorVP:Incoming 44 20523
 newdef PVectorVP:OutgoingVector 44 523
 newdef PVectorVP:OutgoingPScalar 44 111
 newdef PVectorVP:Coupling 44 0.314
 newdef PVectorVP:MaxWeight 44 1.59799
 newdef PVectorVP:Incoming 45 20513
 newdef PVectorVP:OutgoingVector 45 523
 newdef PVectorVP:OutgoingPScalar 45 -211
 newdef PVectorVP:Coupling 45 0.445
 newdef PVectorVP:MaxWeight 45 1.59924
 newdef PVectorVP:Incoming 46 20513
 newdef PVectorVP:OutgoingVector 46 513
 newdef PVectorVP:OutgoingPScalar 46 111
 newdef PVectorVP:Coupling 46 0.314
 newdef PVectorVP:MaxWeight 46 1.59793
 newdef PVectorVP:Incoming 47 20433
 newdef PVectorVP:OutgoingVector 47 433
 newdef PVectorVP:OutgoingPScalar 47 111
 newdef PVectorVP:Coupling 47 0.022
 newdef PVectorVP:MaxWeight 47 1.6163
 newdef PVectorVP:Incoming 48 20433
 newdef PVectorVP:OutgoingVector 48 22
 newdef PVectorVP:OutgoingPScalar 48 431
 newdef PVectorVP:Coupling 48 0.0587
 newdef PVectorVP:MaxWeight 48 1.60079
 newdef PVectorVP:Incoming 49 10533
 newdef PVectorVP:OutgoingVector 49 22
 newdef PVectorVP:OutgoingPScalar 49 531
 newdef PVectorVP:Coupling 49 0.142
 newdef PVectorVP:MaxWeight 49 0.253632
 newdef PVectorVP:Incoming 50 10533
 newdef PVectorVP:OutgoingVector 50 533
 newdef PVectorVP:OutgoingPScalar 50 111
 newdef PVectorVP:Coupling 50 0.0074
 newdef PVectorVP:MaxWeight 50 0.126654
 newdef PVectorVP:Incoming 51 10543
 newdef PVectorVP:OutgoingVector 51 22
 newdef PVectorVP:OutgoingPScalar 51 541
 newdef PVectorVP:Coupling 51 0.0759
 newdef PVectorVP:MaxWeight 51 1.60144
 newdef PVectorVP:Incoming 52 20543
 newdef PVectorVP:OutgoingVector 52 22
 newdef PVectorVP:OutgoingPScalar 52 541
 newdef PVectorVP:Coupling 52 0.175
 newdef PVectorVP:MaxWeight 52 1.60099
 newdef PVectorVP:Incoming 53 10443
 newdef PVectorVP:OutgoingVector 53 22
 newdef PVectorVP:OutgoingPScalar 53 441
 newdef PVectorVP:Coupling 53 0.329
 newdef PVectorVP:MaxWeight 53 3.98776
 newdef PVectorVP:Incoming 54 10553
 newdef PVectorVP:OutgoingVector 54 22
 newdef PVectorVP:OutgoingPScalar 54 551
 newdef PVectorVP:Coupling 54 0.0356
 newdef PVectorVP:MaxWeight 54 0.221701
 newdef PVectorVP:Incoming 55 20213
 newdef PVectorVP:OutgoingVector 55 323
 newdef PVectorVP:OutgoingPScalar 55 -311
 newdef PVectorVP:Coupling 55 3.42
 newdef PVectorVP:MaxWeight 55 3.19968
 newdef PVectorVP:Incoming 56 20213
 newdef PVectorVP:OutgoingVector 56 -313
 newdef PVectorVP:OutgoingPScalar 56 321
 newdef PVectorVP:Coupling 56 3.42
 newdef PVectorVP:MaxWeight 56 3.53218
 newdef PVectorVP:Incoming 57 20113
 newdef PVectorVP:OutgoingVector 57 -323
 newdef PVectorVP:OutgoingPScalar 57 321
 newdef PVectorVP:Coupling 57 3.42
 newdef PVectorVP:MaxWeight 57 3.57566
 newdef PVectorVP:Incoming 58 20113
 newdef PVectorVP:OutgoingVector 58 -313
 newdef PVectorVP:OutgoingPScalar 58 311
 newdef PVectorVP:Coupling 58 3.42
 newdef PVectorVP:MaxWeight 58 3.31095
 newdef PVectorVP:Incoming 59 20113
 newdef PVectorVP:OutgoingVector 59 22
 newdef PVectorVP:OutgoingPScalar 59 111
 newdef PVectorVP:Coupling 59 0.01
 newdef PVectorVP:MaxWeight 59 1.6
 newdef PVectorVP:Incoming 60 20213
 newdef PVectorVP:OutgoingVector 60 22
 newdef PVectorVP:OutgoingPScalar 60 211
 newdef PVectorVP:Coupling 60 0.01
 newdef PVectorVP:MaxWeight 60 1.6
 newdef PVectorVP:Incoming 61 20333
 newdef PVectorVP:OutgoingVector 61 -323
 newdef PVectorVP:OutgoingPScalar 61 321
 newdef PVectorVP:Coupling 61 1.637
 newdef PVectorVP:MaxWeight 61 5.43736
 newdef PVectorVP:Incoming 62 20333
 newdef PVectorVP:OutgoingVector 62 -313
 newdef PVectorVP:OutgoingPScalar 62 311
 newdef PVectorVP:Coupling 62 1.737
 newdef PVectorVP:MaxWeight 62 4.63598
 newdef PVectorVP:Incoming 63 10313
 newdef PVectorVP:OutgoingVector 63 22
 newdef PVectorVP:OutgoingPScalar 63 311
 newdef PVectorVP:Coupling 63 0.119
 newdef PVectorVP:MaxWeight 63 1.6
 newdef PVectorVP:Incoming 64 20313
 newdef PVectorVP:OutgoingVector 64 22
 newdef PVectorVP:OutgoingPScalar 64 311
 newdef PVectorVP:Coupling 64 0.22
 newdef PVectorVP:MaxWeight 64 1.6
 newdef PVectorVP:Incoming 65 10533
 newdef PVectorVP:OutgoingVector 65 513
 newdef PVectorVP:OutgoingPScalar 65 -311
 newdef PVectorVP:Coupling 65 0.0418
 newdef PVectorVP:MaxWeight 65 1.60089
 newdef PVectorVP:Incoming 66 10533
 newdef PVectorVP:OutgoingVector 66 523
 newdef PVectorVP:OutgoingPScalar 66 -321
 newdef PVectorVP:Coupling 66 0.0373
 newdef PVectorVP:MaxWeight 66 1.60358
 #
 create Herwig::PScalarLeptonNeutrinoDecayer  PScalarlnu
 newdef PScalarlnu:Iteration 1
 newdef PScalarlnu:Ntry 500
 newdef PScalarlnu:Points 100
 newdef PScalarlnu:GenerateIntermediates 0
 newdef PScalarlnu:Incoming   0 211
 newdef PScalarlnu:Leptons    0 2
 newdef PScalarlnu:MaxWeightElectron 0 0.000138471
 newdef PScalarlnu:MaxWeightMuon 0 1.08315
 newdef PScalarlnu:MaxWeightTau 0 0
 newdef PScalarlnu:DecayConstant 0 127.27
 newdef PScalarlnu:Incoming   1 321
 newdef PScalarlnu:Leptons    1 2
 newdef PScalarlnu:MaxWeightElectron 1 1.87067e-05
 newdef PScalarlnu:MaxWeightMuon 1 0.731058
 newdef PScalarlnu:MaxWeightTau 1 0
 newdef PScalarlnu:DecayConstant 1 36.06
 newdef PScalarlnu:Incoming   2 431
 newdef PScalarlnu:Leptons    2 3
 newdef PScalarlnu:MaxWeightElectron 2 1.83428e-07
 newdef PScalarlnu:MaxWeightMuon 2 0.00782778
 newdef PScalarlnu:MaxWeightTau 2 0.0760936
 newdef PScalarlnu:DecayConstant 2 281.36
 newdef PScalarlnu:Incoming   3 411
 newdef PScalarlnu:Leptons    3 3
 newdef PScalarlnu:MaxWeightElectron 3 1.19915e-08
 newdef PScalarlnu:MaxWeightMuon 3 0.000511418
 newdef PScalarlnu:MaxWeightTau 3 0.00135052
 newdef PScalarlnu:DecayConstant 3 51.2
 newdef PScalarlnu:Incoming   4 541
 newdef PScalarlnu:Leptons    4 3
 newdef PScalarlnu:MaxWeightElectron 4 1.7429e-09
 newdef PScalarlnu:MaxWeightMuon 4 7.47667e-05
 newdef PScalarlnu:MaxWeightTau 4 0.0179128
 newdef PScalarlnu:DecayConstant 4 16
 newdef PScalarlnu:Incoming   5 521
 newdef PScalarlnu:Leptons    5 3
 newdef PScalarlnu:MaxWeightElectron 5 1.19578e-11
 newdef PScalarlnu:MaxWeightMuon 5 5.12844e-07
 newdef PScalarlnu:MaxWeightTau 5 0.000114138
 newdef PScalarlnu:DecayConstant 5 0.759
 #
 create Herwig::VectorMesonVectorVectorDecayer  VectorVV
 newdef VectorVV:Iteration 1
 newdef VectorVV:Ntry 1000
 newdef VectorVV:Points 10000
 newdef VectorVV:GenerateIntermediates 0
 do VectorVV:SetUpDecayMode 30213 213 113 3.21 35.
 do VectorVV:SetUpDecayMode 30113 -213 213 3.21 35.
 do VectorVV:SetUpDecayMode 100213 213 113 9.59 52.2482
 do VectorVV:SetUpDecayMode 100113 -213 213 9.59 45.0477
 do VectorVV:SetUpDecayMode 9000553 533 -533 5.2 1.50168
 do VectorVV:SetUpDecayMode 9000553 513 -513 1.9 1.50069
 do VectorVV:SetUpDecayMode 9000553 523 -523 1.9 1.50134
 #
 create Herwig::ScalarMesonFactorizedDecayer  ISGW2Hadronic
 newdef ISGW2Hadronic:Iteration 1
 newdef ISGW2Hadronic:Ntry 500
 newdef ISGW2Hadronic:Points 10000
 newdef ISGW2Hadronic:GenerateIntermediates 0
 newdef ISGW2Hadronic:a1Bottom 1.1
 newdef ISGW2Hadronic:a2Bottom -0.24
 newdef ISGW2Hadronic:a1Charm 1.3
 newdef ISGW2Hadronic:a2Charm -0.55
 create Herwig::ScalarMesonCurrent ISGW2HadronicScalarCurrent HwWeakCurrents.so
 newdef ISGW2HadronicScalarCurrent:ThetaEtaEtaPrime -0.194
 newdef ISGW2HadronicScalarCurrent:ID 0 211
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 0 130.7
 newdef ISGW2HadronicScalarCurrent:ID 1 111
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 1 130.7
 newdef ISGW2HadronicScalarCurrent:ID 2 111
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 2 130.7
 newdef ISGW2HadronicScalarCurrent:ID 3 221
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 3 130.7
 newdef ISGW2HadronicScalarCurrent:ID 4 221
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 4 130.7
 newdef ISGW2HadronicScalarCurrent:ID 5 221
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 5 130.7
 newdef ISGW2HadronicScalarCurrent:ID 6 331
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 6 130.7
 newdef ISGW2HadronicScalarCurrent:ID 7 331
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 7 130.7
 newdef ISGW2HadronicScalarCurrent:ID 8 331
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 8 130.7
 newdef ISGW2HadronicScalarCurrent:ID 9 311
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 9 159.8
 newdef ISGW2HadronicScalarCurrent:ID 10 321
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 10 159.8
 newdef ISGW2HadronicScalarCurrent:ID 11 411
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 11 200
 newdef ISGW2HadronicScalarCurrent:ID 12 421
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 12 200
 newdef ISGW2HadronicScalarCurrent:ID 13 431
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 13 241
 newdef ISGW2HadronicScalarCurrent:ID 14 10431
 newdef ISGW2HadronicScalarCurrent:Decay_Constant 14 73.7
 newdef ISGW2HadronicScalarCurrent:Quark 0  2
 newdef ISGW2HadronicScalarCurrent:AntiQuark 0  -1
 newdef ISGW2HadronicScalarCurrent:Quark 1  1
 newdef ISGW2HadronicScalarCurrent:AntiQuark 1  -1
 newdef ISGW2HadronicScalarCurrent:Quark 2  2
 newdef ISGW2HadronicScalarCurrent:AntiQuark 2  -2
 newdef ISGW2HadronicScalarCurrent:Quark 3  1
 newdef ISGW2HadronicScalarCurrent:AntiQuark 3  -1
 newdef ISGW2HadronicScalarCurrent:Quark 4  2
 newdef ISGW2HadronicScalarCurrent:AntiQuark 4  -2
 newdef ISGW2HadronicScalarCurrent:Quark 5  3
 newdef ISGW2HadronicScalarCurrent:AntiQuark 5  -3
 newdef ISGW2HadronicScalarCurrent:Quark 6  1
 newdef ISGW2HadronicScalarCurrent:AntiQuark 6  -1
 newdef ISGW2HadronicScalarCurrent:Quark 7  2
 newdef ISGW2HadronicScalarCurrent:AntiQuark 7  -2
 newdef ISGW2HadronicScalarCurrent:Quark 8  3
 newdef ISGW2HadronicScalarCurrent:AntiQuark 8  -3
 newdef ISGW2HadronicScalarCurrent:Quark 9  1
 newdef ISGW2HadronicScalarCurrent:AntiQuark 9  -3
 newdef ISGW2HadronicScalarCurrent:Quark 10  2
 newdef ISGW2HadronicScalarCurrent:AntiQuark 10  -3
 newdef ISGW2HadronicScalarCurrent:Quark 11  4
 newdef ISGW2HadronicScalarCurrent:AntiQuark 11  -1
 newdef ISGW2HadronicScalarCurrent:Quark 12  4
 newdef ISGW2HadronicScalarCurrent:AntiQuark 12  -2
 newdef ISGW2HadronicScalarCurrent:Quark 13  4
 newdef ISGW2HadronicScalarCurrent:AntiQuark 13  -3
 newdef ISGW2HadronicScalarCurrent:Quark 14  4
 newdef ISGW2HadronicScalarCurrent:AntiQuark 14  -3
 insert ISGW2Hadronic:Currents 0 ISGW2HadronicScalarCurrent
 create Herwig::VectorMesonCurrent ISGW2HadronicVectorCurrent HwWeakCurrents.so
 newdef ISGW2HadronicVectorCurrent:ID 0 213
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 0 0.1764
 newdef ISGW2HadronicVectorCurrent:ID 1 113
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 1 0.1764
 newdef ISGW2HadronicVectorCurrent:ID 2 113
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 2 0.1764
 newdef ISGW2HadronicVectorCurrent:ID 3 223
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 3 0.1764
 newdef ISGW2HadronicVectorCurrent:ID 4 223
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 4 0.1764
 newdef ISGW2HadronicVectorCurrent:ID 5 333
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 5 0.238
 newdef ISGW2HadronicVectorCurrent:ID 6 313
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 6 0.2019
 newdef ISGW2HadronicVectorCurrent:ID 7 323
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 7 0.2019
 newdef ISGW2HadronicVectorCurrent:ID 8 20213
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 8 0.4626
 newdef ISGW2HadronicVectorCurrent:ID 9 20113
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 9 0.4626
 newdef ISGW2HadronicVectorCurrent:ID 10 20113
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 10 0.4626
 newdef ISGW2HadronicVectorCurrent:ID 11 413
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 11 0.402
 newdef ISGW2HadronicVectorCurrent:ID 12 423
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 12 0.402
 newdef ISGW2HadronicVectorCurrent:ID 13 433
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 13 0.509
 newdef ISGW2HadronicVectorCurrent:ID 14 443
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 14 1.223
 newdef ISGW2HadronicVectorCurrent:ID 15 100443
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 15 1.08
 newdef ISGW2HadronicVectorCurrent:ID 16 10433
 newdef ISGW2HadronicVectorCurrent:Decay_Constant 16 0.397
 newdef ISGW2HadronicVectorCurrent:Quark 0  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 0  -1
 newdef ISGW2HadronicVectorCurrent:Quark 1  1
 newdef ISGW2HadronicVectorCurrent:AntiQuark 1  -1
 newdef ISGW2HadronicVectorCurrent:Quark 2  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 2  -2
 newdef ISGW2HadronicVectorCurrent:Quark 3  1
 newdef ISGW2HadronicVectorCurrent:AntiQuark 3  -1
 newdef ISGW2HadronicVectorCurrent:Quark 4  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 4  -2
 newdef ISGW2HadronicVectorCurrent:Quark 5  3
 newdef ISGW2HadronicVectorCurrent:AntiQuark 5  -3
 newdef ISGW2HadronicVectorCurrent:Quark 6  1
 newdef ISGW2HadronicVectorCurrent:AntiQuark 6  -3
 newdef ISGW2HadronicVectorCurrent:Quark 7  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 7  -3
 newdef ISGW2HadronicVectorCurrent:Quark 8  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 8  -1
 newdef ISGW2HadronicVectorCurrent:Quark 9  1
 newdef ISGW2HadronicVectorCurrent:AntiQuark 9  -1
 newdef ISGW2HadronicVectorCurrent:Quark 10  2
 newdef ISGW2HadronicVectorCurrent:AntiQuark 10  -2
 newdef ISGW2HadronicVectorCurrent:Quark 11  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 11  -1
 newdef ISGW2HadronicVectorCurrent:Quark 12  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 12  -2
 newdef ISGW2HadronicVectorCurrent:Quark 13  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 13  -3
 newdef ISGW2HadronicVectorCurrent:Quark 14  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 14  -4
 newdef ISGW2HadronicVectorCurrent:Quark 15  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 15  -4
 newdef ISGW2HadronicVectorCurrent:Quark 16  4
 newdef ISGW2HadronicVectorCurrent:AntiQuark 16  -3
 insert ISGW2Hadronic:Currents 1 ISGW2HadronicVectorCurrent
 create Herwig::ISGW2FormFactor ISGW2HadronicFormFactor
 newdef ISGW2HadronicFormFactor:DownMass 0.33
 newdef ISGW2HadronicFormFactor:UpMass 0.33
 newdef ISGW2HadronicFormFactor:StrangeMass 0.55
 newdef ISGW2HadronicFormFactor:CharmMass 1.82
 newdef ISGW2HadronicFormFactor:BottomMass 5.2
 newdef ISGW2HadronicFormFactor:Beta1S0ud 0.41
 newdef ISGW2HadronicFormFactor:Beta1S0us 0.44
 newdef ISGW2HadronicFormFactor:Beta1S0ss 0.53
 newdef ISGW2HadronicFormFactor:Beta1S0cu 0.45
 newdef ISGW2HadronicFormFactor:Beta1S0cs 0.56
 newdef ISGW2HadronicFormFactor:Beta1S0ub 0.43
 newdef ISGW2HadronicFormFactor:Beta1S0sb 0.54
 newdef ISGW2HadronicFormFactor:Beta1S0cc 0.88
 newdef ISGW2HadronicFormFactor:Beta1S0bc 0.92
 newdef ISGW2HadronicFormFactor:Beta1Pud  0.28
 newdef ISGW2HadronicFormFactor:Beta1Pus  0.3
 newdef ISGW2HadronicFormFactor:Beta1Pss  0.33
 newdef ISGW2HadronicFormFactor:Beta1Pcu  0.33
 newdef ISGW2HadronicFormFactor:Beta1Pcs  0.38
 newdef ISGW2HadronicFormFactor:Beta1Pub  0.35
 newdef ISGW2HadronicFormFactor:Beta1Psb  0.41
 newdef ISGW2HadronicFormFactor:Beta1Pcc  0.52
 newdef ISGW2HadronicFormFactor:Beta1Pbc  0.6
 newdef ISGW2HadronicFormFactor:Beta3S1ud 0.3
 newdef ISGW2HadronicFormFactor:Beta3S1us 0.33
 newdef ISGW2HadronicFormFactor:Beta3S1ss 0.37
 newdef ISGW2HadronicFormFactor:Beta3S1cu 0.38
 newdef ISGW2HadronicFormFactor:Beta3S1cs 0.44
 newdef ISGW2HadronicFormFactor:Beta3S1ub 0.4
 newdef ISGW2HadronicFormFactor:Beta3S1sb 0.49
 newdef ISGW2HadronicFormFactor:Beta3S1cc 0.62
 newdef ISGW2HadronicFormFactor:Beta3S1bc 0.75
 newdef ISGW2HadronicFormFactor:AlphaCutOff 0.6
 newdef ISGW2HadronicFormFactor:CfDrho 0.889
 newdef ISGW2HadronicFormFactor:CfDKstar 0.928
 newdef ISGW2HadronicFormFactor:CfDsKstar 0.873
 newdef ISGW2HadronicFormFactor:CfDsphi 0.911
 newdef ISGW2HadronicFormFactor:CfBrho 0.905
 newdef ISGW2HadronicFormFactor:CfBDstar 0.989
 newdef ISGW2HadronicFormFactor:CfBsKstar 0.892
 newdef ISGW2HadronicFormFactor:CfBsDstar 0.984
 newdef ISGW2HadronicFormFactor:CfBcDstar 0.868
 newdef ISGW2HadronicFormFactor:CfBcpsi 0.967
 newdef ISGW2HadronicFormFactor:CfBcBsstar 1
 newdef ISGW2HadronicFormFactor:CfBcBstar 1
 newdef ISGW2HadronicFormFactor:ThetaEtaEtaPrime -0.349066
 newdef ISGW2HadronicFormFactor:Incoming 0 -541
 newdef ISGW2HadronicFormFactor:Outgoing 0 -411
 newdef ISGW2HadronicFormFactor:Spin 0 0
 newdef ISGW2HadronicFormFactor:Spectator 0 -4
 newdef ISGW2HadronicFormFactor:InQuark 0 5
 newdef ISGW2HadronicFormFactor:OutQuark 0 1
 newdef ISGW2HadronicFormFactor:Incoming 1 -541
 newdef ISGW2HadronicFormFactor:Outgoing 1 -413
 newdef ISGW2HadronicFormFactor:Spin 1 1
 newdef ISGW2HadronicFormFactor:Spectator 1 -4
 newdef ISGW2HadronicFormFactor:InQuark 1 5
 newdef ISGW2HadronicFormFactor:OutQuark 1 1
 newdef ISGW2HadronicFormFactor:Incoming 2 -541
 newdef ISGW2HadronicFormFactor:Outgoing 2 -415
 newdef ISGW2HadronicFormFactor:Spin 2 2
 newdef ISGW2HadronicFormFactor:Spectator 2 -4
 newdef ISGW2HadronicFormFactor:InQuark 2 5
 newdef ISGW2HadronicFormFactor:OutQuark 2 1
 newdef ISGW2HadronicFormFactor:Incoming 3 -541
 newdef ISGW2HadronicFormFactor:Outgoing 3 10413
 newdef ISGW2HadronicFormFactor:Spin 3 1
 newdef ISGW2HadronicFormFactor:Spectator 3 -2
 newdef ISGW2HadronicFormFactor:InQuark 3 5
 newdef ISGW2HadronicFormFactor:OutQuark 3 1
 newdef ISGW2HadronicFormFactor:Incoming 4 -541
 newdef ISGW2HadronicFormFactor:Outgoing 4 -20413
 newdef ISGW2HadronicFormFactor:Spin 4 1
 newdef ISGW2HadronicFormFactor:Spectator 4 -4
 newdef ISGW2HadronicFormFactor:InQuark 4 5
 newdef ISGW2HadronicFormFactor:OutQuark 4 1
 newdef ISGW2HadronicFormFactor:Incoming 5 -541
 newdef ISGW2HadronicFormFactor:Outgoing 5 10411
 newdef ISGW2HadronicFormFactor:Spin 5 0
 newdef ISGW2HadronicFormFactor:Spectator 5 4
 newdef ISGW2HadronicFormFactor:InQuark 5 5
 newdef ISGW2HadronicFormFactor:OutQuark 5 1
 newdef ISGW2HadronicFormFactor:Incoming 6 -541
 newdef ISGW2HadronicFormFactor:Outgoing 6 -421
 newdef ISGW2HadronicFormFactor:Spin 6 0
 newdef ISGW2HadronicFormFactor:Spectator 6 -4
 newdef ISGW2HadronicFormFactor:InQuark 6 5
 newdef ISGW2HadronicFormFactor:OutQuark 6 2
 newdef ISGW2HadronicFormFactor:Incoming 7 -541
 newdef ISGW2HadronicFormFactor:Outgoing 7 -423
 newdef ISGW2HadronicFormFactor:Spin 7 1
 newdef ISGW2HadronicFormFactor:Spectator 7 -4
 newdef ISGW2HadronicFormFactor:InQuark 7 5
 newdef ISGW2HadronicFormFactor:OutQuark 7 2
 newdef ISGW2HadronicFormFactor:Incoming 8 -541
 newdef ISGW2HadronicFormFactor:Outgoing 8 -425
 newdef ISGW2HadronicFormFactor:Spin 8 2
 newdef ISGW2HadronicFormFactor:Spectator 8 -4
 newdef ISGW2HadronicFormFactor:InQuark 8 5
 newdef ISGW2HadronicFormFactor:OutQuark 8 2
 newdef ISGW2HadronicFormFactor:Incoming 9 -541
 newdef ISGW2HadronicFormFactor:Outgoing 9 -10423
 newdef ISGW2HadronicFormFactor:Spin 9 1
 newdef ISGW2HadronicFormFactor:Spectator 9 -4
 newdef ISGW2HadronicFormFactor:InQuark 9 5
 newdef ISGW2HadronicFormFactor:OutQuark 9 2
 newdef ISGW2HadronicFormFactor:Incoming 10 -541
 newdef ISGW2HadronicFormFactor:Outgoing 10 -20423
 newdef ISGW2HadronicFormFactor:Spin 10 1
 newdef ISGW2HadronicFormFactor:Spectator 10 -4
 newdef ISGW2HadronicFormFactor:InQuark 10 5
 newdef ISGW2HadronicFormFactor:OutQuark 10 2
 newdef ISGW2HadronicFormFactor:Incoming 11 -541
 newdef ISGW2HadronicFormFactor:Outgoing 11 -10421
 newdef ISGW2HadronicFormFactor:Spin 11 0
 newdef ISGW2HadronicFormFactor:Spectator 11 -4
 newdef ISGW2HadronicFormFactor:InQuark 11 5
 newdef ISGW2HadronicFormFactor:OutQuark 11 2
 newdef ISGW2HadronicFormFactor:Incoming 12 -541
 newdef ISGW2HadronicFormFactor:Outgoing 12 -431
 newdef ISGW2HadronicFormFactor:Spin 12 0
 newdef ISGW2HadronicFormFactor:Spectator 12 -4
 newdef ISGW2HadronicFormFactor:InQuark 12 5
 newdef ISGW2HadronicFormFactor:OutQuark 12 3
 newdef ISGW2HadronicFormFactor:Incoming 13 -541
 newdef ISGW2HadronicFormFactor:Outgoing 13 -433
 newdef ISGW2HadronicFormFactor:Spin 13 1
 newdef ISGW2HadronicFormFactor:Spectator 13 -4
 newdef ISGW2HadronicFormFactor:InQuark 13 5
 newdef ISGW2HadronicFormFactor:OutQuark 13 3
 newdef ISGW2HadronicFormFactor:Incoming 14 -541
 newdef ISGW2HadronicFormFactor:Outgoing 14 -435
 newdef ISGW2HadronicFormFactor:Spin 14 2
 newdef ISGW2HadronicFormFactor:Spectator 14 -4
 newdef ISGW2HadronicFormFactor:InQuark 14 5
 newdef ISGW2HadronicFormFactor:OutQuark 14 3
 newdef ISGW2HadronicFormFactor:Incoming 15 -541
 newdef ISGW2HadronicFormFactor:Outgoing 15 -10433
 newdef ISGW2HadronicFormFactor:Spin 15 1
 newdef ISGW2HadronicFormFactor:Spectator 15 -4
 newdef ISGW2HadronicFormFactor:InQuark 15 5
 newdef ISGW2HadronicFormFactor:OutQuark 15 3
 newdef ISGW2HadronicFormFactor:Incoming 16 -541
 newdef ISGW2HadronicFormFactor:Outgoing 16 -20433
 newdef ISGW2HadronicFormFactor:Spin 16 1
 newdef ISGW2HadronicFormFactor:Spectator 16 -4
 newdef ISGW2HadronicFormFactor:InQuark 16 5
 newdef ISGW2HadronicFormFactor:OutQuark 16 3
 newdef ISGW2HadronicFormFactor:Incoming 17 -541
 newdef ISGW2HadronicFormFactor:Outgoing 17 -10431
 newdef ISGW2HadronicFormFactor:Spin 17 0
 newdef ISGW2HadronicFormFactor:Spectator 17 4
 newdef ISGW2HadronicFormFactor:InQuark 17 5
 newdef ISGW2HadronicFormFactor:OutQuark 17 3
 newdef ISGW2HadronicFormFactor:Incoming 18 -541
 newdef ISGW2HadronicFormFactor:Outgoing 18 441
 newdef ISGW2HadronicFormFactor:Spin 18 0
 newdef ISGW2HadronicFormFactor:Spectator 18 -4
 newdef ISGW2HadronicFormFactor:InQuark 18 5
 newdef ISGW2HadronicFormFactor:OutQuark 18 4
 newdef ISGW2HadronicFormFactor:Incoming 19 -541
 newdef ISGW2HadronicFormFactor:Outgoing 19 443
 newdef ISGW2HadronicFormFactor:Spin 19 1
 newdef ISGW2HadronicFormFactor:Spectator 19 -4
 newdef ISGW2HadronicFormFactor:InQuark 19 5
 newdef ISGW2HadronicFormFactor:OutQuark 19 4
 newdef ISGW2HadronicFormFactor:Incoming 20 -541
 newdef ISGW2HadronicFormFactor:Outgoing 20 445
 newdef ISGW2HadronicFormFactor:Spin 20 2
 newdef ISGW2HadronicFormFactor:Spectator 20 -4
 newdef ISGW2HadronicFormFactor:InQuark 20 5
 newdef ISGW2HadronicFormFactor:OutQuark 20 4
 newdef ISGW2HadronicFormFactor:Incoming 21 -541
 newdef ISGW2HadronicFormFactor:Outgoing 21 10443
 newdef ISGW2HadronicFormFactor:Spin 21 1
 newdef ISGW2HadronicFormFactor:Spectator 21 -4
 newdef ISGW2HadronicFormFactor:InQuark 21 5
 newdef ISGW2HadronicFormFactor:OutQuark 21 4
 newdef ISGW2HadronicFormFactor:Incoming 22 -541
 newdef ISGW2HadronicFormFactor:Outgoing 22 20443
 newdef ISGW2HadronicFormFactor:Spin 22 1
 newdef ISGW2HadronicFormFactor:Spectator 22 -4
 newdef ISGW2HadronicFormFactor:InQuark 22 5
 newdef ISGW2HadronicFormFactor:OutQuark 22 4
 newdef ISGW2HadronicFormFactor:Incoming 23 -541
 newdef ISGW2HadronicFormFactor:Outgoing 23 10441
 newdef ISGW2HadronicFormFactor:Spin 23 0
 newdef ISGW2HadronicFormFactor:Spectator 23 4
 newdef ISGW2HadronicFormFactor:InQuark 23 5
 newdef ISGW2HadronicFormFactor:OutQuark 23 4
 newdef ISGW2HadronicFormFactor:Incoming 24 541
 newdef ISGW2HadronicFormFactor:Outgoing 24 511
 newdef ISGW2HadronicFormFactor:Spin 24 0
 newdef ISGW2HadronicFormFactor:Spectator 24 5
 newdef ISGW2HadronicFormFactor:InQuark 24 -4
 newdef ISGW2HadronicFormFactor:OutQuark 24 -1
 newdef ISGW2HadronicFormFactor:Incoming 25 541
 newdef ISGW2HadronicFormFactor:Outgoing 25 513
 newdef ISGW2HadronicFormFactor:Spin 25 1
 newdef ISGW2HadronicFormFactor:Spectator 25 5
 newdef ISGW2HadronicFormFactor:InQuark 25 -4
 newdef ISGW2HadronicFormFactor:OutQuark 25 -1
 newdef ISGW2HadronicFormFactor:Incoming 26 541
 newdef ISGW2HadronicFormFactor:Outgoing 26 515
 newdef ISGW2HadronicFormFactor:Spin 26 2
 newdef ISGW2HadronicFormFactor:Spectator 26 5
 newdef ISGW2HadronicFormFactor:InQuark 26 -4
 newdef ISGW2HadronicFormFactor:OutQuark 26 -1
 newdef ISGW2HadronicFormFactor:Incoming 27 541
 newdef ISGW2HadronicFormFactor:Outgoing 27 10513
 newdef ISGW2HadronicFormFactor:Spin 27 1
 newdef ISGW2HadronicFormFactor:Spectator 27 5
 newdef ISGW2HadronicFormFactor:InQuark 27 -4
 newdef ISGW2HadronicFormFactor:OutQuark 27 -1
 newdef ISGW2HadronicFormFactor:Incoming 28 541
 newdef ISGW2HadronicFormFactor:Outgoing 28 20513
 newdef ISGW2HadronicFormFactor:Spin 28 1
 newdef ISGW2HadronicFormFactor:Spectator 28 5
 newdef ISGW2HadronicFormFactor:InQuark 28 -4
 newdef ISGW2HadronicFormFactor:OutQuark 28 -1
 newdef ISGW2HadronicFormFactor:Incoming 29 541
 newdef ISGW2HadronicFormFactor:Outgoing 29 10511
 newdef ISGW2HadronicFormFactor:Spin 29 0
 newdef ISGW2HadronicFormFactor:Spectator 29 5
 newdef ISGW2HadronicFormFactor:InQuark 29 -4
 newdef ISGW2HadronicFormFactor:OutQuark 29 -1
 newdef ISGW2HadronicFormFactor:Incoming 30 541
 newdef ISGW2HadronicFormFactor:Outgoing 30 521
 newdef ISGW2HadronicFormFactor:Spin 30 0
 newdef ISGW2HadronicFormFactor:Spectator 30 5
 newdef ISGW2HadronicFormFactor:InQuark 30 -4
 newdef ISGW2HadronicFormFactor:OutQuark 30 -2
 newdef ISGW2HadronicFormFactor:Incoming 31 541
 newdef ISGW2HadronicFormFactor:Outgoing 31 523
 newdef ISGW2HadronicFormFactor:Spin 31 1
 newdef ISGW2HadronicFormFactor:Spectator 31 5
 newdef ISGW2HadronicFormFactor:InQuark 31 -4
 newdef ISGW2HadronicFormFactor:OutQuark 31 -2
 newdef ISGW2HadronicFormFactor:Incoming 32 541
 newdef ISGW2HadronicFormFactor:Outgoing 32 525
 newdef ISGW2HadronicFormFactor:Spin 32 2
 newdef ISGW2HadronicFormFactor:Spectator 32 5
 newdef ISGW2HadronicFormFactor:InQuark 32 -4
 newdef ISGW2HadronicFormFactor:OutQuark 32 -2
 newdef ISGW2HadronicFormFactor:Incoming 33 541
 newdef ISGW2HadronicFormFactor:Outgoing 33 10523
 newdef ISGW2HadronicFormFactor:Spin 33 1
 newdef ISGW2HadronicFormFactor:Spectator 33 5
 newdef ISGW2HadronicFormFactor:InQuark 33 -4
 newdef ISGW2HadronicFormFactor:OutQuark 33 -2
 newdef ISGW2HadronicFormFactor:Incoming 34 541
 newdef ISGW2HadronicFormFactor:Outgoing 34 20523
 newdef ISGW2HadronicFormFactor:Spin 34 1
 newdef ISGW2HadronicFormFactor:Spectator 34 5
 newdef ISGW2HadronicFormFactor:InQuark 34 -4
 newdef ISGW2HadronicFormFactor:OutQuark 34 -2
 newdef ISGW2HadronicFormFactor:Incoming 35 541
 newdef ISGW2HadronicFormFactor:Outgoing 35 10521
 newdef ISGW2HadronicFormFactor:Spin 35 0
 newdef ISGW2HadronicFormFactor:Spectator 35 5
 newdef ISGW2HadronicFormFactor:InQuark 35 -4
 newdef ISGW2HadronicFormFactor:OutQuark 35 -2
 newdef ISGW2HadronicFormFactor:Incoming 36 541
 newdef ISGW2HadronicFormFactor:Outgoing 36 531
 newdef ISGW2HadronicFormFactor:Spin 36 0
 newdef ISGW2HadronicFormFactor:Spectator 36 5
 newdef ISGW2HadronicFormFactor:InQuark 36 -4
 newdef ISGW2HadronicFormFactor:OutQuark 36 -3
 newdef ISGW2HadronicFormFactor:Incoming 37 541
 newdef ISGW2HadronicFormFactor:Outgoing 37 533
 newdef ISGW2HadronicFormFactor:Spin 37 1
 newdef ISGW2HadronicFormFactor:Spectator 37 5
 newdef ISGW2HadronicFormFactor:InQuark 37 -4
 newdef ISGW2HadronicFormFactor:OutQuark 37 -3
 newdef ISGW2HadronicFormFactor:Incoming 38 541
 newdef ISGW2HadronicFormFactor:Outgoing 38 535
 newdef ISGW2HadronicFormFactor:Spin 38 2
 newdef ISGW2HadronicFormFactor:Spectator 38 5
 newdef ISGW2HadronicFormFactor:InQuark 38 -4
 newdef ISGW2HadronicFormFactor:OutQuark 38 -3
 newdef ISGW2HadronicFormFactor:Incoming 39 541
 newdef ISGW2HadronicFormFactor:Outgoing 39 10533
 newdef ISGW2HadronicFormFactor:Spin 39 1
 newdef ISGW2HadronicFormFactor:Spectator 39 5
 newdef ISGW2HadronicFormFactor:InQuark 39 -4
 newdef ISGW2HadronicFormFactor:OutQuark 39 -3
 newdef ISGW2HadronicFormFactor:Incoming 40 541
 newdef ISGW2HadronicFormFactor:Outgoing 40 20533
 newdef ISGW2HadronicFormFactor:Spin 40 1
 newdef ISGW2HadronicFormFactor:Spectator 40 5
 newdef ISGW2HadronicFormFactor:InQuark 40 -4
 newdef ISGW2HadronicFormFactor:OutQuark 40 -3
 newdef ISGW2HadronicFormFactor:Incoming 41 541
 newdef ISGW2HadronicFormFactor:Outgoing 41 10531
 newdef ISGW2HadronicFormFactor:Spin 41 0
 newdef ISGW2HadronicFormFactor:Spectator 41 5
 newdef ISGW2HadronicFormFactor:InQuark 41 -4
 newdef ISGW2HadronicFormFactor:OutQuark 41 -3
 newdef ISGW2HadronicFormFactor:Incoming 42 -531
 newdef ISGW2HadronicFormFactor:Outgoing 42 311
 newdef ISGW2HadronicFormFactor:Spin 42 0
 newdef ISGW2HadronicFormFactor:Spectator 42 3
 newdef ISGW2HadronicFormFactor:InQuark 42 -5
 newdef ISGW2HadronicFormFactor:OutQuark 42 -1
 newdef ISGW2HadronicFormFactor:Incoming 43 -531
 newdef ISGW2HadronicFormFactor:Outgoing 43 313
 newdef ISGW2HadronicFormFactor:Spin 43 1
 newdef ISGW2HadronicFormFactor:Spectator 43 3
 newdef ISGW2HadronicFormFactor:InQuark 43 -5
 newdef ISGW2HadronicFormFactor:OutQuark 43 -1
 newdef ISGW2HadronicFormFactor:Incoming 44 -531
 newdef ISGW2HadronicFormFactor:Outgoing 44 315
 newdef ISGW2HadronicFormFactor:Spin 44 2
 newdef ISGW2HadronicFormFactor:Spectator 44 3
 newdef ISGW2HadronicFormFactor:InQuark 44 -5
 newdef ISGW2HadronicFormFactor:OutQuark 44 -1
 newdef ISGW2HadronicFormFactor:Incoming 45 -531
 newdef ISGW2HadronicFormFactor:Outgoing 45 10313
 newdef ISGW2HadronicFormFactor:Spin 45 1
 newdef ISGW2HadronicFormFactor:Spectator 45 3
 newdef ISGW2HadronicFormFactor:InQuark 45 -5
 newdef ISGW2HadronicFormFactor:OutQuark 45 -1
 newdef ISGW2HadronicFormFactor:Incoming 46 -531
 newdef ISGW2HadronicFormFactor:Outgoing 46 20313
 newdef ISGW2HadronicFormFactor:Spin 46 1
 newdef ISGW2HadronicFormFactor:Spectator 46 3
 newdef ISGW2HadronicFormFactor:InQuark 46 -5
 newdef ISGW2HadronicFormFactor:OutQuark 46 -1
 newdef ISGW2HadronicFormFactor:Incoming 47 -531
 newdef ISGW2HadronicFormFactor:Outgoing 47 10311
 newdef ISGW2HadronicFormFactor:Spin 47 0
 newdef ISGW2HadronicFormFactor:Spectator 47 3
 newdef ISGW2HadronicFormFactor:InQuark 47 -5
 newdef ISGW2HadronicFormFactor:OutQuark 47 -1
 newdef ISGW2HadronicFormFactor:Incoming 48 -531
 newdef ISGW2HadronicFormFactor:Outgoing 48 321
 newdef ISGW2HadronicFormFactor:Spin 48 0
 newdef ISGW2HadronicFormFactor:Spectator 48 3
 newdef ISGW2HadronicFormFactor:InQuark 48 -5
 newdef ISGW2HadronicFormFactor:OutQuark 48 -2
 newdef ISGW2HadronicFormFactor:Incoming 49 -531
 newdef ISGW2HadronicFormFactor:Outgoing 49 323
 newdef ISGW2HadronicFormFactor:Spin 49 1
 newdef ISGW2HadronicFormFactor:Spectator 49 3
 newdef ISGW2HadronicFormFactor:InQuark 49 -5
 newdef ISGW2HadronicFormFactor:OutQuark 49 -2
 newdef ISGW2HadronicFormFactor:Incoming 50 -531
 newdef ISGW2HadronicFormFactor:Outgoing 50 325
 newdef ISGW2HadronicFormFactor:Spin 50 2
 newdef ISGW2HadronicFormFactor:Spectator 50 3
 newdef ISGW2HadronicFormFactor:InQuark 50 -5
 newdef ISGW2HadronicFormFactor:OutQuark 50 -2
 newdef ISGW2HadronicFormFactor:Incoming 51 -531
 newdef ISGW2HadronicFormFactor:Outgoing 51 10323
 newdef ISGW2HadronicFormFactor:Spin 51 1
 newdef ISGW2HadronicFormFactor:Spectator 51 3
 newdef ISGW2HadronicFormFactor:InQuark 51 -5
 newdef ISGW2HadronicFormFactor:OutQuark 51 -2
 newdef ISGW2HadronicFormFactor:Incoming 52 -531
 newdef ISGW2HadronicFormFactor:Outgoing 52 20323
 newdef ISGW2HadronicFormFactor:Spin 52 1
 newdef ISGW2HadronicFormFactor:Spectator 52 3
 newdef ISGW2HadronicFormFactor:InQuark 52 -5
 newdef ISGW2HadronicFormFactor:OutQuark 52 -2
 newdef ISGW2HadronicFormFactor:Incoming 53 -531
 newdef ISGW2HadronicFormFactor:Outgoing 53 10321
 newdef ISGW2HadronicFormFactor:Spin 53 0
 newdef ISGW2HadronicFormFactor:Spectator 53 3
 newdef ISGW2HadronicFormFactor:InQuark 53 -5
 newdef ISGW2HadronicFormFactor:OutQuark 53 -2
 newdef ISGW2HadronicFormFactor:Incoming 54 -531
 newdef ISGW2HadronicFormFactor:Outgoing 54 221
 newdef ISGW2HadronicFormFactor:Spin 54 0
 newdef ISGW2HadronicFormFactor:Spectator 54 3
 newdef ISGW2HadronicFormFactor:InQuark 54 -5
 newdef ISGW2HadronicFormFactor:OutQuark 54 -3
 newdef ISGW2HadronicFormFactor:Incoming 55 -531
 newdef ISGW2HadronicFormFactor:Outgoing 55 331
 newdef ISGW2HadronicFormFactor:Spin 55 0
 newdef ISGW2HadronicFormFactor:Spectator 55 3
 newdef ISGW2HadronicFormFactor:InQuark 55 -5
 newdef ISGW2HadronicFormFactor:OutQuark 55 -3
 newdef ISGW2HadronicFormFactor:Incoming 56 -531
 newdef ISGW2HadronicFormFactor:Outgoing 56 333
 newdef ISGW2HadronicFormFactor:Spin 56 1
 newdef ISGW2HadronicFormFactor:Spectator 56 3
 newdef ISGW2HadronicFormFactor:InQuark 56 -5
 newdef ISGW2HadronicFormFactor:OutQuark 56 -3
 newdef ISGW2HadronicFormFactor:Incoming 57 -531
 newdef ISGW2HadronicFormFactor:Outgoing 57 335
 newdef ISGW2HadronicFormFactor:Spin 57 2
 newdef ISGW2HadronicFormFactor:Spectator 57 3
 newdef ISGW2HadronicFormFactor:InQuark 57 -5
 newdef ISGW2HadronicFormFactor:OutQuark 57 -3
 newdef ISGW2HadronicFormFactor:Incoming 58 -531
 newdef ISGW2HadronicFormFactor:Outgoing 58 10333
 newdef ISGW2HadronicFormFactor:Spin 58 1
 newdef ISGW2HadronicFormFactor:Spectator 58 3
 newdef ISGW2HadronicFormFactor:InQuark 58 -5
 newdef ISGW2HadronicFormFactor:OutQuark 58 -3
 newdef ISGW2HadronicFormFactor:Incoming 59 -531
 newdef ISGW2HadronicFormFactor:Outgoing 59 20333
 newdef ISGW2HadronicFormFactor:Spin 59 1
 newdef ISGW2HadronicFormFactor:Spectator 59 3
 newdef ISGW2HadronicFormFactor:InQuark 59 -5
 newdef ISGW2HadronicFormFactor:OutQuark 59 -3
 newdef ISGW2HadronicFormFactor:Incoming 60 -531
 newdef ISGW2HadronicFormFactor:Outgoing 60 10331
 newdef ISGW2HadronicFormFactor:Spin 60 0
 newdef ISGW2HadronicFormFactor:Spectator 60 3
 newdef ISGW2HadronicFormFactor:InQuark 60 -5
 newdef ISGW2HadronicFormFactor:OutQuark 60 -3
 newdef ISGW2HadronicFormFactor:Incoming 61 -531
 newdef ISGW2HadronicFormFactor:Outgoing 61 431
 newdef ISGW2HadronicFormFactor:Spin 61 0
 newdef ISGW2HadronicFormFactor:Spectator 61 3
 newdef ISGW2HadronicFormFactor:InQuark 61 -5
 newdef ISGW2HadronicFormFactor:OutQuark 61 -4
 newdef ISGW2HadronicFormFactor:Incoming 62 -531
 newdef ISGW2HadronicFormFactor:Outgoing 62 433
 newdef ISGW2HadronicFormFactor:Spin 62 1
 newdef ISGW2HadronicFormFactor:Spectator 62 3
 newdef ISGW2HadronicFormFactor:InQuark 62 -5
 newdef ISGW2HadronicFormFactor:OutQuark 62 -4
 newdef ISGW2HadronicFormFactor:Incoming 63 -531
 newdef ISGW2HadronicFormFactor:Outgoing 63 435
 newdef ISGW2HadronicFormFactor:Spin 63 2
 newdef ISGW2HadronicFormFactor:Spectator 63 3
 newdef ISGW2HadronicFormFactor:InQuark 63 -5
 newdef ISGW2HadronicFormFactor:OutQuark 63 -4
 newdef ISGW2HadronicFormFactor:Incoming 64 -531
 newdef ISGW2HadronicFormFactor:Outgoing 64 10433
 newdef ISGW2HadronicFormFactor:Spin 64 1
 newdef ISGW2HadronicFormFactor:Spectator 64 3
 newdef ISGW2HadronicFormFactor:InQuark 64 -5
 newdef ISGW2HadronicFormFactor:OutQuark 64 -4
 newdef ISGW2HadronicFormFactor:Incoming 65 -531
 newdef ISGW2HadronicFormFactor:Outgoing 65 20433
 newdef ISGW2HadronicFormFactor:Spin 65 1
 newdef ISGW2HadronicFormFactor:Spectator 65 3
 newdef ISGW2HadronicFormFactor:InQuark 65 -5
 newdef ISGW2HadronicFormFactor:OutQuark 65 -4
 newdef ISGW2HadronicFormFactor:Incoming 66 -531
 newdef ISGW2HadronicFormFactor:Outgoing 66 10431
 newdef ISGW2HadronicFormFactor:Spin 66 0
 newdef ISGW2HadronicFormFactor:Spectator 66 3
 newdef ISGW2HadronicFormFactor:InQuark 66 -5
 newdef ISGW2HadronicFormFactor:OutQuark 66 -4
 newdef ISGW2HadronicFormFactor:Incoming 67 -521
 newdef ISGW2HadronicFormFactor:Outgoing 67 -211
 newdef ISGW2HadronicFormFactor:Spin 67 0
 newdef ISGW2HadronicFormFactor:Spectator 67 -2
 newdef ISGW2HadronicFormFactor:InQuark 67 5
 newdef ISGW2HadronicFormFactor:OutQuark 67 1
 newdef ISGW2HadronicFormFactor:Incoming 68 -521
 newdef ISGW2HadronicFormFactor:Outgoing 68 -213
 newdef ISGW2HadronicFormFactor:Spin 68 1
 newdef ISGW2HadronicFormFactor:Spectator 68 -2
 newdef ISGW2HadronicFormFactor:InQuark 68 5
 newdef ISGW2HadronicFormFactor:OutQuark 68 1
 newdef ISGW2HadronicFormFactor:Incoming 69 -521
 newdef ISGW2HadronicFormFactor:Outgoing 69 -215
 newdef ISGW2HadronicFormFactor:Spin 69 2
 newdef ISGW2HadronicFormFactor:Spectator 69 -2
 newdef ISGW2HadronicFormFactor:InQuark 69 5
 newdef ISGW2HadronicFormFactor:OutQuark 69 1
 newdef ISGW2HadronicFormFactor:Incoming 70 -521
 newdef ISGW2HadronicFormFactor:Outgoing 70 -10213
 newdef ISGW2HadronicFormFactor:Spin 70 1
 newdef ISGW2HadronicFormFactor:Spectator 70 -2
 newdef ISGW2HadronicFormFactor:InQuark 70 5
 newdef ISGW2HadronicFormFactor:OutQuark 70 1
 newdef ISGW2HadronicFormFactor:Incoming 71 -521
 newdef ISGW2HadronicFormFactor:Outgoing 71 -20213
 newdef ISGW2HadronicFormFactor:Spin 71 1
 newdef ISGW2HadronicFormFactor:Spectator 71 -2
 newdef ISGW2HadronicFormFactor:InQuark 71 5
 newdef ISGW2HadronicFormFactor:OutQuark 71 1
 newdef ISGW2HadronicFormFactor:Incoming 72 -521
 newdef ISGW2HadronicFormFactor:Outgoing 72 -10211
 newdef ISGW2HadronicFormFactor:Spin 72 0
 newdef ISGW2HadronicFormFactor:Spectator 72 -2
 newdef ISGW2HadronicFormFactor:InQuark 72 5
 newdef ISGW2HadronicFormFactor:OutQuark 72 1
 newdef ISGW2HadronicFormFactor:Incoming 73 -521
 newdef ISGW2HadronicFormFactor:Outgoing 73 221
 newdef ISGW2HadronicFormFactor:Spin 73 0
 newdef ISGW2HadronicFormFactor:Spectator 73 -2
 newdef ISGW2HadronicFormFactor:InQuark 73 5
 newdef ISGW2HadronicFormFactor:OutQuark 73 2
 newdef ISGW2HadronicFormFactor:Incoming 74 -521
 newdef ISGW2HadronicFormFactor:Outgoing 74 331
 newdef ISGW2HadronicFormFactor:Spin 74 0
 newdef ISGW2HadronicFormFactor:Spectator 74 -2
 newdef ISGW2HadronicFormFactor:InQuark 74 5
 newdef ISGW2HadronicFormFactor:OutQuark 74 2
 newdef ISGW2HadronicFormFactor:Incoming 75 -521
 newdef ISGW2HadronicFormFactor:Outgoing 75 223
 newdef ISGW2HadronicFormFactor:Spin 75 1
 newdef ISGW2HadronicFormFactor:Spectator 75 -2
 newdef ISGW2HadronicFormFactor:InQuark 75 5
 newdef ISGW2HadronicFormFactor:OutQuark 75 2
 newdef ISGW2HadronicFormFactor:Incoming 76 -521
 newdef ISGW2HadronicFormFactor:Outgoing 76 225
 newdef ISGW2HadronicFormFactor:Spin 76 2
 newdef ISGW2HadronicFormFactor:Spectator 76 -2
 newdef ISGW2HadronicFormFactor:InQuark 76 5
 newdef ISGW2HadronicFormFactor:OutQuark 76 2
 newdef ISGW2HadronicFormFactor:Incoming 77 -521
 newdef ISGW2HadronicFormFactor:Outgoing 77 10223
 newdef ISGW2HadronicFormFactor:Spin 77 1
 newdef ISGW2HadronicFormFactor:Spectator 77 -2
 newdef ISGW2HadronicFormFactor:InQuark 77 5
 newdef ISGW2HadronicFormFactor:OutQuark 77 2
 newdef ISGW2HadronicFormFactor:Incoming 78 -521
 newdef ISGW2HadronicFormFactor:Outgoing 78 20223
 newdef ISGW2HadronicFormFactor:Spin 78 1
 newdef ISGW2HadronicFormFactor:Spectator 78 -2
 newdef ISGW2HadronicFormFactor:InQuark 78 5
 newdef ISGW2HadronicFormFactor:OutQuark 78 2
 newdef ISGW2HadronicFormFactor:Incoming 79 -521
 newdef ISGW2HadronicFormFactor:Outgoing 79 10221
 newdef ISGW2HadronicFormFactor:Spin 79 0
 newdef ISGW2HadronicFormFactor:Spectator 79 -2
 newdef ISGW2HadronicFormFactor:InQuark 79 5
 newdef ISGW2HadronicFormFactor:OutQuark 79 2
 newdef ISGW2HadronicFormFactor:Incoming 80 -521
 newdef ISGW2HadronicFormFactor:Outgoing 80 111
 newdef ISGW2HadronicFormFactor:Spin 80 0
 newdef ISGW2HadronicFormFactor:Spectator 80 -2
 newdef ISGW2HadronicFormFactor:InQuark 80 5
 newdef ISGW2HadronicFormFactor:OutQuark 80 2
 newdef ISGW2HadronicFormFactor:Incoming 81 -521
 newdef ISGW2HadronicFormFactor:Outgoing 81 113
 newdef ISGW2HadronicFormFactor:Spin 81 1
 newdef ISGW2HadronicFormFactor:Spectator 81 -2
 newdef ISGW2HadronicFormFactor:InQuark 81 5
 newdef ISGW2HadronicFormFactor:OutQuark 81 2
 newdef ISGW2HadronicFormFactor:Incoming 82 -521
 newdef ISGW2HadronicFormFactor:Outgoing 82 115
 newdef ISGW2HadronicFormFactor:Spin 82 2
 newdef ISGW2HadronicFormFactor:Spectator 82 -2
 newdef ISGW2HadronicFormFactor:InQuark 82 5
 newdef ISGW2HadronicFormFactor:OutQuark 82 2
 newdef ISGW2HadronicFormFactor:Incoming 83 -521
 newdef ISGW2HadronicFormFactor:Outgoing 83 10113
 newdef ISGW2HadronicFormFactor:Spin 83 1
 newdef ISGW2HadronicFormFactor:Spectator 83 -2
 newdef ISGW2HadronicFormFactor:InQuark 83 5
 newdef ISGW2HadronicFormFactor:OutQuark 83 2
 newdef ISGW2HadronicFormFactor:Incoming 84 -521
 newdef ISGW2HadronicFormFactor:Outgoing 84 20113
 newdef ISGW2HadronicFormFactor:Spin 84 1
 newdef ISGW2HadronicFormFactor:Spectator 84 -2
 newdef ISGW2HadronicFormFactor:InQuark 84 5
 newdef ISGW2HadronicFormFactor:OutQuark 84 2
 newdef ISGW2HadronicFormFactor:Incoming 85 -521
 newdef ISGW2HadronicFormFactor:Outgoing 85 10111
 newdef ISGW2HadronicFormFactor:Spin 85 0
 newdef ISGW2HadronicFormFactor:Spectator 85 -2
 newdef ISGW2HadronicFormFactor:InQuark 85 5
 newdef ISGW2HadronicFormFactor:OutQuark 85 2
 newdef ISGW2HadronicFormFactor:Incoming 86 -521
 newdef ISGW2HadronicFormFactor:Outgoing 86 -321
 newdef ISGW2HadronicFormFactor:Spin 86 0
 newdef ISGW2HadronicFormFactor:Spectator 86 -2
 newdef ISGW2HadronicFormFactor:InQuark 86 5
 newdef ISGW2HadronicFormFactor:OutQuark 86 3
 newdef ISGW2HadronicFormFactor:Incoming 87 -521
 newdef ISGW2HadronicFormFactor:Outgoing 87 -323
 newdef ISGW2HadronicFormFactor:Spin 87 1
 newdef ISGW2HadronicFormFactor:Spectator 87 -2
 newdef ISGW2HadronicFormFactor:InQuark 87 5
 newdef ISGW2HadronicFormFactor:OutQuark 87 3
 newdef ISGW2HadronicFormFactor:Incoming 88 -521
 newdef ISGW2HadronicFormFactor:Outgoing 88 -325
 newdef ISGW2HadronicFormFactor:Spin 88 2
 newdef ISGW2HadronicFormFactor:Spectator 88 -2
 newdef ISGW2HadronicFormFactor:InQuark 88 5
 newdef ISGW2HadronicFormFactor:OutQuark 88 3
 newdef ISGW2HadronicFormFactor:Incoming 89 -521
 newdef ISGW2HadronicFormFactor:Outgoing 89 -10323
 newdef ISGW2HadronicFormFactor:Spin 89 1
 newdef ISGW2HadronicFormFactor:Spectator 89 -2
 newdef ISGW2HadronicFormFactor:InQuark 89 5
 newdef ISGW2HadronicFormFactor:OutQuark 89 3
 newdef ISGW2HadronicFormFactor:Incoming 90 -521
 newdef ISGW2HadronicFormFactor:Outgoing 90 -20323
 newdef ISGW2HadronicFormFactor:Spin 90 1
 newdef ISGW2HadronicFormFactor:Spectator 90 -2
 newdef ISGW2HadronicFormFactor:InQuark 90 5
 newdef ISGW2HadronicFormFactor:OutQuark 90 3
 newdef ISGW2HadronicFormFactor:Incoming 91 -521
 newdef ISGW2HadronicFormFactor:Outgoing 91 -10321
 newdef ISGW2HadronicFormFactor:Spin 91 0
 newdef ISGW2HadronicFormFactor:Spectator 91 -2
 newdef ISGW2HadronicFormFactor:InQuark 91 5
 newdef ISGW2HadronicFormFactor:OutQuark 91 3
 newdef ISGW2HadronicFormFactor:Incoming 92 -521
 newdef ISGW2HadronicFormFactor:Outgoing 92 421
 newdef ISGW2HadronicFormFactor:Spin 92 0
 newdef ISGW2HadronicFormFactor:Spectator 92 -2
 newdef ISGW2HadronicFormFactor:InQuark 92 5
 newdef ISGW2HadronicFormFactor:OutQuark 92 4
 newdef ISGW2HadronicFormFactor:Incoming 93 -521
 newdef ISGW2HadronicFormFactor:Outgoing 93 423
 newdef ISGW2HadronicFormFactor:Spin 93 1
 newdef ISGW2HadronicFormFactor:Spectator 93 -2
 newdef ISGW2HadronicFormFactor:InQuark 93 5
 newdef ISGW2HadronicFormFactor:OutQuark 93 4
 newdef ISGW2HadronicFormFactor:Incoming 94 -521
 newdef ISGW2HadronicFormFactor:Outgoing 94 425
 newdef ISGW2HadronicFormFactor:Spin 94 2
 newdef ISGW2HadronicFormFactor:Spectator 94 -2
 newdef ISGW2HadronicFormFactor:InQuark 94 5
 newdef ISGW2HadronicFormFactor:OutQuark 94 4
 newdef ISGW2HadronicFormFactor:Incoming 95 -521
 newdef ISGW2HadronicFormFactor:Outgoing 95 10423
 newdef ISGW2HadronicFormFactor:Spin 95 1
 newdef ISGW2HadronicFormFactor:Spectator 95 -2
 newdef ISGW2HadronicFormFactor:InQuark 95 5
 newdef ISGW2HadronicFormFactor:OutQuark 95 4
 newdef ISGW2HadronicFormFactor:Incoming 96 -521
 newdef ISGW2HadronicFormFactor:Outgoing 96 20423
 newdef ISGW2HadronicFormFactor:Spin 96 1
 newdef ISGW2HadronicFormFactor:Spectator 96 -2
 newdef ISGW2HadronicFormFactor:InQuark 96 5
 newdef ISGW2HadronicFormFactor:OutQuark 96 4
 newdef ISGW2HadronicFormFactor:Incoming 97 -521
 newdef ISGW2HadronicFormFactor:Outgoing 97 10421
 newdef ISGW2HadronicFormFactor:Spin 97 0
 newdef ISGW2HadronicFormFactor:Spectator 97 -2
 newdef ISGW2HadronicFormFactor:InQuark 97 5
 newdef ISGW2HadronicFormFactor:OutQuark 97 4
 newdef ISGW2HadronicFormFactor:Incoming 98 -511
 newdef ISGW2HadronicFormFactor:Outgoing 98 221
 newdef ISGW2HadronicFormFactor:Spin 98 0
 newdef ISGW2HadronicFormFactor:Spectator 98 1
 newdef ISGW2HadronicFormFactor:InQuark 98 -5
 newdef ISGW2HadronicFormFactor:OutQuark 98 -1
 newdef ISGW2HadronicFormFactor:Incoming 99 -511
 newdef ISGW2HadronicFormFactor:Outgoing 99 331
 newdef ISGW2HadronicFormFactor:Spin 99 0
 newdef ISGW2HadronicFormFactor:Spectator 99 1
 newdef ISGW2HadronicFormFactor:InQuark 99 -5
 newdef ISGW2HadronicFormFactor:OutQuark 99 -1
 newdef ISGW2HadronicFormFactor:Incoming 100 -511
 newdef ISGW2HadronicFormFactor:Outgoing 100 223
 newdef ISGW2HadronicFormFactor:Spin 100 1
 newdef ISGW2HadronicFormFactor:Spectator 100 1
 newdef ISGW2HadronicFormFactor:InQuark 100 -5
 newdef ISGW2HadronicFormFactor:OutQuark 100 -1
 newdef ISGW2HadronicFormFactor:Incoming 101 -511
 newdef ISGW2HadronicFormFactor:Outgoing 101 225
 newdef ISGW2HadronicFormFactor:Spin 101 2
 newdef ISGW2HadronicFormFactor:Spectator 101 1
 newdef ISGW2HadronicFormFactor:InQuark 101 -5
 newdef ISGW2HadronicFormFactor:OutQuark 101 -1
 newdef ISGW2HadronicFormFactor:Incoming 102 -511
 newdef ISGW2HadronicFormFactor:Outgoing 102 10223
 newdef ISGW2HadronicFormFactor:Spin 102 1
 newdef ISGW2HadronicFormFactor:Spectator 102 1
 newdef ISGW2HadronicFormFactor:InQuark 102 -5
 newdef ISGW2HadronicFormFactor:OutQuark 102 -1
 newdef ISGW2HadronicFormFactor:Incoming 103 -511
 newdef ISGW2HadronicFormFactor:Outgoing 103 20223
 newdef ISGW2HadronicFormFactor:Spin 103 1
 newdef ISGW2HadronicFormFactor:Spectator 103 1
 newdef ISGW2HadronicFormFactor:InQuark 103 -5
 newdef ISGW2HadronicFormFactor:OutQuark 103 -1
 newdef ISGW2HadronicFormFactor:Incoming 104 -511
 newdef ISGW2HadronicFormFactor:Outgoing 104 10221
 newdef ISGW2HadronicFormFactor:Spin 104 0
 newdef ISGW2HadronicFormFactor:Spectator 104 1
 newdef ISGW2HadronicFormFactor:InQuark 104 -5
 newdef ISGW2HadronicFormFactor:OutQuark 104 -1
 newdef ISGW2HadronicFormFactor:Incoming 105 -511
 newdef ISGW2HadronicFormFactor:Outgoing 105 111
 newdef ISGW2HadronicFormFactor:Spin 105 0
 newdef ISGW2HadronicFormFactor:Spectator 105 1
 newdef ISGW2HadronicFormFactor:InQuark 105 -5
 newdef ISGW2HadronicFormFactor:OutQuark 105 -1
 newdef ISGW2HadronicFormFactor:Incoming 106 -511
 newdef ISGW2HadronicFormFactor:Outgoing 106 113
 newdef ISGW2HadronicFormFactor:Spin 106 1
 newdef ISGW2HadronicFormFactor:Spectator 106 1
 newdef ISGW2HadronicFormFactor:InQuark 106 -5
 newdef ISGW2HadronicFormFactor:OutQuark 106 -1
 newdef ISGW2HadronicFormFactor:Incoming 107 -511
 newdef ISGW2HadronicFormFactor:Outgoing 107 115
 newdef ISGW2HadronicFormFactor:Spin 107 2
 newdef ISGW2HadronicFormFactor:Spectator 107 1
 newdef ISGW2HadronicFormFactor:InQuark 107 -5
 newdef ISGW2HadronicFormFactor:OutQuark 107 -1
 newdef ISGW2HadronicFormFactor:Incoming 108 -511
 newdef ISGW2HadronicFormFactor:Outgoing 108 10113
 newdef ISGW2HadronicFormFactor:Spin 108 1
 newdef ISGW2HadronicFormFactor:Spectator 108 1
 newdef ISGW2HadronicFormFactor:InQuark 108 -5
 newdef ISGW2HadronicFormFactor:OutQuark 108 -1
 newdef ISGW2HadronicFormFactor:Incoming 109 -511
 newdef ISGW2HadronicFormFactor:Outgoing 109 20113
 newdef ISGW2HadronicFormFactor:Spin 109 1
 newdef ISGW2HadronicFormFactor:Spectator 109 1
 newdef ISGW2HadronicFormFactor:InQuark 109 -5
 newdef ISGW2HadronicFormFactor:OutQuark 109 -1
 newdef ISGW2HadronicFormFactor:Incoming 110 -511
 newdef ISGW2HadronicFormFactor:Outgoing 110 10111
 newdef ISGW2HadronicFormFactor:Spin 110 0
 newdef ISGW2HadronicFormFactor:Spectator 110 1
 newdef ISGW2HadronicFormFactor:InQuark 110 -5
 newdef ISGW2HadronicFormFactor:OutQuark 110 -1
 newdef ISGW2HadronicFormFactor:Incoming 111 -511
 newdef ISGW2HadronicFormFactor:Outgoing 111 211
 newdef ISGW2HadronicFormFactor:Spin 111 0
 newdef ISGW2HadronicFormFactor:Spectator 111 1
 newdef ISGW2HadronicFormFactor:InQuark 111 -5
 newdef ISGW2HadronicFormFactor:OutQuark 111 -2
 newdef ISGW2HadronicFormFactor:Incoming 112 -511
 newdef ISGW2HadronicFormFactor:Outgoing 112 213
 newdef ISGW2HadronicFormFactor:Spin 112 1
 newdef ISGW2HadronicFormFactor:Spectator 112 1
 newdef ISGW2HadronicFormFactor:InQuark 112 -5
 newdef ISGW2HadronicFormFactor:OutQuark 112 -2
 newdef ISGW2HadronicFormFactor:Incoming 113 -511
 newdef ISGW2HadronicFormFactor:Outgoing 113 215
 newdef ISGW2HadronicFormFactor:Spin 113 2
 newdef ISGW2HadronicFormFactor:Spectator 113 1
 newdef ISGW2HadronicFormFactor:InQuark 113 -5
 newdef ISGW2HadronicFormFactor:OutQuark 113 -2
 newdef ISGW2HadronicFormFactor:Incoming 114 -511
 newdef ISGW2HadronicFormFactor:Outgoing 114 10213
 newdef ISGW2HadronicFormFactor:Spin 114 1
 newdef ISGW2HadronicFormFactor:Spectator 114 1
 newdef ISGW2HadronicFormFactor:InQuark 114 -5
 newdef ISGW2HadronicFormFactor:OutQuark 114 -2
 newdef ISGW2HadronicFormFactor:Incoming 115 -511
 newdef ISGW2HadronicFormFactor:Outgoing 115 20213
 newdef ISGW2HadronicFormFactor:Spin 115 1
 newdef ISGW2HadronicFormFactor:Spectator 115 1
 newdef ISGW2HadronicFormFactor:InQuark 115 -5
 newdef ISGW2HadronicFormFactor:OutQuark 115 -2
 newdef ISGW2HadronicFormFactor:Incoming 116 -511
 newdef ISGW2HadronicFormFactor:Outgoing 116 10211
 newdef ISGW2HadronicFormFactor:Spin 116 0
 newdef ISGW2HadronicFormFactor:Spectator 116 1
 newdef ISGW2HadronicFormFactor:InQuark 116 -5
 newdef ISGW2HadronicFormFactor:OutQuark 116 -2
 newdef ISGW2HadronicFormFactor:Incoming 117 -511
 newdef ISGW2HadronicFormFactor:Outgoing 117 311
 newdef ISGW2HadronicFormFactor:Spin 117 0
 newdef ISGW2HadronicFormFactor:Spectator 117 1
 newdef ISGW2HadronicFormFactor:InQuark 117 -5
 newdef ISGW2HadronicFormFactor:OutQuark 117 -3
 newdef ISGW2HadronicFormFactor:Incoming 118 -511
 newdef ISGW2HadronicFormFactor:Outgoing 118 313
 newdef ISGW2HadronicFormFactor:Spin 118 1
 newdef ISGW2HadronicFormFactor:Spectator 118 1
 newdef ISGW2HadronicFormFactor:InQuark 118 -5
 newdef ISGW2HadronicFormFactor:OutQuark 118 -3
 newdef ISGW2HadronicFormFactor:Incoming 119 -511
 newdef ISGW2HadronicFormFactor:Outgoing 119 315
 newdef ISGW2HadronicFormFactor:Spin 119 2
 newdef ISGW2HadronicFormFactor:Spectator 119 1
 newdef ISGW2HadronicFormFactor:InQuark 119 -5
 newdef ISGW2HadronicFormFactor:OutQuark 119 -3
 newdef ISGW2HadronicFormFactor:Incoming 120 -511
 newdef ISGW2HadronicFormFactor:Outgoing 120 10313
 newdef ISGW2HadronicFormFactor:Spin 120 1
 newdef ISGW2HadronicFormFactor:Spectator 120 1
 newdef ISGW2HadronicFormFactor:InQuark 120 -5
 newdef ISGW2HadronicFormFactor:OutQuark 120 -3
 newdef ISGW2HadronicFormFactor:Incoming 121 -511
 newdef ISGW2HadronicFormFactor:Outgoing 121 20313
 newdef ISGW2HadronicFormFactor:Spin 121 1
 newdef ISGW2HadronicFormFactor:Spectator 121 1
 newdef ISGW2HadronicFormFactor:InQuark 121 -5
 newdef ISGW2HadronicFormFactor:OutQuark 121 -3
 newdef ISGW2HadronicFormFactor:Incoming 122 -511
 newdef ISGW2HadronicFormFactor:Outgoing 122 10311
 newdef ISGW2HadronicFormFactor:Spin 122 0
 newdef ISGW2HadronicFormFactor:Spectator 122 1
 newdef ISGW2HadronicFormFactor:InQuark 122 -5
 newdef ISGW2HadronicFormFactor:OutQuark 122 -3
 newdef ISGW2HadronicFormFactor:Incoming 123 -511
 newdef ISGW2HadronicFormFactor:Outgoing 123 411
 newdef ISGW2HadronicFormFactor:Spin 123 0
 newdef ISGW2HadronicFormFactor:Spectator 123 1
 newdef ISGW2HadronicFormFactor:InQuark 123 -5
 newdef ISGW2HadronicFormFactor:OutQuark 123 -4
 newdef ISGW2HadronicFormFactor:Incoming 124 -511
 newdef ISGW2HadronicFormFactor:Outgoing 124 413
 newdef ISGW2HadronicFormFactor:Spin 124 1
 newdef ISGW2HadronicFormFactor:Spectator 124 1
 newdef ISGW2HadronicFormFactor:InQuark 124 -5
 newdef ISGW2HadronicFormFactor:OutQuark 124 -4
 newdef ISGW2HadronicFormFactor:Incoming 125 -511
 newdef ISGW2HadronicFormFactor:Outgoing 125 415
 newdef ISGW2HadronicFormFactor:Spin 125 2
 newdef ISGW2HadronicFormFactor:Spectator 125 1
 newdef ISGW2HadronicFormFactor:InQuark 125 -5
 newdef ISGW2HadronicFormFactor:OutQuark 125 -4
 newdef ISGW2HadronicFormFactor:Incoming 126 -511
 newdef ISGW2HadronicFormFactor:Outgoing 126 10413
 newdef ISGW2HadronicFormFactor:Spin 126 1
 newdef ISGW2HadronicFormFactor:Spectator 126 1
 newdef ISGW2HadronicFormFactor:InQuark 126 -5
 newdef ISGW2HadronicFormFactor:OutQuark 126 -4
 newdef ISGW2HadronicFormFactor:Incoming 127 -511
 newdef ISGW2HadronicFormFactor:Outgoing 127 20413
 newdef ISGW2HadronicFormFactor:Spin 127 1
 newdef ISGW2HadronicFormFactor:Spectator 127 1
 newdef ISGW2HadronicFormFactor:InQuark 127 -5
 newdef ISGW2HadronicFormFactor:OutQuark 127 -4
 newdef ISGW2HadronicFormFactor:Incoming 128 -511
 newdef ISGW2HadronicFormFactor:Outgoing 128 10411
 newdef ISGW2HadronicFormFactor:Spin 128 0
 newdef ISGW2HadronicFormFactor:Spectator 128 1
 newdef ISGW2HadronicFormFactor:InQuark 128 -5
 newdef ISGW2HadronicFormFactor:OutQuark 128 -4
 newdef ISGW2HadronicFormFactor:Incoming 129 431
 newdef ISGW2HadronicFormFactor:Outgoing 129 311
 newdef ISGW2HadronicFormFactor:Spin 129 0
 newdef ISGW2HadronicFormFactor:Spectator 129 -3
 newdef ISGW2HadronicFormFactor:InQuark 129 4
 newdef ISGW2HadronicFormFactor:OutQuark 129 1
 newdef ISGW2HadronicFormFactor:Incoming 130 431
 newdef ISGW2HadronicFormFactor:Outgoing 130 313
 newdef ISGW2HadronicFormFactor:Spin 130 1
 newdef ISGW2HadronicFormFactor:Spectator 130 -3
 newdef ISGW2HadronicFormFactor:InQuark 130 4
 newdef ISGW2HadronicFormFactor:OutQuark 130 1
 newdef ISGW2HadronicFormFactor:Incoming 131 431
 newdef ISGW2HadronicFormFactor:Outgoing 131 315
 newdef ISGW2HadronicFormFactor:Spin 131 2
 newdef ISGW2HadronicFormFactor:Spectator 131 -3
 newdef ISGW2HadronicFormFactor:InQuark 131 4
 newdef ISGW2HadronicFormFactor:OutQuark 131 1
 newdef ISGW2HadronicFormFactor:Incoming 132 431
 newdef ISGW2HadronicFormFactor:Outgoing 132 10313
 newdef ISGW2HadronicFormFactor:Spin 132 1
 newdef ISGW2HadronicFormFactor:Spectator 132 -3
 newdef ISGW2HadronicFormFactor:InQuark 132 4
 newdef ISGW2HadronicFormFactor:OutQuark 132 1
 newdef ISGW2HadronicFormFactor:Incoming 133 431
 newdef ISGW2HadronicFormFactor:Outgoing 133 20313
 newdef ISGW2HadronicFormFactor:Spin 133 1
 newdef ISGW2HadronicFormFactor:Spectator 133 -3
 newdef ISGW2HadronicFormFactor:InQuark 133 4
 newdef ISGW2HadronicFormFactor:OutQuark 133 1
 newdef ISGW2HadronicFormFactor:Incoming 134 431
 newdef ISGW2HadronicFormFactor:Outgoing 134 10311
 newdef ISGW2HadronicFormFactor:Spin 134 0
 newdef ISGW2HadronicFormFactor:Spectator 134 -3
 newdef ISGW2HadronicFormFactor:InQuark 134 4
 newdef ISGW2HadronicFormFactor:OutQuark 134 1
 newdef ISGW2HadronicFormFactor:Incoming 135 431
 newdef ISGW2HadronicFormFactor:Outgoing 135 321
 newdef ISGW2HadronicFormFactor:Spin 135 0
 newdef ISGW2HadronicFormFactor:Spectator 135 -3
 newdef ISGW2HadronicFormFactor:InQuark 135 4
 newdef ISGW2HadronicFormFactor:OutQuark 135 2
 newdef ISGW2HadronicFormFactor:Incoming 136 431
 newdef ISGW2HadronicFormFactor:Outgoing 136 323
 newdef ISGW2HadronicFormFactor:Spin 136 1
 newdef ISGW2HadronicFormFactor:Spectator 136 -3
 newdef ISGW2HadronicFormFactor:InQuark 136 4
 newdef ISGW2HadronicFormFactor:OutQuark 136 2
 newdef ISGW2HadronicFormFactor:Incoming 137 431
 newdef ISGW2HadronicFormFactor:Outgoing 137 325
 newdef ISGW2HadronicFormFactor:Spin 137 2
 newdef ISGW2HadronicFormFactor:Spectator 137 -3
 newdef ISGW2HadronicFormFactor:InQuark 137 4
 newdef ISGW2HadronicFormFactor:OutQuark 137 2
 newdef ISGW2HadronicFormFactor:Incoming 138 431
 newdef ISGW2HadronicFormFactor:Outgoing 138 10323
 newdef ISGW2HadronicFormFactor:Spin 138 1
 newdef ISGW2HadronicFormFactor:Spectator 138 -3
 newdef ISGW2HadronicFormFactor:InQuark 138 4
 newdef ISGW2HadronicFormFactor:OutQuark 138 2
 newdef ISGW2HadronicFormFactor:Incoming 139 431
 newdef ISGW2HadronicFormFactor:Outgoing 139 20323
 newdef ISGW2HadronicFormFactor:Spin 139 1
 newdef ISGW2HadronicFormFactor:Spectator 139 -3
 newdef ISGW2HadronicFormFactor:InQuark 139 4
 newdef ISGW2HadronicFormFactor:OutQuark 139 2
 newdef ISGW2HadronicFormFactor:Incoming 140 431
 newdef ISGW2HadronicFormFactor:Outgoing 140 10321
 newdef ISGW2HadronicFormFactor:Spin 140 0
 newdef ISGW2HadronicFormFactor:Spectator 140 -3
 newdef ISGW2HadronicFormFactor:InQuark 140 4
 newdef ISGW2HadronicFormFactor:OutQuark 140 2
 newdef ISGW2HadronicFormFactor:Incoming 141 431
 newdef ISGW2HadronicFormFactor:Outgoing 141 221
 newdef ISGW2HadronicFormFactor:Spin 141 0
 newdef ISGW2HadronicFormFactor:Spectator 141 -3
 newdef ISGW2HadronicFormFactor:InQuark 141 4
 newdef ISGW2HadronicFormFactor:OutQuark 141 3
 newdef ISGW2HadronicFormFactor:Incoming 142 431
 newdef ISGW2HadronicFormFactor:Outgoing 142 331
 newdef ISGW2HadronicFormFactor:Spin 142 0
 newdef ISGW2HadronicFormFactor:Spectator 142 -3
 newdef ISGW2HadronicFormFactor:InQuark 142 4
 newdef ISGW2HadronicFormFactor:OutQuark 142 3
 newdef ISGW2HadronicFormFactor:Incoming 143 431
 newdef ISGW2HadronicFormFactor:Outgoing 143 333
 newdef ISGW2HadronicFormFactor:Spin 143 1
 newdef ISGW2HadronicFormFactor:Spectator 143 -3
 newdef ISGW2HadronicFormFactor:InQuark 143 4
 newdef ISGW2HadronicFormFactor:OutQuark 143 3
 newdef ISGW2HadronicFormFactor:Incoming 144 431
 newdef ISGW2HadronicFormFactor:Outgoing 144 335
 newdef ISGW2HadronicFormFactor:Spin 144 2
 newdef ISGW2HadronicFormFactor:Spectator 144 -3
 newdef ISGW2HadronicFormFactor:InQuark 144 4
 newdef ISGW2HadronicFormFactor:OutQuark 144 3
 newdef ISGW2HadronicFormFactor:Incoming 145 431
 newdef ISGW2HadronicFormFactor:Outgoing 145 10333
 newdef ISGW2HadronicFormFactor:Spin 145 1
 newdef ISGW2HadronicFormFactor:Spectator 145 -3
 newdef ISGW2HadronicFormFactor:InQuark 145 4
 newdef ISGW2HadronicFormFactor:OutQuark 145 3
 newdef ISGW2HadronicFormFactor:Incoming 146 431
 newdef ISGW2HadronicFormFactor:Outgoing 146 20333
 newdef ISGW2HadronicFormFactor:Spin 146 1
 newdef ISGW2HadronicFormFactor:Spectator 146 -3
 newdef ISGW2HadronicFormFactor:InQuark 146 4
 newdef ISGW2HadronicFormFactor:OutQuark 146 3
 newdef ISGW2HadronicFormFactor:Incoming 147 431
 newdef ISGW2HadronicFormFactor:Outgoing 147 10331
 newdef ISGW2HadronicFormFactor:Spin 147 0
 newdef ISGW2HadronicFormFactor:Spectator 147 -3
 newdef ISGW2HadronicFormFactor:InQuark 147 4
 newdef ISGW2HadronicFormFactor:OutQuark 147 3
 newdef ISGW2HadronicFormFactor:Incoming 148 421
 newdef ISGW2HadronicFormFactor:Outgoing 148 -211
 newdef ISGW2HadronicFormFactor:Spin 148 0
 newdef ISGW2HadronicFormFactor:Spectator 148 -2
 newdef ISGW2HadronicFormFactor:InQuark 148 4
 newdef ISGW2HadronicFormFactor:OutQuark 148 1
 newdef ISGW2HadronicFormFactor:Incoming 149 421
 newdef ISGW2HadronicFormFactor:Outgoing 149 -213
 newdef ISGW2HadronicFormFactor:Spin 149 1
 newdef ISGW2HadronicFormFactor:Spectator 149 -2
 newdef ISGW2HadronicFormFactor:InQuark 149 4
 newdef ISGW2HadronicFormFactor:OutQuark 149 1
 newdef ISGW2HadronicFormFactor:Incoming 150 421
 newdef ISGW2HadronicFormFactor:Outgoing 150 -215
 newdef ISGW2HadronicFormFactor:Spin 150 2
 newdef ISGW2HadronicFormFactor:Spectator 150 -2
 newdef ISGW2HadronicFormFactor:InQuark 150 4
 newdef ISGW2HadronicFormFactor:OutQuark 150 1
 newdef ISGW2HadronicFormFactor:Incoming 151 421
 newdef ISGW2HadronicFormFactor:Outgoing 151 -10213
 newdef ISGW2HadronicFormFactor:Spin 151 1
 newdef ISGW2HadronicFormFactor:Spectator 151 -2
 newdef ISGW2HadronicFormFactor:InQuark 151 4
 newdef ISGW2HadronicFormFactor:OutQuark 151 1
 newdef ISGW2HadronicFormFactor:Incoming 152 421
 newdef ISGW2HadronicFormFactor:Outgoing 152 -20213
 newdef ISGW2HadronicFormFactor:Spin 152 1
 newdef ISGW2HadronicFormFactor:Spectator 152 -2
 newdef ISGW2HadronicFormFactor:InQuark 152 4
 newdef ISGW2HadronicFormFactor:OutQuark 152 1
 newdef ISGW2HadronicFormFactor:Incoming 153 421
 newdef ISGW2HadronicFormFactor:Outgoing 153 -10211
 newdef ISGW2HadronicFormFactor:Spin 153 0
 newdef ISGW2HadronicFormFactor:Spectator 153 -2
 newdef ISGW2HadronicFormFactor:InQuark 153 4
 newdef ISGW2HadronicFormFactor:OutQuark 153 1
 newdef ISGW2HadronicFormFactor:Incoming 154 421
 newdef ISGW2HadronicFormFactor:Outgoing 154 111
 newdef ISGW2HadronicFormFactor:Spin 154 0
 newdef ISGW2HadronicFormFactor:Spectator 154 -2
 newdef ISGW2HadronicFormFactor:InQuark 154 4
 newdef ISGW2HadronicFormFactor:OutQuark 154 2
 newdef ISGW2HadronicFormFactor:Incoming 155 421
 newdef ISGW2HadronicFormFactor:Outgoing 155 113
 newdef ISGW2HadronicFormFactor:Spin 155 1
 newdef ISGW2HadronicFormFactor:Spectator 155 -2
 newdef ISGW2HadronicFormFactor:InQuark 155 4
 newdef ISGW2HadronicFormFactor:OutQuark 155 2
 newdef ISGW2HadronicFormFactor:Incoming 156 421
 newdef ISGW2HadronicFormFactor:Outgoing 156 115
 newdef ISGW2HadronicFormFactor:Spin 156 2
 newdef ISGW2HadronicFormFactor:Spectator 156 -2
 newdef ISGW2HadronicFormFactor:InQuark 156 4
 newdef ISGW2HadronicFormFactor:OutQuark 156 2
 newdef ISGW2HadronicFormFactor:Incoming 157 421
 newdef ISGW2HadronicFormFactor:Outgoing 157 10113
 newdef ISGW2HadronicFormFactor:Spin 157 1
 newdef ISGW2HadronicFormFactor:Spectator 157 -2
 newdef ISGW2HadronicFormFactor:InQuark 157 4
 newdef ISGW2HadronicFormFactor:OutQuark 157 2
 newdef ISGW2HadronicFormFactor:Incoming 158 421
 newdef ISGW2HadronicFormFactor:Outgoing 158 20113
 newdef ISGW2HadronicFormFactor:Spin 158 1
 newdef ISGW2HadronicFormFactor:Spectator 158 -2
 newdef ISGW2HadronicFormFactor:InQuark 158 4
 newdef ISGW2HadronicFormFactor:OutQuark 158 2
 newdef ISGW2HadronicFormFactor:Incoming 159 421
 newdef ISGW2HadronicFormFactor:Outgoing 159 10111
 newdef ISGW2HadronicFormFactor:Spin 159 0
 newdef ISGW2HadronicFormFactor:Spectator 159 -2
 newdef ISGW2HadronicFormFactor:InQuark 159 4
 newdef ISGW2HadronicFormFactor:OutQuark 159 2
 newdef ISGW2HadronicFormFactor:Incoming 160 421
 newdef ISGW2HadronicFormFactor:Outgoing 160 221
 newdef ISGW2HadronicFormFactor:Spin 160 0
 newdef ISGW2HadronicFormFactor:Spectator 160 -2
 newdef ISGW2HadronicFormFactor:InQuark 160 4
 newdef ISGW2HadronicFormFactor:OutQuark 160 2
 newdef ISGW2HadronicFormFactor:Incoming 161 421
 newdef ISGW2HadronicFormFactor:Outgoing 161 331
 newdef ISGW2HadronicFormFactor:Spin 161 0
 newdef ISGW2HadronicFormFactor:Spectator 161 -2
 newdef ISGW2HadronicFormFactor:InQuark 161 4
 newdef ISGW2HadronicFormFactor:OutQuark 161 2
 newdef ISGW2HadronicFormFactor:Incoming 162 421
 newdef ISGW2HadronicFormFactor:Outgoing 162 223
 newdef ISGW2HadronicFormFactor:Spin 162 1
 newdef ISGW2HadronicFormFactor:Spectator 162 -2
 newdef ISGW2HadronicFormFactor:InQuark 162 4
 newdef ISGW2HadronicFormFactor:OutQuark 162 2
 newdef ISGW2HadronicFormFactor:Incoming 163 421
 newdef ISGW2HadronicFormFactor:Outgoing 163 225
 newdef ISGW2HadronicFormFactor:Spin 163 2
 newdef ISGW2HadronicFormFactor:Spectator 163 -2
 newdef ISGW2HadronicFormFactor:InQuark 163 4
 newdef ISGW2HadronicFormFactor:OutQuark 163 2
 newdef ISGW2HadronicFormFactor:Incoming 164 421
 newdef ISGW2HadronicFormFactor:Outgoing 164 10223
 newdef ISGW2HadronicFormFactor:Spin 164 1
 newdef ISGW2HadronicFormFactor:Spectator 164 -2
 newdef ISGW2HadronicFormFactor:InQuark 164 4
 newdef ISGW2HadronicFormFactor:OutQuark 164 2
 newdef ISGW2HadronicFormFactor:Incoming 165 421
 newdef ISGW2HadronicFormFactor:Outgoing 165 20223
 newdef ISGW2HadronicFormFactor:Spin 165 1
 newdef ISGW2HadronicFormFactor:Spectator 165 -2
 newdef ISGW2HadronicFormFactor:InQuark 165 4
 newdef ISGW2HadronicFormFactor:OutQuark 165 2
 newdef ISGW2HadronicFormFactor:Incoming 166 421
 newdef ISGW2HadronicFormFactor:Outgoing 166 10221
 newdef ISGW2HadronicFormFactor:Spin 166 0
 newdef ISGW2HadronicFormFactor:Spectator 166 -2
 newdef ISGW2HadronicFormFactor:InQuark 166 4
 newdef ISGW2HadronicFormFactor:OutQuark 166 2
 newdef ISGW2HadronicFormFactor:Incoming 167 421
 newdef ISGW2HadronicFormFactor:Outgoing 167 -321
 newdef ISGW2HadronicFormFactor:Spin 167 0
 newdef ISGW2HadronicFormFactor:Spectator 167 -2
 newdef ISGW2HadronicFormFactor:InQuark 167 4
 newdef ISGW2HadronicFormFactor:OutQuark 167 3
 newdef ISGW2HadronicFormFactor:Incoming 168 421
 newdef ISGW2HadronicFormFactor:Outgoing 168 -323
 newdef ISGW2HadronicFormFactor:Spin 168 1
 newdef ISGW2HadronicFormFactor:Spectator 168 -2
 newdef ISGW2HadronicFormFactor:InQuark 168 4
 newdef ISGW2HadronicFormFactor:OutQuark 168 3
 newdef ISGW2HadronicFormFactor:Incoming 169 421
 newdef ISGW2HadronicFormFactor:Outgoing 169 -325
 newdef ISGW2HadronicFormFactor:Spin 169 2
 newdef ISGW2HadronicFormFactor:Spectator 169 -2
 newdef ISGW2HadronicFormFactor:InQuark 169 4
 newdef ISGW2HadronicFormFactor:OutQuark 169 3
 newdef ISGW2HadronicFormFactor:Incoming 170 421
 newdef ISGW2HadronicFormFactor:Outgoing 170 -10323
 newdef ISGW2HadronicFormFactor:Spin 170 1
 newdef ISGW2HadronicFormFactor:Spectator 170 -2
 newdef ISGW2HadronicFormFactor:InQuark 170 4
 newdef ISGW2HadronicFormFactor:OutQuark 170 3
 newdef ISGW2HadronicFormFactor:Incoming 171 421
 newdef ISGW2HadronicFormFactor:Outgoing 171 -20323
 newdef ISGW2HadronicFormFactor:Spin 171 1
 newdef ISGW2HadronicFormFactor:Spectator 171 -2
 newdef ISGW2HadronicFormFactor:InQuark 171 4
 newdef ISGW2HadronicFormFactor:OutQuark 171 3
 newdef ISGW2HadronicFormFactor:Incoming 172 421
 newdef ISGW2HadronicFormFactor:Outgoing 172 -10321
 newdef ISGW2HadronicFormFactor:Spin 172 0
 newdef ISGW2HadronicFormFactor:Spectator 172 -2
 newdef ISGW2HadronicFormFactor:InQuark 172 4
 newdef ISGW2HadronicFormFactor:OutQuark 172 3
 newdef ISGW2HadronicFormFactor:Incoming 173 411
 newdef ISGW2HadronicFormFactor:Outgoing 173 221
 newdef ISGW2HadronicFormFactor:Spin 173 0
 newdef ISGW2HadronicFormFactor:Spectator 173 -1
 newdef ISGW2HadronicFormFactor:InQuark 173 4
 newdef ISGW2HadronicFormFactor:OutQuark 173 1
 newdef ISGW2HadronicFormFactor:Incoming 174 411
 newdef ISGW2HadronicFormFactor:Outgoing 174 331
 newdef ISGW2HadronicFormFactor:Spin 174 0
 newdef ISGW2HadronicFormFactor:Spectator 174 -1
 newdef ISGW2HadronicFormFactor:InQuark 174 4
 newdef ISGW2HadronicFormFactor:OutQuark 174 1
 newdef ISGW2HadronicFormFactor:Incoming 175 411
 newdef ISGW2HadronicFormFactor:Outgoing 175 223
 newdef ISGW2HadronicFormFactor:Spin 175 1
 newdef ISGW2HadronicFormFactor:Spectator 175 -1
 newdef ISGW2HadronicFormFactor:InQuark 175 4
 newdef ISGW2HadronicFormFactor:OutQuark 175 1
 newdef ISGW2HadronicFormFactor:Incoming 176 411
 newdef ISGW2HadronicFormFactor:Outgoing 176 225
 newdef ISGW2HadronicFormFactor:Spin 176 2
 newdef ISGW2HadronicFormFactor:Spectator 176 -1
 newdef ISGW2HadronicFormFactor:InQuark 176 4
 newdef ISGW2HadronicFormFactor:OutQuark 176 1
 newdef ISGW2HadronicFormFactor:Incoming 177 411
 newdef ISGW2HadronicFormFactor:Outgoing 177 10223
 newdef ISGW2HadronicFormFactor:Spin 177 1
 newdef ISGW2HadronicFormFactor:Spectator 177 -1
 newdef ISGW2HadronicFormFactor:InQuark 177 4
 newdef ISGW2HadronicFormFactor:OutQuark 177 1
 newdef ISGW2HadronicFormFactor:Incoming 178 411
 newdef ISGW2HadronicFormFactor:Outgoing 178 20223
 newdef ISGW2HadronicFormFactor:Spin 178 1
 newdef ISGW2HadronicFormFactor:Spectator 178 -1
 newdef ISGW2HadronicFormFactor:InQuark 178 4
 newdef ISGW2HadronicFormFactor:OutQuark 178 1
 newdef ISGW2HadronicFormFactor:Incoming 179 411
 newdef ISGW2HadronicFormFactor:Outgoing 179 10221
 newdef ISGW2HadronicFormFactor:Spin 179 0
 newdef ISGW2HadronicFormFactor:Spectator 179 -1
 newdef ISGW2HadronicFormFactor:InQuark 179 4
 newdef ISGW2HadronicFormFactor:OutQuark 179 1
 newdef ISGW2HadronicFormFactor:Incoming 180 411
 newdef ISGW2HadronicFormFactor:Outgoing 180 111
 newdef ISGW2HadronicFormFactor:Spin 180 0
 newdef ISGW2HadronicFormFactor:Spectator 180 -1
 newdef ISGW2HadronicFormFactor:InQuark 180 4
 newdef ISGW2HadronicFormFactor:OutQuark 180 1
 newdef ISGW2HadronicFormFactor:Incoming 181 411
 newdef ISGW2HadronicFormFactor:Outgoing 181 113
 newdef ISGW2HadronicFormFactor:Spin 181 1
 newdef ISGW2HadronicFormFactor:Spectator 181 -1
 newdef ISGW2HadronicFormFactor:InQuark 181 4
 newdef ISGW2HadronicFormFactor:OutQuark 181 1
 newdef ISGW2HadronicFormFactor:Incoming 182 411
 newdef ISGW2HadronicFormFactor:Outgoing 182 115
 newdef ISGW2HadronicFormFactor:Spin 182 2
 newdef ISGW2HadronicFormFactor:Spectator 182 -1
 newdef ISGW2HadronicFormFactor:InQuark 182 4
 newdef ISGW2HadronicFormFactor:OutQuark 182 1
 newdef ISGW2HadronicFormFactor:Incoming 183 411
 newdef ISGW2HadronicFormFactor:Outgoing 183 10113
 newdef ISGW2HadronicFormFactor:Spin 183 1
 newdef ISGW2HadronicFormFactor:Spectator 183 -1
 newdef ISGW2HadronicFormFactor:InQuark 183 4
 newdef ISGW2HadronicFormFactor:OutQuark 183 1
 newdef ISGW2HadronicFormFactor:Incoming 184 411
 newdef ISGW2HadronicFormFactor:Outgoing 184 20113
 newdef ISGW2HadronicFormFactor:Spin 184 1
 newdef ISGW2HadronicFormFactor:Spectator 184 -1
 newdef ISGW2HadronicFormFactor:InQuark 184 4
 newdef ISGW2HadronicFormFactor:OutQuark 184 1
 newdef ISGW2HadronicFormFactor:Incoming 185 411
 newdef ISGW2HadronicFormFactor:Outgoing 185 10111
 newdef ISGW2HadronicFormFactor:Spin 185 0
 newdef ISGW2HadronicFormFactor:Spectator 185 -1
 newdef ISGW2HadronicFormFactor:InQuark 185 4
 newdef ISGW2HadronicFormFactor:OutQuark 185 1
 newdef ISGW2HadronicFormFactor:Incoming 186 411
 newdef ISGW2HadronicFormFactor:Outgoing 186 211
 newdef ISGW2HadronicFormFactor:Spin 186 0
 newdef ISGW2HadronicFormFactor:Spectator 186 -1
 newdef ISGW2HadronicFormFactor:InQuark 186 4
 newdef ISGW2HadronicFormFactor:OutQuark 186 2
 newdef ISGW2HadronicFormFactor:Incoming 187 411
 newdef ISGW2HadronicFormFactor:Outgoing 187 213
 newdef ISGW2HadronicFormFactor:Spin 187 1
 newdef ISGW2HadronicFormFactor:Spectator 187 -1
 newdef ISGW2HadronicFormFactor:InQuark 187 4
 newdef ISGW2HadronicFormFactor:OutQuark 187 2
 newdef ISGW2HadronicFormFactor:Incoming 188 411
 newdef ISGW2HadronicFormFactor:Outgoing 188 215
 newdef ISGW2HadronicFormFactor:Spin 188 2
 newdef ISGW2HadronicFormFactor:Spectator 188 -1
 newdef ISGW2HadronicFormFactor:InQuark 188 4
 newdef ISGW2HadronicFormFactor:OutQuark 188 2
 newdef ISGW2HadronicFormFactor:Incoming 189 411
 newdef ISGW2HadronicFormFactor:Outgoing 189 10213
 newdef ISGW2HadronicFormFactor:Spin 189 1
 newdef ISGW2HadronicFormFactor:Spectator 189 -1
 newdef ISGW2HadronicFormFactor:InQuark 189 4
 newdef ISGW2HadronicFormFactor:OutQuark 189 2
 newdef ISGW2HadronicFormFactor:Incoming 190 411
 newdef ISGW2HadronicFormFactor:Outgoing 190 20213
 newdef ISGW2HadronicFormFactor:Spin 190 1
 newdef ISGW2HadronicFormFactor:Spectator 190 -1
 newdef ISGW2HadronicFormFactor:InQuark 190 4
 newdef ISGW2HadronicFormFactor:OutQuark 190 2
 newdef ISGW2HadronicFormFactor:Incoming 191 411
 newdef ISGW2HadronicFormFactor:Outgoing 191 10211
 newdef ISGW2HadronicFormFactor:Spin 191 0
 newdef ISGW2HadronicFormFactor:Spectator 191 -1
 newdef ISGW2HadronicFormFactor:InQuark 191 4
 newdef ISGW2HadronicFormFactor:OutQuark 191 2
 newdef ISGW2HadronicFormFactor:Incoming 192 411
 newdef ISGW2HadronicFormFactor:Outgoing 192 -311
 newdef ISGW2HadronicFormFactor:Spin 192 0
 newdef ISGW2HadronicFormFactor:Spectator 192 -1
 newdef ISGW2HadronicFormFactor:InQuark 192 4
 newdef ISGW2HadronicFormFactor:OutQuark 192 3
 newdef ISGW2HadronicFormFactor:Incoming 193 411
 newdef ISGW2HadronicFormFactor:Outgoing 193 -313
 newdef ISGW2HadronicFormFactor:Spin 193 1
 newdef ISGW2HadronicFormFactor:Spectator 193 -1
 newdef ISGW2HadronicFormFactor:InQuark 193 4
 newdef ISGW2HadronicFormFactor:OutQuark 193 3
 newdef ISGW2HadronicFormFactor:Incoming 194 411
 newdef ISGW2HadronicFormFactor:Outgoing 194 -315
 newdef ISGW2HadronicFormFactor:Spin 194 2
 newdef ISGW2HadronicFormFactor:Spectator 194 -1
 newdef ISGW2HadronicFormFactor:InQuark 194 4
 newdef ISGW2HadronicFormFactor:OutQuark 194 3
 newdef ISGW2HadronicFormFactor:Incoming 195 411
 newdef ISGW2HadronicFormFactor:Outgoing 195 -10313
 newdef ISGW2HadronicFormFactor:Spin 195 1
 newdef ISGW2HadronicFormFactor:Spectator 195 -1
 newdef ISGW2HadronicFormFactor:InQuark 195 4
 newdef ISGW2HadronicFormFactor:OutQuark 195 3
 newdef ISGW2HadronicFormFactor:Incoming 196 411
 newdef ISGW2HadronicFormFactor:Outgoing 196 -20313
 newdef ISGW2HadronicFormFactor:Spin 196 1
 newdef ISGW2HadronicFormFactor:Spectator 196 -1
 newdef ISGW2HadronicFormFactor:InQuark 196 4
 newdef ISGW2HadronicFormFactor:OutQuark 196 3
 newdef ISGW2HadronicFormFactor:Incoming 197 411
 newdef ISGW2HadronicFormFactor:Outgoing 197 -10311
 newdef ISGW2HadronicFormFactor:Spin 197 0
 newdef ISGW2HadronicFormFactor:Spectator 197 -1
 newdef ISGW2HadronicFormFactor:InQuark 197 4
 newdef ISGW2HadronicFormFactor:OutQuark 197 3
 insert ISGW2Hadronic:FormFactors 0 ISGW2HadronicFormFactor
 insert ISGW2Hadronic:WeightLocation 0 0
 insert ISGW2Hadronic:WeightLocation 1 0
 insert ISGW2Hadronic:WeightLocation 2 0
 insert ISGW2Hadronic:WeightLocation 3 0
 insert ISGW2Hadronic:WeightLocation 4 0
 insert ISGW2Hadronic:WeightLocation 5 0
 insert ISGW2Hadronic:WeightLocation 6 0
 insert ISGW2Hadronic:WeightLocation 7 0
 insert ISGW2Hadronic:WeightLocation 8 0
 insert ISGW2Hadronic:WeightLocation 9 0
 insert ISGW2Hadronic:WeightLocation 10 0
 insert ISGW2Hadronic:WeightLocation 11 0
 insert ISGW2Hadronic:WeightLocation 12 0
 insert ISGW2Hadronic:WeightLocation 13 0
 insert ISGW2Hadronic:WeightLocation 14 0
 insert ISGW2Hadronic:WeightLocation 15 0
 insert ISGW2Hadronic:WeightLocation 16 0
 insert ISGW2Hadronic:WeightLocation 17 0
 insert ISGW2Hadronic:WeightLocation 18 0
 insert ISGW2Hadronic:WeightLocation 19 0
 insert ISGW2Hadronic:WeightLocation 20 0
 insert ISGW2Hadronic:WeightLocation 21 0
 insert ISGW2Hadronic:WeightLocation 22 0
 insert ISGW2Hadronic:WeightLocation 23 0
 insert ISGW2Hadronic:WeightLocation 24 0
 insert ISGW2Hadronic:WeightLocation 25 0
 insert ISGW2Hadronic:WeightLocation 26 0
 insert ISGW2Hadronic:WeightLocation 27 0
 insert ISGW2Hadronic:WeightLocation 28 0
 insert ISGW2Hadronic:WeightLocation 29 0
 insert ISGW2Hadronic:WeightLocation 30 0
 insert ISGW2Hadronic:WeightLocation 31 0
 insert ISGW2Hadronic:WeightLocation 32 0
 insert ISGW2Hadronic:WeightLocation 33 0
 insert ISGW2Hadronic:WeightLocation 34 0
 insert ISGW2Hadronic:WeightLocation 35 0
 insert ISGW2Hadronic:WeightLocation 36 0
 insert ISGW2Hadronic:WeightLocation 37 0
 insert ISGW2Hadronic:WeightLocation 38 0
 insert ISGW2Hadronic:WeightLocation 39 0
 insert ISGW2Hadronic:WeightLocation 40 0
 insert ISGW2Hadronic:WeightLocation 41 0
 insert ISGW2Hadronic:WeightLocation 42 0
 insert ISGW2Hadronic:WeightLocation 43 0
 insert ISGW2Hadronic:WeightLocation 44 0
 insert ISGW2Hadronic:WeightLocation 45 0
 insert ISGW2Hadronic:WeightLocation 46 0
 insert ISGW2Hadronic:WeightLocation 47 0
 insert ISGW2Hadronic:WeightLocation 48 0
 insert ISGW2Hadronic:WeightLocation 49 0
 insert ISGW2Hadronic:WeightLocation 50 0
 insert ISGW2Hadronic:WeightLocation 51 0
 insert ISGW2Hadronic:WeightLocation 52 0
 insert ISGW2Hadronic:WeightLocation 53 0
 insert ISGW2Hadronic:WeightLocation 54 0
 insert ISGW2Hadronic:WeightLocation 55 0
 insert ISGW2Hadronic:WeightLocation 56 0
 insert ISGW2Hadronic:WeightLocation 57 0
 insert ISGW2Hadronic:WeightLocation 58 0
 insert ISGW2Hadronic:WeightLocation 59 0
 insert ISGW2Hadronic:WeightLocation 60 0
 insert ISGW2Hadronic:WeightLocation 61 0
 insert ISGW2Hadronic:WeightLocation 62 0
 insert ISGW2Hadronic:WeightLocation 63 0
 insert ISGW2Hadronic:WeightLocation 64 0
 insert ISGW2Hadronic:WeightLocation 65 0
 insert ISGW2Hadronic:WeightLocation 66 0
 insert ISGW2Hadronic:WeightLocation 67 0
 insert ISGW2Hadronic:WeightLocation 68 0
 insert ISGW2Hadronic:WeightLocation 69 0
 insert ISGW2Hadronic:WeightLocation 70 0
 insert ISGW2Hadronic:WeightLocation 71 0
 insert ISGW2Hadronic:WeightLocation 72 0
 insert ISGW2Hadronic:WeightLocation 73 0
 insert ISGW2Hadronic:WeightLocation 74 0
 insert ISGW2Hadronic:WeightLocation 75 0
 insert ISGW2Hadronic:WeightLocation 76 0
 insert ISGW2Hadronic:WeightLocation 77 0
 insert ISGW2Hadronic:WeightLocation 78 0
 insert ISGW2Hadronic:WeightLocation 79 0
 insert ISGW2Hadronic:WeightLocation 80 0
 insert ISGW2Hadronic:WeightLocation 81 0
 insert ISGW2Hadronic:WeightLocation 82 0
 insert ISGW2Hadronic:WeightLocation 83 0
 insert ISGW2Hadronic:WeightLocation 84 0
 insert ISGW2Hadronic:WeightLocation 85 0
 insert ISGW2Hadronic:WeightLocation 86 0
 insert ISGW2Hadronic:WeightLocation 87 0
 insert ISGW2Hadronic:WeightLocation 88 0
 insert ISGW2Hadronic:WeightLocation 89 0
 insert ISGW2Hadronic:WeightLocation 90 0
 insert ISGW2Hadronic:WeightLocation 91 0
 insert ISGW2Hadronic:WeightLocation 92 0
 insert ISGW2Hadronic:WeightLocation 93 0
 insert ISGW2Hadronic:WeightLocation 94 0
 insert ISGW2Hadronic:WeightLocation 95 0
 insert ISGW2Hadronic:WeightLocation 96 0
 insert ISGW2Hadronic:WeightLocation 97 0
 insert ISGW2Hadronic:WeightLocation 98 0
 insert ISGW2Hadronic:WeightLocation 99 0
 insert ISGW2Hadronic:WeightLocation 100 0
 insert ISGW2Hadronic:WeightLocation 101 0
 insert ISGW2Hadronic:WeightLocation 102 0
 insert ISGW2Hadronic:WeightLocation 103 0
 insert ISGW2Hadronic:WeightLocation 104 0
 insert ISGW2Hadronic:WeightLocation 105 0
 insert ISGW2Hadronic:WeightLocation 106 0
 insert ISGW2Hadronic:WeightLocation 107 0
 insert ISGW2Hadronic:WeightLocation 108 0
 insert ISGW2Hadronic:WeightLocation 109 0
 insert ISGW2Hadronic:WeightLocation 110 0
 insert ISGW2Hadronic:WeightLocation 111 0
 insert ISGW2Hadronic:WeightLocation 112 0
 insert ISGW2Hadronic:WeightLocation 113 0
 insert ISGW2Hadronic:WeightLocation 114 0
 insert ISGW2Hadronic:WeightLocation 115 0
 insert ISGW2Hadronic:WeightLocation 116 0
 insert ISGW2Hadronic:WeightLocation 117 0
 insert ISGW2Hadronic:WeightLocation 118 0
 insert ISGW2Hadronic:WeightLocation 119 0
 insert ISGW2Hadronic:WeightLocation 120 0
 insert ISGW2Hadronic:WeightLocation 121 0
 insert ISGW2Hadronic:WeightLocation 122 0
 insert ISGW2Hadronic:WeightLocation 123 0
 insert ISGW2Hadronic:WeightLocation 124 0
 insert ISGW2Hadronic:WeightLocation 125 0
 insert ISGW2Hadronic:WeightLocation 126 0
 insert ISGW2Hadronic:WeightLocation 127 0
 insert ISGW2Hadronic:WeightLocation 128 0
 insert ISGW2Hadronic:WeightLocation 129 0
 insert ISGW2Hadronic:WeightLocation 130 0
 insert ISGW2Hadronic:WeightLocation 131 0
 insert ISGW2Hadronic:WeightLocation 132 0
 insert ISGW2Hadronic:WeightLocation 133 0
 insert ISGW2Hadronic:WeightLocation 134 0
 insert ISGW2Hadronic:WeightLocation 135 0
 insert ISGW2Hadronic:WeightLocation 136 0
 insert ISGW2Hadronic:WeightLocation 137 0
 insert ISGW2Hadronic:WeightLocation 138 0
 insert ISGW2Hadronic:WeightLocation 139 0
 insert ISGW2Hadronic:WeightLocation 140 0
 insert ISGW2Hadronic:WeightLocation 141 0
 insert ISGW2Hadronic:WeightLocation 142 0
 insert ISGW2Hadronic:WeightLocation 143 0
 insert ISGW2Hadronic:WeightLocation 144 0
 insert ISGW2Hadronic:WeightLocation 145 0
 insert ISGW2Hadronic:WeightLocation 146 0
 insert ISGW2Hadronic:WeightLocation 147 0
 insert ISGW2Hadronic:WeightLocation 148 0
 insert ISGW2Hadronic:WeightLocation 149 0
 insert ISGW2Hadronic:WeightLocation 150 0
 insert ISGW2Hadronic:WeightLocation 151 0
 insert ISGW2Hadronic:WeightLocation 152 0
 insert ISGW2Hadronic:WeightLocation 153 0
 insert ISGW2Hadronic:WeightLocation 154 0
 insert ISGW2Hadronic:WeightLocation 155 0
 insert ISGW2Hadronic:WeightLocation 156 0
 insert ISGW2Hadronic:WeightLocation 157 0
 insert ISGW2Hadronic:WeightLocation 158 0
 insert ISGW2Hadronic:WeightLocation 159 0
 insert ISGW2Hadronic:WeightLocation 160 0
 insert ISGW2Hadronic:WeightLocation 161 0
 insert ISGW2Hadronic:WeightLocation 162 0
 insert ISGW2Hadronic:WeightLocation 163 0
 insert ISGW2Hadronic:WeightLocation 164 0
 insert ISGW2Hadronic:WeightLocation 165 0
 insert ISGW2Hadronic:WeightLocation 166 0
 insert ISGW2Hadronic:WeightLocation 167 0
 insert ISGW2Hadronic:WeightLocation 168 0
 insert ISGW2Hadronic:WeightLocation 169 0
 insert ISGW2Hadronic:WeightLocation 170 0
 insert ISGW2Hadronic:WeightLocation 171 0
 insert ISGW2Hadronic:WeightLocation 172 0
 insert ISGW2Hadronic:WeightLocation 173 0
 insert ISGW2Hadronic:WeightLocation 174 0
 insert ISGW2Hadronic:WeightLocation 175 0
 insert ISGW2Hadronic:WeightLocation 176 0
 insert ISGW2Hadronic:WeightLocation 177 0
 insert ISGW2Hadronic:WeightLocation 178 0
 insert ISGW2Hadronic:WeightLocation 179 0
 insert ISGW2Hadronic:WeightLocation 180 0
 insert ISGW2Hadronic:WeightLocation 181 0
 insert ISGW2Hadronic:WeightLocation 182 0
 insert ISGW2Hadronic:WeightLocation 183 0
 insert ISGW2Hadronic:WeightLocation 184 0
 insert ISGW2Hadronic:WeightLocation 185 0
 insert ISGW2Hadronic:WeightLocation 186 0
 insert ISGW2Hadronic:WeightLocation 187 0
 insert ISGW2Hadronic:WeightLocation 188 0
 insert ISGW2Hadronic:WeightLocation 189 0
 insert ISGW2Hadronic:WeightLocation 190 0
 insert ISGW2Hadronic:WeightLocation 191 0
 insert ISGW2Hadronic:WeightLocation 192 0
 insert ISGW2Hadronic:WeightLocation 193 0
 insert ISGW2Hadronic:WeightLocation 194 0
 insert ISGW2Hadronic:WeightLocation 195 0
 insert ISGW2Hadronic:WeightLocation 196 0
 insert ISGW2Hadronic:WeightLocation 197 0
 insert ISGW2Hadronic:WeightLocation 198 0
 insert ISGW2Hadronic:WeightLocation 199 0
 insert ISGW2Hadronic:WeightLocation 200 0
 insert ISGW2Hadronic:WeightLocation 201 0
 insert ISGW2Hadronic:WeightLocation 202 0
 insert ISGW2Hadronic:WeightLocation 203 0
 insert ISGW2Hadronic:WeightLocation 204 0
 insert ISGW2Hadronic:WeightLocation 205 0
 insert ISGW2Hadronic:WeightLocation 206 0
 insert ISGW2Hadronic:WeightLocation 207 0
 insert ISGW2Hadronic:WeightLocation 208 0
 insert ISGW2Hadronic:WeightLocation 209 0
 insert ISGW2Hadronic:WeightLocation 210 0
 insert ISGW2Hadronic:WeightLocation 211 0
 insert ISGW2Hadronic:WeightLocation 212 0
 insert ISGW2Hadronic:WeightLocation 213 0
 insert ISGW2Hadronic:WeightLocation 214 0
 insert ISGW2Hadronic:WeightLocation 215 0
 insert ISGW2Hadronic:WeightLocation 216 0
 insert ISGW2Hadronic:WeightLocation 217 0
 insert ISGW2Hadronic:WeightLocation 218 0
 insert ISGW2Hadronic:WeightLocation 219 0
 insert ISGW2Hadronic:WeightLocation 220 0
 insert ISGW2Hadronic:WeightLocation 221 0
 insert ISGW2Hadronic:WeightLocation 222 0
 insert ISGW2Hadronic:WeightLocation 223 0
 insert ISGW2Hadronic:WeightLocation 224 0
 insert ISGW2Hadronic:WeightLocation 225 0
 insert ISGW2Hadronic:WeightLocation 226 0
 insert ISGW2Hadronic:WeightLocation 227 0
 insert ISGW2Hadronic:WeightLocation 228 0
 insert ISGW2Hadronic:WeightLocation 229 0
 insert ISGW2Hadronic:WeightLocation 230 0
 insert ISGW2Hadronic:WeightLocation 231 0
 insert ISGW2Hadronic:WeightLocation 232 0
 insert ISGW2Hadronic:WeightLocation 233 0
 insert ISGW2Hadronic:WeightLocation 234 0
 insert ISGW2Hadronic:WeightLocation 235 0
 insert ISGW2Hadronic:WeightLocation 236 0
 insert ISGW2Hadronic:WeightLocation 237 0
 insert ISGW2Hadronic:WeightLocation 238 0
 insert ISGW2Hadronic:WeightLocation 239 0
 insert ISGW2Hadronic:WeightLocation 240 0
 insert ISGW2Hadronic:WeightLocation 241 0
 insert ISGW2Hadronic:WeightLocation 242 0
 insert ISGW2Hadronic:WeightLocation 243 0
 insert ISGW2Hadronic:WeightLocation 244 0
 insert ISGW2Hadronic:WeightLocation 245 0
 insert ISGW2Hadronic:WeightLocation 246 0
 insert ISGW2Hadronic:WeightLocation 247 0
 insert ISGW2Hadronic:WeightLocation 248 0
 insert ISGW2Hadronic:WeightLocation 249 0
 insert ISGW2Hadronic:WeightLocation 250 0
 insert ISGW2Hadronic:WeightLocation 251 0
 insert ISGW2Hadronic:WeightLocation 252 0
 insert ISGW2Hadronic:WeightLocation 253 0
 insert ISGW2Hadronic:WeightLocation 254 0
 insert ISGW2Hadronic:WeightLocation 255 0
 insert ISGW2Hadronic:WeightLocation 256 0
 insert ISGW2Hadronic:WeightLocation 257 0
 insert ISGW2Hadronic:WeightLocation 258 0
 insert ISGW2Hadronic:WeightLocation 259 0
 insert ISGW2Hadronic:WeightLocation 260 0
 insert ISGW2Hadronic:WeightLocation 261 0
 insert ISGW2Hadronic:WeightLocation 262 0
 insert ISGW2Hadronic:WeightLocation 263 0
 insert ISGW2Hadronic:WeightLocation 264 0
 insert ISGW2Hadronic:WeightLocation 265 0
 insert ISGW2Hadronic:WeightLocation 266 0
 insert ISGW2Hadronic:WeightLocation 267 0
 insert ISGW2Hadronic:WeightLocation 268 0
 insert ISGW2Hadronic:WeightLocation 269 0
 insert ISGW2Hadronic:WeightLocation 270 0
 insert ISGW2Hadronic:WeightLocation 271 0
 insert ISGW2Hadronic:WeightLocation 272 0
 insert ISGW2Hadronic:WeightLocation 273 0
 insert ISGW2Hadronic:WeightLocation 274 0
 insert ISGW2Hadronic:WeightLocation 275 0
 insert ISGW2Hadronic:WeightLocation 276 0
 insert ISGW2Hadronic:WeightLocation 277 0
 insert ISGW2Hadronic:WeightLocation 278 0
 insert ISGW2Hadronic:WeightLocation 279 0
 insert ISGW2Hadronic:WeightLocation 280 0
 insert ISGW2Hadronic:WeightLocation 281 0
 insert ISGW2Hadronic:WeightLocation 282 0
 insert ISGW2Hadronic:WeightLocation 283 0
 insert ISGW2Hadronic:WeightLocation 284 0
 insert ISGW2Hadronic:WeightLocation 285 0
 insert ISGW2Hadronic:WeightLocation 286 0
 insert ISGW2Hadronic:WeightLocation 287 0
 insert ISGW2Hadronic:WeightLocation 288 0
 insert ISGW2Hadronic:WeightLocation 289 0
 insert ISGW2Hadronic:WeightLocation 290 0
 insert ISGW2Hadronic:WeightLocation 291 0
 insert ISGW2Hadronic:WeightLocation 292 0
 insert ISGW2Hadronic:WeightLocation 293 0
 insert ISGW2Hadronic:WeightLocation 294 0
 insert ISGW2Hadronic:WeightLocation 295 0
 insert ISGW2Hadronic:WeightLocation 296 0
 insert ISGW2Hadronic:WeightLocation 297 0
 insert ISGW2Hadronic:WeightLocation 298 0
 insert ISGW2Hadronic:WeightLocation 299 0
 insert ISGW2Hadronic:WeightLocation 300 0
 insert ISGW2Hadronic:WeightLocation 301 0
 insert ISGW2Hadronic:WeightLocation 302 0
 insert ISGW2Hadronic:WeightLocation 303 0
 insert ISGW2Hadronic:WeightLocation 304 0
 insert ISGW2Hadronic:WeightLocation 305 0
 insert ISGW2Hadronic:WeightLocation 306 0
 insert ISGW2Hadronic:WeightLocation 307 0
 insert ISGW2Hadronic:WeightLocation 308 0
 insert ISGW2Hadronic:WeightLocation 309 0
 insert ISGW2Hadronic:WeightLocation 310 0
 insert ISGW2Hadronic:WeightLocation 311 0
 insert ISGW2Hadronic:WeightLocation 312 0
 insert ISGW2Hadronic:WeightLocation 313 0
 insert ISGW2Hadronic:WeightLocation 314 0
 insert ISGW2Hadronic:WeightLocation 315 0
 insert ISGW2Hadronic:WeightLocation 316 0
 insert ISGW2Hadronic:WeightLocation 317 0
 insert ISGW2Hadronic:WeightLocation 318 0
 insert ISGW2Hadronic:WeightLocation 319 0
 insert ISGW2Hadronic:WeightLocation 320 0
 insert ISGW2Hadronic:WeightLocation 321 0
 insert ISGW2Hadronic:WeightLocation 322 0
 insert ISGW2Hadronic:WeightLocation 323 0
 insert ISGW2Hadronic:WeightLocation 324 0
 insert ISGW2Hadronic:WeightLocation 325 0
 insert ISGW2Hadronic:WeightLocation 326 0
 insert ISGW2Hadronic:WeightLocation 327 0
 insert ISGW2Hadronic:WeightLocation 328 0
 insert ISGW2Hadronic:WeightLocation 329 0
 insert ISGW2Hadronic:WeightLocation 330 0
 insert ISGW2Hadronic:WeightLocation 331 0
 insert ISGW2Hadronic:WeightLocation 332 0
 insert ISGW2Hadronic:WeightLocation 333 0
 insert ISGW2Hadronic:WeightLocation 334 0
 insert ISGW2Hadronic:WeightLocation 335 0
 insert ISGW2Hadronic:WeightLocation 336 0
 insert ISGW2Hadronic:WeightLocation 337 0
 insert ISGW2Hadronic:WeightLocation 338 0
 insert ISGW2Hadronic:WeightLocation 339 0
 insert ISGW2Hadronic:WeightLocation 340 0
 insert ISGW2Hadronic:WeightLocation 341 0
 insert ISGW2Hadronic:WeightLocation 342 0
 insert ISGW2Hadronic:WeightLocation 343 0
 insert ISGW2Hadronic:WeightLocation 344 0
 insert ISGW2Hadronic:WeightLocation 345 0
 insert ISGW2Hadronic:WeightLocation 346 0
 insert ISGW2Hadronic:WeightLocation 347 0
 insert ISGW2Hadronic:WeightLocation 348 0
 insert ISGW2Hadronic:WeightLocation 349 0
 insert ISGW2Hadronic:WeightLocation 350 0
 insert ISGW2Hadronic:WeightLocation 351 0
 insert ISGW2Hadronic:WeightLocation 352 0
 insert ISGW2Hadronic:WeightLocation 353 0
 insert ISGW2Hadronic:WeightLocation 354 0
 insert ISGW2Hadronic:WeightLocation 355 0
 insert ISGW2Hadronic:WeightLocation 356 0
 insert ISGW2Hadronic:WeightLocation 357 0
 insert ISGW2Hadronic:WeightLocation 358 0
 insert ISGW2Hadronic:WeightLocation 359 0
 insert ISGW2Hadronic:WeightLocation 360 0
 insert ISGW2Hadronic:WeightLocation 361 0
 insert ISGW2Hadronic:WeightLocation 362 0
 insert ISGW2Hadronic:WeightLocation 363 0
 insert ISGW2Hadronic:WeightLocation 364 0
 insert ISGW2Hadronic:WeightLocation 365 0
 insert ISGW2Hadronic:WeightLocation 366 0
 insert ISGW2Hadronic:WeightLocation 367 0
 insert ISGW2Hadronic:WeightLocation 368 0
 insert ISGW2Hadronic:WeightLocation 369 0
 insert ISGW2Hadronic:WeightLocation 370 0
 insert ISGW2Hadronic:WeightLocation 371 0
 insert ISGW2Hadronic:WeightLocation 372 0
 insert ISGW2Hadronic:WeightLocation 373 0
 insert ISGW2Hadronic:WeightLocation 374 0
 insert ISGW2Hadronic:WeightLocation 375 0
 insert ISGW2Hadronic:WeightLocation 376 0
 insert ISGW2Hadronic:WeightLocation 377 0
 insert ISGW2Hadronic:WeightLocation 378 0
 insert ISGW2Hadronic:WeightLocation 379 0
 insert ISGW2Hadronic:WeightLocation 380 0
 insert ISGW2Hadronic:WeightLocation 381 0
 insert ISGW2Hadronic:WeightLocation 382 0
 insert ISGW2Hadronic:WeightLocation 383 0
 insert ISGW2Hadronic:WeightLocation 384 0
 insert ISGW2Hadronic:WeightLocation 385 0
 insert ISGW2Hadronic:WeightLocation 386 0
 insert ISGW2Hadronic:WeightLocation 387 0
 insert ISGW2Hadronic:WeightLocation 388 0
 insert ISGW2Hadronic:WeightLocation 389 0
 insert ISGW2Hadronic:WeightLocation 390 0
 insert ISGW2Hadronic:WeightLocation 391 0
 insert ISGW2Hadronic:WeightLocation 392 0
 insert ISGW2Hadronic:WeightLocation 393 0
 insert ISGW2Hadronic:WeightLocation 394 0
 insert ISGW2Hadronic:WeightLocation 395 0
 insert ISGW2Hadronic:WeightLocation 396 0
 insert ISGW2Hadronic:WeightLocation 397 0
 insert ISGW2Hadronic:WeightLocation 398 0
 insert ISGW2Hadronic:WeightLocation 399 0
 insert ISGW2Hadronic:WeightLocation 400 0
 insert ISGW2Hadronic:WeightLocation 401 0
 insert ISGW2Hadronic:WeightLocation 402 0
 insert ISGW2Hadronic:WeightLocation 403 0
 insert ISGW2Hadronic:WeightLocation 404 0
 insert ISGW2Hadronic:WeightLocation 405 0
 insert ISGW2Hadronic:WeightLocation 406 0
 insert ISGW2Hadronic:WeightLocation 407 0
 insert ISGW2Hadronic:WeightLocation 408 0
 insert ISGW2Hadronic:WeightLocation 409 0
 insert ISGW2Hadronic:WeightLocation 410 0
 insert ISGW2Hadronic:WeightLocation 411 0
 insert ISGW2Hadronic:WeightLocation 412 0
 insert ISGW2Hadronic:WeightLocation 413 0
 insert ISGW2Hadronic:WeightLocation 414 0
 insert ISGW2Hadronic:WeightLocation 415 0
 insert ISGW2Hadronic:WeightLocation 416 0
 insert ISGW2Hadronic:WeightLocation 417 0
 insert ISGW2Hadronic:WeightLocation 418 0
 insert ISGW2Hadronic:WeightLocation 419 0
 insert ISGW2Hadronic:WeightLocation 420 0
 insert ISGW2Hadronic:WeightLocation 421 0
 insert ISGW2Hadronic:WeightLocation 422 0
 insert ISGW2Hadronic:WeightLocation 423 0
 insert ISGW2Hadronic:WeightLocation 424 0
 insert ISGW2Hadronic:WeightLocation 425 0
 insert ISGW2Hadronic:WeightLocation 426 0
 insert ISGW2Hadronic:WeightLocation 427 0
 insert ISGW2Hadronic:WeightLocation 428 0
 insert ISGW2Hadronic:WeightLocation 429 0
 insert ISGW2Hadronic:WeightLocation 430 0
 insert ISGW2Hadronic:WeightLocation 431 0
 insert ISGW2Hadronic:WeightLocation 432 0
 insert ISGW2Hadronic:WeightLocation 433 0
 insert ISGW2Hadronic:WeightLocation 434 0
 insert ISGW2Hadronic:WeightLocation 435 0
 insert ISGW2Hadronic:WeightLocation 436 0
 insert ISGW2Hadronic:WeightLocation 437 0
 insert ISGW2Hadronic:WeightLocation 438 0
 insert ISGW2Hadronic:WeightLocation 439 0
 insert ISGW2Hadronic:WeightLocation 440 0
 insert ISGW2Hadronic:WeightLocation 441 0
 insert ISGW2Hadronic:WeightLocation 442 0
 insert ISGW2Hadronic:WeightLocation 443 0
 insert ISGW2Hadronic:WeightLocation 444 0
 insert ISGW2Hadronic:WeightLocation 445 0
 insert ISGW2Hadronic:WeightLocation 446 0
 insert ISGW2Hadronic:WeightLocation 447 0
 insert ISGW2Hadronic:WeightLocation 448 0
 insert ISGW2Hadronic:WeightLocation 449 0
 insert ISGW2Hadronic:WeightLocation 450 0
 insert ISGW2Hadronic:WeightLocation 451 0
 insert ISGW2Hadronic:WeightLocation 452 0
 insert ISGW2Hadronic:WeightLocation 453 0
 insert ISGW2Hadronic:WeightLocation 454 0
 insert ISGW2Hadronic:WeightLocation 455 0
 insert ISGW2Hadronic:WeightLocation 456 0
 insert ISGW2Hadronic:WeightLocation 457 0
 insert ISGW2Hadronic:WeightLocation 458 0
 insert ISGW2Hadronic:WeightLocation 459 0
 insert ISGW2Hadronic:WeightLocation 460 0
 insert ISGW2Hadronic:WeightLocation 461 0
 insert ISGW2Hadronic:WeightLocation 462 0
 insert ISGW2Hadronic:WeightLocation 463 0
 insert ISGW2Hadronic:WeightLocation 464 0
 insert ISGW2Hadronic:WeightLocation 465 0
 insert ISGW2Hadronic:WeightLocation 466 0
 insert ISGW2Hadronic:WeightLocation 467 0
 insert ISGW2Hadronic:WeightLocation 468 0
 insert ISGW2Hadronic:WeightLocation 469 0
 insert ISGW2Hadronic:WeightLocation 470 0
 insert ISGW2Hadronic:WeightLocation 471 0
 insert ISGW2Hadronic:WeightLocation 472 0
 insert ISGW2Hadronic:WeightLocation 473 0
 insert ISGW2Hadronic:WeightLocation 474 0
 insert ISGW2Hadronic:WeightLocation 475 0
 insert ISGW2Hadronic:WeightLocation 476 0
 insert ISGW2Hadronic:WeightLocation 477 0
 insert ISGW2Hadronic:WeightLocation 478 0
 insert ISGW2Hadronic:WeightLocation 479 0
 insert ISGW2Hadronic:WeightLocation 480 0
 insert ISGW2Hadronic:WeightLocation 481 0
 insert ISGW2Hadronic:WeightLocation 482 0
 insert ISGW2Hadronic:WeightLocation 483 0
 insert ISGW2Hadronic:WeightLocation 484 0
 insert ISGW2Hadronic:WeightLocation 485 0
 insert ISGW2Hadronic:WeightLocation 486 0
 insert ISGW2Hadronic:WeightLocation 487 0
 insert ISGW2Hadronic:WeightLocation 488 0
 insert ISGW2Hadronic:WeightLocation 489 0
 insert ISGW2Hadronic:WeightLocation 490 0
 insert ISGW2Hadronic:WeightLocation 491 0
 insert ISGW2Hadronic:WeightLocation 492 0
 insert ISGW2Hadronic:WeightLocation 493 0
 insert ISGW2Hadronic:WeightLocation 494 0
 insert ISGW2Hadronic:WeightLocation 495 0
 insert ISGW2Hadronic:WeightLocation 496 0
 insert ISGW2Hadronic:WeightLocation 497 0
 insert ISGW2Hadronic:WeightLocation 498 0
 insert ISGW2Hadronic:WeightLocation 499 0
 insert ISGW2Hadronic:WeightLocation 500 0
 insert ISGW2Hadronic:WeightLocation 501 0
 insert ISGW2Hadronic:WeightLocation 502 0
 insert ISGW2Hadronic:WeightLocation 503 0
 insert ISGW2Hadronic:WeightLocation 504 0
 insert ISGW2Hadronic:WeightLocation 505 0
 insert ISGW2Hadronic:WeightLocation 506 0
 insert ISGW2Hadronic:WeightLocation 507 0
 insert ISGW2Hadronic:WeightLocation 508 0
 insert ISGW2Hadronic:WeightLocation 509 0
 insert ISGW2Hadronic:WeightLocation 510 0
 insert ISGW2Hadronic:WeightLocation 511 0
 insert ISGW2Hadronic:WeightLocation 512 0
 insert ISGW2Hadronic:WeightLocation 513 0
 insert ISGW2Hadronic:WeightLocation 514 0
 insert ISGW2Hadronic:WeightLocation 515 0
 insert ISGW2Hadronic:WeightLocation 516 0
 insert ISGW2Hadronic:WeightLocation 517 0
 insert ISGW2Hadronic:WeightLocation 518 0
 insert ISGW2Hadronic:WeightLocation 519 0
 insert ISGW2Hadronic:WeightLocation 520 0
 insert ISGW2Hadronic:WeightLocation 521 0
 insert ISGW2Hadronic:WeightLocation 522 0
 insert ISGW2Hadronic:WeightLocation 523 0
 insert ISGW2Hadronic:WeightLocation 524 0
 insert ISGW2Hadronic:WeightLocation 525 0
 insert ISGW2Hadronic:WeightLocation 526 0
 insert ISGW2Hadronic:WeightLocation 527 0
 insert ISGW2Hadronic:WeightLocation 528 0
 insert ISGW2Hadronic:WeightLocation 529 0
 insert ISGW2Hadronic:WeightLocation 530 0
 insert ISGW2Hadronic:WeightLocation 531 0
 insert ISGW2Hadronic:WeightLocation 532 0
 insert ISGW2Hadronic:WeightLocation 533 0
 insert ISGW2Hadronic:WeightLocation 534 0
 insert ISGW2Hadronic:WeightLocation 535 0
 insert ISGW2Hadronic:WeightLocation 536 0
 insert ISGW2Hadronic:WeightLocation 537 0
 insert ISGW2Hadronic:WeightLocation 538 0
 insert ISGW2Hadronic:WeightLocation 539 0
 insert ISGW2Hadronic:WeightLocation 540 0
 insert ISGW2Hadronic:WeightLocation 541 0
 insert ISGW2Hadronic:WeightLocation 542 0
 insert ISGW2Hadronic:WeightLocation 543 0
 insert ISGW2Hadronic:WeightLocation 544 0
 insert ISGW2Hadronic:WeightLocation 545 0
 insert ISGW2Hadronic:WeightLocation 546 0
 insert ISGW2Hadronic:WeightLocation 547 0
 insert ISGW2Hadronic:WeightLocation 548 0
 insert ISGW2Hadronic:WeightLocation 549 0
 insert ISGW2Hadronic:WeightLocation 550 0
 insert ISGW2Hadronic:WeightLocation 551 0
 insert ISGW2Hadronic:WeightLocation 552 0
 insert ISGW2Hadronic:WeightLocation 553 0
 insert ISGW2Hadronic:WeightLocation 554 0
 insert ISGW2Hadronic:WeightLocation 555 0
 insert ISGW2Hadronic:WeightLocation 556 0
 insert ISGW2Hadronic:WeightLocation 557 0
 insert ISGW2Hadronic:WeightLocation 558 0
 insert ISGW2Hadronic:WeightLocation 559 0
 insert ISGW2Hadronic:WeightLocation 560 0
 insert ISGW2Hadronic:WeightLocation 561 0
 insert ISGW2Hadronic:WeightLocation 562 0
 insert ISGW2Hadronic:WeightLocation 563 0
 insert ISGW2Hadronic:WeightLocation 564 0
 insert ISGW2Hadronic:WeightLocation 565 0
 insert ISGW2Hadronic:WeightLocation 566 0
 insert ISGW2Hadronic:WeightLocation 567 0
 insert ISGW2Hadronic:WeightLocation 568 0
 insert ISGW2Hadronic:WeightLocation 569 0
 insert ISGW2Hadronic:WeightLocation 570 0
 insert ISGW2Hadronic:WeightLocation 571 0
 insert ISGW2Hadronic:WeightLocation 572 0
 insert ISGW2Hadronic:WeightLocation 573 0
 insert ISGW2Hadronic:WeightLocation 574 0
 insert ISGW2Hadronic:WeightLocation 575 0
 insert ISGW2Hadronic:WeightLocation 576 0
 insert ISGW2Hadronic:WeightLocation 577 0
 insert ISGW2Hadronic:WeightLocation 578 0
 insert ISGW2Hadronic:WeightLocation 579 0
 insert ISGW2Hadronic:WeightLocation 580 0
 insert ISGW2Hadronic:WeightLocation 581 0
 insert ISGW2Hadronic:WeightLocation 582 0
 insert ISGW2Hadronic:WeightLocation 583 0
 insert ISGW2Hadronic:WeightLocation 584 0
 insert ISGW2Hadronic:WeightLocation 585 0
 insert ISGW2Hadronic:WeightLocation 586 0
 insert ISGW2Hadronic:WeightLocation 587 0
 insert ISGW2Hadronic:WeightLocation 588 0
 insert ISGW2Hadronic:WeightLocation 589 0
 insert ISGW2Hadronic:WeightLocation 590 0
 insert ISGW2Hadronic:WeightLocation 591 0
 insert ISGW2Hadronic:WeightLocation 592 0
 insert ISGW2Hadronic:WeightLocation 593 0
 insert ISGW2Hadronic:WeightLocation 594 0
 insert ISGW2Hadronic:WeightLocation 595 0
 insert ISGW2Hadronic:WeightLocation 596 0
 insert ISGW2Hadronic:WeightLocation 597 0
 insert ISGW2Hadronic:WeightLocation 598 0
 insert ISGW2Hadronic:WeightLocation 599 0
 insert ISGW2Hadronic:WeightLocation 600 0
 insert ISGW2Hadronic:WeightLocation 601 0
 insert ISGW2Hadronic:WeightLocation 602 0
 insert ISGW2Hadronic:WeightLocation 603 0
 insert ISGW2Hadronic:WeightLocation 604 0
 insert ISGW2Hadronic:WeightLocation 605 0
 insert ISGW2Hadronic:WeightLocation 606 0
 insert ISGW2Hadronic:WeightLocation 607 0
 insert ISGW2Hadronic:WeightLocation 608 0
 insert ISGW2Hadronic:WeightLocation 609 0
 insert ISGW2Hadronic:WeightLocation 610 0
 insert ISGW2Hadronic:WeightLocation 611 0
 insert ISGW2Hadronic:WeightLocation 612 0
 insert ISGW2Hadronic:WeightLocation 613 0
 insert ISGW2Hadronic:WeightLocation 614 0
 insert ISGW2Hadronic:WeightLocation 615 0
 insert ISGW2Hadronic:WeightLocation 616 0
 insert ISGW2Hadronic:WeightLocation 617 0
 insert ISGW2Hadronic:WeightLocation 618 0
 insert ISGW2Hadronic:WeightLocation 619 0
 insert ISGW2Hadronic:WeightLocation 620 0
 insert ISGW2Hadronic:WeightLocation 621 0
 insert ISGW2Hadronic:WeightLocation 622 0
 insert ISGW2Hadronic:WeightLocation 623 0
 insert ISGW2Hadronic:WeightLocation 624 0
 insert ISGW2Hadronic:WeightLocation 625 0
 insert ISGW2Hadronic:WeightLocation 626 0
 insert ISGW2Hadronic:WeightLocation 627 0
 insert ISGW2Hadronic:WeightLocation 628 0
 insert ISGW2Hadronic:WeightLocation 629 0
 insert ISGW2Hadronic:WeightLocation 630 0
 insert ISGW2Hadronic:WeightLocation 631 0
 insert ISGW2Hadronic:WeightLocation 632 0
 insert ISGW2Hadronic:WeightLocation 633 0
 insert ISGW2Hadronic:WeightLocation 634 0
 insert ISGW2Hadronic:WeightLocation 635 0
 insert ISGW2Hadronic:WeightLocation 636 0
 insert ISGW2Hadronic:WeightLocation 637 0
 insert ISGW2Hadronic:WeightLocation 638 0
 insert ISGW2Hadronic:WeightLocation 639 0
 insert ISGW2Hadronic:WeightLocation 640 0
 insert ISGW2Hadronic:WeightLocation 641 0
 insert ISGW2Hadronic:WeightLocation 642 0
 insert ISGW2Hadronic:WeightLocation 643 0
 insert ISGW2Hadronic:WeightLocation 644 0
 insert ISGW2Hadronic:WeightLocation 645 0
 insert ISGW2Hadronic:WeightLocation 646 0
 insert ISGW2Hadronic:WeightLocation 647 0
 insert ISGW2Hadronic:WeightLocation 648 0
 insert ISGW2Hadronic:WeightLocation 649 0
 insert ISGW2Hadronic:WeightLocation 650 0
 insert ISGW2Hadronic:WeightLocation 651 0
 insert ISGW2Hadronic:WeightLocation 652 0
 insert ISGW2Hadronic:WeightLocation 653 0
 insert ISGW2Hadronic:WeightLocation 654 0
 insert ISGW2Hadronic:WeightLocation 655 0
 insert ISGW2Hadronic:WeightLocation 656 0
 insert ISGW2Hadronic:WeightLocation 657 0
 insert ISGW2Hadronic:WeightLocation 658 0
 insert ISGW2Hadronic:WeightLocation 659 0
 insert ISGW2Hadronic:WeightLocation 660 0
 insert ISGW2Hadronic:WeightLocation 661 0
 insert ISGW2Hadronic:WeightLocation 662 0
 insert ISGW2Hadronic:WeightLocation 663 0
 insert ISGW2Hadronic:WeightLocation 664 0
 insert ISGW2Hadronic:WeightLocation 665 0
 insert ISGW2Hadronic:WeightLocation 666 0
 insert ISGW2Hadronic:WeightLocation 667 0
 insert ISGW2Hadronic:WeightLocation 668 0
 insert ISGW2Hadronic:WeightLocation 669 0
 insert ISGW2Hadronic:WeightLocation 670 0
 insert ISGW2Hadronic:WeightLocation 671 0
 insert ISGW2Hadronic:WeightLocation 672 0
 insert ISGW2Hadronic:WeightLocation 673 0
 insert ISGW2Hadronic:WeightLocation 674 0
 insert ISGW2Hadronic:WeightLocation 675 0
 insert ISGW2Hadronic:WeightLocation 676 0
 insert ISGW2Hadronic:WeightLocation 677 0
 insert ISGW2Hadronic:WeightLocation 678 0
 insert ISGW2Hadronic:WeightLocation 679 0
 insert ISGW2Hadronic:WeightLocation 680 0
 insert ISGW2Hadronic:WeightLocation 681 0
 insert ISGW2Hadronic:WeightLocation 682 0
 insert ISGW2Hadronic:WeightLocation 683 0
 insert ISGW2Hadronic:WeightLocation 684 0
 insert ISGW2Hadronic:WeightLocation 685 0
 insert ISGW2Hadronic:WeightLocation 686 0
 insert ISGW2Hadronic:WeightLocation 687 0
 insert ISGW2Hadronic:WeightLocation 688 0
 insert ISGW2Hadronic:WeightLocation 689 0
 insert ISGW2Hadronic:WeightLocation 690 0
 insert ISGW2Hadronic:WeightLocation 691 0
 insert ISGW2Hadronic:WeightLocation 692 0
 insert ISGW2Hadronic:WeightLocation 693 0
 insert ISGW2Hadronic:WeightLocation 694 0
 insert ISGW2Hadronic:WeightLocation 695 0
 insert ISGW2Hadronic:WeightLocation 696 0
 insert ISGW2Hadronic:WeightLocation 697 0
 insert ISGW2Hadronic:WeightLocation 698 0
 insert ISGW2Hadronic:WeightLocation 699 0
 insert ISGW2Hadronic:WeightLocation 700 0
 insert ISGW2Hadronic:WeightLocation 701 0
 insert ISGW2Hadronic:WeightLocation 702 0
 insert ISGW2Hadronic:WeightLocation 703 0
 insert ISGW2Hadronic:WeightLocation 704 0
 insert ISGW2Hadronic:WeightLocation 705 0
 insert ISGW2Hadronic:WeightLocation 706 0
 insert ISGW2Hadronic:WeightLocation 707 0
 insert ISGW2Hadronic:WeightLocation 708 0
 insert ISGW2Hadronic:WeightLocation 709 0
 insert ISGW2Hadronic:WeightLocation 710 0
 insert ISGW2Hadronic:WeightLocation 711 0
 insert ISGW2Hadronic:WeightLocation 712 0
 insert ISGW2Hadronic:WeightLocation 713 0
 insert ISGW2Hadronic:WeightLocation 714 0
 insert ISGW2Hadronic:WeightLocation 715 0
 insert ISGW2Hadronic:WeightLocation 716 0
 insert ISGW2Hadronic:WeightLocation 717 0
 insert ISGW2Hadronic:WeightLocation 718 0
 insert ISGW2Hadronic:WeightLocation 719 0
 insert ISGW2Hadronic:WeightLocation 720 0
 insert ISGW2Hadronic:WeightLocation 721 0
 insert ISGW2Hadronic:WeightLocation 722 0
 insert ISGW2Hadronic:WeightLocation 723 0
 insert ISGW2Hadronic:WeightLocation 724 0
 insert ISGW2Hadronic:WeightLocation 725 0
 insert ISGW2Hadronic:WeightLocation 726 0
 insert ISGW2Hadronic:WeightLocation 727 0
 insert ISGW2Hadronic:WeightLocation 728 0
 insert ISGW2Hadronic:WeightLocation 729 0
 insert ISGW2Hadronic:WeightLocation 730 0
 insert ISGW2Hadronic:WeightLocation 731 0
 insert ISGW2Hadronic:WeightLocation 732 0
 insert ISGW2Hadronic:WeightLocation 733 0
 insert ISGW2Hadronic:WeightLocation 734 0
 insert ISGW2Hadronic:WeightLocation 735 0
 insert ISGW2Hadronic:WeightLocation 736 0
 insert ISGW2Hadronic:WeightLocation 737 0
 insert ISGW2Hadronic:WeightLocation 738 0
 insert ISGW2Hadronic:WeightLocation 739 0
 insert ISGW2Hadronic:WeightLocation 740 0
 insert ISGW2Hadronic:WeightLocation 741 0
 insert ISGW2Hadronic:WeightLocation 742 0
 insert ISGW2Hadronic:WeightLocation 743 0
 insert ISGW2Hadronic:WeightLocation 744 0
 insert ISGW2Hadronic:WeightLocation 745 0
 insert ISGW2Hadronic:WeightLocation 746 0
 insert ISGW2Hadronic:WeightLocation 747 0
 insert ISGW2Hadronic:WeightLocation 748 0
 insert ISGW2Hadronic:WeightLocation 749 0
 insert ISGW2Hadronic:WeightLocation 750 0
 insert ISGW2Hadronic:WeightLocation 751 0
 insert ISGW2Hadronic:WeightLocation 752 0
 insert ISGW2Hadronic:WeightLocation 753 0
 insert ISGW2Hadronic:WeightLocation 754 0
 insert ISGW2Hadronic:WeightLocation 755 0
 insert ISGW2Hadronic:WeightLocation 756 0
 insert ISGW2Hadronic:WeightLocation 757 0
 insert ISGW2Hadronic:WeightLocation 758 0
 insert ISGW2Hadronic:WeightLocation 759 0
 insert ISGW2Hadronic:WeightLocation 760 0
 insert ISGW2Hadronic:WeightLocation 761 0
 insert ISGW2Hadronic:WeightLocation 762 0
 insert ISGW2Hadronic:WeightLocation 763 0
 insert ISGW2Hadronic:WeightLocation 764 0
 insert ISGW2Hadronic:WeightLocation 765 0
 insert ISGW2Hadronic:WeightLocation 766 0
 insert ISGW2Hadronic:WeightLocation 767 0
 insert ISGW2Hadronic:WeightLocation 768 0
 insert ISGW2Hadronic:WeightLocation 769 0
 insert ISGW2Hadronic:WeightLocation 770 0
 insert ISGW2Hadronic:WeightLocation 771 0
 insert ISGW2Hadronic:WeightLocation 772 0
 insert ISGW2Hadronic:WeightLocation 773 0
 insert ISGW2Hadronic:WeightLocation 774 0
 insert ISGW2Hadronic:WeightLocation 775 0
 insert ISGW2Hadronic:WeightLocation 776 0
 insert ISGW2Hadronic:WeightLocation 777 0
 insert ISGW2Hadronic:WeightLocation 778 0
 insert ISGW2Hadronic:WeightLocation 779 0
 insert ISGW2Hadronic:WeightLocation 780 0
 insert ISGW2Hadronic:WeightLocation 781 0
 insert ISGW2Hadronic:WeightLocation 782 0
 insert ISGW2Hadronic:WeightLocation 783 0
 insert ISGW2Hadronic:WeightLocation 784 0
 insert ISGW2Hadronic:WeightLocation 785 0
 insert ISGW2Hadronic:WeightLocation 786 0
 insert ISGW2Hadronic:WeightLocation 787 0
 insert ISGW2Hadronic:WeightLocation 788 0
 insert ISGW2Hadronic:WeightLocation 789 0
 insert ISGW2Hadronic:WeightLocation 790 0
 insert ISGW2Hadronic:WeightLocation 791 0
 insert ISGW2Hadronic:WeightLocation 792 0
 insert ISGW2Hadronic:WeightLocation 793 0
 insert ISGW2Hadronic:WeightLocation 794 0
 insert ISGW2Hadronic:WeightLocation 795 0
 insert ISGW2Hadronic:WeightLocation 796 0
 insert ISGW2Hadronic:WeightLocation 797 0
 insert ISGW2Hadronic:WeightLocation 798 0
 insert ISGW2Hadronic:WeightLocation 799 0
 insert ISGW2Hadronic:WeightLocation 800 0
 insert ISGW2Hadronic:WeightLocation 801 0
 insert ISGW2Hadronic:WeightLocation 802 0
 insert ISGW2Hadronic:WeightLocation 803 0
 insert ISGW2Hadronic:WeightLocation 804 0
 insert ISGW2Hadronic:WeightLocation 805 0
 insert ISGW2Hadronic:WeightLocation 806 0
 insert ISGW2Hadronic:WeightLocation 807 0
 insert ISGW2Hadronic:WeightLocation 808 0
 insert ISGW2Hadronic:WeightLocation 809 0
 insert ISGW2Hadronic:WeightLocation 810 0
 insert ISGW2Hadronic:WeightLocation 811 0
 insert ISGW2Hadronic:WeightLocation 812 0
 insert ISGW2Hadronic:WeightLocation 813 0
 insert ISGW2Hadronic:WeightLocation 814 0
 insert ISGW2Hadronic:WeightLocation 815 0
 insert ISGW2Hadronic:WeightLocation 816 0
 insert ISGW2Hadronic:WeightLocation 817 0
 insert ISGW2Hadronic:WeightLocation 818 0
 insert ISGW2Hadronic:WeightLocation 819 0
 insert ISGW2Hadronic:WeightLocation 820 0
 insert ISGW2Hadronic:WeightLocation 821 0
 insert ISGW2Hadronic:WeightLocation 822 0
 insert ISGW2Hadronic:WeightLocation 823 0
 insert ISGW2Hadronic:WeightLocation 824 0
 insert ISGW2Hadronic:WeightLocation 825 0
 insert ISGW2Hadronic:WeightLocation 826 0
 insert ISGW2Hadronic:WeightLocation 827 0
 insert ISGW2Hadronic:WeightLocation 828 0
 insert ISGW2Hadronic:WeightLocation 829 0
 insert ISGW2Hadronic:WeightLocation 830 0
 insert ISGW2Hadronic:WeightLocation 831 0
 insert ISGW2Hadronic:WeightLocation 832 0
 insert ISGW2Hadronic:WeightLocation 833 0
 insert ISGW2Hadronic:WeightLocation 834 0
 insert ISGW2Hadronic:WeightLocation 835 0
 insert ISGW2Hadronic:WeightLocation 836 0
 insert ISGW2Hadronic:WeightLocation 837 0
 insert ISGW2Hadronic:WeightLocation 838 0
 insert ISGW2Hadronic:WeightLocation 839 0
 insert ISGW2Hadronic:WeightLocation 840 0
 insert ISGW2Hadronic:WeightLocation 841 0
 insert ISGW2Hadronic:WeightLocation 842 0
 insert ISGW2Hadronic:WeightLocation 843 0
 insert ISGW2Hadronic:WeightLocation 844 0
 insert ISGW2Hadronic:WeightLocation 845 0
 insert ISGW2Hadronic:WeightLocation 846 0
 insert ISGW2Hadronic:WeightLocation 847 0
 insert ISGW2Hadronic:WeightLocation 848 0
 insert ISGW2Hadronic:WeightLocation 849 0
 insert ISGW2Hadronic:WeightLocation 850 0
 insert ISGW2Hadronic:WeightLocation 851 0
 insert ISGW2Hadronic:WeightLocation 852 0
 insert ISGW2Hadronic:WeightLocation 853 0
 insert ISGW2Hadronic:WeightLocation 854 0
 insert ISGW2Hadronic:WeightLocation 855 0
 insert ISGW2Hadronic:WeightLocation 856 0
 insert ISGW2Hadronic:WeightLocation 857 0
 insert ISGW2Hadronic:WeightLocation 858 0
 insert ISGW2Hadronic:WeightLocation 859 0
 insert ISGW2Hadronic:WeightLocation 860 0
 insert ISGW2Hadronic:WeightLocation 861 0
 insert ISGW2Hadronic:WeightLocation 862 0
 insert ISGW2Hadronic:WeightLocation 863 0
 insert ISGW2Hadronic:WeightLocation 864 0
 insert ISGW2Hadronic:WeightLocation 865 0
 insert ISGW2Hadronic:WeightLocation 866 0
 insert ISGW2Hadronic:WeightLocation 867 0
 insert ISGW2Hadronic:WeightLocation 868 0
 insert ISGW2Hadronic:WeightLocation 869 0
 insert ISGW2Hadronic:WeightLocation 870 0
 insert ISGW2Hadronic:WeightLocation 871 0
 insert ISGW2Hadronic:WeightLocation 872 0
 insert ISGW2Hadronic:WeightLocation 873 0
 insert ISGW2Hadronic:WeightLocation 874 0
 insert ISGW2Hadronic:WeightLocation 875 0
 insert ISGW2Hadronic:WeightLocation 876 0
 insert ISGW2Hadronic:WeightLocation 877 0
 insert ISGW2Hadronic:WeightLocation 878 0
 insert ISGW2Hadronic:WeightLocation 879 0
 insert ISGW2Hadronic:WeightLocation 880 0
 insert ISGW2Hadronic:WeightLocation 881 0
 insert ISGW2Hadronic:WeightLocation 882 0
 insert ISGW2Hadronic:WeightLocation 883 0
 insert ISGW2Hadronic:WeightLocation 884 0
 insert ISGW2Hadronic:WeightLocation 885 0
 insert ISGW2Hadronic:WeightLocation 886 0
 insert ISGW2Hadronic:WeightLocation 887 0
 insert ISGW2Hadronic:WeightLocation 888 0
 insert ISGW2Hadronic:WeightLocation 889 0
 insert ISGW2Hadronic:WeightLocation 890 0
 insert ISGW2Hadronic:WeightLocation 891 0
 insert ISGW2Hadronic:WeightLocation 892 0
 insert ISGW2Hadronic:WeightLocation 893 0
 insert ISGW2Hadronic:WeightLocation 894 0
 insert ISGW2Hadronic:WeightLocation 895 0
 insert ISGW2Hadronic:WeightLocation 896 0
 insert ISGW2Hadronic:WeightLocation 897 0
 insert ISGW2Hadronic:WeightLocation 898 0
 insert ISGW2Hadronic:WeightLocation 899 0
 insert ISGW2Hadronic:WeightLocation 900 0
 insert ISGW2Hadronic:WeightLocation 901 0
 insert ISGW2Hadronic:WeightLocation 902 0
 insert ISGW2Hadronic:WeightLocation 903 0
 insert ISGW2Hadronic:WeightLocation 904 0
 insert ISGW2Hadronic:WeightLocation 905 0
 insert ISGW2Hadronic:WeightLocation 906 0
 insert ISGW2Hadronic:WeightLocation 907 0
 insert ISGW2Hadronic:WeightLocation 908 0
 insert ISGW2Hadronic:WeightLocation 909 0
 insert ISGW2Hadronic:WeightLocation 910 0
 insert ISGW2Hadronic:WeightLocation 911 0
 insert ISGW2Hadronic:WeightLocation 912 0
 insert ISGW2Hadronic:WeightLocation 913 0
 insert ISGW2Hadronic:WeightLocation 914 0
 insert ISGW2Hadronic:WeightLocation 915 0
 insert ISGW2Hadronic:WeightLocation 916 0
 insert ISGW2Hadronic:WeightLocation 917 0
 insert ISGW2Hadronic:WeightLocation 918 0
 insert ISGW2Hadronic:WeightLocation 919 0
 insert ISGW2Hadronic:WeightLocation 920 0
 insert ISGW2Hadronic:WeightLocation 921 0
 insert ISGW2Hadronic:WeightLocation 922 0
 insert ISGW2Hadronic:WeightLocation 923 0
 insert ISGW2Hadronic:WeightLocation 924 0
 insert ISGW2Hadronic:WeightLocation 925 0
 insert ISGW2Hadronic:WeightLocation 926 0
 insert ISGW2Hadronic:WeightLocation 927 0
 insert ISGW2Hadronic:WeightLocation 928 0
 insert ISGW2Hadronic:WeightLocation 929 0
 insert ISGW2Hadronic:WeightLocation 930 0
 insert ISGW2Hadronic:WeightLocation 931 0
 insert ISGW2Hadronic:WeightLocation 932 0
 insert ISGW2Hadronic:WeightLocation 933 0
 insert ISGW2Hadronic:WeightLocation 934 0
 insert ISGW2Hadronic:WeightLocation 935 0
 insert ISGW2Hadronic:WeightLocation 936 0
 insert ISGW2Hadronic:WeightLocation 937 0
 insert ISGW2Hadronic:WeightLocation 938 0
 insert ISGW2Hadronic:WeightLocation 939 0
 insert ISGW2Hadronic:WeightLocation 940 0
 insert ISGW2Hadronic:WeightLocation 941 0
 insert ISGW2Hadronic:WeightLocation 942 0
 insert ISGW2Hadronic:WeightLocation 943 0
 insert ISGW2Hadronic:WeightLocation 944 0
 insert ISGW2Hadronic:WeightLocation 945 0
 insert ISGW2Hadronic:WeightLocation 946 0
 insert ISGW2Hadronic:WeightLocation 947 0
 insert ISGW2Hadronic:WeightLocation 948 0
 insert ISGW2Hadronic:WeightLocation 949 0
 insert ISGW2Hadronic:WeightLocation 950 0
 insert ISGW2Hadronic:WeightLocation 951 0
 insert ISGW2Hadronic:WeightLocation 952 0
 insert ISGW2Hadronic:WeightLocation 953 0
 insert ISGW2Hadronic:WeightLocation 954 0
 insert ISGW2Hadronic:WeightLocation 955 0
 insert ISGW2Hadronic:WeightLocation 956 0
 insert ISGW2Hadronic:WeightLocation 957 0
 insert ISGW2Hadronic:WeightLocation 958 0
 insert ISGW2Hadronic:WeightLocation 959 0
 insert ISGW2Hadronic:WeightLocation 960 0
 insert ISGW2Hadronic:WeightLocation 961 0
 insert ISGW2Hadronic:WeightLocation 962 0
 insert ISGW2Hadronic:WeightLocation 963 0
 insert ISGW2Hadronic:WeightLocation 964 0
 insert ISGW2Hadronic:WeightLocation 965 0
 insert ISGW2Hadronic:WeightLocation 966 0
 insert ISGW2Hadronic:WeightLocation 967 0
 insert ISGW2Hadronic:WeightLocation 968 0
 insert ISGW2Hadronic:WeightLocation 969 0
 insert ISGW2Hadronic:WeightLocation 970 0
 insert ISGW2Hadronic:WeightLocation 971 0
 insert ISGW2Hadronic:WeightLocation 972 0
 insert ISGW2Hadronic:WeightLocation 973 0
 insert ISGW2Hadronic:WeightLocation 974 0
 insert ISGW2Hadronic:WeightLocation 975 0
 insert ISGW2Hadronic:WeightLocation 976 0
 insert ISGW2Hadronic:WeightLocation 977 0
 insert ISGW2Hadronic:WeightLocation 978 0
 insert ISGW2Hadronic:WeightLocation 979 0
 insert ISGW2Hadronic:WeightLocation 980 0
 insert ISGW2Hadronic:WeightLocation 981 0
 insert ISGW2Hadronic:WeightLocation 982 0
 insert ISGW2Hadronic:WeightLocation 983 0
 insert ISGW2Hadronic:WeightLocation 984 0
 insert ISGW2Hadronic:WeightLocation 985 0
 insert ISGW2Hadronic:WeightLocation 986 0
 insert ISGW2Hadronic:WeightLocation 987 0
 insert ISGW2Hadronic:WeightLocation 988 0
 insert ISGW2Hadronic:WeightLocation 989 0
 insert ISGW2Hadronic:WeightLocation 990 0
 insert ISGW2Hadronic:WeightLocation 991 0
 insert ISGW2Hadronic:WeightLocation 992 0
 insert ISGW2Hadronic:WeightLocation 993 0
 insert ISGW2Hadronic:WeightLocation 994 0
 insert ISGW2Hadronic:WeightLocation 995 0
 insert ISGW2Hadronic:WeightLocation 996 0
 insert ISGW2Hadronic:WeightLocation 997 0
 insert ISGW2Hadronic:WeightLocation 998 0
 insert ISGW2Hadronic:WeightLocation 999 0
 insert ISGW2Hadronic:WeightLocation 1000 0
 insert ISGW2Hadronic:WeightLocation 1001 0
 insert ISGW2Hadronic:WeightLocation 1002 0
 insert ISGW2Hadronic:WeightLocation 1003 0
 insert ISGW2Hadronic:WeightLocation 1004 0
 insert ISGW2Hadronic:WeightLocation 1005 0
 insert ISGW2Hadronic:WeightLocation 1006 0
 insert ISGW2Hadronic:WeightLocation 1007 0
 insert ISGW2Hadronic:WeightLocation 1008 0
 insert ISGW2Hadronic:WeightLocation 1009 0
 insert ISGW2Hadronic:WeightLocation 1010 0
 insert ISGW2Hadronic:WeightLocation 1011 0
 insert ISGW2Hadronic:WeightLocation 1012 0
 insert ISGW2Hadronic:WeightLocation 1013 0
 insert ISGW2Hadronic:WeightLocation 1014 0
 insert ISGW2Hadronic:WeightLocation 1015 0
 insert ISGW2Hadronic:WeightLocation 1016 0
 insert ISGW2Hadronic:WeightLocation 1017 0
 insert ISGW2Hadronic:WeightLocation 1018 0
 insert ISGW2Hadronic:WeightLocation 1019 0
 insert ISGW2Hadronic:WeightLocation 1020 0
 insert ISGW2Hadronic:WeightLocation 1021 0
 insert ISGW2Hadronic:WeightLocation 1022 0
 insert ISGW2Hadronic:WeightLocation 1023 0
 insert ISGW2Hadronic:WeightLocation 1024 0
 insert ISGW2Hadronic:WeightLocation 1025 0
 insert ISGW2Hadronic:WeightLocation 1026 0
 insert ISGW2Hadronic:WeightLocation 1027 0
 insert ISGW2Hadronic:WeightLocation 1028 0
 insert ISGW2Hadronic:WeightLocation 1029 0
 insert ISGW2Hadronic:WeightLocation 1030 0
 insert ISGW2Hadronic:WeightLocation 1031 0
 insert ISGW2Hadronic:WeightLocation 1032 0
 insert ISGW2Hadronic:WeightLocation 1033 0
 insert ISGW2Hadronic:WeightLocation 1034 0
 insert ISGW2Hadronic:WeightLocation 1035 0
 insert ISGW2Hadronic:WeightLocation 1036 0
 insert ISGW2Hadronic:WeightLocation 1037 0
 insert ISGW2Hadronic:WeightLocation 1038 0
 insert ISGW2Hadronic:WeightLocation 1039 0
 insert ISGW2Hadronic:WeightLocation 1040 0
 insert ISGW2Hadronic:WeightLocation 1041 0
 insert ISGW2Hadronic:WeightLocation 1042 0
 insert ISGW2Hadronic:WeightLocation 1043 0
 insert ISGW2Hadronic:WeightLocation 1044 0
 insert ISGW2Hadronic:WeightLocation 1045 0
 insert ISGW2Hadronic:WeightLocation 1046 0
 insert ISGW2Hadronic:WeightLocation 1047 0
 insert ISGW2Hadronic:WeightLocation 1048 0
 insert ISGW2Hadronic:WeightLocation 1049 0
 insert ISGW2Hadronic:WeightLocation 1050 0
 insert ISGW2Hadronic:WeightLocation 1051 0
 insert ISGW2Hadronic:WeightLocation 1052 0
 insert ISGW2Hadronic:WeightLocation 1053 0
 insert ISGW2Hadronic:WeightLocation 1054 0
 insert ISGW2Hadronic:WeightLocation 1055 0
 insert ISGW2Hadronic:WeightLocation 1056 0
 insert ISGW2Hadronic:WeightLocation 1057 0
 insert ISGW2Hadronic:WeightLocation 1058 0
 insert ISGW2Hadronic:WeightLocation 1059 0
 insert ISGW2Hadronic:WeightLocation 1060 0
 insert ISGW2Hadronic:WeightLocation 1061 0
 insert ISGW2Hadronic:WeightLocation 1062 0
 insert ISGW2Hadronic:WeightLocation 1063 0
 insert ISGW2Hadronic:WeightLocation 1064 0
 insert ISGW2Hadronic:WeightLocation 1065 0
 insert ISGW2Hadronic:WeightLocation 1066 0
 insert ISGW2Hadronic:WeightLocation 1067 0
 insert ISGW2Hadronic:WeightLocation 1068 0
 insert ISGW2Hadronic:WeightLocation 1069 0
 insert ISGW2Hadronic:WeightLocation 1070 0
 insert ISGW2Hadronic:WeightLocation 1071 0
 insert ISGW2Hadronic:WeightLocation 1072 0
 insert ISGW2Hadronic:WeightLocation 1073 0
 insert ISGW2Hadronic:WeightLocation 1074 0
 insert ISGW2Hadronic:WeightLocation 1075 0
 insert ISGW2Hadronic:WeightLocation 1076 0
 insert ISGW2Hadronic:WeightLocation 1077 0
 insert ISGW2Hadronic:WeightLocation 1078 0
 insert ISGW2Hadronic:WeightLocation 1079 0
 insert ISGW2Hadronic:WeightLocation 1080 0
 insert ISGW2Hadronic:WeightLocation 1081 0
 insert ISGW2Hadronic:WeightLocation 1082 0
 insert ISGW2Hadronic:WeightLocation 1083 0
 insert ISGW2Hadronic:WeightLocation 1084 0
 insert ISGW2Hadronic:WeightLocation 1085 0
 insert ISGW2Hadronic:WeightLocation 1086 0
 insert ISGW2Hadronic:WeightLocation 1087 0
 insert ISGW2Hadronic:WeightLocation 1088 0
 insert ISGW2Hadronic:WeightLocation 1089 0
 insert ISGW2Hadronic:WeightLocation 1090 0
 insert ISGW2Hadronic:WeightLocation 1091 0
 insert ISGW2Hadronic:WeightLocation 1092 0
 insert ISGW2Hadronic:WeightLocation 1093 0
 insert ISGW2Hadronic:WeightLocation 1094 0
 insert ISGW2Hadronic:WeightLocation 1095 0
 insert ISGW2Hadronic:WeightLocation 1096 0
 insert ISGW2Hadronic:WeightLocation 1097 0
 insert ISGW2Hadronic:WeightLocation 1098 0
 insert ISGW2Hadronic:WeightLocation 1099 0
 insert ISGW2Hadronic:WeightLocation 1100 0
 insert ISGW2Hadronic:WeightLocation 1101 0
 insert ISGW2Hadronic:WeightLocation 1102 0
 insert ISGW2Hadronic:WeightLocation 1103 0
 insert ISGW2Hadronic:WeightLocation 1104 0
 insert ISGW2Hadronic:WeightLocation 1105 0
 insert ISGW2Hadronic:WeightLocation 1106 0
 insert ISGW2Hadronic:WeightLocation 1107 0
 insert ISGW2Hadronic:WeightLocation 1108 0
 insert ISGW2Hadronic:WeightLocation 1109 0
 insert ISGW2Hadronic:WeightLocation 1110 0
 insert ISGW2Hadronic:WeightLocation 1111 0
 insert ISGW2Hadronic:WeightLocation 1112 0
 insert ISGW2Hadronic:WeightLocation 1113 0
 insert ISGW2Hadronic:WeightLocation 1114 0
 insert ISGW2Hadronic:WeightLocation 1115 0
 insert ISGW2Hadronic:WeightLocation 1116 0
 insert ISGW2Hadronic:WeightLocation 1117 0
 insert ISGW2Hadronic:WeightLocation 1118 0
 insert ISGW2Hadronic:WeightLocation 1119 0
 insert ISGW2Hadronic:WeightLocation 1120 0
 insert ISGW2Hadronic:WeightLocation 1121 0
 insert ISGW2Hadronic:WeightLocation 1122 0
 insert ISGW2Hadronic:WeightLocation 1123 0
 insert ISGW2Hadronic:WeightLocation 1124 0
 insert ISGW2Hadronic:WeightLocation 1125 0
 insert ISGW2Hadronic:WeightLocation 1126 0
 insert ISGW2Hadronic:WeightLocation 1127 0
 insert ISGW2Hadronic:WeightLocation 1128 0
 insert ISGW2Hadronic:WeightLocation 1129 0
 insert ISGW2Hadronic:WeightLocation 1130 0
 insert ISGW2Hadronic:WeightLocation 1131 0
 insert ISGW2Hadronic:WeightLocation 1132 0
 insert ISGW2Hadronic:WeightLocation 1133 0
 insert ISGW2Hadronic:WeightLocation 1134 0
 insert ISGW2Hadronic:WeightLocation 1135 0
 insert ISGW2Hadronic:WeightLocation 1136 0
 insert ISGW2Hadronic:WeightLocation 1137 0
 insert ISGW2Hadronic:WeightLocation 1138 0
 insert ISGW2Hadronic:WeightLocation 1139 0
 insert ISGW2Hadronic:WeightLocation 1140 0
 insert ISGW2Hadronic:WeightLocation 1141 0
 insert ISGW2Hadronic:WeightLocation 1142 0
 insert ISGW2Hadronic:WeightLocation 1143 0
 insert ISGW2Hadronic:WeightLocation 1144 0
 insert ISGW2Hadronic:WeightLocation 1145 0
 insert ISGW2Hadronic:WeightLocation 1146 0
 insert ISGW2Hadronic:WeightLocation 1147 0
 insert ISGW2Hadronic:WeightLocation 1148 0
 insert ISGW2Hadronic:WeightLocation 1149 0
 insert ISGW2Hadronic:WeightLocation 1150 0
 insert ISGW2Hadronic:WeightLocation 1151 0
 insert ISGW2Hadronic:WeightLocation 1152 0
 insert ISGW2Hadronic:WeightLocation 1153 0
 insert ISGW2Hadronic:WeightLocation 1154 0
 insert ISGW2Hadronic:WeightLocation 1155 0
 insert ISGW2Hadronic:WeightLocation 1156 0
 insert ISGW2Hadronic:WeightLocation 1157 0
 insert ISGW2Hadronic:WeightLocation 1158 0
 insert ISGW2Hadronic:WeightLocation 1159 0
 insert ISGW2Hadronic:WeightLocation 1160 0
 insert ISGW2Hadronic:WeightLocation 1161 0
 insert ISGW2Hadronic:WeightLocation 1162 0
 insert ISGW2Hadronic:WeightLocation 1163 0
 insert ISGW2Hadronic:WeightLocation 1164 0
 insert ISGW2Hadronic:WeightLocation 1165 0
 insert ISGW2Hadronic:WeightLocation 1166 0
 insert ISGW2Hadronic:WeightLocation 1167 0
 insert ISGW2Hadronic:WeightLocation 1168 0
 insert ISGW2Hadronic:WeightLocation 1169 0
 insert ISGW2Hadronic:WeightLocation 1170 0
 insert ISGW2Hadronic:WeightLocation 1171 0
 insert ISGW2Hadronic:WeightLocation 1172 0
 insert ISGW2Hadronic:WeightLocation 1173 0
 insert ISGW2Hadronic:WeightLocation 1174 0
 insert ISGW2Hadronic:WeightLocation 1175 0
 insert ISGW2Hadronic:WeightLocation 1176 0
 insert ISGW2Hadronic:WeightLocation 1177 0
 insert ISGW2Hadronic:WeightLocation 1178 0
 insert ISGW2Hadronic:WeightLocation 1179 0
 insert ISGW2Hadronic:WeightLocation 1180 0
 insert ISGW2Hadronic:WeightLocation 1181 0
 insert ISGW2Hadronic:WeightLocation 1182 0
 insert ISGW2Hadronic:WeightLocation 1183 0
 insert ISGW2Hadronic:WeightLocation 1184 0
 insert ISGW2Hadronic:WeightLocation 1185 0
 insert ISGW2Hadronic:WeightLocation 1186 0
 insert ISGW2Hadronic:WeightLocation 1187 0
 insert ISGW2Hadronic:WeightLocation 1188 0
 insert ISGW2Hadronic:WeightLocation 1189 0
 insert ISGW2Hadronic:WeightLocation 1190 0
 insert ISGW2Hadronic:WeightLocation 1191 0
 insert ISGW2Hadronic:WeightLocation 1192 0
 insert ISGW2Hadronic:WeightLocation 1193 0
 insert ISGW2Hadronic:WeightLocation 1194 0
 insert ISGW2Hadronic:WeightLocation 1195 0
 insert ISGW2Hadronic:WeightLocation 1196 0
 insert ISGW2Hadronic:WeightLocation 1197 0
 insert ISGW2Hadronic:WeightLocation 1198 0
 insert ISGW2Hadronic:WeightLocation 1199 0
 insert ISGW2Hadronic:WeightLocation 1200 0
 insert ISGW2Hadronic:WeightLocation 1201 0
 insert ISGW2Hadronic:WeightLocation 1202 0
 insert ISGW2Hadronic:WeightLocation 1203 0
 insert ISGW2Hadronic:WeightLocation 1204 0
 insert ISGW2Hadronic:WeightLocation 1205 0
 insert ISGW2Hadronic:WeightLocation 1206 0
 insert ISGW2Hadronic:WeightLocation 1207 0
 insert ISGW2Hadronic:WeightLocation 1208 0
 insert ISGW2Hadronic:WeightLocation 1209 0
 insert ISGW2Hadronic:WeightLocation 1210 0
 insert ISGW2Hadronic:WeightLocation 1211 0
 insert ISGW2Hadronic:WeightLocation 1212 0
 insert ISGW2Hadronic:WeightLocation 1213 0
 insert ISGW2Hadronic:WeightLocation 1214 0
 insert ISGW2Hadronic:WeightLocation 1215 0
 insert ISGW2Hadronic:WeightLocation 1216 0
 insert ISGW2Hadronic:WeightLocation 1217 0
 insert ISGW2Hadronic:WeightLocation 1218 0
 insert ISGW2Hadronic:WeightLocation 1219 0
 insert ISGW2Hadronic:WeightLocation 1220 0
 insert ISGW2Hadronic:WeightLocation 1221 0
 insert ISGW2Hadronic:WeightLocation 1222 0
 insert ISGW2Hadronic:WeightLocation 1223 0
 insert ISGW2Hadronic:WeightLocation 1224 0
 insert ISGW2Hadronic:WeightLocation 1225 0
 insert ISGW2Hadronic:WeightLocation 1226 0
 insert ISGW2Hadronic:WeightLocation 1227 0
 insert ISGW2Hadronic:WeightLocation 1228 0
 insert ISGW2Hadronic:WeightLocation 1229 0
 insert ISGW2Hadronic:WeightLocation 1230 0
 insert ISGW2Hadronic:WeightLocation 1231 0
 insert ISGW2Hadronic:WeightLocation 1232 0
 insert ISGW2Hadronic:WeightLocation 1233 0
 insert ISGW2Hadronic:WeightLocation 1234 0
 insert ISGW2Hadronic:WeightLocation 1235 0
 insert ISGW2Hadronic:WeightLocation 1236 0
 insert ISGW2Hadronic:WeightLocation 1237 0
 insert ISGW2Hadronic:WeightLocation 1238 0
 insert ISGW2Hadronic:WeightLocation 1239 0
 insert ISGW2Hadronic:WeightLocation 1240 0
 insert ISGW2Hadronic:WeightLocation 1241 0
 insert ISGW2Hadronic:WeightLocation 1242 0
 insert ISGW2Hadronic:WeightLocation 1243 0
 insert ISGW2Hadronic:WeightLocation 1244 0
 insert ISGW2Hadronic:WeightLocation 1245 0
 insert ISGW2Hadronic:WeightLocation 1246 0
 insert ISGW2Hadronic:WeightLocation 1247 0
 insert ISGW2Hadronic:WeightLocation 1248 0
 insert ISGW2Hadronic:WeightLocation 1249 0
 insert ISGW2Hadronic:WeightLocation 1250 0
 insert ISGW2Hadronic:WeightLocation 1251 0
 insert ISGW2Hadronic:WeightLocation 1252 0
 insert ISGW2Hadronic:WeightLocation 1253 0
 insert ISGW2Hadronic:WeightLocation 1254 0
 insert ISGW2Hadronic:WeightLocation 1255 0
 insert ISGW2Hadronic:WeightLocation 1256 0
 insert ISGW2Hadronic:WeightLocation 1257 0
 insert ISGW2Hadronic:WeightLocation 1258 0
 insert ISGW2Hadronic:WeightLocation 1259 0
 insert ISGW2Hadronic:WeightLocation 1260 0
 insert ISGW2Hadronic:WeightLocation 1261 0
 insert ISGW2Hadronic:WeightLocation 1262 0
 insert ISGW2Hadronic:WeightLocation 1263 0
 insert ISGW2Hadronic:WeightLocation 1264 0
 insert ISGW2Hadronic:WeightLocation 1265 0
 insert ISGW2Hadronic:WeightLocation 1266 0
 insert ISGW2Hadronic:WeightLocation 1267 0
 insert ISGW2Hadronic:WeightLocation 1268 0
 insert ISGW2Hadronic:WeightLocation 1269 0
 insert ISGW2Hadronic:WeightLocation 1270 0
 insert ISGW2Hadronic:WeightLocation 1271 0
 insert ISGW2Hadronic:WeightLocation 1272 0
 insert ISGW2Hadronic:WeightLocation 1273 0
 insert ISGW2Hadronic:WeightLocation 1274 0
 insert ISGW2Hadronic:WeightLocation 1275 0
 insert ISGW2Hadronic:WeightLocation 1276 0
 insert ISGW2Hadronic:WeightLocation 1277 0
 insert ISGW2Hadronic:WeightLocation 1278 0
 insert ISGW2Hadronic:WeightLocation 1279 0
 insert ISGW2Hadronic:WeightLocation 1280 0
 insert ISGW2Hadronic:WeightLocation 1281 0
 insert ISGW2Hadronic:WeightLocation 1282 0
 insert ISGW2Hadronic:WeightLocation 1283 0
 insert ISGW2Hadronic:WeightLocation 1284 0
 insert ISGW2Hadronic:WeightLocation 1285 0
 insert ISGW2Hadronic:WeightLocation 1286 0
 insert ISGW2Hadronic:WeightLocation 1287 0
 insert ISGW2Hadronic:WeightLocation 1288 0
 insert ISGW2Hadronic:WeightLocation 1289 0
 insert ISGW2Hadronic:WeightLocation 1290 0
 insert ISGW2Hadronic:WeightLocation 1291 0
 insert ISGW2Hadronic:WeightLocation 1292 0
 insert ISGW2Hadronic:WeightLocation 1293 0
 insert ISGW2Hadronic:WeightLocation 1294 0
 insert ISGW2Hadronic:WeightLocation 1295 0
 insert ISGW2Hadronic:WeightLocation 1296 0
 insert ISGW2Hadronic:WeightLocation 1297 0
 insert ISGW2Hadronic:WeightLocation 1298 0
 insert ISGW2Hadronic:WeightLocation 1299 0
 insert ISGW2Hadronic:WeightLocation 1300 0
 insert ISGW2Hadronic:WeightLocation 1301 0
 insert ISGW2Hadronic:WeightLocation 1302 0
 insert ISGW2Hadronic:WeightLocation 1303 0
 insert ISGW2Hadronic:WeightLocation 1304 0
 insert ISGW2Hadronic:WeightLocation 1305 0
 insert ISGW2Hadronic:WeightLocation 1306 0
 insert ISGW2Hadronic:WeightLocation 1307 0
 insert ISGW2Hadronic:WeightLocation 1308 0
 insert ISGW2Hadronic:WeightLocation 1309 0
 insert ISGW2Hadronic:WeightLocation 1310 0
 insert ISGW2Hadronic:WeightLocation 1311 0
 insert ISGW2Hadronic:WeightLocation 1312 0
 insert ISGW2Hadronic:WeightLocation 1313 0
 insert ISGW2Hadronic:WeightLocation 1314 0
 insert ISGW2Hadronic:WeightLocation 1315 0
 insert ISGW2Hadronic:WeightLocation 1316 0
 insert ISGW2Hadronic:WeightLocation 1317 0
 insert ISGW2Hadronic:WeightLocation 1318 0
 insert ISGW2Hadronic:WeightLocation 1319 0
 insert ISGW2Hadronic:WeightLocation 1320 0
 insert ISGW2Hadronic:WeightLocation 1321 0
 insert ISGW2Hadronic:WeightLocation 1322 0
 insert ISGW2Hadronic:WeightLocation 1323 0
 insert ISGW2Hadronic:WeightLocation 1324 0
 insert ISGW2Hadronic:WeightLocation 1325 0
 insert ISGW2Hadronic:WeightLocation 1326 0
 insert ISGW2Hadronic:WeightLocation 1327 0
 insert ISGW2Hadronic:WeightLocation 1328 0
 insert ISGW2Hadronic:WeightLocation 1329 0
 insert ISGW2Hadronic:WeightLocation 1330 0
 insert ISGW2Hadronic:WeightLocation 1331 0
 insert ISGW2Hadronic:WeightLocation 1332 0
 insert ISGW2Hadronic:WeightLocation 1333 0
 insert ISGW2Hadronic:WeightLocation 1334 0
 insert ISGW2Hadronic:WeightLocation 1335 0
 insert ISGW2Hadronic:WeightLocation 1336 0
 insert ISGW2Hadronic:WeightLocation 1337 0
 insert ISGW2Hadronic:WeightLocation 1338 0
 insert ISGW2Hadronic:WeightLocation 1339 0
 insert ISGW2Hadronic:WeightLocation 1340 0
 insert ISGW2Hadronic:WeightLocation 1341 0
 insert ISGW2Hadronic:WeightLocation 1342 0
 insert ISGW2Hadronic:WeightLocation 1343 0
 insert ISGW2Hadronic:WeightLocation 1344 0
 insert ISGW2Hadronic:WeightLocation 1345 0
 insert ISGW2Hadronic:WeightLocation 1346 0
 insert ISGW2Hadronic:WeightLocation 1347 0
 insert ISGW2Hadronic:WeightLocation 1348 0
 insert ISGW2Hadronic:WeightLocation 1349 0
 insert ISGW2Hadronic:WeightLocation 1350 0
 insert ISGW2Hadronic:WeightLocation 1351 0
 insert ISGW2Hadronic:WeightLocation 1352 0
 insert ISGW2Hadronic:WeightLocation 1353 0
 insert ISGW2Hadronic:WeightLocation 1354 0
 insert ISGW2Hadronic:WeightLocation 1355 0
 insert ISGW2Hadronic:WeightLocation 1356 0
 insert ISGW2Hadronic:WeightLocation 1357 0
 insert ISGW2Hadronic:WeightLocation 1358 0
 insert ISGW2Hadronic:WeightLocation 1359 0
 insert ISGW2Hadronic:WeightLocation 1360 0
 insert ISGW2Hadronic:WeightLocation 1361 0
 insert ISGW2Hadronic:WeightLocation 1362 0
 insert ISGW2Hadronic:WeightLocation 1363 0
 insert ISGW2Hadronic:WeightLocation 1364 0
 insert ISGW2Hadronic:WeightLocation 1365 0
 insert ISGW2Hadronic:WeightLocation 1366 0
 insert ISGW2Hadronic:WeightLocation 1367 0
 insert ISGW2Hadronic:WeightLocation 1368 0
 insert ISGW2Hadronic:WeightLocation 1369 0
 insert ISGW2Hadronic:WeightLocation 1370 0
 insert ISGW2Hadronic:WeightLocation 1371 0
 insert ISGW2Hadronic:WeightLocation 1372 0
 insert ISGW2Hadronic:WeightLocation 1373 0
 insert ISGW2Hadronic:WeightLocation 1374 0
 insert ISGW2Hadronic:WeightLocation 1375 0
 insert ISGW2Hadronic:WeightLocation 1376 0
 insert ISGW2Hadronic:WeightLocation 1377 0
 insert ISGW2Hadronic:WeightLocation 1378 0
 insert ISGW2Hadronic:WeightLocation 1379 0
 insert ISGW2Hadronic:WeightLocation 1380 0
 insert ISGW2Hadronic:WeightLocation 1381 0
 insert ISGW2Hadronic:WeightLocation 1382 0
 insert ISGW2Hadronic:WeightLocation 1383 0
 insert ISGW2Hadronic:WeightLocation 1384 0
 insert ISGW2Hadronic:WeightLocation 1385 0
 insert ISGW2Hadronic:WeightLocation 1386 0
 insert ISGW2Hadronic:WeightLocation 1387 0
 insert ISGW2Hadronic:WeightLocation 1388 0
 insert ISGW2Hadronic:WeightLocation 1389 0
 insert ISGW2Hadronic:WeightLocation 1390 0
 insert ISGW2Hadronic:WeightLocation 1391 0
 insert ISGW2Hadronic:WeightLocation 1392 0
 insert ISGW2Hadronic:WeightLocation 1393 0
 insert ISGW2Hadronic:WeightLocation 1394 0
 insert ISGW2Hadronic:WeightLocation 1395 0
 insert ISGW2Hadronic:WeightLocation 1396 0
 insert ISGW2Hadronic:WeightLocation 1397 0
 insert ISGW2Hadronic:WeightLocation 1398 0
 insert ISGW2Hadronic:WeightLocation 1399 0
 insert ISGW2Hadronic:WeightLocation 1400 0
 insert ISGW2Hadronic:WeightLocation 1401 0
 insert ISGW2Hadronic:WeightLocation 1402 0
 insert ISGW2Hadronic:WeightLocation 1403 0
 insert ISGW2Hadronic:WeightLocation 1404 0
 insert ISGW2Hadronic:WeightLocation 1405 0
 insert ISGW2Hadronic:WeightLocation 1406 0
 insert ISGW2Hadronic:WeightLocation 1407 0
 insert ISGW2Hadronic:WeightLocation 1408 0
 insert ISGW2Hadronic:WeightLocation 1409 0
 insert ISGW2Hadronic:WeightLocation 1410 0
 insert ISGW2Hadronic:WeightLocation 1411 0
 insert ISGW2Hadronic:WeightLocation 1412 0
 insert ISGW2Hadronic:WeightLocation 1413 0
 insert ISGW2Hadronic:WeightLocation 1414 0
 insert ISGW2Hadronic:WeightLocation 1415 0
 insert ISGW2Hadronic:WeightLocation 1416 0
 insert ISGW2Hadronic:WeightLocation 1417 0
 insert ISGW2Hadronic:WeightLocation 1418 0
 insert ISGW2Hadronic:WeightLocation 1419 0
 insert ISGW2Hadronic:WeightLocation 1420 0
 insert ISGW2Hadronic:WeightLocation 1421 0
 insert ISGW2Hadronic:WeightLocation 1422 0
 insert ISGW2Hadronic:WeightLocation 1423 0
 insert ISGW2Hadronic:WeightLocation 1424 0
 insert ISGW2Hadronic:WeightLocation 1425 0
 insert ISGW2Hadronic:WeightLocation 1426 0
 insert ISGW2Hadronic:WeightLocation 1427 0
 insert ISGW2Hadronic:WeightLocation 1428 0
 insert ISGW2Hadronic:WeightLocation 1429 0
 insert ISGW2Hadronic:WeightLocation 1430 0
 insert ISGW2Hadronic:WeightLocation 1431 0
 insert ISGW2Hadronic:WeightLocation 1432 0
 insert ISGW2Hadronic:WeightLocation 1433 0
 insert ISGW2Hadronic:WeightLocation 1434 0
 insert ISGW2Hadronic:WeightLocation 1435 0
 insert ISGW2Hadronic:WeightLocation 1436 0
 insert ISGW2Hadronic:WeightLocation 1437 0
 insert ISGW2Hadronic:WeightLocation 1438 0
 insert ISGW2Hadronic:WeightLocation 1439 0
 insert ISGW2Hadronic:WeightLocation 1440 0
 insert ISGW2Hadronic:WeightLocation 1441 0
 insert ISGW2Hadronic:WeightLocation 1442 0
 insert ISGW2Hadronic:WeightLocation 1443 0
 insert ISGW2Hadronic:WeightLocation 1444 0
 insert ISGW2Hadronic:WeightLocation 1445 0
 insert ISGW2Hadronic:WeightLocation 1446 0
 insert ISGW2Hadronic:WeightLocation 1447 0
 insert ISGW2Hadronic:WeightLocation 1448 0
 insert ISGW2Hadronic:WeightLocation 1449 0
 insert ISGW2Hadronic:WeightLocation 1450 0
 insert ISGW2Hadronic:WeightLocation 1451 0
 insert ISGW2Hadronic:WeightLocation 1452 0
 insert ISGW2Hadronic:WeightLocation 1453 0
 insert ISGW2Hadronic:WeightLocation 1454 0
 insert ISGW2Hadronic:WeightLocation 1455 0
 insert ISGW2Hadronic:WeightLocation 1456 0
 insert ISGW2Hadronic:WeightLocation 1457 0
 insert ISGW2Hadronic:WeightLocation 1458 0
 insert ISGW2Hadronic:WeightLocation 1459 0
 insert ISGW2Hadronic:WeightLocation 1460 0
 insert ISGW2Hadronic:WeightLocation 1461 0
 insert ISGW2Hadronic:WeightLocation 1462 0
 insert ISGW2Hadronic:WeightLocation 1463 0
 insert ISGW2Hadronic:WeightLocation 1464 0
 insert ISGW2Hadronic:WeightLocation 1465 0
 insert ISGW2Hadronic:WeightLocation 1466 0
 insert ISGW2Hadronic:WeightLocation 1467 0
 insert ISGW2Hadronic:WeightLocation 1468 0
 insert ISGW2Hadronic:WeightLocation 1469 0
 insert ISGW2Hadronic:WeightLocation 1470 0
 insert ISGW2Hadronic:WeightLocation 1471 0
 insert ISGW2Hadronic:WeightLocation 1472 0
 insert ISGW2Hadronic:WeightLocation 1473 0
 insert ISGW2Hadronic:WeightLocation 1474 0
 insert ISGW2Hadronic:WeightLocation 1475 0
 insert ISGW2Hadronic:WeightLocation 1476 0
 insert ISGW2Hadronic:WeightLocation 1477 0
 insert ISGW2Hadronic:WeightLocation 1478 0
 insert ISGW2Hadronic:WeightLocation 1479 0
 insert ISGW2Hadronic:WeightLocation 1480 0
 insert ISGW2Hadronic:WeightLocation 1481 0
 insert ISGW2Hadronic:WeightLocation 1482 0
 insert ISGW2Hadronic:WeightLocation 1483 0
 insert ISGW2Hadronic:WeightLocation 1484 0
 insert ISGW2Hadronic:WeightLocation 1485 0
 insert ISGW2Hadronic:WeightLocation 1486 0
 insert ISGW2Hadronic:WeightLocation 1487 0
 insert ISGW2Hadronic:WeightLocation 1488 0
 insert ISGW2Hadronic:WeightLocation 1489 0
 insert ISGW2Hadronic:WeightLocation 1490 0
 insert ISGW2Hadronic:WeightLocation 1491 0
 insert ISGW2Hadronic:WeightLocation 1492 0
 insert ISGW2Hadronic:WeightLocation 1493 0
 insert ISGW2Hadronic:WeightLocation 1494 0
 insert ISGW2Hadronic:WeightLocation 1495 0
 insert ISGW2Hadronic:WeightLocation 1496 0
 insert ISGW2Hadronic:WeightLocation 1497 0
 insert ISGW2Hadronic:WeightLocation 1498 0
 insert ISGW2Hadronic:WeightLocation 1499 0
 insert ISGW2Hadronic:WeightLocation 1500 0
 insert ISGW2Hadronic:WeightLocation 1501 0
 insert ISGW2Hadronic:WeightLocation 1502 0
 insert ISGW2Hadronic:WeightLocation 1503 0
 insert ISGW2Hadronic:WeightLocation 1504 0
 insert ISGW2Hadronic:WeightLocation 1505 0
 insert ISGW2Hadronic:WeightLocation 1506 0
 insert ISGW2Hadronic:WeightLocation 1507 0
 insert ISGW2Hadronic:WeightLocation 1508 0
 insert ISGW2Hadronic:WeightLocation 1509 0
 insert ISGW2Hadronic:WeightLocation 1510 0
 insert ISGW2Hadronic:WeightLocation 1511 0
 insert ISGW2Hadronic:WeightLocation 1512 0
 insert ISGW2Hadronic:WeightLocation 1513 0
 insert ISGW2Hadronic:WeightLocation 1514 0
 insert ISGW2Hadronic:WeightLocation 1515 0
 insert ISGW2Hadronic:WeightLocation 1516 0
 insert ISGW2Hadronic:WeightLocation 1517 0
 insert ISGW2Hadronic:WeightLocation 1518 0
 insert ISGW2Hadronic:WeightLocation 1519 0
 insert ISGW2Hadronic:WeightLocation 1520 0
 insert ISGW2Hadronic:WeightLocation 1521 0
 insert ISGW2Hadronic:WeightLocation 1522 0
 insert ISGW2Hadronic:WeightLocation 1523 0
 insert ISGW2Hadronic:WeightLocation 1524 0
 insert ISGW2Hadronic:WeightLocation 1525 0
 insert ISGW2Hadronic:WeightLocation 1526 0
 insert ISGW2Hadronic:WeightLocation 1527 0
 insert ISGW2Hadronic:WeightLocation 1528 0
 insert ISGW2Hadronic:WeightLocation 1529 0
 insert ISGW2Hadronic:WeightLocation 1530 0
 insert ISGW2Hadronic:WeightLocation 1531 0
 insert ISGW2Hadronic:WeightLocation 1532 0
 insert ISGW2Hadronic:WeightLocation 1533 0
 insert ISGW2Hadronic:WeightLocation 1534 0
 insert ISGW2Hadronic:WeightLocation 1535 0
 insert ISGW2Hadronic:WeightLocation 1536 0
 insert ISGW2Hadronic:WeightLocation 1537 0
 insert ISGW2Hadronic:WeightLocation 1538 0
 insert ISGW2Hadronic:WeightLocation 1539 0
 insert ISGW2Hadronic:WeightLocation 1540 0
 insert ISGW2Hadronic:WeightLocation 1541 0
 insert ISGW2Hadronic:WeightLocation 1542 0
 insert ISGW2Hadronic:WeightLocation 1543 0
 insert ISGW2Hadronic:WeightLocation 1544 0
 insert ISGW2Hadronic:WeightLocation 1545 0
 insert ISGW2Hadronic:WeightLocation 1546 0
 insert ISGW2Hadronic:WeightLocation 1547 0
 insert ISGW2Hadronic:WeightLocation 1548 0
 insert ISGW2Hadronic:WeightLocation 1549 0
 insert ISGW2Hadronic:WeightLocation 1550 0
 insert ISGW2Hadronic:WeightLocation 1551 0
 insert ISGW2Hadronic:WeightLocation 1552 0
 insert ISGW2Hadronic:WeightLocation 1553 0
 insert ISGW2Hadronic:WeightLocation 1554 0
 insert ISGW2Hadronic:WeightLocation 1555 0
 insert ISGW2Hadronic:WeightLocation 1556 0
 insert ISGW2Hadronic:WeightLocation 1557 0
 insert ISGW2Hadronic:WeightLocation 1558 0
 insert ISGW2Hadronic:WeightLocation 1559 0
 insert ISGW2Hadronic:WeightLocation 1560 0
 insert ISGW2Hadronic:WeightLocation 1561 0
 insert ISGW2Hadronic:WeightLocation 1562 0
 insert ISGW2Hadronic:WeightLocation 1563 0
 insert ISGW2Hadronic:WeightLocation 1564 0
 insert ISGW2Hadronic:WeightLocation 1565 0
 insert ISGW2Hadronic:WeightLocation 1566 0
 insert ISGW2Hadronic:WeightLocation 1567 0
 insert ISGW2Hadronic:WeightLocation 1568 0
 insert ISGW2Hadronic:WeightLocation 1569 0
 insert ISGW2Hadronic:WeightLocation 1570 0
 insert ISGW2Hadronic:WeightLocation 1571 0
 insert ISGW2Hadronic:WeightLocation 1572 0
 insert ISGW2Hadronic:WeightLocation 1573 0
 insert ISGW2Hadronic:WeightLocation 1574 0
 insert ISGW2Hadronic:WeightLocation 1575 0
 insert ISGW2Hadronic:WeightLocation 1576 0
 insert ISGW2Hadronic:WeightLocation 1577 0
 insert ISGW2Hadronic:WeightLocation 1578 0
 insert ISGW2Hadronic:WeightLocation 1579 0
 insert ISGW2Hadronic:WeightLocation 1580 0
 insert ISGW2Hadronic:WeightLocation 1581 0
 insert ISGW2Hadronic:WeightLocation 1582 0
 insert ISGW2Hadronic:WeightLocation 1583 0
 insert ISGW2Hadronic:WeightLocation 1584 0
 insert ISGW2Hadronic:WeightLocation 1585 0
 insert ISGW2Hadronic:WeightLocation 1586 0
 insert ISGW2Hadronic:WeightLocation 1587 0
 insert ISGW2Hadronic:WeightLocation 1588 0
 insert ISGW2Hadronic:WeightLocation 1589 0
 insert ISGW2Hadronic:WeightLocation 1590 0
 insert ISGW2Hadronic:WeightLocation 1591 0
 insert ISGW2Hadronic:WeightLocation 1592 0
 insert ISGW2Hadronic:WeightLocation 1593 0
 insert ISGW2Hadronic:WeightLocation 1594 0
 insert ISGW2Hadronic:WeightLocation 1595 0
 insert ISGW2Hadronic:WeightLocation 1596 0
 insert ISGW2Hadronic:WeightLocation 1597 0
 insert ISGW2Hadronic:WeightLocation 1598 0
 insert ISGW2Hadronic:WeightLocation 1599 0
 insert ISGW2Hadronic:WeightLocation 1600 0
 insert ISGW2Hadronic:WeightLocation 1601 0
 insert ISGW2Hadronic:WeightLocation 1602 0
 insert ISGW2Hadronic:WeightLocation 1603 0
 insert ISGW2Hadronic:WeightLocation 1604 0
 insert ISGW2Hadronic:WeightLocation 1605 0
 insert ISGW2Hadronic:WeightLocation 1606 0
 insert ISGW2Hadronic:WeightLocation 1607 0
 insert ISGW2Hadronic:WeightLocation 1608 0
 insert ISGW2Hadronic:WeightLocation 1609 0
 insert ISGW2Hadronic:WeightLocation 1610 0
 insert ISGW2Hadronic:WeightLocation 1611 0
 insert ISGW2Hadronic:WeightLocation 1612 0
 insert ISGW2Hadronic:WeightLocation 1613 0
 insert ISGW2Hadronic:WeightLocation 1614 0
 insert ISGW2Hadronic:WeightLocation 1615 0
 insert ISGW2Hadronic:WeightLocation 1616 0
 insert ISGW2Hadronic:WeightLocation 1617 0
 insert ISGW2Hadronic:WeightLocation 1618 0
 insert ISGW2Hadronic:WeightLocation 1619 0
 insert ISGW2Hadronic:WeightLocation 1620 0
 insert ISGW2Hadronic:WeightLocation 1621 0
 insert ISGW2Hadronic:WeightLocation 1622 0
 insert ISGW2Hadronic:WeightLocation 1623 0
 insert ISGW2Hadronic:WeightLocation 1624 0
 insert ISGW2Hadronic:WeightLocation 1625 0
 insert ISGW2Hadronic:WeightLocation 1626 0
 insert ISGW2Hadronic:WeightLocation 1627 0
 insert ISGW2Hadronic:WeightLocation 1628 0
 insert ISGW2Hadronic:WeightLocation 1629 0
 insert ISGW2Hadronic:WeightLocation 1630 0
 insert ISGW2Hadronic:WeightLocation 1631 0
 insert ISGW2Hadronic:WeightLocation 1632 0
 insert ISGW2Hadronic:WeightLocation 1633 0
 insert ISGW2Hadronic:WeightLocation 1634 0
 insert ISGW2Hadronic:WeightLocation 1635 0
 insert ISGW2Hadronic:WeightLocation 1636 0
 insert ISGW2Hadronic:WeightLocation 1637 0
 insert ISGW2Hadronic:WeightLocation 1638 0
 insert ISGW2Hadronic:WeightLocation 1639 0
 insert ISGW2Hadronic:WeightLocation 1640 0
 insert ISGW2Hadronic:WeightLocation 1641 0
 insert ISGW2Hadronic:WeightLocation 1642 0
 insert ISGW2Hadronic:WeightLocation 1643 0
 insert ISGW2Hadronic:WeightLocation 1644 0
 insert ISGW2Hadronic:WeightLocation 1645 0
 insert ISGW2Hadronic:WeightLocation 1646 0
 insert ISGW2Hadronic:WeightLocation 1647 0
 insert ISGW2Hadronic:WeightLocation 1648 0
 insert ISGW2Hadronic:WeightLocation 1649 0
 insert ISGW2Hadronic:WeightLocation 1650 0
 insert ISGW2Hadronic:WeightLocation 1651 0
 insert ISGW2Hadronic:WeightLocation 1652 0
 insert ISGW2Hadronic:WeightLocation 1653 0
 insert ISGW2Hadronic:WeightLocation 1654 0
 insert ISGW2Hadronic:WeightLocation 1655 0
 insert ISGW2Hadronic:WeightLocation 1656 0
 insert ISGW2Hadronic:WeightLocation 1657 0
 insert ISGW2Hadronic:WeightLocation 1658 0
 insert ISGW2Hadronic:WeightLocation 1659 0
 insert ISGW2Hadronic:WeightLocation 1660 0
 insert ISGW2Hadronic:WeightLocation 1661 0
 insert ISGW2Hadronic:WeightLocation 1662 0
 insert ISGW2Hadronic:WeightLocation 1663 0
 insert ISGW2Hadronic:WeightLocation 1664 0
 insert ISGW2Hadronic:WeightLocation 1665 0
 insert ISGW2Hadronic:WeightLocation 1666 0
 insert ISGW2Hadronic:WeightLocation 1667 0
 insert ISGW2Hadronic:WeightLocation 1668 0
 insert ISGW2Hadronic:WeightLocation 1669 0
 insert ISGW2Hadronic:WeightLocation 1670 0
 insert ISGW2Hadronic:WeightLocation 1671 0
 insert ISGW2Hadronic:WeightLocation 1672 0
 insert ISGW2Hadronic:WeightLocation 1673 0
 insert ISGW2Hadronic:WeightLocation 1674 0
 insert ISGW2Hadronic:WeightLocation 1675 0
 insert ISGW2Hadronic:WeightLocation 1676 0
 insert ISGW2Hadronic:WeightLocation 1677 0
 insert ISGW2Hadronic:WeightLocation 1678 0
 insert ISGW2Hadronic:WeightLocation 1679 0
 insert ISGW2Hadronic:WeightLocation 1680 0
 insert ISGW2Hadronic:WeightLocation 1681 0
 insert ISGW2Hadronic:WeightLocation 1682 0
 insert ISGW2Hadronic:WeightLocation 1683 0
 insert ISGW2Hadronic:WeightLocation 1684 0
 insert ISGW2Hadronic:WeightLocation 1685 0
 insert ISGW2Hadronic:WeightLocation 1686 0
 insert ISGW2Hadronic:MaximumWeight 0 2.6273e-08
 insert ISGW2Hadronic:MaximumWeight 1 1.35244e-08
 insert ISGW2Hadronic:MaximumWeight 2 1.30407e-08
 insert ISGW2Hadronic:MaximumWeight 3 1.84481e-05
 insert ISGW2Hadronic:MaximumWeight 4 1.00022e-07
 insert ISGW2Hadronic:MaximumWeight 5 8.69679e-08
 insert ISGW2Hadronic:MaximumWeight 6 2.37369e-07
 insert ISGW2Hadronic:MaximumWeight 7 2.40173e-07
 insert ISGW2Hadronic:MaximumWeight 8 1.885e-05
 insert ISGW2Hadronic:MaximumWeight 9 9.06637e-08
 insert ISGW2Hadronic:MaximumWeight 10 6.03355e-05
 insert ISGW2Hadronic:MaximumWeight 11 2.419e-06
 insert ISGW2Hadronic:MaximumWeight 12 1.76737e-08
 insert ISGW2Hadronic:MaximumWeight 13 8.99748e-09
 insert ISGW2Hadronic:MaximumWeight 14 8.22012e-09
 insert ISGW2Hadronic:MaximumWeight 15 1.0638e-05
 insert ISGW2Hadronic:MaximumWeight 16 1.95416e-07
 insert ISGW2Hadronic:MaximumWeight 17 6.42798e-08
 insert ISGW2Hadronic:MaximumWeight 18 1.49109e-07
 insert ISGW2Hadronic:MaximumWeight 19 2.00461e-07
 insert ISGW2Hadronic:MaximumWeight 20 2.19925e-05
 insert ISGW2Hadronic:MaximumWeight 21 1.22187e-07
 insert ISGW2Hadronic:MaximumWeight 22 0.000141161
 insert ISGW2Hadronic:MaximumWeight 23 8.16906e-06
 insert ISGW2Hadronic:MaximumWeight 24 2.27794e-08
 insert ISGW2Hadronic:MaximumWeight 25 1.13643e-08
 insert ISGW2Hadronic:MaximumWeight 26 1.03284e-08
 insert ISGW2Hadronic:MaximumWeight 27 1.18385e-05
 insert ISGW2Hadronic:MaximumWeight 28 5.05622e-09
 insert ISGW2Hadronic:MaximumWeight 29 8.09975e-08
 insert ISGW2Hadronic:MaximumWeight 30 1.76075e-07
 insert ISGW2Hadronic:MaximumWeight 31 2.35542e-07
 insert ISGW2Hadronic:MaximumWeight 32 2.59353e-05
 insert ISGW2Hadronic:MaximumWeight 33 1.10373e-08
 insert ISGW2Hadronic:MaximumWeight 34 5.25982e-06
 insert ISGW2Hadronic:MaximumWeight 35 2.2536e-07
 insert ISGW2Hadronic:MaximumWeight 36 1.44434e-10
 insert ISGW2Hadronic:MaximumWeight 37 7.53423e-11
 insert ISGW2Hadronic:MaximumWeight 38 7.22816e-11
 insert ISGW2Hadronic:MaximumWeight 39 1.1018e-07
 insert ISGW2Hadronic:MaximumWeight 40 4.66401e-11
 insert ISGW2Hadronic:MaximumWeight 41 5.18388e-09
 insert ISGW2Hadronic:MaximumWeight 42 7.59587e-09
 insert ISGW2Hadronic:MaximumWeight 43 1.28001e-08
 insert ISGW2Hadronic:MaximumWeight 44 3.16256e-06
 insert ISGW2Hadronic:MaximumWeight 45 1.32713e-09
 insert ISGW2Hadronic:MaximumWeight 46 1.32677e-06
 insert ISGW2Hadronic:MaximumWeight 47 4.70452e-07
 insert ISGW2Hadronic:MaximumWeight 48 1.0977e-06
 insert ISGW2Hadronic:MaximumWeight 49 8.78984e-08
 insert ISGW2Hadronic:MaximumWeight 50 2.29736e-06
 insert ISGW2Hadronic:MaximumWeight 51 3.05728e-07
 insert ISGW2Hadronic:MaximumWeight 52 3.63284e-06
 insert ISGW2Hadronic:MaximumWeight 53 4.05981e-07
 insert ISGW2Hadronic:MaximumWeight 54 1.00368e-05
 insert ISGW2Hadronic:MaximumWeight 55 4.38303e-06
 insert ISGW2Hadronic:MaximumWeight 56 2.27471e-06
 insert ISGW2Hadronic:MaximumWeight 57 6.46968e-07
 insert ISGW2Hadronic:MaximumWeight 58 5.13693e-08
 insert ISGW2Hadronic:MaximumWeight 59 2.65897e-06
 insert ISGW2Hadronic:MaximumWeight 60 2.28228e-07
 insert ISGW2Hadronic:MaximumWeight 61 2.45839e-06
 insert ISGW2Hadronic:MaximumWeight 62 3.18108e-07
 insert ISGW2Hadronic:MaximumWeight 63 7.27664e-06
 insert ISGW2Hadronic:MaximumWeight 64 2.96635e-06
 insert ISGW2Hadronic:MaximumWeight 65 5.01636e-06
 insert ISGW2Hadronic:MaximumWeight 66 5.89736e-07
 insert ISGW2Hadronic:MaximumWeight 67 4.66424e-08
 insert ISGW2Hadronic:MaximumWeight 68 6.69525e-08
 insert ISGW2Hadronic:MaximumWeight 69 1.79775e-06
 insert ISGW2Hadronic:MaximumWeight 70 1.45096e-07
 insert ISGW2Hadronic:MaximumWeight 71 2.13653e-06
 insert ISGW2Hadronic:MaximumWeight 72 2.20816e-07
 insert ISGW2Hadronic:MaximumWeight 73 6.23877e-06
 insert ISGW2Hadronic:MaximumWeight 74 1.54446e-07
 insert ISGW2Hadronic:MaximumWeight 75 4.01427e-06
 insert ISGW2Hadronic:MaximumWeight 76 2.03138e-06
 insert ISGW2Hadronic:MaximumWeight 77 1.41756e-06
 insert ISGW2Hadronic:MaximumWeight 78 1.14101e-07
 insert ISGW2Hadronic:MaximumWeight 79 2.27078e-07
 insert ISGW2Hadronic:MaximumWeight 80 6.39037e-06
 insert ISGW2Hadronic:MaximumWeight 81 6.33212e-07
 insert ISGW2Hadronic:MaximumWeight 82 4.98991e-06
 insert ISGW2Hadronic:MaximumWeight 83 5.45891e-07
 insert ISGW2Hadronic:MaximumWeight 84 1.48447e-05
 insert ISGW2Hadronic:MaximumWeight 85 3.56298e-07
 insert ISGW2Hadronic:MaximumWeight 86 9.13698e-06
 insert ISGW2Hadronic:MaximumWeight 87 5.10267e-06
 insert ISGW2Hadronic:MaximumWeight 88 6.07913e-09
 insert ISGW2Hadronic:MaximumWeight 89 4.91014e-10
 insert ISGW2Hadronic:MaximumWeight 90 9.83142e-10
 insert ISGW2Hadronic:MaximumWeight 91 2.75247e-08
 insert ISGW2Hadronic:MaximumWeight 92 2.55297e-09
 insert ISGW2Hadronic:MaximumWeight 93 1.86081e-07
 insert ISGW2Hadronic:MaximumWeight 94 2.76235e-08
 insert ISGW2Hadronic:MaximumWeight 95 5.67391e-07
 insert ISGW2Hadronic:MaximumWeight 96 2.89779e-08
 insert ISGW2Hadronic:MaximumWeight 97 8.53303e-07
 insert ISGW2Hadronic:MaximumWeight 98 5.60908e-07
 insert ISGW2Hadronic:MaximumWeight 99 1.59547e-07
 insert ISGW2Hadronic:MaximumWeight 100 1.26864e-08
 insert ISGW2Hadronic:MaximumWeight 101 1.98934e-08
 insert ISGW2Hadronic:MaximumWeight 102 5.38708e-07
 insert ISGW2Hadronic:MaximumWeight 103 4.4518e-08
 insert ISGW2Hadronic:MaximumWeight 104 5.31692e-07
 insert ISGW2Hadronic:MaximumWeight 105 4.72499e-08
 insert ISGW2Hadronic:MaximumWeight 106 1.46722e-06
 insert ISGW2Hadronic:MaximumWeight 107 2.44309e-08
 insert ISGW2Hadronic:MaximumWeight 108 5.95373e-07
 insert ISGW2Hadronic:MaximumWeight 109 2.37572e-07
 insert ISGW2Hadronic:MaximumWeight 110 3.80748e-09
 insert ISGW2Hadronic:MaximumWeight 111 1.95564e-09
 insert ISGW2Hadronic:MaximumWeight 112 1.8764e-09
 insert ISGW2Hadronic:MaximumWeight 113 2.59208e-06
 insert ISGW2Hadronic:MaximumWeight 114 1.25229e-08
 insert ISGW2Hadronic:MaximumWeight 115 3.40723e-08
 insert ISGW2Hadronic:MaximumWeight 116 3.43019e-08
 insert ISGW2Hadronic:MaximumWeight 117 2.57365e-06
 insert ISGW2Hadronic:MaximumWeight 118 0.00165402
 insert ISGW2Hadronic:MaximumWeight 119 8.43698e-05
 insert ISGW2Hadronic:MaximumWeight 120 9.97146e-10
 insert ISGW2Hadronic:MaximumWeight 121 5.08864e-10
 insert ISGW2Hadronic:MaximumWeight 122 4.78158e-10
 insert ISGW2Hadronic:MaximumWeight 123 6.20927e-07
 insert ISGW2Hadronic:MaximumWeight 124 4.56981e-09
 insert ISGW2Hadronic:MaximumWeight 125 1.13897e-08
 insert ISGW2Hadronic:MaximumWeight 126 1.28134e-08
 insert ISGW2Hadronic:MaximumWeight 127 1.74167e-06
 insert ISGW2Hadronic:MaximumWeight 128 0.00316931
 insert ISGW2Hadronic:MaximumWeight 129 0.000215502
 insert ISGW2Hadronic:MaximumWeight 130 3.12291e-09
 insert ISGW2Hadronic:MaximumWeight 131 1.56717e-09
 insert ISGW2Hadronic:MaximumWeight 132 1.38591e-09
 insert ISGW2Hadronic:MaximumWeight 133 1.47179e-06
 insert ISGW2Hadronic:MaximumWeight 134 2.23493e-07
 insert ISGW2Hadronic:MaximumWeight 135 1.16062e-08
 insert ISGW2Hadronic:MaximumWeight 136 2.01032e-08
 insert ISGW2Hadronic:MaximumWeight 137 3.27719e-08
 insert ISGW2Hadronic:MaximumWeight 138 3.1706e-06
 insert ISGW2Hadronic:MaximumWeight 139 4.81181e-07
 insert ISGW2Hadronic:MaximumWeight 140 0.000195381
 insert ISGW2Hadronic:MaximumWeight 141 1.24337e-06
 insert ISGW2Hadronic:MaximumWeight 142 2.57759e-09
 insert ISGW2Hadronic:MaximumWeight 143 1.32536e-09
 insert ISGW2Hadronic:MaximumWeight 144 1.27228e-09
 insert ISGW2Hadronic:MaximumWeight 145 1.73629e-06
 insert ISGW2Hadronic:MaximumWeight 146 8.81842e-09
 insert ISGW2Hadronic:MaximumWeight 147 2.41801e-08
 insert ISGW2Hadronic:MaximumWeight 148 2.52718e-08
 insert ISGW2Hadronic:MaximumWeight 149 2.3135e-06
 insert ISGW2Hadronic:MaximumWeight 150 0.00445015
 insert ISGW2Hadronic:MaximumWeight 151 0.000101026
 insert ISGW2Hadronic:MaximumWeight 152 5.29311e-11
 insert ISGW2Hadronic:MaximumWeight 153 2.74725e-11
 insert ISGW2Hadronic:MaximumWeight 154 2.63423e-11
 insert ISGW2Hadronic:MaximumWeight 155 3.90476e-08
 insert ISGW2Hadronic:MaximumWeight 156 5.91351e-09
 insert ISGW2Hadronic:MaximumWeight 157 3.69536e-10
 insert ISGW2Hadronic:MaximumWeight 158 7.07901e-10
 insert ISGW2Hadronic:MaximumWeight 159 1.01382e-09
 insert ISGW2Hadronic:MaximumWeight 160 1.68767e-07
 insert ISGW2Hadronic:MaximumWeight 161 2.46065e-08
 insert ISGW2Hadronic:MaximumWeight 162 2.20078e-05
 insert ISGW2Hadronic:MaximumWeight 163 4.70748e-06
 insert ISGW2Hadronic:MaximumWeight 164 1.78216e-10
 insert ISGW2Hadronic:MaximumWeight 165 9.02815e-11
 insert ISGW2Hadronic:MaximumWeight 166 8.37941e-11
 insert ISGW2Hadronic:MaximumWeight 167 9.72852e-08
 insert ISGW2Hadronic:MaximumWeight 168 5.95325e-10
 insert ISGW2Hadronic:MaximumWeight 169 1.63884e-09
 insert ISGW2Hadronic:MaximumWeight 170 1.65892e-09
 insert ISGW2Hadronic:MaximumWeight 171 1.33833e-07
 insert ISGW2Hadronic:MaximumWeight 172 0.000116913
 insert ISGW2Hadronic:MaximumWeight 173 2.75753e-06
 insert ISGW2Hadronic:MaximumWeight 174 0.00167722
 insert ISGW2Hadronic:MaximumWeight 175 0.00013295
 insert ISGW2Hadronic:MaximumWeight 176 0.000203786
 insert ISGW2Hadronic:MaximumWeight 177 0.00553154
 insert ISGW2Hadronic:MaximumWeight 178 0.000473675
 insert ISGW2Hadronic:MaximumWeight 179 0.00518734
 insert ISGW2Hadronic:MaximumWeight 180 0.000469397
 insert ISGW2Hadronic:MaximumWeight 181 0.0132838
 insert ISGW2Hadronic:MaximumWeight 182 0.000163423
 insert ISGW2Hadronic:MaximumWeight 183 0.00344953
 insert ISGW2Hadronic:MaximumWeight 184 0.00125308
 insert ISGW2Hadronic:MaximumWeight 185 0.000571907
 insert ISGW2Hadronic:MaximumWeight 186 4.48583e-05
 insert ISGW2Hadronic:MaximumWeight 187 0.00259643
 insert ISGW2Hadronic:MaximumWeight 188 0.000347289
 insert ISGW2Hadronic:MaximumWeight 189 0.0072989
 insert ISGW2Hadronic:MaximumWeight 190 0.000187601
 insert ISGW2Hadronic:MaximumWeight 191 1.41401e-05
 insert ISGW2Hadronic:MaximumWeight 192 7.62346e-06
 insert ISGW2Hadronic:MaximumWeight 193 0.000171732
 insert ISGW2Hadronic:MaximumWeight 194 5.17111e-06
 insert ISGW2Hadronic:MaximumWeight 195 0.000657476
 insert ISGW2Hadronic:MaximumWeight 196 7.5333e-05
 insert ISGW2Hadronic:MaximumWeight 197 0.0018744
 insert ISGW2Hadronic:MaximumWeight 198 2.6806e-05
 insert ISGW2Hadronic:MaximumWeight 199 0.000539339
 insert ISGW2Hadronic:MaximumWeight 200 0.000115146
 insert ISGW2Hadronic:MaximumWeight 201 0.000540583
 insert ISGW2Hadronic:MaximumWeight 202 4.19891e-05
 insert ISGW2Hadronic:MaximumWeight 203 4.05903e-05
 insert ISGW2Hadronic:MaximumWeight 204 0.00100829
 insert ISGW2Hadronic:MaximumWeight 205 5.20864e-05
 insert ISGW2Hadronic:MaximumWeight 206 0.00163491
 insert ISGW2Hadronic:MaximumWeight 207 0.000134305
 insert ISGW2Hadronic:MaximumWeight 208 0.00401264
 insert ISGW2Hadronic:MaximumWeight 209 3.56565e-05
 insert ISGW2Hadronic:MaximumWeight 210 0.000696971
 insert ISGW2Hadronic:MaximumWeight 211 0.000166961
 insert ISGW2Hadronic:MaximumWeight 212 2.65629e-05
 insert ISGW2Hadronic:MaximumWeight 213 2.04808e-06
 insert ISGW2Hadronic:MaximumWeight 214 1.7854e-06
 insert ISGW2Hadronic:MaximumWeight 215 4.39361e-05
 insert ISGW2Hadronic:MaximumWeight 216 2.18549e-06
 insert ISGW2Hadronic:MaximumWeight 217 0.000269939
 insert ISGW2Hadronic:MaximumWeight 218 3.70581e-05
 insert ISGW2Hadronic:MaximumWeight 219 0.000707211
 insert ISGW2Hadronic:MaximumWeight 220 2.0537e-05
 insert ISGW2Hadronic:MaximumWeight 221 0.000446673
 insert ISGW2Hadronic:MaximumWeight 222 0.000136675
 insert ISGW2Hadronic:MaximumWeight 223 9.71719e-05
 insert ISGW2Hadronic:MaximumWeight 224 7.36441e-06
 insert ISGW2Hadronic:MaximumWeight 225 4.50907e-06
 insert ISGW2Hadronic:MaximumWeight 226 0.000106269
 insert ISGW2Hadronic:MaximumWeight 227 4.30179e-06
 insert ISGW2Hadronic:MaximumWeight 228 0.000302064
 insert ISGW2Hadronic:MaximumWeight 229 2.70627e-05
 insert ISGW2Hadronic:MaximumWeight 230 0.000773929
 insert ISGW2Hadronic:MaximumWeight 231 8.44511e-06
 insert ISGW2Hadronic:MaximumWeight 232 0.000177719
 insert ISGW2Hadronic:MaximumWeight 233 5.01412e-05
 insert ISGW2Hadronic:MaximumWeight 234 0.00142356
 insert ISGW2Hadronic:MaximumWeight 235 0.000119786
 insert ISGW2Hadronic:MaximumWeight 236 0.00262841
 insert ISGW2Hadronic:MaximumWeight 237 5.98525e-05
 insert ISGW2Hadronic:MaximumWeight 238 0.000174613
 insert ISGW2Hadronic:MaximumWeight 239 0.000936994
 insert ISGW2Hadronic:MaximumWeight 240 6.23369e-05
 insert ISGW2Hadronic:MaximumWeight 241 0.00597481
 insert ISGW2Hadronic:MaximumWeight 242 0.000273608
 insert ISGW2Hadronic:MaximumWeight 243 0.000874378
 insert ISGW2Hadronic:MaximumWeight 244 1.04737e-05
 insert ISGW2Hadronic:MaximumWeight 245 6.0613e-08
 insert ISGW2Hadronic:MaximumWeight 246 8.36364e-07
 insert ISGW2Hadronic:MaximumWeight 247 0.000632599
 insert ISGW2Hadronic:MaximumWeight 248 2.06321e-05
 insert ISGW2Hadronic:MaximumWeight 249 0.000261013
 insert ISGW2Hadronic:MaximumWeight 250 3.26013e-11
 insert ISGW2Hadronic:MaximumWeight 251 6.75528e-07
 insert ISGW2Hadronic:MaximumWeight 252 4.93106e-09
 insert ISGW2Hadronic:MaximumWeight 253 1.56061e-05
 insert ISGW2Hadronic:MaximumWeight 254 1.90638e-09
 insert ISGW2Hadronic:MaximumWeight 255 7.04045e-09
 insert ISGW2Hadronic:MaximumWeight 256 6.8887e-06
 insert ISGW2Hadronic:MaximumWeight 257 6.42437e-08
 insert ISGW2Hadronic:MaximumWeight 258 3.67611e-06
 insert ISGW2Hadronic:MaximumWeight 259 6.62957e-10
 insert ISGW2Hadronic:MaximumWeight 260 1.61303e-09
 insert ISGW2Hadronic:MaximumWeight 261 0.000127399
 insert ISGW2Hadronic:MaximumWeight 262 0.000383008
 insert ISGW2Hadronic:MaximumWeight 263 9.952e-06
 insert ISGW2Hadronic:MaximumWeight 264 0.00764798
 insert ISGW2Hadronic:MaximumWeight 265 2.14688e-05
 insert ISGW2Hadronic:MaximumWeight 266 0.00023493
 insert ISGW2Hadronic:MaximumWeight 267 0.000310714
 insert ISGW2Hadronic:MaximumWeight 268 5.94265e-08
 insert ISGW2Hadronic:MaximumWeight 269 0.00367853
 insert ISGW2Hadronic:MaximumWeight 270 1.0326e-05
 insert ISGW2Hadronic:MaximumWeight 271 1.60784e-05
 insert ISGW2Hadronic:MaximumWeight 272 8.39391e-05
 insert ISGW2Hadronic:MaximumWeight 273 0.000184857
 insert ISGW2Hadronic:MaximumWeight 274 3.0607e-08
 insert ISGW2Hadronic:MaximumWeight 275 0.00395947
 insert ISGW2Hadronic:MaximumWeight 276 1.11147e-05
 insert ISGW2Hadronic:MaximumWeight 277 0.00053498
 insert ISGW2Hadronic:MaximumWeight 278 0.00149738
 insert ISGW2Hadronic:MaximumWeight 279 0.0169251
 insert ISGW2Hadronic:MaximumWeight 280 4.75154e-05
 insert ISGW2Hadronic:MaximumWeight 281 7.96047e-05
 insert ISGW2Hadronic:MaximumWeight 282 9.50306e-07
 insert ISGW2Hadronic:MaximumWeight 283 1.19971e-08
 insert ISGW2Hadronic:MaximumWeight 284 3.6416e-06
 insert ISGW2Hadronic:MaximumWeight 285 1.02161e-08
 insert ISGW2Hadronic:MaximumWeight 286 7.74342e-08
 insert ISGW2Hadronic:MaximumWeight 287 5.68032e-05
 insert ISGW2Hadronic:MaximumWeight 288 3.94883e-05
 insert ISGW2Hadronic:MaximumWeight 289 0.00127751
 insert ISGW2Hadronic:MaximumWeight 290 3.59219e-06
 insert ISGW2Hadronic:MaximumWeight 291 2.37848e-05
 insert ISGW2Hadronic:MaximumWeight 292 1.3289e-09
 insert ISGW2Hadronic:MaximumWeight 293 3.72391e-12
 insert ISGW2Hadronic:MaximumWeight 294 6.12796e-08
 insert ISGW2Hadronic:MaximumWeight 295 4.33288e-09
 insert ISGW2Hadronic:MaximumWeight 296 2.91363e-07
 insert ISGW2Hadronic:MaximumWeight 297 8.17889e-10
 insert ISGW2Hadronic:MaximumWeight 298 1.39564e-06
 insert ISGW2Hadronic:MaximumWeight 299 3.17171e-08
 insert ISGW2Hadronic:MaximumWeight 300 1.0417e-07
 insert ISGW2Hadronic:MaximumWeight 301 2.90036e-10
 insert ISGW2Hadronic:MaximumWeight 302 6.36914e-10
 insert ISGW2Hadronic:MaximumWeight 303 6.21309e-07
 insert ISGW2Hadronic:MaximumWeight 304 6.88223e-08
 insert ISGW2Hadronic:MaximumWeight 305 3.84933e-06
 insert ISGW2Hadronic:MaximumWeight 306 1.08055e-08
 insert ISGW2Hadronic:MaximumWeight 307 3.24017e-07
 insert ISGW2Hadronic:MaximumWeight 308 7.52667e-09
 insert ISGW2Hadronic:MaximumWeight 309 3.56259e-08
 insert ISGW2Hadronic:MaximumWeight 310 9.968e-11
 insert ISGW2Hadronic:MaximumWeight 311 1.47015e-10
 insert ISGW2Hadronic:MaximumWeight 312 0.0466378
 insert ISGW2Hadronic:MaximumWeight 313 0.00371169
 insert ISGW2Hadronic:MaximumWeight 314 0.0643529
 insert ISGW2Hadronic:MaximumWeight 315 0.000710401
 insert ISGW2Hadronic:MaximumWeight 316 0.000913001
 insert ISGW2Hadronic:MaximumWeight 317 0.0262388
 insert ISGW2Hadronic:MaximumWeight 318 0.00151209
 insert ISGW2Hadronic:MaximumWeight 319 0.152946
 insert ISGW2Hadronic:MaximumWeight 320 0.00144631
 insert ISGW2Hadronic:MaximumWeight 321 0.00455556
 insert ISGW2Hadronic:MaximumWeight 322 0.000165832
 insert ISGW2Hadronic:MaximumWeight 323 9.1706e-07
 insert ISGW2Hadronic:MaximumWeight 324 0.00514793
 insert ISGW2Hadronic:MaximumWeight 325 9.83697e-05
 insert ISGW2Hadronic:MaximumWeight 326 3.78191e-05
 insert ISGW2Hadronic:MaximumWeight 327 1.77944e-07
 insert ISGW2Hadronic:MaximumWeight 328 7.84244e-05
 insert ISGW2Hadronic:MaximumWeight 329 2.62791e-10
 insert ISGW2Hadronic:MaximumWeight 330 7.11646e-07
 insert ISGW2Hadronic:MaximumWeight 331 2.98315e-07
 insert ISGW2Hadronic:MaximumWeight 332 1.51615e-07
 insert ISGW2Hadronic:MaximumWeight 333 1.42044e-07
 insert ISGW2Hadronic:MaximumWeight 334 7.4973e-08
 insert ISGW2Hadronic:MaximumWeight 335 0.000176449
 insert ISGW2Hadronic:MaximumWeight 336 9.69905e-07
 insert ISGW2Hadronic:MaximumWeight 337 2.61479e-06
 insert ISGW2Hadronic:MaximumWeight 338 2.61797e-06
 insert ISGW2Hadronic:MaximumWeight 339 7.77707e-08
 insert ISGW2Hadronic:MaximumWeight 340 0.000182947
 insert ISGW2Hadronic:MaximumWeight 341 3.19045e-05
 insert ISGW2Hadronic:MaximumWeight 342 1.56429e-05
 insert ISGW2Hadronic:MaximumWeight 343 7.47231e-08
 insert ISGW2Hadronic:MaximumWeight 344 3.79083e-08
 insert ISGW2Hadronic:MaximumWeight 345 3.49272e-08
 insert ISGW2Hadronic:MaximumWeight 346 1.83592e-08
 insert ISGW2Hadronic:MaximumWeight 347 4.32086e-05
 insert ISGW2Hadronic:MaximumWeight 348 1.04577e-06
 insert ISGW2Hadronic:MaximumWeight 349 1.45993e-06
 insert ISGW2Hadronic:MaximumWeight 350 2.67392e-06
 insert ISGW2Hadronic:MaximumWeight 351 2.41852e-07
 insert ISGW2Hadronic:MaximumWeight 352 0.000570294
 insert ISGW2Hadronic:MaximumWeight 353 0.000262824
 insert ISGW2Hadronic:MaximumWeight 354 0.000137684
 insert ISGW2Hadronic:MaximumWeight 355 1.27574e-07
 insert ISGW2Hadronic:MaximumWeight 356 6.35219e-08
 insert ISGW2Hadronic:MaximumWeight 357 5.67028e-08
 insert ISGW2Hadronic:MaximumWeight 358 2.38203e-08
 insert ISGW2Hadronic:MaximumWeight 359 5.60612e-05
 insert ISGW2Hadronic:MaximumWeight 360 4.2985e-07
 insert ISGW2Hadronic:MaximumWeight 361 1.09272e-06
 insert ISGW2Hadronic:MaximumWeight 362 1.20435e-06
 insert ISGW2Hadronic:MaximumWeight 363 3.89464e-08
 insert ISGW2Hadronic:MaximumWeight 364 9.26319e-05
 insert ISGW2Hadronic:MaximumWeight 365 1.39009e-05
 insert ISGW2Hadronic:MaximumWeight 366 2.60847e-06
 insert ISGW2Hadronic:MaximumWeight 367 7.94206e-07
 insert ISGW2Hadronic:MaximumWeight 368 4.03563e-07
 insert ISGW2Hadronic:MaximumWeight 369 3.67946e-07
 insert ISGW2Hadronic:MaximumWeight 370 1.96131e-07
 insert ISGW2Hadronic:MaximumWeight 371 0.000461444
 insert ISGW2Hadronic:MaximumWeight 372 2.58124e-06
 insert ISGW2Hadronic:MaximumWeight 373 5.60659e-06
 insert ISGW2Hadronic:MaximumWeight 374 7.21228e-06
 insert ISGW2Hadronic:MaximumWeight 375 2.30192e-07
 insert ISGW2Hadronic:MaximumWeight 376 0.000537935
 insert ISGW2Hadronic:MaximumWeight 377 0.000115659
 insert ISGW2Hadronic:MaximumWeight 378 4.67863e-05
 insert ISGW2Hadronic:MaximumWeight 379 4.40657e-09
 insert ISGW2Hadronic:MaximumWeight 380 2.23877e-09
 insert ISGW2Hadronic:MaximumWeight 381 2.052e-09
 insert ISGW2Hadronic:MaximumWeight 382 1.08135e-09
 insert ISGW2Hadronic:MaximumWeight 383 2.5306e-06
 insert ISGW2Hadronic:MaximumWeight 384 4.38347e-08
 insert ISGW2Hadronic:MaximumWeight 385 6.20581e-08
 insert ISGW2Hadronic:MaximumWeight 386 1.25913e-07
 insert ISGW2Hadronic:MaximumWeight 387 9.70463e-09
 insert ISGW2Hadronic:MaximumWeight 388 2.23565e-05
 insert ISGW2Hadronic:MaximumWeight 389 7.83469e-06
 insert ISGW2Hadronic:MaximumWeight 390 2.56193e-06
 insert ISGW2Hadronic:MaximumWeight 391 3.79088e-08
 insert ISGW2Hadronic:MaximumWeight 392 1.90871e-08
 insert ISGW2Hadronic:MaximumWeight 393 1.70256e-08
 insert ISGW2Hadronic:MaximumWeight 394 7.93393e-09
 insert ISGW2Hadronic:MaximumWeight 395 1.86662e-05
 insert ISGW2Hadronic:MaximumWeight 396 1.22309e-07
 insert ISGW2Hadronic:MaximumWeight 397 2.42224e-07
 insert ISGW2Hadronic:MaximumWeight 398 3.26693e-07
 insert ISGW2Hadronic:MaximumWeight 399 8.26115e-09
 insert ISGW2Hadronic:MaximumWeight 400 1.96192e-05
 insert ISGW2Hadronic:MaximumWeight 401 1.94236e-06
 insert ISGW2Hadronic:MaximumWeight 402 5.53694e-07
 insert ISGW2Hadronic:MaximumWeight 403 1.24652e-05
 insert ISGW2Hadronic:MaximumWeight 404 9.88093e-07
 insert ISGW2Hadronic:MaximumWeight 405 1.56643e-06
 insert ISGW2Hadronic:MaximumWeight 406 4.2953e-05
 insert ISGW2Hadronic:MaximumWeight 407 3.89902e-06
 insert ISGW2Hadronic:MaximumWeight 408 4.05235e-05
 insert ISGW2Hadronic:MaximumWeight 409 4.28859e-06
 insert ISGW2Hadronic:MaximumWeight 410 0.000109423
 insert ISGW2Hadronic:MaximumWeight 411 1.85096e-06
 insert ISGW2Hadronic:MaximumWeight 412 4.09032e-05
 insert ISGW2Hadronic:MaximumWeight 413 1.79063e-05
 insert ISGW2Hadronic:MaximumWeight 414 3.13352e-06
 insert ISGW2Hadronic:MaximumWeight 415 2.48057e-07
 insert ISGW2Hadronic:MaximumWeight 416 3.85001e-07
 insert ISGW2Hadronic:MaximumWeight 417 1.05264e-05
 insert ISGW2Hadronic:MaximumWeight 418 9.42521e-07
 insert ISGW2Hadronic:MaximumWeight 419 3.33896e-05
 insert ISGW2Hadronic:MaximumWeight 420 4.4126e-06
 insert ISGW2Hadronic:MaximumWeight 421 0.000118879
 insert ISGW2Hadronic:MaximumWeight 422 5.06334e-06
 insert ISGW2Hadronic:MaximumWeight 423 0.000156483
 insert ISGW2Hadronic:MaximumWeight 424 9.57021e-05
 insert ISGW2Hadronic:MaximumWeight 425 5.34507e-06
 insert ISGW2Hadronic:MaximumWeight 426 4.16908e-07
 insert ISGW2Hadronic:MaximumWeight 427 4.98662e-07
 insert ISGW2Hadronic:MaximumWeight 428 1.31356e-05
 insert ISGW2Hadronic:MaximumWeight 429 9.97058e-07
 insert ISGW2Hadronic:MaximumWeight 430 1.80148e-05
 insert ISGW2Hadronic:MaximumWeight 431 2.04787e-06
 insert ISGW2Hadronic:MaximumWeight 432 5.04508e-05
 insert ISGW2Hadronic:MaximumWeight 433 9.66314e-07
 insert ISGW2Hadronic:MaximumWeight 434 2.23357e-05
 insert ISGW2Hadronic:MaximumWeight 435 9.88777e-06
 insert ISGW2Hadronic:MaximumWeight 436 3.68215e-05
 insert ISGW2Hadronic:MaximumWeight 437 2.9154e-06
 insert ISGW2Hadronic:MaximumWeight 438 4.54675e-06
 insert ISGW2Hadronic:MaximumWeight 439 0.000123988
 insert ISGW2Hadronic:MaximumWeight 440 1.08929e-05
 insert ISGW2Hadronic:MaximumWeight 441 0.000121427
 insert ISGW2Hadronic:MaximumWeight 442 1.17881e-05
 insert ISGW2Hadronic:MaximumWeight 443 0.000335905
 insert ISGW2Hadronic:MaximumWeight 444 6.16012e-06
 insert ISGW2Hadronic:MaximumWeight 445 0.000144285
 insert ISGW2Hadronic:MaximumWeight 446 6.70849e-05
 insert ISGW2Hadronic:MaximumWeight 447 1.87256e-07
 insert ISGW2Hadronic:MaximumWeight 448 1.48554e-08
 insert ISGW2Hadronic:MaximumWeight 449 2.29949e-08
 insert ISGW2Hadronic:MaximumWeight 450 6.2513e-07
 insert ISGW2Hadronic:MaximumWeight 451 5.36475e-08
 insert ISGW2Hadronic:MaximumWeight 452 1.87424e-06
 insert ISGW2Hadronic:MaximumWeight 453 2.62658e-07
 insert ISGW2Hadronic:MaximumWeight 454 5.27927e-06
 insert ISGW2Hadronic:MaximumWeight 455 2.37739e-07
 insert ISGW2Hadronic:MaximumWeight 456 5.89279e-06
 insert ISGW2Hadronic:MaximumWeight 457 3.37022e-06
 insert ISGW2Hadronic:MaximumWeight 458 1.59414e-06
 insert ISGW2Hadronic:MaximumWeight 459 1.25716e-07
 insert ISGW2Hadronic:MaximumWeight 460 1.67024e-07
 insert ISGW2Hadronic:MaximumWeight 461 4.4245e-06
 insert ISGW2Hadronic:MaximumWeight 462 3.3657e-07
 insert ISGW2Hadronic:MaximumWeight 463 5.14209e-06
 insert ISGW2Hadronic:MaximumWeight 464 5.04695e-07
 insert ISGW2Hadronic:MaximumWeight 465 1.34615e-05
 insert ISGW2Hadronic:MaximumWeight 466 1.92809e-07
 insert ISGW2Hadronic:MaximumWeight 467 4.29269e-06
 insert ISGW2Hadronic:MaximumWeight 468 1.6164e-06
 insert ISGW2Hadronic:MaximumWeight 469 1.1289e-08
 insert ISGW2Hadronic:MaximumWeight 470 1.14298e-08
 insert ISGW2Hadronic:MaximumWeight 471 3.01771e-09
 insert ISGW2Hadronic:MaximumWeight 472 9.60431e-07
 insert ISGW2Hadronic:MaximumWeight 473 6.34514e-06
 insert ISGW2Hadronic:MaximumWeight 474 3.63652e-08
 insert ISGW2Hadronic:MaximumWeight 475 9.8312e-08
 insert ISGW2Hadronic:MaximumWeight 476 9.70304e-08
 insert ISGW2Hadronic:MaximumWeight 477 9.66144e-07
 insert ISGW2Hadronic:MaximumWeight 478 6.37736e-06
 insert ISGW2Hadronic:MaximumWeight 479 0.000341128
 insert ISGW2Hadronic:MaximumWeight 480 0.000143463
 insert ISGW2Hadronic:MaximumWeight 481 3.22245e-08
 insert ISGW2Hadronic:MaximumWeight 482 2.99111e-08
 insert ISGW2Hadronic:MaximumWeight 483 2.78333e-06
 insert ISGW2Hadronic:MaximumWeight 484 1.83889e-05
 insert ISGW2Hadronic:MaximumWeight 485 1.03678e-07
 insert ISGW2Hadronic:MaximumWeight 486 2.72419e-07
 insert ISGW2Hadronic:MaximumWeight 487 2.7525e-07
 insert ISGW2Hadronic:MaximumWeight 488 2.68329e-06
 insert ISGW2Hadronic:MaximumWeight 489 1.77561e-05
 insert ISGW2Hadronic:MaximumWeight 490 0.000925606
 insert ISGW2Hadronic:MaximumWeight 491 0.000327444
 insert ISGW2Hadronic:MaximumWeight 492 2.23837e-08
 insert ISGW2Hadronic:MaximumWeight 493 1.13659e-08
 insert ISGW2Hadronic:MaximumWeight 494 1.05161e-08
 insert ISGW2Hadronic:MaximumWeight 495 1.98302e-06
 insert ISGW2Hadronic:MaximumWeight 496 1.31233e-05
 insert ISGW2Hadronic:MaximumWeight 497 1.13422e-07
 insert ISGW2Hadronic:MaximumWeight 498 1.7014e-07
 insert ISGW2Hadronic:MaximumWeight 499 3.00817e-07
 insert ISGW2Hadronic:MaximumWeight 500 6.40694e-06
 insert ISGW2Hadronic:MaximumWeight 501 4.23346e-05
 insert ISGW2Hadronic:MaximumWeight 502 0.00559239
 insert ISGW2Hadronic:MaximumWeight 503 0.00339219
 insert ISGW2Hadronic:MaximumWeight 504 1.7965e-08
 insert ISGW2Hadronic:MaximumWeight 505 8.82261e-09
 insert ISGW2Hadronic:MaximumWeight 506 7.53071e-09
 insert ISGW2Hadronic:MaximumWeight 507 9.28842e-07
 insert ISGW2Hadronic:MaximumWeight 508 6.13788e-06
 insert ISGW2Hadronic:MaximumWeight 509 6.3671e-08
 insert ISGW2Hadronic:MaximumWeight 510 1.41866e-07
 insert ISGW2Hadronic:MaximumWeight 511 1.80971e-07
 insert ISGW2Hadronic:MaximumWeight 512 2.07167e-06
 insert ISGW2Hadronic:MaximumWeight 513 1.40653e-05
 insert ISGW2Hadronic:MaximumWeight 514 0.000396834
 insert ISGW2Hadronic:MaximumWeight 515 3.84278e-05
 insert ISGW2Hadronic:MaximumWeight 516 4.66654e-08
 insert ISGW2Hadronic:MaximumWeight 517 2.35011e-08
 insert ISGW2Hadronic:MaximumWeight 518 2.14985e-08
 insert ISGW2Hadronic:MaximumWeight 519 3.64576e-06
 insert ISGW2Hadronic:MaximumWeight 520 2.40858e-05
 insert ISGW2Hadronic:MaximumWeight 521 1.49325e-07
 insert ISGW2Hadronic:MaximumWeight 522 3.27935e-07
 insert ISGW2Hadronic:MaximumWeight 523 3.94642e-07
 insert ISGW2Hadronic:MaximumWeight 524 3.63856e-06
 insert ISGW2Hadronic:MaximumWeight 525 2.39955e-05
 insert ISGW2Hadronic:MaximumWeight 526 0.000993493
 insert ISGW2Hadronic:MaximumWeight 527 0.000260782
 insert ISGW2Hadronic:MaximumWeight 528 3.23725e-08
 insert ISGW2Hadronic:MaximumWeight 529 1.61709e-08
 insert ISGW2Hadronic:MaximumWeight 530 1.4092e-08
 insert ISGW2Hadronic:MaximumWeight 531 2.20652e-06
 insert ISGW2Hadronic:MaximumWeight 532 1.45631e-05
 insert ISGW2Hadronic:MaximumWeight 533 1.25348e-07
 insert ISGW2Hadronic:MaximumWeight 534 3.6152e-07
 insert ISGW2Hadronic:MaximumWeight 535 4.11957e-07
 insert ISGW2Hadronic:MaximumWeight 536 6.89897e-06
 insert ISGW2Hadronic:MaximumWeight 537 4.51049e-05
 insert ISGW2Hadronic:MaximumWeight 538 0.00267139
 insert ISGW2Hadronic:MaximumWeight 539 0.000299742
 insert ISGW2Hadronic:MaximumWeight 540 4.14129e-09
 insert ISGW2Hadronic:MaximumWeight 541 2.05873e-09
 insert ISGW2Hadronic:MaximumWeight 542 1.79762e-09
 insert ISGW2Hadronic:MaximumWeight 543 2.51708e-07
 insert ISGW2Hadronic:MaximumWeight 544 1.66303e-06
 insert ISGW2Hadronic:MaximumWeight 545 1.3055e-08
 insert ISGW2Hadronic:MaximumWeight 546 3.16173e-08
 insert ISGW2Hadronic:MaximumWeight 547 3.36881e-08
 insert ISGW2Hadronic:MaximumWeight 548 2.6636e-07
 insert ISGW2Hadronic:MaximumWeight 549 1.76434e-06
 insert ISGW2Hadronic:MaximumWeight 550 5.58364e-05
 insert ISGW2Hadronic:MaximumWeight 551 4.15388e-06
 insert ISGW2Hadronic:MaximumWeight 552 0.00659395
 insert ISGW2Hadronic:MaximumWeight 553 0.000518581
 insert ISGW2Hadronic:MaximumWeight 554 0.000716594
 insert ISGW2Hadronic:MaximumWeight 555 0.0192649
 insert ISGW2Hadronic:MaximumWeight 556 0.00159868
 insert ISGW2Hadronic:MaximumWeight 557 0.0204461
 insert ISGW2Hadronic:MaximumWeight 558 0.0018551
 insert ISGW2Hadronic:MaximumWeight 559 0.0519568
 insert ISGW2Hadronic:MaximumWeight 560 0.000610556
 insert ISGW2Hadronic:MaximumWeight 561 0.0126196
 insert ISGW2Hadronic:MaximumWeight 562 0.00409452
 insert ISGW2Hadronic:MaximumWeight 563 0.00366179
 insert ISGW2Hadronic:MaximumWeight 564 0.000283928
 insert ISGW2Hadronic:MaximumWeight 565 0.000298849
 insert ISGW2Hadronic:MaximumWeight 566 0.00769469
 insert ISGW2Hadronic:MaximumWeight 567 0.000518355
 insert ISGW2Hadronic:MaximumWeight 568 0.0144757
 insert ISGW2Hadronic:MaximumWeight 569 0.00191071
 insert ISGW2Hadronic:MaximumWeight 570 0.042628
 insert ISGW2Hadronic:MaximumWeight 571 0.00104861
 insert ISGW2Hadronic:MaximumWeight 572 0.0240693
 insert ISGW2Hadronic:MaximumWeight 573 0.0113216
 insert ISGW2Hadronic:MaximumWeight 574 0.00315272
 insert ISGW2Hadronic:MaximumWeight 575 0.000232481
 insert ISGW2Hadronic:MaximumWeight 576 8.13847e-05
 insert ISGW2Hadronic:MaximumWeight 577 0.00169532
 insert ISGW2Hadronic:MaximumWeight 578 3.21187e-05
 insert ISGW2Hadronic:MaximumWeight 579 0.00999491
 insert ISGW2Hadronic:MaximumWeight 580 0.000819757
 insert ISGW2Hadronic:MaximumWeight 581 0.0247219
 insert ISGW2Hadronic:MaximumWeight 582 0.000234179
 insert ISGW2Hadronic:MaximumWeight 583 0.00536681
 insert ISGW2Hadronic:MaximumWeight 584 0.000663442
 insert ISGW2Hadronic:MaximumWeight 585 0.00194728
 insert ISGW2Hadronic:MaximumWeight 586 0.00014909
 insert ISGW2Hadronic:MaximumWeight 587 0.00012131
 insert ISGW2Hadronic:MaximumWeight 588 0.00298558
 insert ISGW2Hadronic:MaximumWeight 589 0.000156861
 insert ISGW2Hadronic:MaximumWeight 590 0.00590166
 insert ISGW2Hadronic:MaximumWeight 591 0.000492318
 insert ISGW2Hadronic:MaximumWeight 592 0.0145167
 insert ISGW2Hadronic:MaximumWeight 593 0.000136744
 insert ISGW2Hadronic:MaximumWeight 594 0.00270837
 insert ISGW2Hadronic:MaximumWeight 595 0.000699216
 insert ISGW2Hadronic:MaximumWeight 596 0.000363501
 insert ISGW2Hadronic:MaximumWeight 597 2.792e-05
 insert ISGW2Hadronic:MaximumWeight 598 2.32784e-05
 insert ISGW2Hadronic:MaximumWeight 599 0.000571196
 insert ISGW2Hadronic:MaximumWeight 600 2.85318e-05
 insert ISGW2Hadronic:MaximumWeight 601 0.00116098
 insert ISGW2Hadronic:MaximumWeight 602 9.95665e-05
 insert ISGW2Hadronic:MaximumWeight 603 0.00313378
 insert ISGW2Hadronic:MaximumWeight 604 3.18435e-05
 insert ISGW2Hadronic:MaximumWeight 605 0.000679999
 insert ISGW2Hadronic:MaximumWeight 606 0.000144045
 insert ISGW2Hadronic:MaximumWeight 607 0.000336368
 insert ISGW2Hadronic:MaximumWeight 608 2.53521e-05
 insert ISGW2Hadronic:MaximumWeight 609 1.50959e-05
 insert ISGW2Hadronic:MaximumWeight 610 0.00035301
 insert ISGW2Hadronic:MaximumWeight 611 1.44037e-05
 insert ISGW2Hadronic:MaximumWeight 612 0.00103582
 insert ISGW2Hadronic:MaximumWeight 613 9.04823e-05
 insert ISGW2Hadronic:MaximumWeight 614 0.00259454
 insert ISGW2Hadronic:MaximumWeight 615 2.66835e-05
 insert ISGW2Hadronic:MaximumWeight 616 0.000534161
 insert ISGW2Hadronic:MaximumWeight 617 0.000142624
 insert ISGW2Hadronic:MaximumWeight 618 5.80692e-06
 insert ISGW2Hadronic:MaximumWeight 619 6.33066e-06
 insert ISGW2Hadronic:MaximumWeight 620 4.10621e-06
 insert ISGW2Hadronic:MaximumWeight 621 0.00581606
 insert ISGW2Hadronic:MaximumWeight 622 1.08001e-07
 insert ISGW2Hadronic:MaximumWeight 623 2.75103e-06
 insert ISGW2Hadronic:MaximumWeight 624 5.85739e-06
 insert ISGW2Hadronic:MaximumWeight 625 1.11634e-05
 insert ISGW2Hadronic:MaximumWeight 626 0.00599533
 insert ISGW2Hadronic:MaximumWeight 627 1.10815e-07
 insert ISGW2Hadronic:MaximumWeight 628 4.07377e-05
 insert ISGW2Hadronic:MaximumWeight 629 1.81787e-05
 insert ISGW2Hadronic:MaximumWeight 630 3.07508e-05
 insert ISGW2Hadronic:MaximumWeight 631 2.9076e-05
 insert ISGW2Hadronic:MaximumWeight 632 2.00233e-05
 insert ISGW2Hadronic:MaximumWeight 633 0.0262428
 insert ISGW2Hadronic:MaximumWeight 634 1.6988e-08
 insert ISGW2Hadronic:MaximumWeight 635 9.12298e-06
 insert ISGW2Hadronic:MaximumWeight 636 1.19944e-05
 insert ISGW2Hadronic:MaximumWeight 637 3.35241e-05
 insert ISGW2Hadronic:MaximumWeight 638 0.0183723
 insert ISGW2Hadronic:MaximumWeight 639 1.84091e-07
 insert ISGW2Hadronic:MaximumWeight 640 0.000183902
 insert ISGW2Hadronic:MaximumWeight 641 8.77049e-05
 insert ISGW2Hadronic:MaximumWeight 642 2.2163e-07
 insert ISGW2Hadronic:MaximumWeight 643 1.09685e-07
 insert ISGW2Hadronic:MaximumWeight 644 9.63409e-08
 insert ISGW2Hadronic:MaximumWeight 645 8.98976e-05
 insert ISGW2Hadronic:MaximumWeight 646 3.81974e-08
 insert ISGW2Hadronic:MaximumWeight 647 7.3619e-07
 insert ISGW2Hadronic:MaximumWeight 648 1.90682e-06
 insert ISGW2Hadronic:MaximumWeight 649 2.02617e-06
 insert ISGW2Hadronic:MaximumWeight 650 0.000143567
 insert ISGW2Hadronic:MaximumWeight 651 6.17233e-08
 insert ISGW2Hadronic:MaximumWeight 652 1.83458e-05
 insert ISGW2Hadronic:MaximumWeight 653 3.17889e-06
 insert ISGW2Hadronic:MaximumWeight 654 1.72097e-06
 insert ISGW2Hadronic:MaximumWeight 655 8.64999e-07
 insert ISGW2Hadronic:MaximumWeight 656 7.67698e-07
 insert ISGW2Hadronic:MaximumWeight 657 0.000837888
 insert ISGW2Hadronic:MaximumWeight 658 3.54618e-07
 insert ISGW2Hadronic:MaximumWeight 659 5.39178e-06
 insert ISGW2Hadronic:MaximumWeight 660 8.69755e-06
 insert ISGW2Hadronic:MaximumWeight 661 1.45457e-05
 insert ISGW2Hadronic:MaximumWeight 662 0.000871123
 insert ISGW2Hadronic:MaximumWeight 663 3.87613e-07
 insert ISGW2Hadronic:MaximumWeight 664 8.93038e-05
 insert ISGW2Hadronic:MaximumWeight 665 1.86633e-05
 insert ISGW2Hadronic:MaximumWeight 666 8.243e-05
 insert ISGW2Hadronic:MaximumWeight 667 7.81673e-05
 insert ISGW2Hadronic:MaximumWeight 668 5.37291e-05
 insert ISGW2Hadronic:MaximumWeight 669 0.0662964
 insert ISGW2Hadronic:MaximumWeight 670 7.94422e-08
 insert ISGW2Hadronic:MaximumWeight 671 4.9772e-05
 insert ISGW2Hadronic:MaximumWeight 672 8.82033e-05
 insert ISGW2Hadronic:MaximumWeight 673 4.06884e-05
 insert ISGW2Hadronic:MaximumWeight 674 0.0724293
 insert ISGW2Hadronic:MaximumWeight 675 1.02998e-07
 insert ISGW2Hadronic:MaximumWeight 676 5.00395e-05
 insert ISGW2Hadronic:MaximumWeight 677 2.21968e-05
 insert ISGW2Hadronic:MaximumWeight 678 3.38838e-08
 insert ISGW2Hadronic:MaximumWeight 679 1.70062e-08
 insert ISGW2Hadronic:MaximumWeight 680 1.51916e-08
 insert ISGW2Hadronic:MaximumWeight 681 1.62262e-05
 insert ISGW2Hadronic:MaximumWeight 682 6.89481e-09
 insert ISGW2Hadronic:MaximumWeight 683 1.09694e-07
 insert ISGW2Hadronic:MaximumWeight 684 2.92064e-07
 insert ISGW2Hadronic:MaximumWeight 685 2.93954e-07
 insert ISGW2Hadronic:MaximumWeight 686 1.7999e-05
 insert ISGW2Hadronic:MaximumWeight 687 7.79657e-09
 insert ISGW2Hadronic:MaximumWeight 688 1.93522e-06
 insert ISGW2Hadronic:MaximumWeight 689 3.56258e-07
 insert ISGW2Hadronic:MaximumWeight 690 4.53415e-07
 insert ISGW2Hadronic:MaximumWeight 691 1.09676e-06
 insert ISGW2Hadronic:MaximumWeight 692 2.997e-05
 insert ISGW2Hadronic:MaximumWeight 693 2.68075e-06
 insert ISGW2Hadronic:MaximumWeight 694 3.03405e-06
 insert ISGW2Hadronic:MaximumWeight 695 1.27937e-06
 insert ISGW2Hadronic:MaximumWeight 696 2.81376e-05
 insert ISGW2Hadronic:MaximumWeight 697 1.20657e-05
 insert ISGW2Hadronic:MaximumWeight 698 2.89217e-07
 insert ISGW2Hadronic:MaximumWeight 699 7.74957e-07
 insert ISGW2Hadronic:MaximumWeight 700 2.124e-05
 insert ISGW2Hadronic:MaximumWeight 701 1.91822e-06
 insert ISGW2Hadronic:MaximumWeight 702 2.04924e-06
 insert ISGW2Hadronic:MaximumWeight 703 8.76715e-07
 insert ISGW2Hadronic:MaximumWeight 704 1.9348e-05
 insert ISGW2Hadronic:MaximumWeight 705 8.34839e-06
 insert ISGW2Hadronic:MaximumWeight 706 6.46452e-07
 insert ISGW2Hadronic:MaximumWeight 707 2.58523e-07
 insert ISGW2Hadronic:MaximumWeight 708 7.10855e-06
 insert ISGW2Hadronic:MaximumWeight 709 6.51709e-07
 insert ISGW2Hadronic:MaximumWeight 710 8.87773e-07
 insert ISGW2Hadronic:MaximumWeight 711 2.65369e-06
 insert ISGW2Hadronic:MaximumWeight 712 7.75071e-05
 insert ISGW2Hadronic:MaximumWeight 713 4.55905e-05
 insert ISGW2Hadronic:MaximumWeight 714 4.72183e-06
 insert ISGW2Hadronic:MaximumWeight 715 3.66715e-07
 insert ISGW2Hadronic:MaximumWeight 716 4.11961e-07
 insert ISGW2Hadronic:MaximumWeight 717 1.0774e-05
 insert ISGW2Hadronic:MaximumWeight 718 7.95984e-07
 insert ISGW2Hadronic:MaximumWeight 719 1.55587e-05
 insert ISGW2Hadronic:MaximumWeight 720 1.66467e-06
 insert ISGW2Hadronic:MaximumWeight 721 4.24467e-05
 insert ISGW2Hadronic:MaximumWeight 722 7.16005e-07
 insert ISGW2Hadronic:MaximumWeight 723 1.5711e-05
 insert ISGW2Hadronic:MaximumWeight 724 6.56161e-06
 insert ISGW2Hadronic:MaximumWeight 725 1.50868e-05
 insert ISGW2Hadronic:MaximumWeight 726 1.18992e-06
 insert ISGW2Hadronic:MaximumWeight 727 1.72204e-06
 insert ISGW2Hadronic:MaximumWeight 728 4.65904e-05
 insert ISGW2Hadronic:MaximumWeight 729 3.97988e-06
 insert ISGW2Hadronic:MaximumWeight 730 4.86885e-05
 insert ISGW2Hadronic:MaximumWeight 731 4.98141e-06
 insert ISGW2Hadronic:MaximumWeight 732 0.000130129
 insert ISGW2Hadronic:MaximumWeight 733 2.05579e-06
 insert ISGW2Hadronic:MaximumWeight 734 4.50523e-05
 insert ISGW2Hadronic:MaximumWeight 735 1.88375e-05
 insert ISGW2Hadronic:MaximumWeight 736 1.33939e-05
 insert ISGW2Hadronic:MaximumWeight 737 1.0536e-06
 insert ISGW2Hadronic:MaximumWeight 738 1.489e-06
 insert ISGW2Hadronic:MaximumWeight 739 4.00244e-05
 insert ISGW2Hadronic:MaximumWeight 740 3.3065e-06
 insert ISGW2Hadronic:MaximumWeight 741 4.62627e-05
 insert ISGW2Hadronic:MaximumWeight 742 4.46223e-06
 insert ISGW2Hadronic:MaximumWeight 743 0.000130224
 insert ISGW2Hadronic:MaximumWeight 744 2.55736e-06
 insert ISGW2Hadronic:MaximumWeight 745 6.90093e-05
 insert ISGW2Hadronic:MaximumWeight 746 3.40729e-05
 insert ISGW2Hadronic:MaximumWeight 747 6.35765e-07
 insert ISGW2Hadronic:MaximumWeight 748 4.99304e-08
 insert ISGW2Hadronic:MaximumWeight 749 6.60386e-08
 insert ISGW2Hadronic:MaximumWeight 750 1.76031e-06
 insert ISGW2Hadronic:MaximumWeight 751 1.40018e-07
 insert ISGW2Hadronic:MaximumWeight 752 2.07123e-06
 insert ISGW2Hadronic:MaximumWeight 753 2.12116e-07
 insert ISGW2Hadronic:MaximumWeight 754 5.59086e-06
 insert ISGW2Hadronic:MaximumWeight 755 9.19443e-08
 insert ISGW2Hadronic:MaximumWeight 756 2.02824e-06
 insert ISGW2Hadronic:MaximumWeight 757 8.56435e-07
 insert ISGW2Hadronic:MaximumWeight 758 3.94965e-07
 insert ISGW2Hadronic:MaximumWeight 759 1.12886e-06
 insert ISGW2Hadronic:MaximumWeight 760 3.0742e-05
 insert ISGW2Hadronic:MaximumWeight 761 2.71202e-06
 insert ISGW2Hadronic:MaximumWeight 762 3.19507e-06
 insert ISGW2Hadronic:MaximumWeight 763 1.3232e-06
 insert ISGW2Hadronic:MaximumWeight 764 2.89906e-05
 insert ISGW2Hadronic:MaximumWeight 765 1.23163e-05
 insert ISGW2Hadronic:MaximumWeight 766 2.83149e-07
 insert ISGW2Hadronic:MaximumWeight 767 1.75651e-07
 insert ISGW2Hadronic:MaximumWeight 768 4.80704e-06
 insert ISGW2Hadronic:MaximumWeight 769 4.32187e-07
 insert ISGW2Hadronic:MaximumWeight 770 1.09095e-06
 insert ISGW2Hadronic:MaximumWeight 771 2.08318e-06
 insert ISGW2Hadronic:MaximumWeight 772 5.84392e-05
 insert ISGW2Hadronic:MaximumWeight 773 3.48536e-05
 insert ISGW2Hadronic:MaximumWeight 774 4.65664e-06
 insert ISGW2Hadronic:MaximumWeight 775 3.61419e-07
 insert ISGW2Hadronic:MaximumWeight 776 4.00419e-07
 insert ISGW2Hadronic:MaximumWeight 777 1.04474e-05
 insert ISGW2Hadronic:MaximumWeight 778 7.62726e-07
 insert ISGW2Hadronic:MaximumWeight 779 1.54669e-05
 insert ISGW2Hadronic:MaximumWeight 780 1.69547e-06
 insert ISGW2Hadronic:MaximumWeight 781 4.25764e-05
 insert ISGW2Hadronic:MaximumWeight 782 7.2399e-07
 insert ISGW2Hadronic:MaximumWeight 783 1.61446e-05
 insert ISGW2Hadronic:MaximumWeight 784 6.79588e-06
 insert ISGW2Hadronic:MaximumWeight 785 3.58295e-05
 insert ISGW2Hadronic:MaximumWeight 786 2.83533e-06
 insert ISGW2Hadronic:MaximumWeight 787 3.71764e-06
 insert ISGW2Hadronic:MaximumWeight 788 9.84708e-05
 insert ISGW2Hadronic:MaximumWeight 789 7.57617e-06
 insert ISGW2Hadronic:MaximumWeight 790 0.00011478
 insert ISGW2Hadronic:MaximumWeight 791 1.00423e-05
 insert ISGW2Hadronic:MaximumWeight 792 0.00030695
 insert ISGW2Hadronic:MaximumWeight 793 4.41257e-06
 insert ISGW2Hadronic:MaximumWeight 794 0.00010307
 insert ISGW2Hadronic:MaximumWeight 795 4.126e-05
 insert ISGW2Hadronic:MaximumWeight 796 1.05423e-06
 insert ISGW2Hadronic:MaximumWeight 797 8.3378e-07
 insert ISGW2Hadronic:MaximumWeight 798 2.25836e-05
 insert ISGW2Hadronic:MaximumWeight 799 1.93849e-06
 insert ISGW2Hadronic:MaximumWeight 800 5.23629e-06
 insert ISGW2Hadronic:MaximumWeight 801 1.20575e-06
 insert ISGW2Hadronic:MaximumWeight 802 2.80094e-05
 insert ISGW2Hadronic:MaximumWeight 803 1.29433e-05
 insert ISGW2Hadronic:MaximumWeight 804 7.11826e-07
 insert ISGW2Hadronic:MaximumWeight 805 5.58668e-08
 insert ISGW2Hadronic:MaximumWeight 806 7.232e-08
 insert ISGW2Hadronic:MaximumWeight 807 1.91906e-06
 insert ISGW2Hadronic:MaximumWeight 808 1.48987e-07
 insert ISGW2Hadronic:MaximumWeight 809 2.28249e-06
 insert ISGW2Hadronic:MaximumWeight 810 2.21357e-07
 insert ISGW2Hadronic:MaximumWeight 811 6.14984e-06
 insert ISGW2Hadronic:MaximumWeight 812 9.31588e-08
 insert ISGW2Hadronic:MaximumWeight 813 2.07709e-06
 insert ISGW2Hadronic:MaximumWeight 814 8.23876e-07
 insert ISGW2Hadronic:MaximumWeight 815 0.000410597
 insert ISGW2Hadronic:MaximumWeight 816 4.68271e-06
 insert ISGW2Hadronic:MaximumWeight 817 0.000473521
 insert ISGW2Hadronic:MaximumWeight 818 4.65366e-06
 insert ISGW2Hadronic:MaximumWeight 819 0.00151431
 insert ISGW2Hadronic:MaximumWeight 820 0.000585417
 insert ISGW2Hadronic:MaximumWeight 821 0.00234775
 insert ISGW2Hadronic:MaximumWeight 822 1.81831e-06
 insert ISGW2Hadronic:MaximumWeight 823 0.00185336
 insert ISGW2Hadronic:MaximumWeight 824 1.68158e-05
 insert ISGW2Hadronic:MaximumWeight 825 0.0131144
 insert ISGW2Hadronic:MaximumWeight 826 0.004699
 insert ISGW2Hadronic:MaximumWeight 827 1.82237e-08
 insert ISGW2Hadronic:MaximumWeight 828 8.93551e-09
 insert ISGW2Hadronic:MaximumWeight 829 7.69955e-09
 insert ISGW2Hadronic:MaximumWeight 830 6.50222e-06
 insert ISGW2Hadronic:MaximumWeight 831 9.84208e-07
 insert ISGW2Hadronic:MaximumWeight 832 6.04068e-08
 insert ISGW2Hadronic:MaximumWeight 833 1.58238e-07
 insert ISGW2Hadronic:MaximumWeight 834 1.6518e-07
 insert ISGW2Hadronic:MaximumWeight 835 1.10225e-05
 insert ISGW2Hadronic:MaximumWeight 836 1.69001e-06
 insert ISGW2Hadronic:MaximumWeight 837 0.00039456
 insert ISGW2Hadronic:MaximumWeight 838 3.69587e-05
 insert ISGW2Hadronic:MaximumWeight 839 9.76043e-08
 insert ISGW2Hadronic:MaximumWeight 840 4.87061e-08
 insert ISGW2Hadronic:MaximumWeight 841 4.26645e-08
 insert ISGW2Hadronic:MaximumWeight 842 4.49094e-05
 insert ISGW2Hadronic:MaximumWeight 843 6.79699e-06
 insert ISGW2Hadronic:MaximumWeight 844 3.09741e-07
 insert ISGW2Hadronic:MaximumWeight 845 6.477e-07
 insert ISGW2Hadronic:MaximumWeight 846 7.91503e-07
 insert ISGW2Hadronic:MaximumWeight 847 4.90401e-05
 insert ISGW2Hadronic:MaximumWeight 848 7.1365e-06
 insert ISGW2Hadronic:MaximumWeight 849 0.00203847
 insert ISGW2Hadronic:MaximumWeight 850 0.000450806
 insert ISGW2Hadronic:MaximumWeight 851 2.3999e-09
 insert ISGW2Hadronic:MaximumWeight 852 1.20405e-09
 insert ISGW2Hadronic:MaximumWeight 853 1.062e-09
 insert ISGW2Hadronic:MaximumWeight 854 1.13105e-06
 insert ISGW2Hadronic:MaximumWeight 855 1.7105e-07
 insert ISGW2Hadronic:MaximumWeight 856 9.16127e-09
 insert ISGW2Hadronic:MaximumWeight 857 1.97405e-08
 insert ISGW2Hadronic:MaximumWeight 858 2.79079e-08
 insert ISGW2Hadronic:MaximumWeight 859 2.57305e-06
 insert ISGW2Hadronic:MaximumWeight 860 4.00939e-07
 insert ISGW2Hadronic:MaximumWeight 861 0.000113287
 insert ISGW2Hadronic:MaximumWeight 862 2.35754e-05
 insert ISGW2Hadronic:MaximumWeight 863 4.62955e-09
 insert ISGW2Hadronic:MaximumWeight 864 2.28365e-09
 insert ISGW2Hadronic:MaximumWeight 865 1.97215e-09
 insert ISGW2Hadronic:MaximumWeight 866 1.72238e-06
 insert ISGW2Hadronic:MaximumWeight 867 2.60708e-07
 insert ISGW2Hadronic:MaximumWeight 868 1.44577e-08
 insert ISGW2Hadronic:MaximumWeight 869 3.14056e-08
 insert ISGW2Hadronic:MaximumWeight 870 3.66321e-08
 insert ISGW2Hadronic:MaximumWeight 871 1.87355e-06
 insert ISGW2Hadronic:MaximumWeight 872 2.86205e-07
 insert ISGW2Hadronic:MaximumWeight 873 6.43264e-05
 insert ISGW2Hadronic:MaximumWeight 874 1.36286e-05
 insert ISGW2Hadronic:MaximumWeight 875 0.000886924
 insert ISGW2Hadronic:MaximumWeight 876 0.0237334
 insert ISGW2Hadronic:MaximumWeight 877 0.00193323
 insert ISGW2Hadronic:MaximumWeight 878 0.000748156
 insert ISGW2Hadronic:MaximumWeight 879 0.0154115
 insert ISGW2Hadronic:MaximumWeight 880 0.00490868
 insert ISGW2Hadronic:MaximumWeight 881 0.000441573
 insert ISGW2Hadronic:MaximumWeight 882 0.0112928
 insert ISGW2Hadronic:MaximumWeight 883 0.000743722
 insert ISGW2Hadronic:MaximumWeight 884 0.00140372
 insert ISGW2Hadronic:MaximumWeight 885 0.0340804
 insert ISGW2Hadronic:MaximumWeight 886 0.0156712
 insert ISGW2Hadronic:MaximumWeight 887 0.00163325
 insert ISGW2Hadronic:MaximumWeight 888 0.000119482
 insert ISGW2Hadronic:MaximumWeight 889 3.5879e-05
 insert ISGW2Hadronic:MaximumWeight 890 0.000729475
 insert ISGW2Hadronic:MaximumWeight 891 1.5751e-05
 insert ISGW2Hadronic:MaximumWeight 892 0.00523738
 insert ISGW2Hadronic:MaximumWeight 893 0.000460999
 insert ISGW2Hadronic:MaximumWeight 894 0.0133939
 insert ISGW2Hadronic:MaximumWeight 895 0.000120436
 insert ISGW2Hadronic:MaximumWeight 896 0.00234788
 insert ISGW2Hadronic:MaximumWeight 897 0.000285831
 insert ISGW2Hadronic:MaximumWeight 898 0.0018135
 insert ISGW2Hadronic:MaximumWeight 899 0.000137667
 insert ISGW2Hadronic:MaximumWeight 900 9.31836e-05
 insert ISGW2Hadronic:MaximumWeight 901 0.0022597
 insert ISGW2Hadronic:MaximumWeight 902 0.000110254
 insert ISGW2Hadronic:MaximumWeight 903 0.00540313
 insert ISGW2Hadronic:MaximumWeight 904 0.00041917
 insert ISGW2Hadronic:MaximumWeight 905 0.0130272
 insert ISGW2Hadronic:MaximumWeight 906 0.000104678
 insert ISGW2Hadronic:MaximumWeight 907 0.00203924
 insert ISGW2Hadronic:MaximumWeight 908 0.000493072
 insert ISGW2Hadronic:MaximumWeight 909 0.000271784
 insert ISGW2Hadronic:MaximumWeight 910 2.08393e-05
 insert ISGW2Hadronic:MaximumWeight 911 1.7425e-05
 insert ISGW2Hadronic:MaximumWeight 912 0.000430976
 insert ISGW2Hadronic:MaximumWeight 913 2.2807e-05
 insert ISGW2Hadronic:MaximumWeight 914 0.000879561
 insert ISGW2Hadronic:MaximumWeight 915 8.41457e-05
 insert ISGW2Hadronic:MaximumWeight 916 0.0023151
 insert ISGW2Hadronic:MaximumWeight 917 2.53281e-05
 insert ISGW2Hadronic:MaximumWeight 918 0.000523796
 insert ISGW2Hadronic:MaximumWeight 919 0.00012047
 insert ISGW2Hadronic:MaximumWeight 920 0.000279861
 insert ISGW2Hadronic:MaximumWeight 921 2.06215e-05
 insert ISGW2Hadronic:MaximumWeight 922 1.04397e-05
 insert ISGW2Hadronic:MaximumWeight 923 0.000240148
 insert ISGW2Hadronic:MaximumWeight 924 8.82113e-06
 insert ISGW2Hadronic:MaximumWeight 925 0.000809399
 insert ISGW2Hadronic:MaximumWeight 926 6.6008e-05
 insert ISGW2Hadronic:MaximumWeight 927 0.00195354
 insert ISGW2Hadronic:MaximumWeight 928 1.78419e-05
 insert ISGW2Hadronic:MaximumWeight 929 0.000358847
 insert ISGW2Hadronic:MaximumWeight 930 8.5362e-05
 insert ISGW2Hadronic:MaximumWeight 931 5.88546e-07
 insert ISGW2Hadronic:MaximumWeight 932 1.98919e-07
 insert ISGW2Hadronic:MaximumWeight 933 3.21201e-07
 insert ISGW2Hadronic:MaximumWeight 934 4.79377e-08
 insert ISGW2Hadronic:MaximumWeight 935 0.000112821
 insert ISGW2Hadronic:MaximumWeight 936 6.48632e-07
 insert ISGW2Hadronic:MaximumWeight 937 1.74159e-06
 insert ISGW2Hadronic:MaximumWeight 938 1.78368e-06
 insert ISGW2Hadronic:MaximumWeight 939 4.90761e-08
 insert ISGW2Hadronic:MaximumWeight 940 0.000115554
 insert ISGW2Hadronic:MaximumWeight 941 1.85262e-05
 insert ISGW2Hadronic:MaximumWeight 942 8.18308e-06
 insert ISGW2Hadronic:MaximumWeight 943 4.62801e-07
 insert ISGW2Hadronic:MaximumWeight 944 1.26414e-07
 insert ISGW2Hadronic:MaximumWeight 945 3.38792e-08
 insert ISGW2Hadronic:MaximumWeight 946 7.97359e-05
 insert ISGW2Hadronic:MaximumWeight 947 4.49779e-07
 insert ISGW2Hadronic:MaximumWeight 948 1.17316e-06
 insert ISGW2Hadronic:MaximumWeight 949 1.24509e-06
 insert ISGW2Hadronic:MaximumWeight 950 3.31625e-08
 insert ISGW2Hadronic:MaximumWeight 951 7.81697e-05
 insert ISGW2Hadronic:MaximumWeight 952 1.24059e-05
 insert ISGW2Hadronic:MaximumWeight 953 4.55153e-06
 insert ISGW2Hadronic:MaximumWeight 954 1.85609e-06
 insert ISGW2Hadronic:MaximumWeight 955 1.11755e-08
 insert ISGW2Hadronic:MaximumWeight 956 2.64951e-05
 insert ISGW2Hadronic:MaximumWeight 957 1.58397e-06
 insert ISGW2Hadronic:MaximumWeight 958 9.00351e-07
 insert ISGW2Hadronic:MaximumWeight 959 8.15345e-07
 insert ISGW2Hadronic:MaximumWeight 960 1.12759e-07
 insert ISGW2Hadronic:MaximumWeight 961 0.000286059
 insert ISGW2Hadronic:MaximumWeight 962 0.000115894
 insert ISGW2Hadronic:MaximumWeight 963 7.43252e-05
 insert ISGW2Hadronic:MaximumWeight 964 1.03212e-07
 insert ISGW2Hadronic:MaximumWeight 965 5.11217e-08
 insert ISGW2Hadronic:MaximumWeight 966 4.51115e-08
 insert ISGW2Hadronic:MaximumWeight 967 1.80487e-08
 insert ISGW2Hadronic:MaximumWeight 968 4.24776e-05
 insert ISGW2Hadronic:MaximumWeight 969 3.40117e-07
 insert ISGW2Hadronic:MaximumWeight 970 8.60935e-07
 insert ISGW2Hadronic:MaximumWeight 971 9.27976e-07
 insert ISGW2Hadronic:MaximumWeight 972 2.73631e-08
 insert ISGW2Hadronic:MaximumWeight 973 6.47482e-05
 insert ISGW2Hadronic:MaximumWeight 974 8.27668e-06
 insert ISGW2Hadronic:MaximumWeight 975 1.74418e-06
 insert ISGW2Hadronic:MaximumWeight 976 3.29701e-07
 insert ISGW2Hadronic:MaximumWeight 977 1.66486e-07
 insert ISGW2Hadronic:MaximumWeight 978 1.5326e-07
 insert ISGW2Hadronic:MaximumWeight 979 7.53116e-08
 insert ISGW2Hadronic:MaximumWeight 980 0.000177246
 insert ISGW2Hadronic:MaximumWeight 981 1.0641e-06
 insert ISGW2Hadronic:MaximumWeight 982 2.70055e-06
 insert ISGW2Hadronic:MaximumWeight 983 2.84333e-06
 insert ISGW2Hadronic:MaximumWeight 984 7.90167e-08
 insert ISGW2Hadronic:MaximumWeight 985 0.000185875
 insert ISGW2Hadronic:MaximumWeight 986 2.63344e-05
 insert ISGW2Hadronic:MaximumWeight 987 9.6272e-06
 insert ISGW2Hadronic:MaximumWeight 988 2.92555e-07
 insert ISGW2Hadronic:MaximumWeight 989 1.4757e-07
 insert ISGW2Hadronic:MaximumWeight 990 1.30582e-07
 insert ISGW2Hadronic:MaximumWeight 991 6.50594e-08
 insert ISGW2Hadronic:MaximumWeight 992 0.000153366
 insert ISGW2Hadronic:MaximumWeight 993 1.00193e-06
 insert ISGW2Hadronic:MaximumWeight 994 2.65413e-06
 insert ISGW2Hadronic:MaximumWeight 995 2.83758e-06
 insert ISGW2Hadronic:MaximumWeight 996 1.10096e-07
 insert ISGW2Hadronic:MaximumWeight 997 0.000255503
 insert ISGW2Hadronic:MaximumWeight 998 6.20238e-05
 insert ISGW2Hadronic:MaximumWeight 999 1.67783e-05
 insert ISGW2Hadronic:MaximumWeight 1000 1.38928e-08
 insert ISGW2Hadronic:MaximumWeight 1001 6.97833e-09
 insert ISGW2Hadronic:MaximumWeight 1002 6.32289e-09
 insert ISGW2Hadronic:MaximumWeight 1003 2.88991e-09
 insert ISGW2Hadronic:MaximumWeight 1004 6.8014e-06
 insert ISGW2Hadronic:MaximumWeight 1005 4.52566e-08
 insert ISGW2Hadronic:MaximumWeight 1006 1.18607e-07
 insert ISGW2Hadronic:MaximumWeight 1007 1.22184e-07
 insert ISGW2Hadronic:MaximumWeight 1008 3.5209e-09
 insert ISGW2Hadronic:MaximumWeight 1009 8.21433e-06
 insert ISGW2Hadronic:MaximumWeight 1010 1.12209e-06
 insert ISGW2Hadronic:MaximumWeight 1011 1.89938e-07
 insert ISGW2Hadronic:MaximumWeight 1012 4.15691e-07
 insert ISGW2Hadronic:MaximumWeight 1013 4.93489e-08
 insert ISGW2Hadronic:MaximumWeight 1014 0.000116143
 insert ISGW2Hadronic:MaximumWeight 1015 6.97961e-07
 insert ISGW2Hadronic:MaximumWeight 1016 1.95149e-06
 insert ISGW2Hadronic:MaximumWeight 1017 5.07119e-08
 insert ISGW2Hadronic:MaximumWeight 1018 0.0001194
 insert ISGW2Hadronic:MaximumWeight 1019 1.86096e-05
 insert ISGW2Hadronic:MaximumWeight 1020 8.30376e-06
 insert ISGW2Hadronic:MaximumWeight 1021 7.67537e-09
 insert ISGW2Hadronic:MaximumWeight 1022 1.8064e-05
 insert ISGW2Hadronic:MaximumWeight 1023 6.18392e-07
 insert ISGW2Hadronic:MaximumWeight 1024 8.24791e-07
 insert ISGW2Hadronic:MaximumWeight 1025 8.57592e-08
 insert ISGW2Hadronic:MaximumWeight 1026 0.00020558
 insert ISGW2Hadronic:MaximumWeight 1027 8.45082e-05
 insert ISGW2Hadronic:MaximumWeight 1028 4.01476e-05
 insert ISGW2Hadronic:MaximumWeight 1029 1.01788e-07
 insert ISGW2Hadronic:MaximumWeight 1030 5.03709e-08
 insert ISGW2Hadronic:MaximumWeight 1031 4.43804e-08
 insert ISGW2Hadronic:MaximumWeight 1032 1.75451e-08
 insert ISGW2Hadronic:MaximumWeight 1033 4.12924e-05
 insert ISGW2Hadronic:MaximumWeight 1034 3.3819e-07
 insert ISGW2Hadronic:MaximumWeight 1035 8.89005e-07
 insert ISGW2Hadronic:MaximumWeight 1036 9.29738e-07
 insert ISGW2Hadronic:MaximumWeight 1037 2.79631e-08
 insert ISGW2Hadronic:MaximumWeight 1038 6.53981e-05
 insert ISGW2Hadronic:MaximumWeight 1039 8.43248e-06
 insert ISGW2Hadronic:MaximumWeight 1040 1.4686e-06
 insert ISGW2Hadronic:MaximumWeight 1041 7.8932e-07
 insert ISGW2Hadronic:MaximumWeight 1042 3.93797e-07
 insert ISGW2Hadronic:MaximumWeight 1043 3.51924e-07
 insert ISGW2Hadronic:MaximumWeight 1044 1.62307e-07
 insert ISGW2Hadronic:MaximumWeight 1045 0.000383049
 insert ISGW2Hadronic:MaximumWeight 1046 2.4891e-06
 insert ISGW2Hadronic:MaximumWeight 1047 3.87503e-06
 insert ISGW2Hadronic:MaximumWeight 1048 6.63447e-06
 insert ISGW2Hadronic:MaximumWeight 1049 1.69127e-07
 insert ISGW2Hadronic:MaximumWeight 1050 0.00040778
 insert ISGW2Hadronic:MaximumWeight 1051 4.09542e-05
 insert ISGW2Hadronic:MaximumWeight 1052 8.57939e-06
 insert ISGW2Hadronic:MaximumWeight 1053 3.6461e-08
 insert ISGW2Hadronic:MaximumWeight 1054 8.58109e-05
 insert ISGW2Hadronic:MaximumWeight 1055 2.90724e-06
 insert ISGW2Hadronic:MaximumWeight 1056 4.66503e-08
 insert ISGW2Hadronic:MaximumWeight 1057 0.000109417
 insert ISGW2Hadronic:MaximumWeight 1058 2.29561e-05
 insert ISGW2Hadronic:MaximumWeight 1059 1.01623e-05
 insert ISGW2Hadronic:MaximumWeight 1060 1.55555e-08
 insert ISGW2Hadronic:MaximumWeight 1061 7.80564e-09
 insert ISGW2Hadronic:MaximumWeight 1062 6.93448e-09
 insert ISGW2Hadronic:MaximumWeight 1063 3.16542e-09
 insert ISGW2Hadronic:MaximumWeight 1064 7.44689e-06
 insert ISGW2Hadronic:MaximumWeight 1065 5.0049e-08
 insert ISGW2Hadronic:MaximumWeight 1066 1.18038e-07
 insert ISGW2Hadronic:MaximumWeight 1067 1.34839e-07
 insert ISGW2Hadronic:MaximumWeight 1068 3.51569e-09
 insert ISGW2Hadronic:MaximumWeight 1069 8.59698e-06
 insert ISGW2Hadronic:MaximumWeight 1070 8.88646e-07
 insert ISGW2Hadronic:MaximumWeight 1071 1.63487e-07
 insert ISGW2Hadronic:MaximumWeight 1072 1.75402e-05
 insert ISGW2Hadronic:MaximumWeight 1073 1.38569e-06
 insert ISGW2Hadronic:MaximumWeight 1074 2.08235e-06
 insert ISGW2Hadronic:MaximumWeight 1075 5.67102e-05
 insert ISGW2Hadronic:MaximumWeight 1076 5.00369e-06
 insert ISGW2Hadronic:MaximumWeight 1077 5.65976e-05
 insert ISGW2Hadronic:MaximumWeight 1078 5.84247e-06
 insert ISGW2Hadronic:MaximumWeight 1079 0.000151382
 insert ISGW2Hadronic:MaximumWeight 1080 2.43847e-06
 insert ISGW2Hadronic:MaximumWeight 1081 5.34807e-05
 insert ISGW2Hadronic:MaximumWeight 1082 2.27224e-05
 insert ISGW2Hadronic:MaximumWeight 1083 2.6408e-06
 insert ISGW2Hadronic:MaximumWeight 1084 2.09212e-07
 insert ISGW2Hadronic:MaximumWeight 1085 3.27552e-07
 insert ISGW2Hadronic:MaximumWeight 1086 8.96307e-06
 insert ISGW2Hadronic:MaximumWeight 1087 8.05212e-07
 insert ISGW2Hadronic:MaximumWeight 1088 2.36028e-05
 insert ISGW2Hadronic:MaximumWeight 1089 3.16899e-06
 insert ISGW2Hadronic:MaximumWeight 1090 7.53695e-05
 insert ISGW2Hadronic:MaximumWeight 1091 3.66392e-06
 insert ISGW2Hadronic:MaximumWeight 1092 0.000106789
 insert ISGW2Hadronic:MaximumWeight 1093 6.38752e-05
 insert ISGW2Hadronic:MaximumWeight 1094 8.54953e-06
 insert ISGW2Hadronic:MaximumWeight 1095 6.63564e-07
 insert ISGW2Hadronic:MaximumWeight 1096 7.35264e-07
 insert ISGW2Hadronic:MaximumWeight 1097 1.91843e-05
 insert ISGW2Hadronic:MaximumWeight 1098 1.40067e-06
 insert ISGW2Hadronic:MaximumWeight 1099 2.83886e-05
 insert ISGW2Hadronic:MaximumWeight 1100 2.96672e-06
 insert ISGW2Hadronic:MaximumWeight 1101 7.81843e-05
 insert ISGW2Hadronic:MaximumWeight 1102 1.33592e-06
 insert ISGW2Hadronic:MaximumWeight 1103 2.9807e-05
 insert ISGW2Hadronic:MaximumWeight 1104 1.24781e-05
 insert ISGW2Hadronic:MaximumWeight 1105 6.62475e-05
 insert ISGW2Hadronic:MaximumWeight 1106 5.2246e-06
 insert ISGW2Hadronic:MaximumWeight 1107 6.8377e-06
 insert ISGW2Hadronic:MaximumWeight 1108 0.000181921
 insert ISGW2Hadronic:MaximumWeight 1109 1.39473e-05
 insert ISGW2Hadronic:MaximumWeight 1110 0.000206881
 insert ISGW2Hadronic:MaximumWeight 1111 2.00766e-05
 insert ISGW2Hadronic:MaximumWeight 1112 0.000565527
 insert ISGW2Hadronic:MaximumWeight 1113 7.68625e-06
 insert ISGW2Hadronic:MaximumWeight 1114 0.000190377
 insert ISGW2Hadronic:MaximumWeight 1115 7.59684e-05
 insert ISGW2Hadronic:MaximumWeight 1116 1.32971e-05
 insert ISGW2Hadronic:MaximumWeight 1117 1.04931e-06
 insert ISGW2Hadronic:MaximumWeight 1118 1.53145e-06
 insert ISGW2Hadronic:MaximumWeight 1119 4.14809e-05
 insert ISGW2Hadronic:MaximumWeight 1120 3.56083e-06
 insert ISGW2Hadronic:MaximumWeight 1121 4.41636e-05
 insert ISGW2Hadronic:MaximumWeight 1122 4.74284e-06
 insert ISGW2Hadronic:MaximumWeight 1123 0.000122218
 insert ISGW2Hadronic:MaximumWeight 1124 2.29019e-06
 insert ISGW2Hadronic:MaximumWeight 1125 5.15865e-05
 insert ISGW2Hadronic:MaximumWeight 1126 2.37727e-05
 insert ISGW2Hadronic:MaximumWeight 1127 1.30705e-06
 insert ISGW2Hadronic:MaximumWeight 1128 1.02593e-07
 insert ISGW2Hadronic:MaximumWeight 1129 1.32736e-07
 insert ISGW2Hadronic:MaximumWeight 1130 3.52286e-06
 insert ISGW2Hadronic:MaximumWeight 1131 2.73545e-07
 insert ISGW2Hadronic:MaximumWeight 1132 4.20558e-06
 insert ISGW2Hadronic:MaximumWeight 1133 3.88076e-07
 insert ISGW2Hadronic:MaximumWeight 1134 1.12769e-05
 insert ISGW2Hadronic:MaximumWeight 1135 1.7259e-07
 insert ISGW2Hadronic:MaximumWeight 1136 3.84341e-06
 insert ISGW2Hadronic:MaximumWeight 1137 1.51283e-06
 insert ISGW2Hadronic:MaximumWeight 1138 5.23051e-08
 insert ISGW2Hadronic:MaximumWeight 1139 2.64177e-08
 insert ISGW2Hadronic:MaximumWeight 1140 2.44044e-08
 insert ISGW2Hadronic:MaximumWeight 1141 4.31009e-06
 insert ISGW2Hadronic:MaximumWeight 1142 2.84748e-05
 insert ISGW2Hadronic:MaximumWeight 1143 1.67655e-07
 insert ISGW2Hadronic:MaximumWeight 1144 4.49751e-07
 insert ISGW2Hadronic:MaximumWeight 1145 4.44501e-07
 insert ISGW2Hadronic:MaximumWeight 1146 4.28237e-06
 insert ISGW2Hadronic:MaximumWeight 1147 2.82922e-05
 insert ISGW2Hadronic:MaximumWeight 1148 0.00139213
 insert ISGW2Hadronic:MaximumWeight 1149 0.00053746
 insert ISGW2Hadronic:MaximumWeight 1150 2.13348e-08
 insert ISGW2Hadronic:MaximumWeight 1151 1.07379e-08
 insert ISGW2Hadronic:MaximumWeight 1152 9.65521e-09
 insert ISGW2Hadronic:MaximumWeight 1153 1.66542e-06
 insert ISGW2Hadronic:MaximumWeight 1154 1.10027e-05
 insert ISGW2Hadronic:MaximumWeight 1155 2.26739e-07
 insert ISGW2Hadronic:MaximumWeight 1156 3.20913e-07
 insert ISGW2Hadronic:MaximumWeight 1157 5.85865e-07
 insert ISGW2Hadronic:MaximumWeight 1158 1.49546e-05
 insert ISGW2Hadronic:MaximumWeight 1159 9.91298e-05
 insert ISGW2Hadronic:MaximumWeight 1160 0.0117267
 insert ISGW2Hadronic:MaximumWeight 1161 0.00424909
 insert ISGW2Hadronic:MaximumWeight 1162 1.6742e-08
 insert ISGW2Hadronic:MaximumWeight 1163 8.20864e-09
 insert ISGW2Hadronic:MaximumWeight 1164 7.06158e-09
 insert ISGW2Hadronic:MaximumWeight 1165 9.03113e-07
 insert ISGW2Hadronic:MaximumWeight 1166 5.96646e-06
 insert ISGW2Hadronic:MaximumWeight 1167 5.54773e-08
 insert ISGW2Hadronic:MaximumWeight 1168 1.46362e-07
 insert ISGW2Hadronic:MaximumWeight 1169 1.51826e-07
 insert ISGW2Hadronic:MaximumWeight 1170 1.55353e-06
 insert ISGW2Hadronic:MaximumWeight 1171 1.02815e-05
 insert ISGW2Hadronic:MaximumWeight 1172 0.000361568
 insert ISGW2Hadronic:MaximumWeight 1173 3.27753e-05
 insert ISGW2Hadronic:MaximumWeight 1174 8.11822e-08
 insert ISGW2Hadronic:MaximumWeight 1175 4.0519e-08
 insert ISGW2Hadronic:MaximumWeight 1176 3.55014e-08
 insert ISGW2Hadronic:MaximumWeight 1177 5.64896e-06
 insert ISGW2Hadronic:MaximumWeight 1178 3.71845e-05
 insert ISGW2Hadronic:MaximumWeight 1179 2.58027e-07
 insert ISGW2Hadronic:MaximumWeight 1180 6.34181e-07
 insert ISGW2Hadronic:MaximumWeight 1181 6.76223e-07
 insert ISGW2Hadronic:MaximumWeight 1182 6.15128e-06
 insert ISGW2Hadronic:MaximumWeight 1183 3.99378e-05
 insert ISGW2Hadronic:MaximumWeight 1184 0.00169509
 insert ISGW2Hadronic:MaximumWeight 1185 0.000413171
 insert ISGW2Hadronic:MaximumWeight 1186 2.19673e-09
 insert ISGW2Hadronic:MaximumWeight 1187 1.10107e-09
 insert ISGW2Hadronic:MaximumWeight 1188 9.76783e-10
 insert ISGW2Hadronic:MaximumWeight 1189 1.56394e-07
 insert ISGW2Hadronic:MaximumWeight 1190 1.03151e-06
 insert ISGW2Hadronic:MaximumWeight 1191 8.25863e-09
 insert ISGW2Hadronic:MaximumWeight 1192 2.18363e-08
 insert ISGW2Hadronic:MaximumWeight 1193 2.57299e-08
 insert ISGW2Hadronic:MaximumWeight 1194 3.7531e-07
 insert ISGW2Hadronic:MaximumWeight 1195 2.4446e-06
 insert ISGW2Hadronic:MaximumWeight 1196 0.000104122
 insert ISGW2Hadronic:MaximumWeight 1197 2.16795e-05
 insert ISGW2Hadronic:MaximumWeight 1198 4.23814e-09
 insert ISGW2Hadronic:MaximumWeight 1199 2.09014e-09
 insert ISGW2Hadronic:MaximumWeight 1200 1.78532e-09
 insert ISGW2Hadronic:MaximumWeight 1201 2.38452e-07
 insert ISGW2Hadronic:MaximumWeight 1202 1.57534e-06
 insert ISGW2Hadronic:MaximumWeight 1203 1.31088e-08
 insert ISGW2Hadronic:MaximumWeight 1204 3.17479e-08
 insert ISGW2Hadronic:MaximumWeight 1205 3.36211e-08
 insert ISGW2Hadronic:MaximumWeight 1206 2.63185e-07
 insert ISGW2Hadronic:MaximumWeight 1207 1.73966e-06
 insert ISGW2Hadronic:MaximumWeight 1208 5.89082e-05
 insert ISGW2Hadronic:MaximumWeight 1209 1.25308e-05
 insert ISGW2Hadronic:MaximumWeight 1210 0.0078022
 insert ISGW2Hadronic:MaximumWeight 1211 0.000612036
 insert ISGW2Hadronic:MaximumWeight 1212 0.000813526
 insert ISGW2Hadronic:MaximumWeight 1213 0.0217676
 insert ISGW2Hadronic:MaximumWeight 1214 0.00177234
 insert ISGW2Hadronic:MaximumWeight 1215 0.0240458
 insert ISGW2Hadronic:MaximumWeight 1216 0.00214559
 insert ISGW2Hadronic:MaximumWeight 1217 0.0606444
 insert ISGW2Hadronic:MaximumWeight 1218 0.000686235
 insert ISGW2Hadronic:MaximumWeight 1219 0.0141092
 insert ISGW2Hadronic:MaximumWeight 1220 0.00448638
 insert ISGW2Hadronic:MaximumWeight 1221 0.00600515
 insert ISGW2Hadronic:MaximumWeight 1222 0.000465308
 insert ISGW2Hadronic:MaximumWeight 1223 0.000463279
 insert ISGW2Hadronic:MaximumWeight 1224 0.0118611
 insert ISGW2Hadronic:MaximumWeight 1225 0.000776691
 insert ISGW2Hadronic:MaximumWeight 1226 0.0219934
 insert ISGW2Hadronic:MaximumWeight 1227 0.00276411
 insert ISGW2Hadronic:MaximumWeight 1228 0.067914
 insert ISGW2Hadronic:MaximumWeight 1229 0.00147159
 insert ISGW2Hadronic:MaximumWeight 1230 0.0358058
 insert ISGW2Hadronic:MaximumWeight 1231 0.0163908
 insert ISGW2Hadronic:MaximumWeight 1232 0.00217433
 insert ISGW2Hadronic:MaximumWeight 1233 0.000158004
 insert ISGW2Hadronic:MaximumWeight 1234 4.09367e-05
 insert ISGW2Hadronic:MaximumWeight 1235 0.000799852
 insert ISGW2Hadronic:MaximumWeight 1236 1.45599e-05
 insert ISGW2Hadronic:MaximumWeight 1237 0.00710383
 insert ISGW2Hadronic:MaximumWeight 1238 0.000478098
 insert ISGW2Hadronic:MaximumWeight 1239 0.0174314
 insert ISGW2Hadronic:MaximumWeight 1240 0.000149032
 insert ISGW2Hadronic:MaximumWeight 1241 0.0027465
 insert ISGW2Hadronic:MaximumWeight 1242 0.000290487
 insert ISGW2Hadronic:MaximumWeight 1243 0.0016875
 insert ISGW2Hadronic:MaximumWeight 1244 0.000127946
 insert ISGW2Hadronic:MaximumWeight 1245 8.58441e-05
 insert ISGW2Hadronic:MaximumWeight 1246 0.0020821
 insert ISGW2Hadronic:MaximumWeight 1247 0.000101742
 insert ISGW2Hadronic:MaximumWeight 1248 0.00502281
 insert ISGW2Hadronic:MaximumWeight 1249 0.000381386
 insert ISGW2Hadronic:MaximumWeight 1250 0.0120721
 insert ISGW2Hadronic:MaximumWeight 1251 9.60597e-05
 insert ISGW2Hadronic:MaximumWeight 1252 0.00187873
 insert ISGW2Hadronic:MaximumWeight 1253 0.000454805
 insert ISGW2Hadronic:MaximumWeight 1254 0.000249562
 insert ISGW2Hadronic:MaximumWeight 1255 1.91356e-05
 insert ISGW2Hadronic:MaximumWeight 1256 1.60058e-05
 insert ISGW2Hadronic:MaximumWeight 1257 0.000395901
 insert ISGW2Hadronic:MaximumWeight 1258 2.09622e-05
 insert ISGW2Hadronic:MaximumWeight 1259 0.00080766
 insert ISGW2Hadronic:MaximumWeight 1260 7.69074e-05
 insert ISGW2Hadronic:MaximumWeight 1261 0.00212493
 insert ISGW2Hadronic:MaximumWeight 1262 2.40413e-05
 insert ISGW2Hadronic:MaximumWeight 1263 0.000480097
 insert ISGW2Hadronic:MaximumWeight 1264 0.00011078
 insert ISGW2Hadronic:MaximumWeight 1265 0.000256672
 insert ISGW2Hadronic:MaximumWeight 1266 1.89139e-05
 insert ISGW2Hadronic:MaximumWeight 1267 9.58848e-06
 insert ISGW2Hadronic:MaximumWeight 1268 0.000220586
 insert ISGW2Hadronic:MaximumWeight 1269 8.10829e-06
 insert ISGW2Hadronic:MaximumWeight 1270 0.000743056
 insert ISGW2Hadronic:MaximumWeight 1271 6.0154e-05
 insert ISGW2Hadronic:MaximumWeight 1272 0.00179367
 insert ISGW2Hadronic:MaximumWeight 1273 1.64384e-05
 insert ISGW2Hadronic:MaximumWeight 1274 0.000329703
 insert ISGW2Hadronic:MaximumWeight 1275 7.8486e-05
 insert ISGW2Hadronic:MaximumWeight 1276 0.00367769
 insert ISGW2Hadronic:MaximumWeight 1277 9.25585e-05
 insert ISGW2Hadronic:MaximumWeight 1278 0.00941473
 insert ISGW2Hadronic:MaximumWeight 1279 0.000405428
 insert ISGW2Hadronic:MaximumWeight 1280 0.0128822
 insert ISGW2Hadronic:MaximumWeight 1281 0.000790063
 insert ISGW2Hadronic:MaximumWeight 1282 0.000111289
 insert ISGW2Hadronic:MaximumWeight 1283 0.00721965
 insert ISGW2Hadronic:MaximumWeight 1284 0.00010792
 insert ISGW2Hadronic:MaximumWeight 1285 0.00328307
 insert ISGW2Hadronic:MaximumWeight 1286 1.48509e-05
 insert ISGW2Hadronic:MaximumWeight 1287 2.43091e-07
 insert ISGW2Hadronic:MaximumWeight 1288 7.78723e-06
 insert ISGW2Hadronic:MaximumWeight 1289 1.17322e-10
 insert ISGW2Hadronic:MaximumWeight 1290 5.4119e-10
 insert ISGW2Hadronic:MaximumWeight 1291 0.00174138
 insert ISGW2Hadronic:MaximumWeight 1292 6.2123e-05
 insert ISGW2Hadronic:MaximumWeight 1293 0.00103
 insert ISGW2Hadronic:MaximumWeight 1294 4.59474e-06
 insert ISGW2Hadronic:MaximumWeight 1295 1.01343e-05
 insert ISGW2Hadronic:MaximumWeight 1296 1.16824e-06
 insert ISGW2Hadronic:MaximumWeight 1297 2.28908e-08
 insert ISGW2Hadronic:MaximumWeight 1298 2.64652e-05
 insert ISGW2Hadronic:MaximumWeight 1299 9.98891e-08
 insert ISGW2Hadronic:MaximumWeight 1300 1.3507e-07
 insert ISGW2Hadronic:MaximumWeight 1301 1.92389e-05
 insert ISGW2Hadronic:MaximumWeight 1302 3.86068e-07
 insert ISGW2Hadronic:MaximumWeight 1303 3.02561e-05
 insert ISGW2Hadronic:MaximumWeight 1304 3.39565e-07
 insert ISGW2Hadronic:MaximumWeight 1305 3.84018e-06
 insert ISGW2Hadronic:MaximumWeight 1306 0.00032859
 insert ISGW2Hadronic:MaximumWeight 1307 0.000401135
 insert ISGW2Hadronic:MaximumWeight 1308 0.00349064
 insert ISGW2Hadronic:MaximumWeight 1309 0.0176527
 insert ISGW2Hadronic:MaximumWeight 1310 0.000842462
 insert ISGW2Hadronic:MaximumWeight 1311 0.00194719
 insert ISGW2Hadronic:MaximumWeight 1312 0.0070925
 insert ISGW2Hadronic:MaximumWeight 1313 0.0249823
 insert ISGW2Hadronic:MaximumWeight 1314 0.0011664
 insert ISGW2Hadronic:MaximumWeight 1315 7.18727e-05
 insert ISGW2Hadronic:MaximumWeight 1316 0.00311335
 insert ISGW2Hadronic:MaximumWeight 1317 0.00156395
 insert ISGW2Hadronic:MaximumWeight 1318 0.00266225
 insert ISGW2Hadronic:MaximumWeight 1319 0.000661381
 insert ISGW2Hadronic:MaximumWeight 1320 0.00158384
 insert ISGW2Hadronic:MaximumWeight 1321 0.00621579
 insert ISGW2Hadronic:MaximumWeight 1322 0.0204961
 insert ISGW2Hadronic:MaximumWeight 1323 0.000304811
 insert ISGW2Hadronic:MaximumWeight 1324 1.37468e-06
 insert ISGW2Hadronic:MaximumWeight 1325 2.72612e-07
 insert ISGW2Hadronic:MaximumWeight 1326 4.13346e-08
 insert ISGW2Hadronic:MaximumWeight 1327 1.47043e-05
 insert ISGW2Hadronic:MaximumWeight 1328 6.06771e-07
 insert ISGW2Hadronic:MaximumWeight 1329 4.01993e-11
 insert ISGW2Hadronic:MaximumWeight 1330 9.79514e-12
 insert ISGW2Hadronic:MaximumWeight 1331 3.49517e-09
 insert ISGW2Hadronic:MaximumWeight 1332 2.62134e-11
 insert ISGW2Hadronic:MaximumWeight 1333 0.000156677
 insert ISGW2Hadronic:MaximumWeight 1334 0.000140583
 insert ISGW2Hadronic:MaximumWeight 1335 1.09081e-05
 insert ISGW2Hadronic:MaximumWeight 1336 0.00388588
 insert ISGW2Hadronic:MaximumWeight 1337 9.13054e-05
 insert ISGW2Hadronic:MaximumWeight 1338 3.4736e-05
 insert ISGW2Hadronic:MaximumWeight 1339 6.71085e-07
 insert ISGW2Hadronic:MaximumWeight 1340 0.00024777
 insert ISGW2Hadronic:MaximumWeight 1341 9.31782e-07
 insert ISGW2Hadronic:MaximumWeight 1342 1.03165e-07
 insert ISGW2Hadronic:MaximumWeight 1343 3.9905e-08
 insert ISGW2Hadronic:MaximumWeight 1344 3.86395e-09
 insert ISGW2Hadronic:MaximumWeight 1345 1.37648e-06
 insert ISGW2Hadronic:MaximumWeight 1346 2.3475e-06
 insert ISGW2Hadronic:MaximumWeight 1347 3.97246e-07
 insert ISGW2Hadronic:MaximumWeight 1348 1.51149e-08
 insert ISGW2Hadronic:MaximumWeight 1349 5.36383e-06
 insert ISGW2Hadronic:MaximumWeight 1350 1.20659e-08
 insert ISGW2Hadronic:MaximumWeight 1351 1.74742e-06
 insert ISGW2Hadronic:MaximumWeight 1352 7.14764e-07
 insert ISGW2Hadronic:MaximumWeight 1353 2.00267e-09
 insert ISGW2Hadronic:MaximumWeight 1354 6.76701e-08
 insert ISGW2Hadronic:MaximumWeight 1355 2.41066e-05
 insert ISGW2Hadronic:MaximumWeight 1356 2.72069e-06
 insert ISGW2Hadronic:MaximumWeight 1357 1.07493e-06
 insert ISGW2Hadronic:MaximumWeight 1358 2.33504e-07
 insert ISGW2Hadronic:MaximumWeight 1359 5.80542e-08
 insert ISGW2Hadronic:MaximumWeight 1360 2.07011e-05
 insert ISGW2Hadronic:MaximumWeight 1361 3.43848e-07
 insert ISGW2Hadronic:MaximumWeight 1362 0.0330147
 insert ISGW2Hadronic:MaximumWeight 1363 0.0761273
 insert ISGW2Hadronic:MaximumWeight 1364 0.0822188
 insert ISGW2Hadronic:MaximumWeight 1365 0.0601226
 insert ISGW2Hadronic:MaximumWeight 1366 0.0877635
 insert ISGW2Hadronic:MaximumWeight 1367 0.00432713
 insert ISGW2Hadronic:MaximumWeight 1368 0.0748643
 insert ISGW2Hadronic:MaximumWeight 1369 0.454646
 insert ISGW2Hadronic:MaximumWeight 1370 0.0215769
 insert ISGW2Hadronic:MaximumWeight 1371 0.00022902
 insert ISGW2Hadronic:MaximumWeight 1372 7.63998e-07
 insert ISGW2Hadronic:MaximumWeight 1373 0.000116743
 insert ISGW2Hadronic:MaximumWeight 1374 2.01504e-09
 insert ISGW2Hadronic:MaximumWeight 1375 7.49442e-09
 insert ISGW2Hadronic:MaximumWeight 1376 0.0110998
 insert ISGW2Hadronic:MaximumWeight 1377 0.000168488
 insert ISGW2Hadronic:MaximumWeight 1378 0.00108252
 insert ISGW2Hadronic:MaximumWeight 1379 1.68774e-09
 insert ISGW2Hadronic:MaximumWeight 1380 6.10161e-09
 insert ISGW2Hadronic:MaximumWeight 1381 0.00215666
 insert ISGW2Hadronic:MaximumWeight 1382 5.0497e-05
 insert ISGW2Hadronic:MaximumWeight 1383 0.00251352
 insert ISGW2Hadronic:MaximumWeight 1384 2.5448e-07
 insert ISGW2Hadronic:MaximumWeight 1385 7.96188e-07
 insert ISGW2Hadronic:MaximumWeight 1386 0.000188892
 insert ISGW2Hadronic:MaximumWeight 1387 1.81297e-07
 insert ISGW2Hadronic:MaximumWeight 1388 2.73147e-05
 insert ISGW2Hadronic:MaximumWeight 1389 4.54628e-08
 insert ISGW2Hadronic:MaximumWeight 1390 4.99909e-08
 insert ISGW2Hadronic:MaximumWeight 1391 0.00293643
 insert ISGW2Hadronic:MaximumWeight 1392 0.000216581
 insert ISGW2Hadronic:MaximumWeight 1393 0.00746871
 insert ISGW2Hadronic:MaximumWeight 1394 0.014
 insert ISGW2Hadronic:MaximumWeight 1395 0.0132149
 insert ISGW2Hadronic:MaximumWeight 1396 0.000523708
 insert ISGW2Hadronic:MaximumWeight 1397 3.5083e-05
 insert ISGW2Hadronic:MaximumWeight 1398 0.00559303
 insert ISGW2Hadronic:MaximumWeight 1399 0.000318094
 insert ISGW2Hadronic:MaximumWeight 1400 0.0056286
 insert ISGW2Hadronic:MaximumWeight 1401 1.27614e-05
 insert ISGW2Hadronic:MaximumWeight 1402 1.24871e-07
 insert ISGW2Hadronic:MaximumWeight 1403 4.02971e-06
 insert ISGW2Hadronic:MaximumWeight 1404 7.48277e-11
 insert ISGW2Hadronic:MaximumWeight 1405 3.37843e-10
 insert ISGW2Hadronic:MaximumWeight 1406 0.000728481
 insert ISGW2Hadronic:MaximumWeight 1407 2.47234e-05
 insert ISGW2Hadronic:MaximumWeight 1408 0.00080794
 insert ISGW2Hadronic:MaximumWeight 1409 5.40723e-06
 insert ISGW2Hadronic:MaximumWeight 1410 6.57907e-06
 insert ISGW2Hadronic:MaximumWeight 1411 0.000608471
 insert ISGW2Hadronic:MaximumWeight 1412 2.02492e-05
 insert ISGW2Hadronic:MaximumWeight 1413 0.0012743
 insert ISGW2Hadronic:MaximumWeight 1414 1.69603e-05
 insert ISGW2Hadronic:MaximumWeight 1415 4.16493e-05
 insert ISGW2Hadronic:MaximumWeight 1416 6.69782e-06
 insert ISGW2Hadronic:MaximumWeight 1417 1.51082e-08
 insert ISGW2Hadronic:MaximumWeight 1418 3.61152e-07
 insert ISGW2Hadronic:MaximumWeight 1419 1.83824e-15
 insert ISGW2Hadronic:MaximumWeight 1420 0.00026149
 insert ISGW2Hadronic:MaximumWeight 1421 5.3417e-05
 insert ISGW2Hadronic:MaximumWeight 1422 0.000106628
 insert ISGW2Hadronic:MaximumWeight 1423 1.92528e-05
 insert ISGW2Hadronic:MaximumWeight 1424 0.00685856
 insert ISGW2Hadronic:MaximumWeight 1425 0.000355755
 insert ISGW2Hadronic:MaximumWeight 1426 0.000831802
 insert ISGW2Hadronic:MaximumWeight 1427 0.00130085
 insert ISGW2Hadronic:MaximumWeight 1428 2.96396e-05
 insert ISGW2Hadronic:MaximumWeight 1429 0.0105587
 insert ISGW2Hadronic:MaximumWeight 1430 0.000618186
 insert ISGW2Hadronic:MaximumWeight 1431 0.000321353
 insert ISGW2Hadronic:MaximumWeight 1432 6.07499e-05
 insert ISGW2Hadronic:MaximumWeight 1433 3.10856e-06
 insert ISGW2Hadronic:MaximumWeight 1434 0.00110739
 insert ISGW2Hadronic:MaximumWeight 1435 0.000500143
 insert ISGW2Hadronic:MaximumWeight 1436 1.24519e-06
 insert ISGW2Hadronic:MaximumWeight 1437 0.000968856
 insert ISGW2Hadronic:MaximumWeight 1438 2.76331e-05
 insert ISGW2Hadronic:MaximumWeight 1439 0.00985436
 insert ISGW2Hadronic:MaximumWeight 1440 0.000479951
 insert ISGW2Hadronic:MaximumWeight 1441 5.76351e-07
 insert ISGW2Hadronic:MaximumWeight 1442 7.73783e-08
 insert ISGW2Hadronic:MaximumWeight 1443 1.06292e-08
 insert ISGW2Hadronic:MaximumWeight 1444 3.78679e-06
 insert ISGW2Hadronic:MaximumWeight 1445 1.71629e-07
 insert ISGW2Hadronic:MaximumWeight 1446 5.97405e-11
 insert ISGW2Hadronic:MaximumWeight 1447 5.67563e-12
 insert ISGW2Hadronic:MaximumWeight 1448 2.03119e-09
 insert ISGW2Hadronic:MaximumWeight 1449 1.53204e-11
 insert ISGW2Hadronic:MaximumWeight 1450 3.27472e-05
 insert ISGW2Hadronic:MaximumWeight 1451 2.91729e-05
 insert ISGW2Hadronic:MaximumWeight 1452 2.18535e-06
 insert ISGW2Hadronic:MaximumWeight 1453 0.000778503
 insert ISGW2Hadronic:MaximumWeight 1454 3.66339e-05
 insert ISGW2Hadronic:MaximumWeight 1455 9.64507e-06
 insert ISGW2Hadronic:MaximumWeight 1456 4.53158e-07
 insert ISGW2Hadronic:MaximumWeight 1457 0.000162094
 insert ISGW2Hadronic:MaximumWeight 1458 3.26765e-07
 insert ISGW2Hadronic:MaximumWeight 1459 0.000228276
 insert ISGW2Hadronic:MaximumWeight 1460 6.17453e-07
 insert ISGW2Hadronic:MaximumWeight 1461 1.78476e-06
 insert ISGW2Hadronic:MaximumWeight 1462 0.000635799
 insert ISGW2Hadronic:MaximumWeight 1463 0.000118096
 insert ISGW2Hadronic:MaximumWeight 1464 1.58383e-06
 insert ISGW2Hadronic:MaximumWeight 1465 1.44423e-06
 insert ISGW2Hadronic:MaximumWeight 1466 0.000514053
 insert ISGW2Hadronic:MaximumWeight 1467 3.87438e-06
 insert ISGW2Hadronic:MaximumWeight 1468 3.02908e-07
 insert ISGW2Hadronic:MaximumWeight 1469 5.11615e-09
 insert ISGW2Hadronic:MaximumWeight 1470 1.22897e-09
 insert ISGW2Hadronic:MaximumWeight 1471 4.37771e-07
 insert ISGW2Hadronic:MaximumWeight 1472 1.61607e-08
 insert ISGW2Hadronic:MaximumWeight 1473 7.95834e-17
 insert ISGW2Hadronic:MaximumWeight 1474 2.78824e-14
 insert ISGW2Hadronic:MaximumWeight 1475 0.000602705
 insert ISGW2Hadronic:MaximumWeight 1476 5.8126e-05
 insert ISGW2Hadronic:MaximumWeight 1477 1.74483e-05
 insert ISGW2Hadronic:MaximumWeight 1478 0.00621574
 insert ISGW2Hadronic:MaximumWeight 1479 0.000654424
 insert ISGW2Hadronic:MaximumWeight 1480 0.000658909
 insert ISGW2Hadronic:MaximumWeight 1481 1.96941e-05
 insert ISGW2Hadronic:MaximumWeight 1482 0.00701533
 insert ISGW2Hadronic:MaximumWeight 1483 6.61807e-06
 insert ISGW2Hadronic:MaximumWeight 1484 0.0023576
 insert ISGW2Hadronic:MaximumWeight 1485 2.56761e-05
 insert ISGW2Hadronic:MaximumWeight 1486 8.69341e-07
 insert ISGW2Hadronic:MaximumWeight 1487 0.000308561
 insert ISGW2Hadronic:MaximumWeight 1488 6.59127e-06
 insert ISGW2Hadronic:MaximumWeight 1489 0.00234353
 insert ISGW2Hadronic:MaximumWeight 1490 0.00178689
 insert ISGW2Hadronic:MaximumWeight 1491 0.000607629
 insert ISGW2Hadronic:MaximumWeight 1492 5.88894e-05
 insert ISGW2Hadronic:MaximumWeight 1493 0.0205931
 insert ISGW2Hadronic:MaximumWeight 1494 1.24724e-06
 insert ISGW2Hadronic:MaximumWeight 1495 4.9042e-07
 insert ISGW2Hadronic:MaximumWeight 1496 5.08943e-08
 insert ISGW2Hadronic:MaximumWeight 1497 1.81373e-05
 insert ISGW2Hadronic:MaximumWeight 1498 8.97699e-07
 insert ISGW2Hadronic:MaximumWeight 1499 2.50892e-09
 insert ISGW2Hadronic:MaximumWeight 1500 9.90899e-11
 insert ISGW2Hadronic:MaximumWeight 1501 3.51392e-08
 insert ISGW2Hadronic:MaximumWeight 1502 2.62619e-10
 insert ISGW2Hadronic:MaximumWeight 1503 4.82711e-05
 insert ISGW2Hadronic:MaximumWeight 1504 4.86653e-05
 insert ISGW2Hadronic:MaximumWeight 1505 1.2628e-09
 insert ISGW2Hadronic:MaximumWeight 1506 3.60766e-06
 insert ISGW2Hadronic:MaximumWeight 1507 0.00128518
 insert ISGW2Hadronic:MaximumWeight 1508 6.15486e-05
 insert ISGW2Hadronic:MaximumWeight 1509 3.13414e-05
 insert ISGW2Hadronic:MaximumWeight 1510 1.24113e-07
 insert ISGW2Hadronic:MaximumWeight 1511 1.01578e-06
 insert ISGW2Hadronic:MaximumWeight 1512 0.000362136
 insert ISGW2Hadronic:MaximumWeight 1513 1.04208e-06
 insert ISGW2Hadronic:MaximumWeight 1514 1.6022e-05
 insert ISGW2Hadronic:MaximumWeight 1515 1.99376e-05
 insert ISGW2Hadronic:MaximumWeight 1516 1.44953e-06
 insert ISGW2Hadronic:MaximumWeight 1517 0.000513428
 insert ISGW2Hadronic:MaximumWeight 1518 3.39376e-05
 insert ISGW2Hadronic:MaximumWeight 1519 5.45222e-07
 insert ISGW2Hadronic:MaximumWeight 1520 5.78621e-09
 insert ISGW2Hadronic:MaximumWeight 1521 2.14348e-06
 insert ISGW2Hadronic:MaximumWeight 1522 9.50426e-09
 insert ISGW2Hadronic:MaximumWeight 1523 2.77321e-07
 insert ISGW2Hadronic:MaximumWeight 1524 9.35602e-09
 insert ISGW2Hadronic:MaximumWeight 1525 1.51489e-09
 insert ISGW2Hadronic:MaximumWeight 1526 5.39663e-07
 insert ISGW2Hadronic:MaximumWeight 1527 3.06082e-08
 insert ISGW2Hadronic:MaximumWeight 1528 3.96726e-12
 insert ISGW2Hadronic:MaximumWeight 1529 6.64529e-13
 insert ISGW2Hadronic:MaximumWeight 1530 2.37078e-10
 insert ISGW2Hadronic:MaximumWeight 1531 2.08119e-12
 insert ISGW2Hadronic:MaximumWeight 1532 0.0906514
 insert ISGW2Hadronic:MaximumWeight 1533 0.00655737
 insert ISGW2Hadronic:MaximumWeight 1534 0.194663
 insert ISGW2Hadronic:MaximumWeight 1535 0.00720782
 insert ISGW2Hadronic:MaximumWeight 1536 0.168179
 insert ISGW2Hadronic:MaximumWeight 1537 0.0242007
 insert ISGW2Hadronic:MaximumWeight 1538 0.00128659
 insert ISGW2Hadronic:MaximumWeight 1539 0.151883
 insert ISGW2Hadronic:MaximumWeight 1540 0.0064175
 insert ISGW2Hadronic:MaximumWeight 1541 0.0349962
 insert ISGW2Hadronic:MaximumWeight 1542 0.000119961
 insert ISGW2Hadronic:MaximumWeight 1543 1.99774e-07
 insert ISGW2Hadronic:MaximumWeight 1544 0.0082
 insert ISGW2Hadronic:MaximumWeight 1545 0.00888319
 insert ISGW2Hadronic:MaximumWeight 1546 0.000159215
 insert ISGW2Hadronic:MaximumWeight 1547 0.00160848
 insert ISGW2Hadronic:MaximumWeight 1548 2.21177e-07
 insert ISGW2Hadronic:MaximumWeight 1549 6.84286e-07
 insert ISGW2Hadronic:MaximumWeight 1550 6.33654e-05
 insert ISGW2Hadronic:MaximumWeight 1551 7.10972e-07
 insert ISGW2Hadronic:MaximumWeight 1552 2.2482e-05
 insert ISGW2Hadronic:MaximumWeight 1553 1.03081e-09
 insert ISGW2Hadronic:MaximumWeight 1554 3.71723e-09
 insert ISGW2Hadronic:MaximumWeight 1555 0.000219427
 insert ISGW2Hadronic:MaximumWeight 1556 1.84988e-06
 insert ISGW2Hadronic:MaximumWeight 1557 0.000250142
 insert ISGW2Hadronic:MaximumWeight 1558 1.50801e-06
 insert ISGW2Hadronic:MaximumWeight 1559 1.06989e-05
 insert ISGW2Hadronic:MaximumWeight 1560 0.000294318
 insert ISGW2Hadronic:MaximumWeight 1561 0.000248944
 insert ISGW2Hadronic:MaximumWeight 1562 0.00796066
 insert ISGW2Hadronic:MaximumWeight 1563 0.000288656
 insert ISGW2Hadronic:MaximumWeight 1564 0.00608008
 insert ISGW2Hadronic:MaximumWeight 1565 0.00205386
 insert ISGW2Hadronic:MaximumWeight 1566 9.52966e-05
 insert ISGW2Hadronic:MaximumWeight 1567 0.00174605
 insert ISGW2Hadronic:MaximumWeight 1568 1.50321e-05
 insert ISGW2Hadronic:MaximumWeight 1569 1.85848e-05
 insert ISGW2Hadronic:MaximumWeight 1570 0.00547791
 insert ISGW2Hadronic:MaximumWeight 1571 9.45203e-05
 insert ISGW2Hadronic:MaximumWeight 1572 0.00653332
 insert ISGW2Hadronic:MaximumWeight 1573 0.000892962
 insert ISGW2Hadronic:MaximumWeight 1574 0.00525054
 insert ISGW2Hadronic:MaximumWeight 1575 3.60714e-05
 insert ISGW2Hadronic:MaximumWeight 1576 7.93914e-07
 insert ISGW2Hadronic:MaximumWeight 1577 2.68419e-05
 insert ISGW2Hadronic:MaximumWeight 1578 2.06545e-09
 insert ISGW2Hadronic:MaximumWeight 1579 9.0377e-09
 insert ISGW2Hadronic:MaximumWeight 1580 0.00138584
 insert ISGW2Hadronic:MaximumWeight 1581 5.37466e-05
 insert ISGW2Hadronic:MaximumWeight 1582 0.00182377
 insert ISGW2Hadronic:MaximumWeight 1583 1.72699e-05
 insert ISGW2Hadronic:MaximumWeight 1584 3.2425e-05
 insert ISGW2Hadronic:MaximumWeight 1585 0.00047197
 insert ISGW2Hadronic:MaximumWeight 1586 2.13647e-05
 insert ISGW2Hadronic:MaximumWeight 1587 0.000898207
 insert ISGW2Hadronic:MaximumWeight 1588 1.33171e-07
 insert ISGW2Hadronic:MaximumWeight 1589 3.1837e-07
 insert ISGW2Hadronic:MaximumWeight 1590 8.03532e-06
 insert ISGW2Hadronic:MaximumWeight 1591 2.52199e-08
 insert ISGW2Hadronic:MaximumWeight 1592 1.03332e-06
 insert ISGW2Hadronic:MaximumWeight 1593 1.42268e-11
 insert ISGW2Hadronic:MaximumWeight 1594 7.61904e-11
 insert ISGW2Hadronic:MaximumWeight 1595 0.00753127
 insert ISGW2Hadronic:MaximumWeight 1596 0.000273977
 insert ISGW2Hadronic:MaximumWeight 1597 0.00958453
 insert ISGW2Hadronic:MaximumWeight 1598 0.000436011
 insert ISGW2Hadronic:MaximumWeight 1599 0.0170353
 insert ISGW2Hadronic:MaximumWeight 1600 0.00236283
 insert ISGW2Hadronic:MaximumWeight 1601 4.43421e-05
 insert ISGW2Hadronic:MaximumWeight 1602 0.0144288
 insert ISGW2Hadronic:MaximumWeight 1603 0.000410463
 insert ISGW2Hadronic:MaximumWeight 1604 0.00515483
 insert ISGW2Hadronic:MaximumWeight 1605 1.67725e-05
 insert ISGW2Hadronic:MaximumWeight 1606 1.69155e-07
 insert ISGW2Hadronic:MaximumWeight 1607 5.55169e-06
 insert ISGW2Hadronic:MaximumWeight 1608 1.24044e-10
 insert ISGW2Hadronic:MaximumWeight 1609 5.50562e-10
 insert ISGW2Hadronic:MaximumWeight 1610 0.000942081
 insert ISGW2Hadronic:MaximumWeight 1611 3.25734e-05
 insert ISGW2Hadronic:MaximumWeight 1612 0.0010801
 insert ISGW2Hadronic:MaximumWeight 1613 8.48479e-06
 insert ISGW2Hadronic:MaximumWeight 1614 1.05941e-05
 insert ISGW2Hadronic:MaximumWeight 1615 0.00381795
 insert ISGW2Hadronic:MaximumWeight 1616 2.65595e-05
 insert ISGW2Hadronic:MaximumWeight 1617 0.00719333
 insert ISGW2Hadronic:MaximumWeight 1618 2.34508e-05
 insert ISGW2Hadronic:MaximumWeight 1619 1.97446e-05
 insert ISGW2Hadronic:MaximumWeight 1620 8.74246e-06
 insert ISGW2Hadronic:MaximumWeight 1621 2.15809e-08
 insert ISGW2Hadronic:MaximumWeight 1622 5.10599e-07
 insert ISGW2Hadronic:MaximumWeight 1623 8.03246e-15
 insert ISGW2Hadronic:MaximumWeight 1624 9.84887e-05
 insert ISGW2Hadronic:MaximumWeight 1625 0.0859114
 insert ISGW2Hadronic:MaximumWeight 1626 0.00665947
 insert ISGW2Hadronic:MaximumWeight 1627 0.000152355
 insert ISGW2Hadronic:MaximumWeight 1628 0.115277
 insert ISGW2Hadronic:MaximumWeight 1629 1.59278e-05
 insert ISGW2Hadronic:MaximumWeight 1630 0.501858
 insert ISGW2Hadronic:MaximumWeight 1631 0.00487397
 insert ISGW2Hadronic:MaximumWeight 1632 0.00014329
 insert ISGW2Hadronic:MaximumWeight 1633 0.18175
 insert ISGW2Hadronic:MaximumWeight 1634 3.02994e-06
 insert ISGW2Hadronic:MaximumWeight 1635 4.46212e-07
 insert ISGW2Hadronic:MaximumWeight 1636 5.80007e-08
 insert ISGW2Hadronic:MaximumWeight 1637 2.0662e-05
 insert ISGW2Hadronic:MaximumWeight 1638 9.99202e-07
 insert ISGW2Hadronic:MaximumWeight 1639 5.19569e-10
 insert ISGW2Hadronic:MaximumWeight 1640 3.80089e-11
 insert ISGW2Hadronic:MaximumWeight 1641 1.36745e-08
 insert ISGW2Hadronic:MaximumWeight 1642 1.00467e-10
 insert ISGW2Hadronic:MaximumWeight 1643 0.000169181
 insert ISGW2Hadronic:MaximumWeight 1644 0.000152837
 insert ISGW2Hadronic:MaximumWeight 1645 1.13787e-05
 insert ISGW2Hadronic:MaximumWeight 1646 0.00405351
 insert ISGW2Hadronic:MaximumWeight 1647 0.000190006
 insert ISGW2Hadronic:MaximumWeight 1648 5.21745e-05
 insert ISGW2Hadronic:MaximumWeight 1649 2.48955e-06
 insert ISGW2Hadronic:MaximumWeight 1650 0.000885514
 insert ISGW2Hadronic:MaximumWeight 1651 1.80427e-06
 insert ISGW2Hadronic:MaximumWeight 1652 9.29678e-06
 insert ISGW2Hadronic:MaximumWeight 1653 0.433737
 insert ISGW2Hadronic:MaximumWeight 1654 8.81207e-06
 insert ISGW2Hadronic:MaximumWeight 1655 7.74234e-06
 insert ISGW2Hadronic:MaximumWeight 1656 0.207994
 insert ISGW2Hadronic:MaximumWeight 1657 1.58071e-06
 insert ISGW2Hadronic:MaximumWeight 1658 3.06389e-08
 insert ISGW2Hadronic:MaximumWeight 1659 7.03968e-09
 insert ISGW2Hadronic:MaximumWeight 1660 2.50744e-06
 insert ISGW2Hadronic:MaximumWeight 1661 9.03655e-08
 insert ISGW2Hadronic:MaximumWeight 1662 1.77767e-15
 insert ISGW2Hadronic:MaximumWeight 1663 6.34078e-13
 insert ISGW2Hadronic:MaximumWeight 1664 0.0167046
 insert ISGW2Hadronic:MaximumWeight 1665 0.0183919
 insert ISGW2Hadronic:MaximumWeight 1666 0.00327335
 insert ISGW2Hadronic:MaximumWeight 1667 0.016342
 insert ISGW2Hadronic:MaximumWeight 1668 0.000318794
 insert ISGW2Hadronic:MaximumWeight 1669 6.91014e-07
 insert ISGW2Hadronic:MaximumWeight 1670 3.74945e-05
 insert ISGW2Hadronic:MaximumWeight 1671 8.81558e-14
 insert ISGW2Hadronic:MaximumWeight 1672 0.0230301
 insert ISGW2Hadronic:MaximumWeight 1673 0.000433045
 insert ISGW2Hadronic:MaximumWeight 1674 0.00440227
 insert ISGW2Hadronic:MaximumWeight 1675 7.14496e-07
 insert ISGW2Hadronic:MaximumWeight 1676 0.00016
 insert ISGW2Hadronic:MaximumWeight 1677 0.000165861
 insert ISGW2Hadronic:MaximumWeight 1678 1.98216e-06
 insert ISGW2Hadronic:MaximumWeight 1679 6.41893e-05
 insert ISGW2Hadronic:MaximumWeight 1680 3.34973e-09
 insert ISGW2Hadronic:MaximumWeight 1681 1.15405e-08
 insert ISGW2Hadronic:MaximumWeight 1682 0.000563589
 insert ISGW2Hadronic:MaximumWeight 1683 4.93522e-06
 insert ISGW2Hadronic:MaximumWeight 1684 0.000655498
 insert ISGW2Hadronic:MaximumWeight 1685 4.05064e-06
 insert ISGW2Hadronic:MaximumWeight 1686 2.96856e-05
 #
 create Herwig::PScalar4FermionsDecayer  PScalar4f
 newdef PScalar4f:Iteration 1
 newdef PScalar4f:Ntry 500
 newdef PScalar4f:Points 10000
 newdef PScalar4f:GenerateIntermediates 0
 do PScalar4f:SetUpDecayMode 111 11 11 0.0251591 2 113 0.7758 0.1503 0.000287254
 do PScalar4f:SetUpDecayMode 221 11 11 0.0248 2 113 0.7758 0.1503 0.000268792
 #
 create Herwig::ScalarScalarScalarDecayer  ScalarSS
 newdef ScalarSS:Iteration 1
 newdef ScalarSS:Ntry 500
 newdef ScalarSS:Points 10000
 newdef ScalarSS:GenerateIntermediates 0
 newdef ScalarSS:Incoming 0 9010221
 newdef ScalarSS:FirstOutgoing 0 111
 newdef ScalarSS:SecondOutgoing 0 111
 newdef ScalarSS:Coupling 0 1660
 newdef ScalarSS:MaxWeight 0 1.1
 newdef ScalarSS:Incoming 1 9010221
 newdef ScalarSS:FirstOutgoing 1 211
 newdef ScalarSS:SecondOutgoing 1 -211
 newdef ScalarSS:Coupling 1 2350
 newdef ScalarSS:MaxWeight 1 1.1
 newdef ScalarSS:Incoming 2 9010221
 newdef ScalarSS:FirstOutgoing 2 321
 newdef ScalarSS:SecondOutgoing 2 -321
 newdef ScalarSS:Coupling 2 1020
 newdef ScalarSS:MaxWeight 2 1.1
 newdef ScalarSS:Incoming 3 9010221
 newdef ScalarSS:FirstOutgoing 3 311
 newdef ScalarSS:SecondOutgoing 3 -311
 newdef ScalarSS:Coupling 3 1020
 newdef ScalarSS:MaxWeight 3 1.1
 newdef ScalarSS:Incoming 4 10221
 newdef ScalarSS:FirstOutgoing 4 111
 newdef ScalarSS:SecondOutgoing 4 111
 newdef ScalarSS:Coupling 4 745
 newdef ScalarSS:MaxWeight 4 1.18096
 newdef ScalarSS:Incoming 5 10221
 newdef ScalarSS:FirstOutgoing 5 211
 newdef ScalarSS:SecondOutgoing 5 -211
 newdef ScalarSS:Coupling 5 1054
 newdef ScalarSS:MaxWeight 5 1.18029
 newdef ScalarSS:Incoming 6 10221
 newdef ScalarSS:FirstOutgoing 6 100111
 newdef ScalarSS:SecondOutgoing 6 111
 newdef ScalarSS:Coupling 6 5027
 newdef ScalarSS:MaxWeight 6 2.3846
 newdef ScalarSS:Incoming 7 10221
 newdef ScalarSS:FirstOutgoing 7 100211
 newdef ScalarSS:SecondOutgoing 7 -211
 newdef ScalarSS:Coupling 7 5027
 newdef ScalarSS:MaxWeight 7 2.30756
 newdef ScalarSS:Incoming 8 10221
 newdef ScalarSS:FirstOutgoing 8 321
 newdef ScalarSS:SecondOutgoing 8 -321
 newdef ScalarSS:Coupling 8 886
 newdef ScalarSS:MaxWeight 8 1.19989
 newdef ScalarSS:Incoming 9 10221
 newdef ScalarSS:FirstOutgoing 9 311
 newdef ScalarSS:SecondOutgoing 9 -311
 newdef ScalarSS:Coupling 9 886
 newdef ScalarSS:MaxWeight 9 1.19012
 newdef ScalarSS:Incoming 10 10331
 newdef ScalarSS:FirstOutgoing 10 111
 newdef ScalarSS:SecondOutgoing 10 111
 newdef ScalarSS:Coupling 10 503
 newdef ScalarSS:MaxWeight 10 1.1012
 newdef ScalarSS:Incoming 11 10331
 newdef ScalarSS:FirstOutgoing 11 211
 newdef ScalarSS:SecondOutgoing 11 -211
 newdef ScalarSS:Coupling 11 711
 newdef ScalarSS:MaxWeight 11 1.09915
 newdef ScalarSS:Incoming 12 10331
 newdef ScalarSS:FirstOutgoing 12 321
 newdef ScalarSS:SecondOutgoing 12 -321
 newdef ScalarSS:Coupling 12 2096
 newdef ScalarSS:MaxWeight 12 1.05631
 newdef ScalarSS:Incoming 13 10331
 newdef ScalarSS:FirstOutgoing 13 311
 newdef ScalarSS:SecondOutgoing 13 -311
 newdef ScalarSS:Coupling 13 2096
 newdef ScalarSS:MaxWeight 13 1.05209
 newdef ScalarSS:Incoming 14 9000221
 newdef ScalarSS:FirstOutgoing 14 111
 newdef ScalarSS:SecondOutgoing 14 111
 newdef ScalarSS:Coupling 14 3654
 newdef ScalarSS:MaxWeight 14 1.09971
 newdef ScalarSS:Incoming 15 9000221
 newdef ScalarSS:FirstOutgoing 15 211
 newdef ScalarSS:SecondOutgoing 15 -211
 newdef ScalarSS:Coupling 15 5178
 newdef ScalarSS:MaxWeight 15 1.09997
 newdef ScalarSS:Incoming 16 9000111
 newdef ScalarSS:FirstOutgoing 16 221
 newdef ScalarSS:SecondOutgoing 16 111
 newdef ScalarSS:Coupling 16 3330
 newdef ScalarSS:MaxWeight 16 1.10192
 newdef ScalarSS:Incoming 17 9000211
 newdef ScalarSS:FirstOutgoing 17 221
 newdef ScalarSS:SecondOutgoing 17 211
 newdef ScalarSS:Coupling 17 3330
 newdef ScalarSS:MaxWeight 17 1.10212
 newdef ScalarSS:Incoming 18 9000111
 newdef ScalarSS:FirstOutgoing 18 321
 newdef ScalarSS:SecondOutgoing 18 -321
 newdef ScalarSS:Coupling 18 2540
 newdef ScalarSS:MaxWeight 18 1.1
 newdef ScalarSS:Incoming 19 9000111
 newdef ScalarSS:FirstOutgoing 19 311
 newdef ScalarSS:SecondOutgoing 19 -311
 newdef ScalarSS:Coupling 19 2540
 newdef ScalarSS:MaxWeight 19 1.1
 newdef ScalarSS:Incoming 20 9000211
 newdef ScalarSS:FirstOutgoing 20 321
 newdef ScalarSS:SecondOutgoing 20 -311
 newdef ScalarSS:Coupling 20 3590
 newdef ScalarSS:MaxWeight 20 1.1
 newdef ScalarSS:Incoming 21 10111
 newdef ScalarSS:FirstOutgoing 21 221
 newdef ScalarSS:SecondOutgoing 21 111
 newdef ScalarSS:Coupling 21 1357
 newdef ScalarSS:MaxWeight 21 1.09914
 newdef ScalarSS:Incoming 22 10211
 newdef ScalarSS:FirstOutgoing 22 221
 newdef ScalarSS:SecondOutgoing 22 211
 newdef ScalarSS:Coupling 22 1357
 newdef ScalarSS:MaxWeight 22 1.09815
 newdef ScalarSS:Incoming 23 10111
 newdef ScalarSS:FirstOutgoing 23 331
 newdef ScalarSS:SecondOutgoing 23 111
 newdef ScalarSS:Coupling 23 995
 newdef ScalarSS:MaxWeight 23 1.13279
 newdef ScalarSS:Incoming 24 10211
 newdef ScalarSS:FirstOutgoing 24 331
 newdef ScalarSS:SecondOutgoing 24 211
 newdef ScalarSS:Coupling 24 995
 newdef ScalarSS:MaxWeight 24 1.13026
 newdef ScalarSS:Incoming 25 10111
 newdef ScalarSS:FirstOutgoing 25 321
 newdef ScalarSS:SecondOutgoing 25 -321
 newdef ScalarSS:Coupling 25 950
 newdef ScalarSS:MaxWeight 25 1.10325
 newdef ScalarSS:Incoming 26 10111
 newdef ScalarSS:FirstOutgoing 26 311
 newdef ScalarSS:SecondOutgoing 26 -311
 newdef ScalarSS:Coupling 26 950
 newdef ScalarSS:MaxWeight 26 1.09597
 newdef ScalarSS:Incoming 27 10211
 newdef ScalarSS:FirstOutgoing 27 321
 newdef ScalarSS:SecondOutgoing 27 -311
 newdef ScalarSS:Coupling 27 1344
 newdef ScalarSS:MaxWeight 27 1.10042
 newdef ScalarSS:Incoming 28 10221
 newdef ScalarSS:FirstOutgoing 28 221
 newdef ScalarSS:SecondOutgoing 28 221
 newdef ScalarSS:Coupling 28 235
 newdef ScalarSS:MaxWeight 28 1.26383
 newdef ScalarSS:Incoming 29 10331
 newdef ScalarSS:FirstOutgoing 29 221
 newdef ScalarSS:SecondOutgoing 29 221
 newdef ScalarSS:Coupling 29 2189
 newdef ScalarSS:MaxWeight 29 5.4
 newdef ScalarSS:Incoming 30 10221
 newdef ScalarSS:FirstOutgoing 30 9000221
 newdef ScalarSS:SecondOutgoing 30 9000221
 newdef ScalarSS:Coupling 30 21460
 newdef ScalarSS:MaxWeight 30 7.54408
 newdef ScalarSS:Incoming 31 10311
 newdef ScalarSS:FirstOutgoing 31 311
 newdef ScalarSS:SecondOutgoing 31 111
 newdef ScalarSS:Coupling 31 2837
 newdef ScalarSS:MaxWeight 31 1.1139
 newdef ScalarSS:Incoming 32 10311
 newdef ScalarSS:FirstOutgoing 32 321
 newdef ScalarSS:SecondOutgoing 32 -211
 newdef ScalarSS:Coupling 32 4000
 newdef ScalarSS:MaxWeight 32 1.1087
 newdef ScalarSS:Incoming 33 10321
 newdef ScalarSS:FirstOutgoing 33 321
 newdef ScalarSS:SecondOutgoing 33 111
 newdef ScalarSS:Coupling 33 2837
 newdef ScalarSS:MaxWeight 33 1.1165
 newdef ScalarSS:Incoming 34 10321
 newdef ScalarSS:FirstOutgoing 34 311
 newdef ScalarSS:SecondOutgoing 34 211
 newdef ScalarSS:Coupling 34 4000
 newdef ScalarSS:MaxWeight 34 1.10612
 newdef ScalarSS:Incoming 35 10411
 newdef ScalarSS:FirstOutgoing 35 411
 newdef ScalarSS:SecondOutgoing 35 111
 newdef ScalarSS:Coupling 35 5472
 newdef ScalarSS:MaxWeight 35 1.09982
 newdef ScalarSS:Incoming 36 10411
 newdef ScalarSS:FirstOutgoing 36 421
 newdef ScalarSS:SecondOutgoing 36 211
 newdef ScalarSS:Coupling 36 7714
 newdef ScalarSS:MaxWeight 36 1.09992
 newdef ScalarSS:Incoming 37 10421
 newdef ScalarSS:FirstOutgoing 37 421
 newdef ScalarSS:SecondOutgoing 37 111
 newdef ScalarSS:Coupling 37 5447
 newdef ScalarSS:MaxWeight 37 1.09983
 newdef ScalarSS:Incoming 38 10421
 newdef ScalarSS:FirstOutgoing 38 411
 newdef ScalarSS:SecondOutgoing 38 -211
 newdef ScalarSS:Coupling 38 7818
 newdef ScalarSS:MaxWeight 38 1.1194
 newdef ScalarSS:Incoming 39 10511
 newdef ScalarSS:FirstOutgoing 39 511
 newdef ScalarSS:SecondOutgoing 39 111
 newdef ScalarSS:Coupling 39 9698
 newdef ScalarSS:MaxWeight 39 1.10058
 newdef ScalarSS:Incoming 40 10511
 newdef ScalarSS:FirstOutgoing 40 521
 newdef ScalarSS:SecondOutgoing 40 -211
 newdef ScalarSS:Coupling 40 13710
 newdef ScalarSS:MaxWeight 40 1.09697
 newdef ScalarSS:Incoming 41 10521
 newdef ScalarSS:FirstOutgoing 41 521
 newdef ScalarSS:SecondOutgoing 41 111
 newdef ScalarSS:Coupling 41 9698
 newdef ScalarSS:MaxWeight 41 1.10162
 newdef ScalarSS:Incoming 42 10521
 newdef ScalarSS:FirstOutgoing 42 511
 newdef ScalarSS:SecondOutgoing 42 211
 newdef ScalarSS:Coupling 42 13710
 newdef ScalarSS:MaxWeight 42 1.09592
 newdef ScalarSS:Incoming 43 100311
 newdef ScalarSS:FirstOutgoing 43 10311
 newdef ScalarSS:SecondOutgoing 43 111
 newdef ScalarSS:Coupling 43 6595
 newdef ScalarSS:MaxWeight 43 2.13753
 newdef ScalarSS:Incoming 44 100311
 newdef ScalarSS:FirstOutgoing 44 10321
 newdef ScalarSS:SecondOutgoing 44 -211
 newdef ScalarSS:Coupling 44 9445
 newdef ScalarSS:MaxWeight 44 2.13275
 newdef ScalarSS:Incoming 45 100321
 newdef ScalarSS:FirstOutgoing 45 10321
 newdef ScalarSS:SecondOutgoing 45 111
 newdef ScalarSS:Coupling 45 6595
 newdef ScalarSS:MaxWeight 45 2.13257
 newdef ScalarSS:Incoming 46 100321
 newdef ScalarSS:FirstOutgoing 46 10311
 newdef ScalarSS:SecondOutgoing 46 211
 newdef ScalarSS:Coupling 46 9445
 newdef ScalarSS:MaxWeight 46 2.13815
 newdef ScalarSS:Incoming 47 10431
 newdef ScalarSS:FirstOutgoing 47 431
 newdef ScalarSS:SecondOutgoing 47 111
 newdef ScalarSS:Coupling 47 103
 newdef ScalarSS:MaxWeight 47 1.10901
 newdef ScalarSS:Incoming 48 10531
 newdef ScalarSS:FirstOutgoing 48 531
 newdef ScalarSS:SecondOutgoing 48 111
 newdef ScalarSS:Coupling 48 8314
 newdef ScalarSS:MaxWeight 48 0.664961
 newdef ScalarSS:Incoming 49 100221
 newdef ScalarSS:FirstOutgoing 49 9000111
 newdef ScalarSS:SecondOutgoing 49 111
 newdef ScalarSS:Coupling 49 2057
 newdef ScalarSS:MaxWeight 49 1.89242
 newdef ScalarSS:Incoming 50 100221
 newdef ScalarSS:FirstOutgoing 50 9000211
 newdef ScalarSS:SecondOutgoing 50 -211
 newdef ScalarSS:Coupling 50 2057
 newdef ScalarSS:MaxWeight 50 1.91997
 newdef ScalarSS:Incoming 51 9020221
 newdef ScalarSS:FirstOutgoing 51 9000111
 newdef ScalarSS:SecondOutgoing 51 111
 newdef ScalarSS:Coupling 51 1470
 newdef ScalarSS:MaxWeight 51 1.85695
 newdef ScalarSS:Incoming 52 9020221
 newdef ScalarSS:FirstOutgoing 52 9000211
 newdef ScalarSS:SecondOutgoing 52 -211
 newdef ScalarSS:Coupling 52 1470
 newdef ScalarSS:MaxWeight 52 1.89707
 newdef ScalarSS:Incoming 53 9020221
 newdef ScalarSS:FirstOutgoing 53 221
 newdef ScalarSS:SecondOutgoing 53 9000221
 newdef ScalarSS:Coupling 53 4051
 newdef ScalarSS:MaxWeight 53 1.76697
 newdef ScalarSS:Incoming 54 100221
 newdef ScalarSS:FirstOutgoing 54 9000221
 newdef ScalarSS:SecondOutgoing 54 221
 newdef ScalarSS:Coupling 54 4316
 newdef ScalarSS:MaxWeight 54 1.75782
 newdef ScalarSS:Incoming 55 10441
 newdef ScalarSS:FirstOutgoing 55 321
 newdef ScalarSS:SecondOutgoing 55 -321
 newdef ScalarSS:Coupling 55 104
 newdef ScalarSS:MaxWeight 55 1.18153
 newdef ScalarSS:Incoming 56 10441
 newdef ScalarSS:FirstOutgoing 56 311
 newdef ScalarSS:SecondOutgoing 56 -311
 newdef ScalarSS:Coupling 56 104
 newdef ScalarSS:MaxWeight 56 1.18066
 newdef ScalarSS:Incoming 57 10441
 newdef ScalarSS:FirstOutgoing 57 211
 newdef ScalarSS:SecondOutgoing 57 -211
 newdef ScalarSS:Coupling 57 93
 newdef ScalarSS:MaxWeight 57 1.10662
 newdef ScalarSS:Incoming 58 10441
 newdef ScalarSS:FirstOutgoing 58 111
 newdef ScalarSS:SecondOutgoing 58 111
 newdef ScalarSS:Coupling 58 66
 newdef ScalarSS:MaxWeight 58 1.11492
 newdef ScalarSS:Incoming 59 10441
 newdef ScalarSS:FirstOutgoing 59 221
 newdef ScalarSS:SecondOutgoing 59 221
 newdef ScalarSS:Coupling 59 64
 newdef ScalarSS:MaxWeight 59 1.17978
 newdef ScalarSS:Incoming 60 9030221
 newdef ScalarSS:FirstOutgoing 60 211
 newdef ScalarSS:SecondOutgoing 60 -211
 newdef ScalarSS:Coupling 60 1398
 newdef ScalarSS:MaxWeight 60 1.09972
 newdef ScalarSS:Incoming 61 9030221
 newdef ScalarSS:FirstOutgoing 61 111
 newdef ScalarSS:SecondOutgoing 61 111
 newdef ScalarSS:Coupling 61 989
 newdef ScalarSS:MaxWeight 61 1.10202
 newdef ScalarSS:Incoming 62 9030221
 newdef ScalarSS:FirstOutgoing 62 9000221
 newdef ScalarSS:SecondOutgoing 62 9000221
 newdef ScalarSS:Coupling 62 6079
 newdef ScalarSS:MaxWeight 62 7.35565
 newdef ScalarSS:Incoming 63 9030221
 newdef ScalarSS:FirstOutgoing 63 221
 newdef ScalarSS:SecondOutgoing 63 221
 newdef ScalarSS:Coupling 63 809
 newdef ScalarSS:MaxWeight 63 1.12039
 newdef ScalarSS:Incoming 64 9030221
 newdef ScalarSS:FirstOutgoing 64 221
 newdef ScalarSS:SecondOutgoing 64 331
 newdef ScalarSS:Coupling 64 2844
 newdef ScalarSS:MaxWeight 64 6.5
 newdef ScalarSS:Incoming 65 9030221
 newdef ScalarSS:FirstOutgoing 65 321
 newdef ScalarSS:SecondOutgoing 65 -321
 newdef ScalarSS:Coupling 65 686
 newdef ScalarSS:MaxWeight 65 1.1015
 newdef ScalarSS:Incoming 66 9030221
 newdef ScalarSS:FirstOutgoing 66 311
 newdef ScalarSS:SecondOutgoing 66 -311
 newdef ScalarSS:Coupling 66 686
 newdef ScalarSS:MaxWeight 66 1.09478
 newdef ScalarSS:Incoming 67 9030221
 newdef ScalarSS:FirstOutgoing 67 100111
 newdef ScalarSS:SecondOutgoing 67 111
 newdef ScalarSS:Coupling 67 2615
 newdef ScalarSS:MaxWeight 67 2.28089
 newdef ScalarSS:Incoming 68 9030221
 newdef ScalarSS:FirstOutgoing 68 100211
 newdef ScalarSS:SecondOutgoing 68 -211
 newdef ScalarSS:Coupling 68 2615
 newdef ScalarSS:MaxWeight 68 2.23395
 newdef ScalarSS:Incoming 69 9000311
 newdef ScalarSS:FirstOutgoing 69 311
 newdef ScalarSS:SecondOutgoing 69 111
 newdef ScalarSS:Coupling 69 3834
 newdef ScalarSS:MaxWeight 69 1.10384
 newdef ScalarSS:Incoming 70 9000311
 newdef ScalarSS:FirstOutgoing 70 321
 newdef ScalarSS:SecondOutgoing 70 -211
 newdef ScalarSS:Coupling 70 5406
 newdef ScalarSS:MaxWeight 70 1.10171
 newdef ScalarSS:Incoming 71 9000321
 newdef ScalarSS:FirstOutgoing 71 321
 newdef ScalarSS:SecondOutgoing 71 111
 newdef ScalarSS:Coupling 71 3834
 newdef ScalarSS:MaxWeight 71 1.11557
 newdef ScalarSS:Incoming 72 9000321
 newdef ScalarSS:FirstOutgoing 72 311
 newdef ScalarSS:SecondOutgoing 72 211
 newdef ScalarSS:Coupling 72 5406
 newdef ScalarSS:MaxWeight 72 1.08994
 newdef ScalarSS:Incoming 73 10441
 newdef ScalarSS:FirstOutgoing 73 10321
 newdef ScalarSS:SecondOutgoing 73 -10321
 newdef ScalarSS:Coupling 73 104
 newdef ScalarSS:MaxWeight 73 1.53966
 newdef ScalarSS:Incoming 74 10441
 newdef ScalarSS:FirstOutgoing 74 10311
 newdef ScalarSS:SecondOutgoing 74 -10311
 newdef ScalarSS:Coupling 74 104
 newdef ScalarSS:MaxWeight 74 1.50609
 newdef ScalarSS:Incoming 75 10531
 newdef ScalarSS:FirstOutgoing 75 511
 newdef ScalarSS:SecondOutgoing 75 -311
 newdef ScalarSS:Coupling 75 12170
 newdef ScalarSS:MaxWeight 75 1.07391
 newdef ScalarSS:Incoming 76 10531
 newdef ScalarSS:FirstOutgoing 76 521
 newdef ScalarSS:SecondOutgoing 76 -321
 newdef ScalarSS:Coupling 76 12170
 newdef ScalarSS:MaxWeight 76 1.1278
 newdef ScalarSS:Incoming 77 10441
 newdef ScalarSS:FirstOutgoing 77 9010221
 newdef ScalarSS:SecondOutgoing 77 9010221
 newdef ScalarSS:Coupling 77 84
 newdef ScalarSS:MaxWeight 77 1.31568
 #
 create Herwig::PScalarPScalarVectorDecayer  PPVDecayer
 newdef PPVDecayer:Iteration 1
 newdef PPVDecayer:Ntry 500
 newdef PPVDecayer:Points 10000
 newdef PPVDecayer:GenerateIntermediates 0
 newdef PPVDecayer:Incoming 0 100111
 newdef PPVDecayer:OutgoingPScalar 0 -211
 newdef PPVDecayer:OutgoingVector 0 213
 newdef PPVDecayer:Coupling 0 3.57
 newdef PPVDecayer:MaxWeight 0 4.85468
 newdef PPVDecayer:Incoming 1 100211
 newdef PPVDecayer:OutgoingPScalar 1 111
 newdef PPVDecayer:OutgoingVector 1 213
 newdef PPVDecayer:Coupling 1 3.57
 newdef PPVDecayer:MaxWeight 1 4.92159
 newdef PPVDecayer:Incoming 2 100211
 newdef PPVDecayer:OutgoingPScalar 2 211
 newdef PPVDecayer:OutgoingVector 2 113
 newdef PPVDecayer:Coupling 2 3.57
 newdef PPVDecayer:MaxWeight 2 4.77463
 newdef PPVDecayer:Incoming 3 100311
 newdef PPVDecayer:OutgoingPScalar 3 311
 newdef PPVDecayer:OutgoingVector 3 113
 newdef PPVDecayer:Coupling 3 1
 newdef PPVDecayer:MaxWeight 3 3.79851
 newdef PPVDecayer:Incoming 4 100321
 newdef PPVDecayer:OutgoingPScalar 4 321
 newdef PPVDecayer:OutgoingVector 4 113
 newdef PPVDecayer:Coupling 4 1
 newdef PPVDecayer:MaxWeight 4 3.8839
 newdef PPVDecayer:Incoming 5 100311
 newdef PPVDecayer:OutgoingPScalar 5 321
 newdef PPVDecayer:OutgoingVector 5 -213
 newdef PPVDecayer:Coupling 5 1.41
 newdef PPVDecayer:MaxWeight 5 3.92582
 newdef PPVDecayer:Incoming 6 100321
 newdef PPVDecayer:OutgoingPScalar 6 311
 newdef PPVDecayer:OutgoingVector 6 213
 newdef PPVDecayer:Coupling 6 1.41
 newdef PPVDecayer:MaxWeight 6 3.83809
 newdef PPVDecayer:Incoming 7 100311
 newdef PPVDecayer:OutgoingPScalar 7 111
 newdef PPVDecayer:OutgoingVector 7 313
 newdef PPVDecayer:Coupling 7 1.55
 newdef PPVDecayer:MaxWeight 7 1.63383
 newdef PPVDecayer:Incoming 8 100321
 newdef PPVDecayer:OutgoingPScalar 8 111
 newdef PPVDecayer:OutgoingVector 8 323
 newdef PPVDecayer:Coupling 8 1.55
 newdef PPVDecayer:MaxWeight 8 1.64466
 newdef PPVDecayer:Incoming 9 100311
 newdef PPVDecayer:OutgoingPScalar 9 -211
 newdef PPVDecayer:OutgoingVector 9 323
 newdef PPVDecayer:Coupling 9 2.19
 newdef PPVDecayer:MaxWeight 9 1.64501
 newdef PPVDecayer:Incoming 10 100321
 newdef PPVDecayer:OutgoingPScalar 10 211
 newdef PPVDecayer:OutgoingVector 10 313
 newdef PPVDecayer:Coupling 10 2.19
 newdef PPVDecayer:MaxWeight 10 1.61787
 newdef PPVDecayer:Incoming 11 100331
 newdef PPVDecayer:OutgoingPScalar 11 -321
 newdef PPVDecayer:OutgoingVector 11 323
 newdef PPVDecayer:Coupling 11 2.92
 newdef PPVDecayer:MaxWeight 11 4.09876
 newdef PPVDecayer:Incoming 12 100331
 newdef PPVDecayer:OutgoingPScalar 12 -311
 newdef PPVDecayer:OutgoingVector 12 313
 newdef PPVDecayer:Coupling 12 2.92
 newdef PPVDecayer:MaxWeight 12 3.68371
 newdef PPVDecayer:Incoming 13 9020221
 newdef PPVDecayer:OutgoingPScalar 13 -321
 newdef PPVDecayer:OutgoingVector 13 323
 newdef PPVDecayer:Coupling 13 0.956
 newdef PPVDecayer:MaxWeight 13 4.40423
 newdef PPVDecayer:Incoming 14 9020221
 newdef PPVDecayer:OutgoingPScalar 14 -311
 newdef PPVDecayer:OutgoingVector 14 313
 newdef PPVDecayer:Coupling 14 0.956
 newdef PPVDecayer:MaxWeight 14 3.48178
 newdef PPVDecayer:Incoming 15 10221
 newdef PPVDecayer:OutgoingPScalar 15 -211
 newdef PPVDecayer:OutgoingVector 15 20213
 newdef PPVDecayer:Coupling 15 2.68
 newdef PPVDecayer:MaxWeight 15 3.30881
 newdef PPVDecayer:Incoming 16 10221
 newdef PPVDecayer:OutgoingPScalar 16 111
 newdef PPVDecayer:OutgoingVector 16 20113
 newdef PPVDecayer:Coupling 16 2.68
 newdef PPVDecayer:MaxWeight 16 3.42189
 newdef PPVDecayer:Incoming 17 9030221
 newdef PPVDecayer:OutgoingPScalar 17 -211
 newdef PPVDecayer:OutgoingVector 17 20213
 newdef PPVDecayer:Coupling 17 1.147
 newdef PPVDecayer:MaxWeight 17 3.21729
 newdef PPVDecayer:Incoming 18 9030221
 newdef PPVDecayer:OutgoingPScalar 18 111
 newdef PPVDecayer:OutgoingVector 18 20113
 newdef PPVDecayer:Coupling 18 1.147
 newdef PPVDecayer:MaxWeight 18 3.28207
 #
 create Herwig::QuarkoniumDecayer  QDecayME0
 newdef  QDecayME0:PartonSplitter /Herwig/Hadronization/PartonSplitter
 newdef  QDecayME0:ClusterFinder /Herwig/Hadronization/ClusterFinder
 newdef  QDecayME0:ClusterFissioner /Herwig/Hadronization/ClusterFissioner
 newdef  QDecayME0:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer
 newdef  QDecayME0:ClusterDecayer /Herwig/Hadronization/ClusterDecayer
 newdef  QDecayME0:PartnerFinder      /Herwig/Shower/PartnerFinder
 newdef  QDecayME0:SplittingGenerator /Herwig/Shower/SplittingGenerator
 newdef  QDecayME0:KinematicsReconstructor /Herwig/Shower/KinematicsReconstructor
 newdef  QDecayME0:Shower Yes
 newdef  QDecayME0:Exclusive 1 
 newdef  QDecayME0:Intermediates 0 
 newdef  QDecayME0:Partonic_Tries 100 
 newdef QDecayME0:MECode 0 
 #
 create Herwig::QuarkoniumDecayer  QDecayME130
 newdef  QDecayME130:PartonSplitter /Herwig/Hadronization/PartonSplitter 
 newdef  QDecayME130:ClusterFinder /Herwig/Hadronization/ClusterFinder 
 newdef  QDecayME130:ClusterFissioner /Herwig/Hadronization/ClusterFissioner 
 newdef  QDecayME130:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer 
 newdef  QDecayME130:ClusterDecayer /Herwig/Hadronization/ClusterDecayer 
 newdef  QDecayME130:PartnerFinder      /Herwig/Shower/PartnerFinder
 newdef  QDecayME130:SplittingGenerator /Herwig/Shower/SplittingGenerator
 newdef  QDecayME130:KinematicsReconstructor /Herwig/Shower/KinematicsReconstructor
 newdef  QDecayME130:Shower Yes
 newdef  QDecayME130:Exclusive 1 
 newdef  QDecayME130:Intermediates 0 
 newdef  QDecayME130:Partonic_Tries 100 
 newdef QDecayME130:MECode 130 
 #
 create Herwig::VectorMesonVectorScalarDecayer  VVSDecayer
 newdef VVSDecayer:Iteration 1
 newdef VVSDecayer:Ntry 500
 newdef VVSDecayer:Points 10000
 newdef VVSDecayer:GenerateIntermediates 0
 newdef VVSDecayer:Incoming 0 333
 newdef VVSDecayer:OutgoingVector 0 22
 newdef VVSDecayer:OutgoingScalar 0 9000111
 newdef VVSDecayer:Coupling 0 0.238
 newdef VVSDecayer:MaxWeight 0 9.00936
 newdef VVSDecayer:Incoming 1 333
 newdef VVSDecayer:OutgoingVector 1 22
 newdef VVSDecayer:OutgoingScalar 1 9010221
 newdef VVSDecayer:Coupling 1 0.267
 newdef VVSDecayer:MaxWeight 1 14.2908
 newdef VVSDecayer:Incoming 2 443
 newdef VVSDecayer:OutgoingVector 2 22
 newdef VVSDecayer:OutgoingScalar 2 10331
 newdef VVSDecayer:Coupling 2 0.00207
 newdef VVSDecayer:MaxWeight 2 2.22552
 newdef VVSDecayer:Incoming 3 443
 newdef VVSDecayer:OutgoingVector 3 223
 newdef VVSDecayer:OutgoingScalar 3 10331
 newdef VVSDecayer:Coupling 3 0.00144
 newdef VVSDecayer:MaxWeight 3 8.11845
 newdef VVSDecayer:Incoming 4 443
 newdef VVSDecayer:OutgoingVector 4 333
 newdef VVSDecayer:OutgoingScalar 4 10331
 newdef VVSDecayer:Coupling 4 0.00127
 newdef VVSDecayer:MaxWeight 4 7.04697
 newdef VVSDecayer:Incoming 5 443
 newdef VVSDecayer:OutgoingVector 5 333
 newdef VVSDecayer:OutgoingScalar 5 9010221
 newdef VVSDecayer:Coupling 5 0.00064
 newdef VVSDecayer:MaxWeight 5 5.78346
 newdef VVSDecayer:Incoming 6 443
 newdef VVSDecayer:OutgoingVector 6 223
 newdef VVSDecayer:OutgoingScalar 6 9010221
 newdef VVSDecayer:Coupling 6 0.00044
 newdef VVSDecayer:MaxWeight 6 6.12632
 newdef VVSDecayer:Incoming 7 100553
 newdef VVSDecayer:OutgoingVector 7 22
 newdef VVSDecayer:OutgoingScalar 7 10551
 newdef VVSDecayer:Coupling 7 0.105
 newdef VVSDecayer:MaxWeight 7 1.84492
 newdef VVSDecayer:Incoming 8 200553
 newdef VVSDecayer:OutgoingVector 8 22
 newdef VVSDecayer:OutgoingScalar 8 110551
 newdef VVSDecayer:Coupling 8 0.16
 newdef VVSDecayer:MaxWeight 8 1.95828
 newdef VVSDecayer:Incoming 9 100443
 newdef VVSDecayer:OutgoingVector 9 22
 newdef VVSDecayer:OutgoingScalar 9 10441
 newdef VVSDecayer:Coupling 9 0.258
 newdef VVSDecayer:MaxWeight 9 3.80961
 newdef VVSDecayer:Incoming 10 100443
 newdef VVSDecayer:OutgoingVector 10 22
 newdef VVSDecayer:OutgoingScalar 10 331
 newdef VVSDecayer:Coupling 10 0.0508
 newdef VVSDecayer:MaxWeight 10 1.64121
 newdef VVSDecayer:Incoming 11 100443
 newdef VVSDecayer:OutgoingVector 11 22
 newdef VVSDecayer:OutgoingScalar 11 10331
 newdef VVSDecayer:Coupling 11 0.00068
 newdef VVSDecayer:MaxWeight 11 1.8543
 newdef VVSDecayer:Incoming 12 100443
 newdef VVSDecayer:OutgoingVector 12 333
 newdef VVSDecayer:OutgoingScalar 12 9010221
 newdef VVSDecayer:Coupling 12 0.000509
 newdef VVSDecayer:MaxWeight 12 5.66804
 newdef VVSDecayer:Incoming 13 100213
 newdef VVSDecayer:OutgoingVector 13 213
 newdef VVSDecayer:OutgoingScalar 13 9000221
 newdef VVSDecayer:Coupling 13 5.056
 newdef VVSDecayer:MaxWeight 13 4.95975
 newdef VVSDecayer:Incoming 14 100113
 newdef VVSDecayer:OutgoingVector 14 113
 newdef VVSDecayer:OutgoingScalar 14 9000221
 newdef VVSDecayer:Coupling 14 5.056
 newdef VVSDecayer:MaxWeight 14 5.10698
 newdef VVSDecayer:Incoming 15 443
 newdef VVSDecayer:OutgoingVector 15 22
 newdef VVSDecayer:OutgoingScalar 15 9030221
 newdef VVSDecayer:Coupling 15 0.00114
 newdef VVSDecayer:MaxWeight 15 2.8072
 #
 create Herwig::VectorMesonPVectorPScalarDecayer  VAPDecayer
 newdef VAPDecayer:Iteration 1
 newdef VAPDecayer:Ntry 1500
 newdef VAPDecayer:Points 10000
 newdef VAPDecayer:GenerateIntermediates 0
 newdef VAPDecayer:Incoming 0 443
 newdef VAPDecayer:OutgoingPVector 0 20313
 newdef VAPDecayer:OutgoingPScalar 0 -311
 newdef VAPDecayer:Coupling 0 0.00127
 newdef VAPDecayer:MaxWeight 0 3.57449
 newdef VAPDecayer:Incoming 1 443
 newdef VAPDecayer:OutgoingPVector 1 20323
 newdef VAPDecayer:OutgoingPScalar 1 -321
 newdef VAPDecayer:Coupling 1 0.00127
 newdef VAPDecayer:MaxWeight 1 3.58
 newdef VAPDecayer:Incoming 2 443
 newdef VAPDecayer:OutgoingPVector 2 10213
 newdef VAPDecayer:OutgoingPScalar 2 -211
 newdef VAPDecayer:Coupling 2 0.00106
 newdef VAPDecayer:MaxWeight 2 7.98666
 newdef VAPDecayer:Incoming 3 443
 newdef VAPDecayer:OutgoingPVector 3 10113
 newdef VAPDecayer:OutgoingPScalar 3 111
 newdef VAPDecayer:Coupling 3 0.00106
 newdef VAPDecayer:MaxWeight 3 8.01101
 newdef VAPDecayer:Incoming 4 100443
 newdef VAPDecayer:OutgoingPVector 4 10313
 newdef VAPDecayer:OutgoingPScalar 4 -311
 newdef VAPDecayer:Coupling 4 0.00152
 newdef VAPDecayer:MaxWeight 4 3.70225
 newdef VAPDecayer:Incoming 5 100443
 newdef VAPDecayer:OutgoingPVector 5 10323
 newdef VAPDecayer:OutgoingPScalar 5 -321
 newdef VAPDecayer:Coupling 5 0.00152
 newdef VAPDecayer:MaxWeight 5 4.09967
 newdef VAPDecayer:Incoming 6 100443
 newdef VAPDecayer:OutgoingPVector 6 10213
 newdef VAPDecayer:OutgoingPScalar 6 -211
 newdef VAPDecayer:Coupling 6 0.000694
 newdef VAPDecayer:MaxWeight 6 8.30558
 newdef VAPDecayer:Incoming 7 100443
 newdef VAPDecayer:OutgoingPVector 7 10113
 newdef VAPDecayer:OutgoingPScalar 7 111
 newdef VAPDecayer:Coupling 7 0.000694
 newdef VAPDecayer:MaxWeight 7 8.31092
 newdef VAPDecayer:Incoming 8 30213
 newdef VAPDecayer:OutgoingPVector 8 10223
 newdef VAPDecayer:OutgoingPScalar 8 211
 newdef VAPDecayer:Coupling 8 1.45
 newdef VAPDecayer:MaxWeight 8 2.82326
 newdef VAPDecayer:Incoming 9 30113
 newdef VAPDecayer:OutgoingPVector 9 10223
 newdef VAPDecayer:OutgoingPScalar 9 111
 newdef VAPDecayer:Coupling 9 1.45
 newdef VAPDecayer:MaxWeight 9 2.83643
 newdef VAPDecayer:Incoming 10 30213
 newdef VAPDecayer:OutgoingPVector 10 20213
 newdef VAPDecayer:OutgoingPScalar 10 111
 newdef VAPDecayer:Coupling 10 1.09
 newdef VAPDecayer:MaxWeight 10 2.82168
 newdef VAPDecayer:Incoming 11 30213
 newdef VAPDecayer:OutgoingPVector 11 20113
 newdef VAPDecayer:OutgoingPScalar 11 211
 newdef VAPDecayer:Coupling 11 1.09
 newdef VAPDecayer:MaxWeight 11 2.78114
 newdef VAPDecayer:Incoming 12 30113
 newdef VAPDecayer:OutgoingPVector 12 20213
 newdef VAPDecayer:OutgoingPScalar 12 -211
 newdef VAPDecayer:Coupling 12 1.09
 newdef VAPDecayer:MaxWeight 12 2.79808
 newdef VAPDecayer:Incoming 13 100213
 newdef VAPDecayer:OutgoingPVector 13 10223
 newdef VAPDecayer:OutgoingPScalar 13 211
 newdef VAPDecayer:Coupling 13 1.2
 newdef VAPDecayer:MaxWeight 13 2.81029
 newdef VAPDecayer:Incoming 14 100113
 newdef VAPDecayer:OutgoingPVector 14 10223
 newdef VAPDecayer:OutgoingPScalar 14 111
 newdef VAPDecayer:Coupling 14 1.2
 newdef VAPDecayer:MaxWeight 14 2.85301
 newdef VAPDecayer:Incoming 15 100213
 newdef VAPDecayer:OutgoingPVector 15 20213
 newdef VAPDecayer:OutgoingPScalar 15 111
 newdef VAPDecayer:Coupling 15 1.83
 newdef VAPDecayer:MaxWeight 15 2.96886
 newdef VAPDecayer:Incoming 16 100213
 newdef VAPDecayer:OutgoingPVector 16 20113
 newdef VAPDecayer:OutgoingPScalar 16 211
 newdef VAPDecayer:Coupling 16 1.83
 newdef VAPDecayer:MaxWeight 16 2.92035
 newdef VAPDecayer:Incoming 17 100113
 newdef VAPDecayer:OutgoingPVector 17 20213
 newdef VAPDecayer:OutgoingPScalar 17 -211
 newdef VAPDecayer:Coupling 17 1.83
 newdef VAPDecayer:MaxWeight 17 2.92087
 newdef VAPDecayer:Incoming 18 100223
 newdef VAPDecayer:OutgoingPVector 18 10113
 newdef VAPDecayer:OutgoingPScalar 18 111
 newdef VAPDecayer:Coupling 18 1.659
 newdef VAPDecayer:MaxWeight 18 2.55908
 newdef VAPDecayer:Incoming 19 100223
 newdef VAPDecayer:OutgoingPVector 19 10213
 newdef VAPDecayer:OutgoingPScalar 19 -211
 newdef VAPDecayer:Coupling 19 1.659
 newdef VAPDecayer:MaxWeight 19 2.33324
 newdef VAPDecayer:Incoming 20 100443
 newdef VAPDecayer:OutgoingPVector 20 10443
 newdef VAPDecayer:OutgoingPScalar 20 111
 newdef VAPDecayer:Coupling 20 0.0029
 newdef VAPDecayer:MaxWeight 20 1.86135
 #
 create Herwig::HeavyDecayer  HvyDecayME0
 newdef  HvyDecayME0:PartonSplitter /Herwig/Hadronization/PartonSplitter 
 newdef  HvyDecayME0:ClusterFinder /Herwig/Hadronization/ClusterFinder 
 newdef  HvyDecayME0:ClusterFissioner /Herwig/Hadronization/ClusterFissioner 
 newdef  HvyDecayME0:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer 
 newdef  HvyDecayME0:ClusterDecayer /Herwig/Hadronization/ClusterDecayer 
 newdef  HvyDecayME0:Exclusive 1 
 newdef  HvyDecayME0:Intermediates 0 
 newdef  HvyDecayME0:Partonic_Tries 100 
 newdef HvyDecayME0:MECode 0 
 #
 create Herwig::HeavyDecayer  HvyDecayME100
 newdef  HvyDecayME100:PartonSplitter /Herwig/Hadronization/PartonSplitter 
 newdef  HvyDecayME100:ClusterFinder /Herwig/Hadronization/ClusterFinder 
 newdef  HvyDecayME100:ClusterFissioner /Herwig/Hadronization/ClusterFissioner 
 newdef  HvyDecayME100:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer 
 newdef  HvyDecayME100:ClusterDecayer /Herwig/Hadronization/ClusterDecayer 
 newdef  HvyDecayME100:Exclusive 1 
 newdef  HvyDecayME100:Intermediates 0 
 newdef  HvyDecayME100:Partonic_Tries 100 
 newdef HvyDecayME100:MECode 100 
 #
 create Herwig::ScalarMesonTensorScalarDecayer  STSDecayer
 newdef STSDecayer:Iteration 1
 newdef STSDecayer:Ntry 500
 newdef STSDecayer:Points 10000
 newdef STSDecayer:GenerateIntermediates 0
 newdef STSDecayer:Incoming 0 411
 newdef STSDecayer:OutgoingTensor 0 225
 newdef STSDecayer:OutgoingScalar 0 211
 newdef STSDecayer:Coupling 0 8.23e-07
 newdef STSDecayer:MaxWeight 0 0.00242193
 newdef STSDecayer:Incoming 1 10441
 newdef STSDecayer:OutgoingTensor 1 325
 newdef STSDecayer:OutgoingScalar 1 -10321
 newdef STSDecayer:Coupling 1 0.0217
 newdef STSDecayer:MaxWeight 1 4.36393
 newdef STSDecayer:Incoming 2 10441
 newdef STSDecayer:OutgoingTensor 2 315
 newdef STSDecayer:OutgoingScalar 2 -10311
 newdef STSDecayer:Coupling 2 0.0217
 newdef STSDecayer:MaxWeight 2 4.35748
 #
 create Herwig::SemiLeptonicBaryonDecayer  BaryonLight1
 newdef BaryonLight1:Iteration 1
 newdef BaryonLight1:Ntry 500
 newdef BaryonLight1:Points 10000
 newdef BaryonLight1:GenerateIntermediates 0
 insert BaryonLight1:MaximumWeight 0 2.29031
 insert BaryonLight1:MaximumWeight 1 3.98905e-05
 insert BaryonLight1:MaximumWeight 2 0.000122986
 insert BaryonLight1:MaximumWeight 3 4.63043e-10
 insert BaryonLight1:MaximumWeight 4 2.99887e-20
 insert BaryonLight1:MaximumWeight 5 1.02435e-09
 insert BaryonLight1:MaximumWeight 6 0.0037
 insert BaryonLight1:MaximumWeight 7 0.00055
 insert BaryonLight1:MaximumWeight 8 9.60594e-13
 insert BaryonLight1:MaximumWeight 9 3.14573e-13
 insert BaryonLight1:MaximumWeight 10 0.00404325
 insert BaryonLight1:MaximumWeight 11 0.00135948
 insert BaryonLight1:MaximumWeight 12 0.00239575
 insert BaryonLight1:MaximumWeight 13 0.000490015
 insert BaryonLight1:MaximumWeight 14 0.000228
 insert BaryonLight1:MaximumWeight 15 3.58814e-06
 insert BaryonLight1:MaximumWeight 16 0.00075
 insert BaryonLight1:MaximumWeight 17 7.52759e-06
 create Herwig::LeptonNeutrinoCurrent BaryonLight1Current  HwWeakCurrents.so
 newdef BaryonLight1Current:Quark 0  11
 newdef BaryonLight1Current:AntiQuark 0  -12
 newdef BaryonLight1Current:Quark 1  13
 newdef BaryonLight1Current:AntiQuark 1  -15
 newdef BaryonLight1Current:Quark 2  15
 newdef BaryonLight1Current:AntiQuark 2  -16
 newdef BaryonLight1:Current BaryonLight1Current
 create Herwig::LightBaryonQuarkModelFormFactor BaryonLight1Form
 newdef BaryonLight1Form:f1 0  1
 newdef BaryonLight1Form:g1 0  1.25
 newdef BaryonLight1Form:f2 0  1.81
 newdef BaryonLight1Form:g2 0  0
 newdef BaryonLight1Form:Lambdaf1 0  0.69
 newdef BaryonLight1Form:Lambdaf2 0  0.96
 newdef BaryonLight1Form:Lambdag1 0  0.76
 newdef BaryonLight1Form:Lambdag2 0  1.04
 newdef BaryonLight1Form:f1 1  0
 newdef BaryonLight1Form:g1 1  0.6
 newdef BaryonLight1Form:f2 1  1.04
 newdef BaryonLight1Form:g2 1  0
 newdef BaryonLight1Form:Lambdaf1 1  -0.32
 newdef BaryonLight1Form:Lambdaf2 1  -1.72
 newdef BaryonLight1Form:Lambdag1 1  0.77
 newdef BaryonLight1Form:Lambdag2 1  1.05
 newdef BaryonLight1Form:f1 2  0
 newdef BaryonLight1Form:g1 2  0.6
 newdef BaryonLight1Form:f2 2  1.04
 newdef BaryonLight1Form:g2 2  0
 newdef BaryonLight1Form:Lambdaf1 2  -0.32
 newdef BaryonLight1Form:Lambdaf2 2  -1.72
 newdef BaryonLight1Form:Lambdag1 2  0.77
 newdef BaryonLight1Form:Lambdag2 2  1.05
 newdef BaryonLight1Form:f1 3  1.41
 newdef BaryonLight1Form:g1 3  0.69
 newdef BaryonLight1Form:f2 3  0.76
 newdef BaryonLight1Form:g2 3  0
 newdef BaryonLight1Form:Lambdaf1 3  0.6
 newdef BaryonLight1Form:Lambdaf2 3  0.81
 newdef BaryonLight1Form:Lambdag1 3  0.77
 newdef BaryonLight1Form:Lambdag2 3  1.04
 newdef BaryonLight1Form:f1 4  -1.41
 newdef BaryonLight1Form:g1 4  -0.69
 newdef BaryonLight1Form:f2 4  -0.76
 newdef BaryonLight1Form:g2 4  0
 newdef BaryonLight1Form:Lambdaf1 4  0.6
 newdef BaryonLight1Form:Lambdaf2 4  0.81
 newdef BaryonLight1Form:Lambdag1 4  0.77
 newdef BaryonLight1Form:Lambdag2 4  1.04
 newdef BaryonLight1Form:f1 5  -1
 newdef BaryonLight1Form:g1 5  0.24
 newdef BaryonLight1Form:f2 5  0.73
 newdef BaryonLight1Form:g2 5  0
 newdef BaryonLight1Form:Lambdaf1 5  0.56
 newdef BaryonLight1Form:Lambdaf2 5  0.71
 newdef BaryonLight1Form:Lambdag1 5  0.76
 newdef BaryonLight1Form:Lambdag2 5  1.04
 newdef BaryonLight1Form:f1 6  -1.19
 newdef BaryonLight1Form:g1 6  -0.99
 newdef BaryonLight1Form:f2 6  -0.85
 newdef BaryonLight1Form:g2 6  -0.025
 newdef BaryonLight1Form:Lambdaf1 6  0.71
 newdef BaryonLight1Form:Lambdaf2 6  0.98
 newdef BaryonLight1Form:Lambdag1 6  0.81
 newdef BaryonLight1Form:Lambdag2 6  1.12
 newdef BaryonLight1Form:f1 7  -0.69
 newdef BaryonLight1Form:g1 7  0.19
 newdef BaryonLight1Form:f2 7  0.44
 newdef BaryonLight1Form:g2 7  0.0043
 newdef BaryonLight1Form:Lambdaf1 7  0.64
 newdef BaryonLight1Form:Lambdaf2 7  0.84
 newdef BaryonLight1Form:Lambdag1 7  0.83
 newdef BaryonLight1Form:Lambdag2 7  1.16
 newdef BaryonLight1Form:f1 8  -0.97
 newdef BaryonLight1Form:g1 8  0.27
 newdef BaryonLight1Form:f2 8  0.62
 newdef BaryonLight1Form:g2 8  0.0061
 newdef BaryonLight1Form:Lambdaf1 8  0.64
 newdef BaryonLight1Form:Lambdaf2 8  0.9
 newdef BaryonLight1Form:Lambdag1 8  0.83
 newdef BaryonLight1Form:Lambdag2 8  1.16
 newdef BaryonLight1Form:f1 9  1.19
 newdef BaryonLight1Form:g1 9  0.33
 newdef BaryonLight1Form:f2 9  0.07
 newdef BaryonLight1Form:g2 9  0.0076
 newdef BaryonLight1Form:Lambdaf1 9  0.68
 newdef BaryonLight1Form:Lambdaf2 9  0.89
 newdef BaryonLight1Form:Lambdag1 9  0.81
 newdef BaryonLight1Form:Lambdag2 9  1.1
 newdef BaryonLight1Form:f1 10  0.69
 newdef BaryonLight1Form:g1 10  0.94
 newdef BaryonLight1Form:f2 10  0.98
 newdef BaryonLight1Form:g2 10  0.022
 newdef BaryonLight1Form:Lambdaf1 10  0.75
 newdef BaryonLight1Form:Lambdaf2 10  1.05
 newdef BaryonLight1Form:Lambdag1 10  0.81
 newdef BaryonLight1Form:Lambdag2 10  1.12
 newdef BaryonLight1Form:f1 11  0.98
 newdef BaryonLight1Form:g1 11  1.33
 newdef BaryonLight1Form:f2 11  1.38
 newdef BaryonLight1Form:g2 11  0.031
 newdef BaryonLight1Form:Lambdaf1 11  0.75
 newdef BaryonLight1Form:Lambdaf2 11  1.05
 newdef BaryonLight1Form:Lambdag1 11  0.81
 newdef BaryonLight1Form:Lambdag2 11  1.12
 newdef BaryonLight1Form:Incoming 0 2112
 newdef BaryonLight1Form:Outgoing 0 2212
 newdef BaryonLight1Form:InSpin 0 2
 newdef BaryonLight1Form:OutSpin 0 2
 newdef BaryonLight1Form:Spectator1 0 2
 newdef BaryonLight1Form:Spectator2 0 1
 newdef BaryonLight1Form:InQuark 0 1
 newdef BaryonLight1Form:OutQuark 0 2
 newdef BaryonLight1Form:Incoming 1 3222
 newdef BaryonLight1Form:Outgoing 1 3122
 newdef BaryonLight1Form:InSpin 1 2
 newdef BaryonLight1Form:OutSpin 1 2
 newdef BaryonLight1Form:Spectator1 1 3
 newdef BaryonLight1Form:Spectator2 1 2
 newdef BaryonLight1Form:InQuark 1 2
 newdef BaryonLight1Form:OutQuark 1 1
 newdef BaryonLight1Form:Incoming 2 3112
 newdef BaryonLight1Form:Outgoing 2 3122
 newdef BaryonLight1Form:InSpin 2 2
 newdef BaryonLight1Form:OutSpin 2 2
 newdef BaryonLight1Form:Spectator1 2 3
 newdef BaryonLight1Form:Spectator2 2 1
 newdef BaryonLight1Form:InQuark 2 1
 newdef BaryonLight1Form:OutQuark 2 2
 newdef BaryonLight1Form:Incoming 3 3112
 newdef BaryonLight1Form:Outgoing 3 3212
 newdef BaryonLight1Form:InSpin 3 2
 newdef BaryonLight1Form:OutSpin 3 2
 newdef BaryonLight1Form:Spectator1 3 3
 newdef BaryonLight1Form:Spectator2 3 1
 newdef BaryonLight1Form:InQuark 3 1
 newdef BaryonLight1Form:OutQuark 3 2
 newdef BaryonLight1Form:Incoming 4 3212
 newdef BaryonLight1Form:Outgoing 4 3222
 newdef BaryonLight1Form:InSpin 4 2
 newdef BaryonLight1Form:OutSpin 4 2
 newdef BaryonLight1Form:Spectator1 4 3
 newdef BaryonLight1Form:Spectator2 4 2
 newdef BaryonLight1Form:InQuark 4 1
 newdef BaryonLight1Form:OutQuark 4 2
 newdef BaryonLight1Form:Incoming 5 3312
 newdef BaryonLight1Form:Outgoing 5 3322
 newdef BaryonLight1Form:InSpin 5 2
 newdef BaryonLight1Form:OutSpin 5 2
 newdef BaryonLight1Form:Spectator1 5 3
 newdef BaryonLight1Form:Spectator2 5 3
 newdef BaryonLight1Form:InQuark 5 1
 newdef BaryonLight1Form:OutQuark 5 2
 newdef BaryonLight1Form:Incoming 6 3122
 newdef BaryonLight1Form:Outgoing 6 2212
 newdef BaryonLight1Form:InSpin 6 2
 newdef BaryonLight1Form:OutSpin 6 2
 newdef BaryonLight1Form:Spectator1 6 1
 newdef BaryonLight1Form:Spectator2 6 2
 newdef BaryonLight1Form:InQuark 6 3
 newdef BaryonLight1Form:OutQuark 6 2
 newdef BaryonLight1Form:Incoming 7 3212
 newdef BaryonLight1Form:Outgoing 7 2212
 newdef BaryonLight1Form:InSpin 7 2
 newdef BaryonLight1Form:OutSpin 7 2
 newdef BaryonLight1Form:Spectator1 7 2
 newdef BaryonLight1Form:Spectator2 7 1
 newdef BaryonLight1Form:InQuark 7 3
 newdef BaryonLight1Form:OutQuark 7 2
 newdef BaryonLight1Form:Incoming 8 3112
 newdef BaryonLight1Form:Outgoing 8 2112
 newdef BaryonLight1Form:InSpin 8 2
 newdef BaryonLight1Form:OutSpin 8 2
 newdef BaryonLight1Form:Spectator1 8 1
 newdef BaryonLight1Form:Spectator2 8 1
 newdef BaryonLight1Form:InQuark 8 3
 newdef BaryonLight1Form:OutQuark 8 2
 newdef BaryonLight1Form:Incoming 9 3312
 newdef BaryonLight1Form:Outgoing 9 3122
 newdef BaryonLight1Form:InSpin 9 2
 newdef BaryonLight1Form:OutSpin 9 2
 newdef BaryonLight1Form:Spectator1 9 3
 newdef BaryonLight1Form:Spectator2 9 1
 newdef BaryonLight1Form:InQuark 9 3
 newdef BaryonLight1Form:OutQuark 9 2
 newdef BaryonLight1Form:Incoming 10 3312
 newdef BaryonLight1Form:Outgoing 10 3212
 newdef BaryonLight1Form:InSpin 10 2
 newdef BaryonLight1Form:OutSpin 10 2
 newdef BaryonLight1Form:Spectator1 10 3
 newdef BaryonLight1Form:Spectator2 10 1
 newdef BaryonLight1Form:InQuark 10 3
 newdef BaryonLight1Form:OutQuark 10 2
 newdef BaryonLight1Form:Incoming 11 3322
 newdef BaryonLight1Form:Outgoing 11 3222
 newdef BaryonLight1Form:InSpin 11 2
 newdef BaryonLight1Form:OutSpin 11 2
 newdef BaryonLight1Form:Spectator1 11 3
 newdef BaryonLight1Form:Spectator2 11 2
 newdef BaryonLight1Form:InQuark 11 3
 newdef BaryonLight1Form:OutQuark 11 2
 newdef BaryonLight1:FormFactor BaryonLight1Form
 #
 create Herwig::SemiLeptonicBaryonDecayer  BaryonHeavy1
 newdef BaryonHeavy1:Iteration 1
 newdef BaryonHeavy1:Ntry 500
 newdef BaryonHeavy1:Points 10000
 insert BaryonHeavy1:MaximumWeight 0 0.224655
 insert BaryonHeavy1:MaximumWeight 1 0.223647
 insert BaryonHeavy1:MaximumWeight 2 0.0680859
 insert BaryonHeavy1:MaximumWeight 3 0.261028
 insert BaryonHeavy1:MaximumWeight 4 0.259932
 insert BaryonHeavy1:MaximumWeight 5 0.081155
 insert BaryonHeavy1:MaximumWeight 6 0.261825
 insert BaryonHeavy1:MaximumWeight 7 0.260714
 insert BaryonHeavy1:MaximumWeight 8 0.0813646
 insert BaryonHeavy1:MaximumWeight 9 6.31228e-11
 insert BaryonHeavy1:MaximumWeight 10 6.64235e-11
 insert BaryonHeavy1:MaximumWeight 11 1.66042e-11
 insert BaryonHeavy1:MaximumWeight 12 6.40337e-11
 insert BaryonHeavy1:MaximumWeight 13 5.98422e-11
 insert BaryonHeavy1:MaximumWeight 14 1.57092e-11
 insert BaryonHeavy1:MaximumWeight 15 6.19344e-11
 insert BaryonHeavy1:MaximumWeight 16 5.98856e-11
 insert BaryonHeavy1:MaximumWeight 17 1.59245e-11
 insert BaryonHeavy1:MaximumWeight 18 0.116794
 insert BaryonHeavy1:MaximumWeight 19 0.111392
 insert BaryonHeavy1:MaximumWeight 20 0.031394
 insert BaryonHeavy1:MaximumWeight 21 8.71083e-11
 insert BaryonHeavy1:MaximumWeight 22 8.08105e-11
 insert BaryonHeavy1:MaximumWeight 23 2.10457e-11
 insert BaryonHeavy1:MaximumWeight 24 8.60724e-11
 insert BaryonHeavy1:MaximumWeight 25 8.27541e-11
 insert BaryonHeavy1:MaximumWeight 26 2.03931e-11
 insert BaryonHeavy1:MaximumWeight 27 1.07084e-10
 insert BaryonHeavy1:MaximumWeight 28 1.06392e-10
 insert BaryonHeavy1:MaximumWeight 29 2.51075e-11
 insert BaryonHeavy1:MaximumWeight 30 0.164188
 insert BaryonHeavy1:MaximumWeight 31 0.164551
 insert BaryonHeavy1:MaximumWeight 32 0.0460406
 create Herwig::LeptonNeutrinoCurrent BaryonHeavy1Current
 newdef BaryonHeavy1Current:Quark 0  11
 newdef BaryonHeavy1Current:AntiQuark 0  -12
 newdef BaryonHeavy1Current:Quark 1  13
 newdef BaryonHeavy1Current:AntiQuark 1  -15
 newdef BaryonHeavy1Current:Quark 2  15
 newdef BaryonHeavy1Current:AntiQuark 2  -16
 newdef BaryonHeavy1:Current BaryonHeavy1Current
 create Herwig::BaryonThreeQuarkModelFormFactor BaryonHeavy1Form
 newdef BaryonHeavy1Form:Order       50
 newdef BaryonHeavy1Form:LightMass   0.42
 newdef BaryonHeavy1Form:StrangeMass 0.57
 newdef BaryonHeavy1Form:LambdaQ     2.5
 newdef BaryonHeavy1Form:Lambdaqq    0.71
 newdef BaryonHeavy1Form:Lambdasq    0.85
 newdef BaryonHeavy1Form:Lambdass    1
 insert BaryonHeavy1Form:C0 0   0.000375628
 insert BaryonHeavy1Form:C0 1   0.00343009
 insert BaryonHeavy1Form:C0 2   0.0199814
 insert BaryonHeavy1Form:C0 3   0.0917634
 insert BaryonHeavy1Form:C0 4   0.359697
 insert BaryonHeavy1Form:C0 5   1.2551
 insert BaryonHeavy1Form:C0 6   4.00327
 insert BaryonHeavy1Form:C0 7   11.8929
 insert BaryonHeavy1Form:C0 8   33.3858
 insert BaryonHeavy1Form:C0 9   89.612
 insert BaryonHeavy1Form:C0 10   232.335
 insert BaryonHeavy1Form:C0 11   587.125
 insert BaryonHeavy1Form:C0 12   1457.96
 insert BaryonHeavy1Form:C0 13   3583.66
 insert BaryonHeavy1Form:C0 14   8774.68
 insert BaryonHeavy1Form:C0 15   21515.4
 insert BaryonHeavy1Form:C0 16   53045.1
 insert BaryonHeavy1Form:C0 17   131869
 insert BaryonHeavy1Form:C0 18   331096
 insert BaryonHeavy1Form:C0 19   840161
 insert BaryonHeavy1Form:C0 20   2.15444e+06
 insert BaryonHeavy1Form:C0 21   5.57995e+06
 insert BaryonHeavy1Form:C0 22   1.45848e+07
 insert BaryonHeavy1Form:C0 23   3.84373e+07
 insert BaryonHeavy1Form:C0 24   1.0205e+08
 insert BaryonHeavy1Form:C0 25   2.72723e+08
 insert BaryonHeavy1Form:C0 26   7.33119e+08
 insert BaryonHeavy1Form:C0 27   1.98107e+09
 insert BaryonHeavy1Form:C0 28   5.37853e+09
 insert BaryonHeavy1Form:C0 29   1.46646e+10
 insert BaryonHeavy1Form:C0 30   4.01372e+10
 insert BaryonHeavy1Form:C0 31   1.10242e+11
 insert BaryonHeavy1Form:C0 32   3.03769e+11
 insert BaryonHeavy1Form:C0 33   8.39505e+11
 insert BaryonHeavy1Form:C0 34   2.32642e+12
 insert BaryonHeavy1Form:C0 35   6.46325e+12
 insert BaryonHeavy1Form:C0 36   1.79984e+13
 insert BaryonHeavy1Form:C0 37   5.02307e+13
 insert BaryonHeavy1Form:C0 38   1.40473e+14
 insert BaryonHeavy1Form:C0 39   3.93594e+14
 insert BaryonHeavy1Form:C0 40   1.10481e+15
 insert BaryonHeavy1Form:C0 41   3.10643e+15
 insert BaryonHeavy1Form:C0 42   8.74841e+15
 insert BaryonHeavy1Form:C0 43   2.46747e+16
 insert BaryonHeavy1Form:C0 44   6.96937e+16
 insert BaryonHeavy1Form:C0 45   1.97116e+17
 insert BaryonHeavy1Form:C0 46   5.58224e+17
 insert BaryonHeavy1Form:C0 47   1.58279e+18
 insert BaryonHeavy1Form:C0 48   4.49307e+18
 insert BaryonHeavy1Form:C0 49   1.27686e+19
 insert BaryonHeavy1Form:C0 50   3.63244e+19
 insert BaryonHeavy1Form:C0 51   1.58249e-43
 insert BaryonHeavy1Form:C0 52   1.55096e-43
 insert BaryonHeavy1Form:C0 53   7.6833e-42
 insert BaryonHeavy1Form:C0 54   3.77428e-42
 insert BaryonHeavy1Form:C0 55   1.25131e-40
 insert BaryonHeavy1Form:C0 56   4.63466e-41
 insert BaryonHeavy1Form:C0 57   1.23766e-39
 insert BaryonHeavy1Form:C0 58   3.85248e-40
 insert BaryonHeavy1Form:C0 59   8.90842e-39
 insert BaryonHeavy1Form:C0 60   2.45582e-39
 insert BaryonHeavy1Form:C0 61   5.11996e-38
 insert BaryonHeavy1Form:C0 62   1.29144e-38
 insert BaryonHeavy1Form:C0 63   2.4948e-37
 insert BaryonHeavy1Form:C0 64   5.89613e-38
 insert BaryonHeavy1Form:C0 65   1.07799e-36
 insert BaryonHeavy1Form:C0 66   2.43358e-37
 insert BaryonHeavy1Form:C0 67   4.28681e-36
 insert BaryonHeavy1Form:C0 68   9.39947e-37
 insert BaryonHeavy1Form:C0 69   1.62026e-35
 insert BaryonHeavy1Form:C0 70   3.50054e-36
 insert BaryonHeavy1Form:C0 71   5.98256e-35
 insert BaryonHeavy1Form:C0 72   1.28841e-35
 insert BaryonHeavy1Form:C0 73   2.20484e-34
 insert BaryonHeavy1Form:C0 74   4.77162e-35
 insert BaryonHeavy1Form:C0 75   8.22738e-34
 insert BaryonHeavy1Form:C0 76   1.7972e-34
 insert BaryonHeavy1Form:C0 77   3.13098e-33
 insert BaryonHeavy1Form:C0 78   6.91323e-34
 insert BaryonHeavy1Form:C0 79   1.21734e-32
 insert BaryonHeavy1Form:C0 80   2.71581e-33
 insert BaryonHeavy1Form:C0 81   4.82921e-32
 insert BaryonHeavy1Form:C0 82   1.08724e-32
 insert BaryonHeavy1Form:C0 83   1.94969e-31
 insert BaryonHeavy1Form:C0 84   4.42369e-32
 insert BaryonHeavy1Form:C0 85   7.9895e-31
 insert BaryonHeavy1Form:C0 86   1.82466e-31
 insert BaryonHeavy1Form:C0 87   3.31537e-30
 insert BaryonHeavy1Form:C0 88   7.61387e-31
 insert BaryonHeavy1Form:C0 89   1.39053e-29
 insert BaryonHeavy1Form:C0 90   3.20863e-30
 insert BaryonHeavy1Form:C0 91   5.88593e-29
 insert BaryonHeavy1Form:C0 92   1.36377e-29
 insert BaryonHeavy1Form:C0 93   2.51135e-28
 insert BaryonHeavy1Form:C0 94   5.83983e-29
 insert BaryonHeavy1Form:C0 95   1.07904e-27
 insert BaryonHeavy1Form:C0 96   2.51718e-28
 insert BaryonHeavy1Form:C0 97   4.66507e-27
 insert BaryonHeavy1Form:C0 98   1.09136e-27
 insert BaryonHeavy1Form:C0 99   2.02805e-26
 insert BaryonHeavy1Form:C0 100   4.75657e-27
 insert BaryonHeavy1Form:C0 101   8.86043e-26
 insert BaryonHeavy1Form:C1 0   0.000303248
 insert BaryonHeavy1Form:C1 1   0.00283105
 insert BaryonHeavy1Form:C1 2   0.01681
 insert BaryonHeavy1Form:C1 3   0.0785061
 insert BaryonHeavy1Form:C1 4   0.312373
 insert BaryonHeavy1Form:C1 5   1.10482
 insert BaryonHeavy1Form:C1 6   3.56784
 insert BaryonHeavy1Form:C1 7   10.7214
 insert BaryonHeavy1Form:C1 8   30.4204
 insert BaryonHeavy1Form:C1 9   82.4753
 insert BaryonHeavy1Form:C1 10   215.861
 insert BaryonHeavy1Form:C1 11   550.36
 insert BaryonHeavy1Form:C1 12   1378.07
 insert BaryonHeavy1Form:C1 13   3413.44
 insert BaryonHeavy1Form:C1 14   8416.66
 insert BaryonHeavy1Form:C1 15   20767.3
 insert BaryonHeavy1Form:C1 16   51482.6
 insert BaryonHeavy1Form:C1 17   128588
 insert BaryonHeavy1Form:C1 18   324138
 insert BaryonHeavy1Form:C1 19   825199
 insert BaryonHeavy1Form:C1 20   2.12174e+06
 insert BaryonHeavy1Form:C1 21   5.50721e+06
 insert BaryonHeavy1Form:C1 22   1.442e+07
 insert BaryonHeavy1Form:C1 23   3.8058e+07
 insert BaryonHeavy1Form:C1 24   1.01162e+08
 insert BaryonHeavy1Form:C1 25   2.70614e+08
 insert BaryonHeavy1Form:C1 26   7.28045e+08
 insert BaryonHeavy1Form:C1 27   1.96871e+09
 insert BaryonHeavy1Form:C1 28   5.34813e+09
 insert BaryonHeavy1Form:C1 29   1.45891e+10
 insert BaryonHeavy1Form:C1 30   3.99481e+10
 insert BaryonHeavy1Form:C1 31   1.09765e+11
 insert BaryonHeavy1Form:C1 32   3.02556e+11
 insert BaryonHeavy1Form:C1 33   8.36403e+11
 insert BaryonHeavy1Form:C1 34   2.31844e+12
 insert BaryonHeavy1Form:C1 35   6.44261e+12
 insert BaryonHeavy1Form:C1 36   1.79448e+13
 insert BaryonHeavy1Form:C1 37   5.00906e+13
 insert BaryonHeavy1Form:C1 38   1.40106e+14
 insert BaryonHeavy1Form:C1 39   3.92627e+14
 insert BaryonHeavy1Form:C1 40   1.10225e+15
 insert BaryonHeavy1Form:C1 41   3.09965e+15
 insert BaryonHeavy1Form:C1 42   8.73037e+15
 insert BaryonHeavy1Form:C1 43   2.46265e+16
 insert BaryonHeavy1Form:C1 44   6.95648e+16
 insert BaryonHeavy1Form:C1 45   1.9677e+17
 insert BaryonHeavy1Form:C1 46   5.57293e+17
 insert BaryonHeavy1Form:C1 47   1.58028e+18
 insert BaryonHeavy1Form:C1 48   4.48627e+18
 insert BaryonHeavy1Form:C1 49   1.27501e+19
 insert BaryonHeavy1Form:C1 50   3.62743e+19
 insert BaryonHeavy1Form:C1 51   1.33486e-43
 insert BaryonHeavy1Form:C1 52   1.3252e-43
 insert BaryonHeavy1Form:C1 53   6.64089e-42
 insert BaryonHeavy1Form:C1 54   3.29627e-42
 insert BaryonHeavy1Form:C1 55   1.10321e-40
 insert BaryonHeavy1Form:C1 56   4.12175e-41
 insert BaryonHeavy1Form:C1 57   1.10956e-39
 insert BaryonHeavy1Form:C1 58   3.47961e-40
 insert BaryonHeavy1Form:C1 59   8.10273e-39
 insert BaryonHeavy1Form:C1 60   2.24852e-39
 insert BaryonHeavy1Form:C1 61   4.71724e-38
 insert BaryonHeavy1Form:C1 62   1.197e-38
 insert BaryonHeavy1Form:C1 63   2.32564e-37
 insert BaryonHeavy1Form:C1 64   5.52664e-38
 insert BaryonHeavy1Form:C1 65   1.0158e-36
 insert BaryonHeavy1Form:C1 66   2.30489e-37
 insert BaryonHeavy1Form:C1 67   4.07999e-36
 insert BaryonHeavy1Form:C1 68   8.98784e-37
 insert BaryonHeavy1Form:C1 69   1.55618e-35
 insert BaryonHeavy1Form:C1 70   3.37615e-36
 insert BaryonHeavy1Form:C1 71   5.79239e-35
 insert BaryonHeavy1Form:C1 72   1.25191e-35
 insert BaryonHeavy1Form:C1 73   2.14933e-34
 insert BaryonHeavy1Form:C1 74   4.66503e-35
 insert BaryonHeavy1Form:C1 75   8.06432e-34
 insert BaryonHeavy1Form:C1 76   1.76556e-34
 insert BaryonHeavy1Form:C1 77   3.0819e-33
 insert BaryonHeavy1Form:C1 78   6.81643e-34
 insert BaryonHeavy1Form:C1 79   1.20205e-32
 insert BaryonHeavy1Form:C1 80   2.68509e-33
 insert BaryonHeavy1Form:C1 81   4.77975e-32
 insert BaryonHeavy1Form:C1 82   1.07712e-32
 insert BaryonHeavy1Form:C1 83   1.9331e-31
 insert BaryonHeavy1Form:C1 84   4.38918e-32
 insert BaryonHeavy1Form:C1 85   7.93209e-31
 insert BaryonHeavy1Form:C1 86   1.81255e-31
 insert BaryonHeavy1Form:C1 87   3.29495e-30
 insert BaryonHeavy1Form:C1 88   7.57025e-31
 insert BaryonHeavy1Form:C1 89   1.3831e-29
 insert BaryonHeavy1Form:C1 90   3.19259e-30
 insert BaryonHeavy1Form:C1 91   5.85835e-29
 insert BaryonHeavy1Form:C1 92   1.35777e-29
 insert BaryonHeavy1Form:C1 93   2.50095e-28
 insert BaryonHeavy1Form:C1 94   5.81701e-29
 insert BaryonHeavy1Form:C1 95   1.07506e-27
 insert BaryonHeavy1Form:C1 96   2.50838e-28
 insert BaryonHeavy1Form:C1 97   4.64961e-27
 insert BaryonHeavy1Form:C1 98   1.08793e-27
 insert BaryonHeavy1Form:C1 99   2.02198e-26
 insert BaryonHeavy1Form:C1 100   4.74303e-27
 insert BaryonHeavy1Form:C1 101   8.83639e-26
 insert BaryonHeavy1Form:C2 0   5.97614e-05
 insert BaryonHeavy1Form:C2 1   0.000758598
 insert BaryonHeavy1Form:C2 2   0.00548822
 insert BaryonHeavy1Form:C2 3   0.0294731
 insert BaryonHeavy1Form:C2 4   0.13017
 insert BaryonHeavy1Form:C2 5   0.499099
 insert BaryonHeavy1Form:C2 6   1.71799
 insert BaryonHeavy1Form:C2 7   5.43326
 insert BaryonHeavy1Form:C2 8   16.0622
 insert BaryonHeavy1Form:C2 9   45.0003
 insert BaryonHeavy1Form:C2 10   120.858
 insert BaryonHeavy1Form:C2 11   314.271
 insert BaryonHeavy1Form:C2 12   798.245
 insert BaryonHeavy1Form:C2 13   1996.12
 insert BaryonHeavy1Form:C2 14   4948.31
 insert BaryonHeavy1Form:C2 15   12232
 insert BaryonHeavy1Form:C2 16   30294.2
 insert BaryonHeavy1Form:C2 17   75435.4
 insert BaryonHeavy1Form:C2 18   189304
 insert BaryonHeavy1Form:C2 19   479380
 insert BaryonHeavy1Form:C2 20   1.22556e+06
 insert BaryonHeavy1Form:C2 21   3.16273e+06
 insert BaryonHeavy1Form:C2 22   8.23472e+06
 insert BaryonHeavy1Form:C2 23   2.16168e+07
 insert BaryonHeavy1Form:C2 24   5.71691e+07
 insert BaryonHeavy1Form:C2 25   1.52209e+08
 insert BaryonHeavy1Form:C2 26   4.0769e+08
 insert BaryonHeavy1Form:C2 27   1.09792e+09
 insert BaryonHeavy1Form:C2 28   2.97116e+09
 insert BaryonHeavy1Form:C2 29   8.07608e+09
 insert BaryonHeavy1Form:C2 30   2.20403e+10
 insert BaryonHeavy1Form:C2 31   6.03707e+10
 insert BaryonHeavy1Form:C2 32   1.65918e+11
 insert BaryonHeavy1Form:C2 33   4.57408e+11
 insert BaryonHeavy1Form:C2 34   1.2646e+12
 insert BaryonHeavy1Form:C2 35   3.50554e+12
 insert BaryonHeavy1Form:C2 36   9.74144e+12
 insert BaryonHeavy1Form:C2 37   2.71324e+13
 insert BaryonHeavy1Form:C2 38   7.57327e+13
 insert BaryonHeavy1Form:C2 39   2.11812e+14
 insert BaryonHeavy1Form:C2 40   5.93521e+14
 insert BaryonHeavy1Form:C2 41   1.66606e+15
 insert BaryonHeavy1Form:C2 42   4.68459e+15
 insert BaryonHeavy1Form:C2 43   1.31928e+16
 insert BaryonHeavy1Form:C2 44   3.72091e+16
 insert BaryonHeavy1Form:C2 45   1.05093e+17
 insert BaryonHeavy1Form:C2 46   2.97223e+17
 insert BaryonHeavy1Form:C2 47   8.41671e+17
 insert BaryonHeavy1Form:C2 48   2.38631e+18
 insert BaryonHeavy1Form:C2 49   6.7735e+18
 insert BaryonHeavy1Form:C2 50   1.92476e+19
 insert BaryonHeavy1Form:C2 51   1.86707e-44
 insert BaryonHeavy1Form:C2 52   2.5887e-44
 insert BaryonHeavy1Form:C2 53   1.61756e-42
 insert BaryonHeavy1Form:C2 54   9.42145e-43
 insert BaryonHeavy1Form:C2 55   3.56394e-41
 insert BaryonHeavy1Form:C2 56   1.46742e-41
 insert BaryonHeavy1Form:C2 57   4.27536e-40
 insert BaryonHeavy1Form:C2 58   1.43162e-40
 insert BaryonHeavy1Form:C2 59   3.52241e-39
 insert BaryonHeavy1Form:C2 60   1.02417e-39
 insert BaryonHeavy1Form:C2 61   2.23583e-38
 insert BaryonHeavy1Form:C2 62   5.86951e-39
 insert BaryonHeavy1Form:C2 63   1.17394e-37
 insert BaryonHeavy1Form:C2 64   2.85934e-38
 insert BaryonHeavy1Form:C2 65   5.36564e-37
 insert BaryonHeavy1Form:C2 66   1.23864e-37
 insert BaryonHeavy1Form:C2 67   2.22353e-36
 insert BaryonHeavy1Form:C2 68   4.95279e-37
 insert BaryonHeavy1Form:C2 69   8.64771e-36
 insert BaryonHeavy1Form:C2 70   1.88739e-36
 insert BaryonHeavy1Form:C2 71   3.25063e-35
 insert BaryonHeavy1Form:C2 72   7.03967e-36
 insert BaryonHeavy1Form:C2 73   1.20917e-34
 insert BaryonHeavy1Form:C2 74   2.62249e-35
 insert BaryonHeavy1Form:C2 75   4.52583e-34
 insert BaryonHeavy1Form:C2 76   9.88547e-35
 insert BaryonHeavy1Form:C2 77   1.72081e-33
 insert BaryonHeavy1Form:C2 78   3.79455e-34
 insert BaryonHeavy1Form:C2 79   6.67068e-33
 insert BaryonHeavy1Form:C2 80   1.48541e-33
 insert BaryonHeavy1Form:C2 81   2.6361e-32
 insert BaryonHeavy1Form:C2 82   5.92285e-33
 insert BaryonHeavy1Form:C2 83   1.05996e-31
 insert BaryonHeavy1Form:C2 84   2.40017e-32
 insert BaryonHeavy1Form:C2 85   4.32644e-31
 insert BaryonHeavy1Form:C2 86   9.86219e-32
 insert BaryonHeavy1Form:C2 87   1.78867e-30
 insert BaryonHeavy1Form:C2 88   4.10053e-31
 insert BaryonHeavy1Form:C2 89   7.47622e-30
 insert BaryonHeavy1Form:C2 90   1.72232e-30
 insert BaryonHeavy1Form:C2 91   3.15449e-29
 insert BaryonHeavy1Form:C2 92   7.298e-30
 insert BaryonHeavy1Form:C2 93   1.34197e-28
 insert BaryonHeavy1Form:C2 94   3.11625e-29
 insert BaryonHeavy1Form:C2 95   5.7503e-28
 insert BaryonHeavy1Form:C2 96   1.3397e-28
 insert BaryonHeavy1Form:C2 97   2.47979e-27
 insert BaryonHeavy1Form:C2 98   5.79439e-28
 insert BaryonHeavy1Form:C2 99   1.07552e-26
 insert BaryonHeavy1Form:C2 100   2.51974e-27
 insert BaryonHeavy1Form:C2 101   4.6887e-26
 newdef BaryonHeavy1Form:Incoming 0 5122
 newdef BaryonHeavy1Form:Outgoing 0 4122
 newdef BaryonHeavy1Form:InSpin 0 2
 newdef BaryonHeavy1Form:OutSpin 0 2
 newdef BaryonHeavy1Form:Spectator1 0 1
 newdef BaryonHeavy1Form:Spectator2 0 2
 newdef BaryonHeavy1Form:InQuark 0 5
 newdef BaryonHeavy1Form:OutQuark 0 4
 newdef BaryonHeavy1Form:Incoming 1 5232
 newdef BaryonHeavy1Form:Outgoing 1 4232
 newdef BaryonHeavy1Form:InSpin 1 2
 newdef BaryonHeavy1Form:OutSpin 1 2
 newdef BaryonHeavy1Form:Spectator1 1 2
 newdef BaryonHeavy1Form:Spectator2 1 3
 newdef BaryonHeavy1Form:InQuark 1 5
 newdef BaryonHeavy1Form:OutQuark 1 4
 newdef BaryonHeavy1Form:Incoming 2 5132
 newdef BaryonHeavy1Form:Outgoing 2 4132
 newdef BaryonHeavy1Form:InSpin 2 2
 newdef BaryonHeavy1Form:OutSpin 2 2
 newdef BaryonHeavy1Form:Spectator1 2 1
 newdef BaryonHeavy1Form:Spectator2 2 3
 newdef BaryonHeavy1Form:InQuark 2 5
 newdef BaryonHeavy1Form:OutQuark 2 4
 newdef BaryonHeavy1Form:Incoming 3 5112
 newdef BaryonHeavy1Form:Outgoing 3 4112
 newdef BaryonHeavy1Form:InSpin 3 2
 newdef BaryonHeavy1Form:OutSpin 3 2
 newdef BaryonHeavy1Form:Spectator1 3 1
 newdef BaryonHeavy1Form:Spectator2 3 1
 newdef BaryonHeavy1Form:InQuark 3 5
 newdef BaryonHeavy1Form:OutQuark 3 4
 newdef BaryonHeavy1Form:Incoming 4 5212
 newdef BaryonHeavy1Form:Outgoing 4 4212
 newdef BaryonHeavy1Form:InSpin 4 2
 newdef BaryonHeavy1Form:OutSpin 4 2
 newdef BaryonHeavy1Form:Spectator1 4 2
 newdef BaryonHeavy1Form:Spectator2 4 1
 newdef BaryonHeavy1Form:InQuark 4 5
 newdef BaryonHeavy1Form:OutQuark 4 4
 newdef BaryonHeavy1Form:Incoming 5 5222
 newdef BaryonHeavy1Form:Outgoing 5 4222
 newdef BaryonHeavy1Form:InSpin 5 2
 newdef BaryonHeavy1Form:OutSpin 5 2
 newdef BaryonHeavy1Form:Spectator1 5 2
 newdef BaryonHeavy1Form:Spectator2 5 2
 newdef BaryonHeavy1Form:InQuark 5 5
 newdef BaryonHeavy1Form:OutQuark 5 4
 newdef BaryonHeavy1Form:Incoming 6 5332
 newdef BaryonHeavy1Form:Outgoing 6 4332
 newdef BaryonHeavy1Form:InSpin 6 2
 newdef BaryonHeavy1Form:OutSpin 6 2
 newdef BaryonHeavy1Form:Spectator1 6 3
 newdef BaryonHeavy1Form:Spectator2 6 3
 newdef BaryonHeavy1Form:InQuark 6 5
 newdef BaryonHeavy1Form:OutQuark 6 4
 newdef BaryonHeavy1Form:Incoming 7 5112
 newdef BaryonHeavy1Form:Outgoing 7 4114
 newdef BaryonHeavy1Form:InSpin 7 2
 newdef BaryonHeavy1Form:OutSpin 7 4
 newdef BaryonHeavy1Form:Spectator1 7 1
 newdef BaryonHeavy1Form:Spectator2 7 1
 newdef BaryonHeavy1Form:InQuark 7 5
 newdef BaryonHeavy1Form:OutQuark 7 4
 newdef BaryonHeavy1Form:Incoming 8 5212
 newdef BaryonHeavy1Form:Outgoing 8 4214
 newdef BaryonHeavy1Form:InSpin 8 2
 newdef BaryonHeavy1Form:OutSpin 8 4
 newdef BaryonHeavy1Form:Spectator1 8 2
 newdef BaryonHeavy1Form:Spectator2 8 1
 newdef BaryonHeavy1Form:InQuark 8 5
 newdef BaryonHeavy1Form:OutQuark 8 4
 newdef BaryonHeavy1Form:Incoming 9 5222
 newdef BaryonHeavy1Form:Outgoing 9 4224
 newdef BaryonHeavy1Form:InSpin 9 2
 newdef BaryonHeavy1Form:OutSpin 9 4
 newdef BaryonHeavy1Form:Spectator1 9 2
 newdef BaryonHeavy1Form:Spectator2 9 2
 newdef BaryonHeavy1Form:InQuark 9 5
 newdef BaryonHeavy1Form:OutQuark 9 4
 newdef BaryonHeavy1Form:Incoming 10 5332
 newdef BaryonHeavy1Form:Outgoing 10 4334
 newdef BaryonHeavy1Form:InSpin 10 2
 newdef BaryonHeavy1Form:OutSpin 10 4
 newdef BaryonHeavy1Form:Spectator1 10 3
 newdef BaryonHeavy1Form:Spectator2 10 3
 newdef BaryonHeavy1Form:InQuark 10 5
 newdef BaryonHeavy1Form:OutQuark 10 4
 newdef BaryonHeavy1:FormFactor BaryonHeavy1Form
 #
 create Herwig::SemiLeptonicBaryonDecayer  BaryonHeavy2
 newdef BaryonHeavy2:Iteration 1
 newdef BaryonHeavy2:Ntry 500
 newdef BaryonHeavy2:Points 10000
 insert BaryonHeavy2:MaximumWeight 0 0.224529
 insert BaryonHeavy2:MaximumWeight 1 0.220339
 insert BaryonHeavy2:MaximumWeight 2 0.0563864
 insert BaryonHeavy2:MaximumWeight 3 2.99041e-11
 insert BaryonHeavy2:MaximumWeight 4 3.16203e-11
 insert BaryonHeavy2:MaximumWeight 5 5.07564e-12
 insert BaryonHeavy2:MaximumWeight 6 2.20245e-11
 insert BaryonHeavy2:MaximumWeight 7 2.73425e-11
 insert BaryonHeavy2:MaximumWeight 8 4.50209e-12
 insert BaryonHeavy2:MaximumWeight 9 3.83095e-11
 insert BaryonHeavy2:MaximumWeight 10 3.46566e-11
 insert BaryonHeavy2:MaximumWeight 11 6.57251e-12
 insert BaryonHeavy2:MaximumWeight 12 0.266394
 insert BaryonHeavy2:MaximumWeight 13 0.247822
 insert BaryonHeavy2:MaximumWeight 14 0.0409128
 insert BaryonHeavy2:MaximumWeight 15 0.273397
 insert BaryonHeavy2:MaximumWeight 16 0.267639
 insert BaryonHeavy2:MaximumWeight 17 0.0666931
 insert BaryonHeavy2:MaximumWeight 18 0.273754
 insert BaryonHeavy2:MaximumWeight 19 0.268016
 insert BaryonHeavy2:MaximumWeight 20 0.0667733
 insert BaryonHeavy2:MaximumWeight 21 0.100
 insert BaryonHeavy2:MaximumWeight 22 0.098
 insert BaryonHeavy2:MaximumWeight 23 1.72323e-10
 insert BaryonHeavy2:MaximumWeight 24 1.46686e-10
 insert BaryonHeavy2:MaximumWeight 25 1.71899e-10
 insert BaryonHeavy2:MaximumWeight 26 1.45838e-10
 insert BaryonHeavy2:MaximumWeight 27 1.75848e-10
 insert BaryonHeavy2:MaximumWeight 28 1.49537e-10
 insert BaryonHeavy2:MaximumWeight 29 0.164607
 insert BaryonHeavy2:MaximumWeight 30 0.143456
 insert BaryonHeavy2:MaximumWeight 31 0.041659
 insert BaryonHeavy2:MaximumWeight 32 0.0362478
 create Herwig::LeptonNeutrinoCurrent BaryonHeavy2Current  HwWeakCurrents.so
 newdef BaryonHeavy2Current:Quark 0  11
 newdef BaryonHeavy2Current:AntiQuark 0  -12
 newdef BaryonHeavy2Current:Quark 1  13
 newdef BaryonHeavy2Current:AntiQuark 1  -15
 newdef BaryonHeavy2Current:Quark 2  15
 newdef BaryonHeavy2Current:AntiQuark 2  -16
 newdef BaryonHeavy2:Current BaryonHeavy2Current
 create Herwig::SingletonFormFactor BaryonHeavy2Form
 newdef BaryonHeavy2Form:CharmMass 1.8
 newdef BaryonHeavy2Form:StrangeMass 0.51
 newdef BaryonHeavy2Form:ThetaLambda 0.785398
 newdef BaryonHeavy2Form:ThetaSigma 0.785398
 newdef BaryonHeavy2Form:ThetaXi 0.785398
 newdef BaryonHeavy2Form:ThetaXiPrime 0.785398
 newdef BaryonHeavy2Form:PoleMass 0  6
 newdef BaryonHeavy2Form:PoleMass 1  6
 newdef BaryonHeavy2Form:PoleMass 2  6
 newdef BaryonHeavy2Form:PoleMass 3  6
 newdef BaryonHeavy2Form:PoleMass 4  6.4
 newdef BaryonHeavy2Form:PoleMass 5  6
 newdef BaryonHeavy2Form:PoleMass 6  6
 newdef BaryonHeavy2Form:PoleMass 7  2.5
 newdef BaryonHeavy2Form:PoleMass 8  2.8
 newdef BaryonHeavy2Form:PoleMass 9  2.8
 newdef BaryonHeavy2Form:PoleMass 10  2.8
 newdef BaryonHeavy2Form:PoleMass 11  2.8
 newdef BaryonHeavy2Form:PoleMass 12  2.8
 newdef BaryonHeavy2Form:Incoming 0 5122
 newdef BaryonHeavy2Form:Outgoing 0 4122
 newdef BaryonHeavy2Form:InSpin 0 2
 newdef BaryonHeavy2Form:OutSpin 0 2
 newdef BaryonHeavy2Form:Spectator1 0 1
 newdef BaryonHeavy2Form:Spectator2 0 2
 newdef BaryonHeavy2Form:InQuark 0 5
 newdef BaryonHeavy2Form:OutQuark 0 4
 newdef BaryonHeavy2Form:Incoming 1 5112
 newdef BaryonHeavy2Form:Outgoing 1 4112
 newdef BaryonHeavy2Form:InSpin 1 2
 newdef BaryonHeavy2Form:OutSpin 1 2
 newdef BaryonHeavy2Form:Spectator1 1 1
 newdef BaryonHeavy2Form:Spectator2 1 1
 newdef BaryonHeavy2Form:InQuark 1 5
 newdef BaryonHeavy2Form:OutQuark 1 4
 newdef BaryonHeavy2Form:Incoming 2 5212
 newdef BaryonHeavy2Form:Outgoing 2 4212
 newdef BaryonHeavy2Form:InSpin 2 2
 newdef BaryonHeavy2Form:OutSpin 2 2
 newdef BaryonHeavy2Form:Spectator1 2 2
 newdef BaryonHeavy2Form:Spectator2 2 1
 newdef BaryonHeavy2Form:InQuark 2 5
 newdef BaryonHeavy2Form:OutQuark 2 4
 newdef BaryonHeavy2Form:Incoming 3 5222
 newdef BaryonHeavy2Form:Outgoing 3 4222
 newdef BaryonHeavy2Form:InSpin 3 2
 newdef BaryonHeavy2Form:OutSpin 3 2
 newdef BaryonHeavy2Form:Spectator1 3 2
 newdef BaryonHeavy2Form:Spectator2 3 2
 newdef BaryonHeavy2Form:InQuark 3 5
 newdef BaryonHeavy2Form:OutQuark 3 4
 newdef BaryonHeavy2Form:Incoming 4 5332
 newdef BaryonHeavy2Form:Outgoing 4 4332
 newdef BaryonHeavy2Form:InSpin 4 2
 newdef BaryonHeavy2Form:OutSpin 4 2
 newdef BaryonHeavy2Form:Spectator1 4 3
 newdef BaryonHeavy2Form:Spectator2 4 3
 newdef BaryonHeavy2Form:InQuark 4 5
 newdef BaryonHeavy2Form:OutQuark 4 4
 newdef BaryonHeavy2Form:Incoming 5 5232
 newdef BaryonHeavy2Form:Outgoing 5 4232
 newdef BaryonHeavy2Form:InSpin 5 2
 newdef BaryonHeavy2Form:OutSpin 5 2
 newdef BaryonHeavy2Form:Spectator1 5 2
 newdef BaryonHeavy2Form:Spectator2 5 3
 newdef BaryonHeavy2Form:InQuark 5 5
 newdef BaryonHeavy2Form:OutQuark 5 4
 newdef BaryonHeavy2Form:Incoming 6 5132
 newdef BaryonHeavy2Form:Outgoing 6 4132
 newdef BaryonHeavy2Form:InSpin 6 2
 newdef BaryonHeavy2Form:OutSpin 6 2
 newdef BaryonHeavy2Form:Spectator1 6 1
 newdef BaryonHeavy2Form:Spectator2 6 3
 newdef BaryonHeavy2Form:InQuark 6 5
 newdef BaryonHeavy2Form:OutQuark 6 4
 newdef BaryonHeavy2Form:Incoming 7 4122
 newdef BaryonHeavy2Form:Outgoing 7 3122
 newdef BaryonHeavy2Form:InSpin 7 2
 newdef BaryonHeavy2Form:OutSpin 7 2
 newdef BaryonHeavy2Form:Spectator1 7 1
 newdef BaryonHeavy2Form:Spectator2 7 2
 newdef BaryonHeavy2Form:InQuark 7 4
 newdef BaryonHeavy2Form:OutQuark 7 3
 newdef BaryonHeavy2Form:Incoming 8 4112
 newdef BaryonHeavy2Form:Outgoing 8 3112
 newdef BaryonHeavy2Form:InSpin 8 2
 newdef BaryonHeavy2Form:OutSpin 8 2
 newdef BaryonHeavy2Form:Spectator1 8 1
 newdef BaryonHeavy2Form:Spectator2 8 1
 newdef BaryonHeavy2Form:InQuark 8 4
 newdef BaryonHeavy2Form:OutQuark 8 3
 newdef BaryonHeavy2Form:Incoming 9 4212
 newdef BaryonHeavy2Form:Outgoing 9 3212
 newdef BaryonHeavy2Form:InSpin 9 2
 newdef BaryonHeavy2Form:OutSpin 9 2
 newdef BaryonHeavy2Form:Spectator1 9 2
 newdef BaryonHeavy2Form:Spectator2 9 1
 newdef BaryonHeavy2Form:InQuark 9 4
 newdef BaryonHeavy2Form:OutQuark 9 3
 newdef BaryonHeavy2Form:Incoming 10 4222
 newdef BaryonHeavy2Form:Outgoing 10 3222
 newdef BaryonHeavy2Form:InSpin 10 2
 newdef BaryonHeavy2Form:OutSpin 10 2
 newdef BaryonHeavy2Form:Spectator1 10 2
 newdef BaryonHeavy2Form:Spectator2 10 2
 newdef BaryonHeavy2Form:InQuark 10 4
 newdef BaryonHeavy2Form:OutQuark 10 3
 newdef BaryonHeavy2Form:Incoming 11 4232
 newdef BaryonHeavy2Form:Outgoing 11 3322
 newdef BaryonHeavy2Form:InSpin 11 2
 newdef BaryonHeavy2Form:OutSpin 11 2
 newdef BaryonHeavy2Form:Spectator1 11 2
 newdef BaryonHeavy2Form:Spectator2 11 3
 newdef BaryonHeavy2Form:InQuark 11 4
 newdef BaryonHeavy2Form:OutQuark 11 3
 newdef BaryonHeavy2Form:Incoming 12 4132
 newdef BaryonHeavy2Form:Outgoing 12 3312
 newdef BaryonHeavy2Form:InSpin 12 2
 newdef BaryonHeavy2Form:OutSpin 12 2
 newdef BaryonHeavy2Form:Spectator1 12 1
 newdef BaryonHeavy2Form:Spectator2 12 3
 newdef BaryonHeavy2Form:InQuark 12 4
 newdef BaryonHeavy2Form:OutQuark 12 3
 newdef BaryonHeavy2:FormFactor BaryonHeavy2Form
 #
 create Herwig::KornerKramerCharmDecayer  CharmBaryon1
 newdef CharmBaryon1:Iteration 1
 newdef CharmBaryon1:Ntry 500
 newdef CharmBaryon1:Points 10000
 newdef CharmBaryon1:GenerateIntermediates 0
 newdef CharmBaryon1:OneOverNc 0
 newdef CharmBaryon1:Fpi 131.7
 newdef CharmBaryon1:FK 160.6
 newdef CharmBaryon1:Frho 0.272
 newdef CharmBaryon1:fKstar 0.238
 newdef CharmBaryon1:Mdcplus 2.42
 newdef CharmBaryon1:Mscplus 2.54
 newdef CharmBaryon1:Mdcminus 2.01
 newdef CharmBaryon1:Mscminus 2.11
 newdef CharmBaryon1:Cplus 0.73
 newdef CharmBaryon1:Cminus 1.9
 newdef CharmBaryon1:H2 0.119
 newdef CharmBaryon1:H3 -0.011
 newdef CharmBaryon1:I1 0 -0.333333
 newdef CharmBaryon1:I2 0 -0.333333
 newdef CharmBaryon1:I3 0 -0.333333
 newdef CharmBaryon1:I4 0 0.666667
 newdef CharmBaryon1:I5 0 0.166667
 newdef CharmBaryon1:Ihat3 0 -0.333333
 newdef CharmBaryon1:Ihat4 0 0.666667
 newdef CharmBaryon1:Incoming 0 4122
 newdef CharmBaryon1:OutgoingB 0 3122
 newdef CharmBaryon1:OutgoingM 0 211
 newdef CharmBaryon1:MaxWeight 0 0.0131
 newdef CharmBaryon1:I1 1 0
 newdef CharmBaryon1:I2 1 0
 newdef CharmBaryon1:I3 1 -0.57735
 newdef CharmBaryon1:I4 1 0
 newdef CharmBaryon1:I5 1 -0.288675
 newdef CharmBaryon1:Ihat3 1 0.57735
 newdef CharmBaryon1:Ihat4 1 -1.1547
 newdef CharmBaryon1:Incoming 1 4122
 newdef CharmBaryon1:OutgoingB 1 3212
 newdef CharmBaryon1:OutgoingM 1 211
 newdef CharmBaryon1:MaxWeight 1 0.00585
 newdef CharmBaryon1:I1 2 0
 newdef CharmBaryon1:I2 2 0
 newdef CharmBaryon1:I3 2 0.57735
 newdef CharmBaryon1:I4 2 0
 newdef CharmBaryon1:I5 2 0.288675
 newdef CharmBaryon1:Ihat3 2 -0.57735
 newdef CharmBaryon1:Ihat4 2 1.1547
 newdef CharmBaryon1:Incoming 2 4122
 newdef CharmBaryon1:OutgoingB 2 3222
 newdef CharmBaryon1:OutgoingM 2 111
 newdef CharmBaryon1:MaxWeight 2 0.0059
 newdef CharmBaryon1:I1 3 0
 newdef CharmBaryon1:I2 3 0
 newdef CharmBaryon1:I3 3 -0.169102
 newdef CharmBaryon1:I4 3 0.57735
 newdef CharmBaryon1:I5 3 0.204124
 newdef CharmBaryon1:Ihat3 3 0.408248
 newdef CharmBaryon1:Ihat4 3 -0.816497
 newdef CharmBaryon1:Incoming 3 4122
 newdef CharmBaryon1:OutgoingB 3 3222
 newdef CharmBaryon1:OutgoingM 3 221
 newdef CharmBaryon1:MaxWeight 3 0.00247881
 newdef CharmBaryon1:I1 4 0
 newdef CharmBaryon1:I2 4 0
 newdef CharmBaryon1:I3 4 0.985599
 newdef CharmBaryon1:I4 4 -0.57735
 newdef CharmBaryon1:I5 4 0.204124
 newdef CharmBaryon1:Ihat3 4 0.408248
 newdef CharmBaryon1:Ihat4 4 -0.816497
 newdef CharmBaryon1:Incoming 4 4122
 newdef CharmBaryon1:OutgoingB 4 3222
 newdef CharmBaryon1:OutgoingM 4 331
 newdef CharmBaryon1:MaxWeight 4 0.0215345
 newdef CharmBaryon1:I1 5 -0.408248
 newdef CharmBaryon1:I2 5 -0.408248
 newdef CharmBaryon1:I3 5 -0.816497
 newdef CharmBaryon1:I4 5 0.816497
 newdef CharmBaryon1:I5 5 0
 newdef CharmBaryon1:Ihat3 5 0
 newdef CharmBaryon1:Ihat4 5 0
 newdef CharmBaryon1:Incoming 5 4122
 newdef CharmBaryon1:OutgoingB 5 2212
 newdef CharmBaryon1:OutgoingM 5 -311
 newdef CharmBaryon1:MaxWeight 5 0.045
 newdef CharmBaryon1:I1 6 0
 newdef CharmBaryon1:I2 6 0
 newdef CharmBaryon1:I3 6 0
 newdef CharmBaryon1:I4 6 0.816497
 newdef CharmBaryon1:I5 6 0.408248
 newdef CharmBaryon1:Ihat3 6 0
 newdef CharmBaryon1:Ihat4 6 0
 newdef CharmBaryon1:Incoming 6 4122
 newdef CharmBaryon1:OutgoingB 6 3322
 newdef CharmBaryon1:OutgoingM 6 321
 newdef CharmBaryon1:MaxWeight 6 0.00427652
 newdef CharmBaryon1:I1 7 -0.408248
 newdef CharmBaryon1:I2 7 -0.408248
 newdef CharmBaryon1:I3 7 0
 newdef CharmBaryon1:I4 7 0
 newdef CharmBaryon1:I5 7 0
 newdef CharmBaryon1:Ihat3 7 -0.816497
 newdef CharmBaryon1:Ihat4 7 1.63299
 newdef CharmBaryon1:Incoming 7 4232
 newdef CharmBaryon1:OutgoingB 7 3222
 newdef CharmBaryon1:OutgoingM 7 -311
 newdef CharmBaryon1:MaxWeight 7 0.136
 newdef CharmBaryon1:I1 8 0.408248
 newdef CharmBaryon1:I2 8 0.408248
 newdef CharmBaryon1:I3 8 0
 newdef CharmBaryon1:I4 8 0
 newdef CharmBaryon1:I5 8 0
 newdef CharmBaryon1:Ihat3 8 0.816497
 newdef CharmBaryon1:Ihat4 8 -1.63299
 newdef CharmBaryon1:Incoming 8 4232
 newdef CharmBaryon1:OutgoingB 8 3322
 newdef CharmBaryon1:OutgoingM 8 211
 newdef CharmBaryon1:MaxWeight 8 0.067
 newdef CharmBaryon1:I1 9 0.166667
 newdef CharmBaryon1:I2 9 0.166667
 newdef CharmBaryon1:I3 9 0.666667
 newdef CharmBaryon1:I4 9 -0.333333
 newdef CharmBaryon1:I5 9 0.166667
 newdef CharmBaryon1:Ihat3 9 -0.333333
 newdef CharmBaryon1:Ihat4 9 0.666667
 newdef CharmBaryon1:Incoming 9 4132
 newdef CharmBaryon1:OutgoingB 9 3122
 newdef CharmBaryon1:OutgoingM 9 -311
 newdef CharmBaryon1:MaxWeight 9 0.0023
 newdef CharmBaryon1:I1 10 0.288675
 newdef CharmBaryon1:I2 10 0.288675
 newdef CharmBaryon1:I3 10 0
 newdef CharmBaryon1:I4 10 -0.57735
 newdef CharmBaryon1:I5 10 -0.288675
 newdef CharmBaryon1:Ihat3 10 0.57735
 newdef CharmBaryon1:Ihat4 10 -1.1547
 newdef CharmBaryon1:Incoming 10 4132
 newdef CharmBaryon1:OutgoingB 10 3212
 newdef CharmBaryon1:OutgoingM 10 -311
 newdef CharmBaryon1:MaxWeight 10 0.025
 newdef CharmBaryon1:I1 11 0
 newdef CharmBaryon1:I2 11 0
 newdef CharmBaryon1:I3 11 0
 newdef CharmBaryon1:I4 11 0.816497
 newdef CharmBaryon1:I5 11 0.408248
 newdef CharmBaryon1:Ihat3 11 0
 newdef CharmBaryon1:Ihat4 11 0
 newdef CharmBaryon1:Incoming 11 4132
 newdef CharmBaryon1:OutgoingB 11 3222
 newdef CharmBaryon1:OutgoingM 11 -321
 newdef CharmBaryon1:MaxWeight 11 0.00201135
 newdef CharmBaryon1:I1 12 0
 newdef CharmBaryon1:I2 12 0
 newdef CharmBaryon1:I3 12 0.57735
 newdef CharmBaryon1:I4 12 -0.57735
 newdef CharmBaryon1:I5 12 0
 newdef CharmBaryon1:Ihat3 12 -0.57735
 newdef CharmBaryon1:Ihat4 12 1.1547
 newdef CharmBaryon1:Incoming 12 4132
 newdef CharmBaryon1:OutgoingB 12 3322
 newdef CharmBaryon1:OutgoingM 12 111
 newdef CharmBaryon1:MaxWeight 12 0.00075
 newdef CharmBaryon1:I1 13 0
 newdef CharmBaryon1:I2 13 0
 newdef CharmBaryon1:I3 13 -0.169102
 newdef CharmBaryon1:I4 13 -0.408248
 newdef CharmBaryon1:I5 13 -0.288675
 newdef CharmBaryon1:Ihat3 13 0.408248
 newdef CharmBaryon1:Ihat4 13 -0.816497
 newdef CharmBaryon1:Incoming 13 4132
 newdef CharmBaryon1:OutgoingB 13 3322
 newdef CharmBaryon1:OutgoingM 13 221
 newdef CharmBaryon1:MaxWeight 13 0.0048
 newdef CharmBaryon1:I1 14 0
 newdef CharmBaryon1:I2 14 0
 newdef CharmBaryon1:I3 14 0.985599
 newdef CharmBaryon1:I4 14 -0.408248
 newdef CharmBaryon1:I5 14 0.288675
 newdef CharmBaryon1:Ihat3 14 0.408248
 newdef CharmBaryon1:Ihat4 14 -0.816497
 newdef CharmBaryon1:Incoming 14 4132
 newdef CharmBaryon1:OutgoingB 14 3322
 newdef CharmBaryon1:OutgoingM 14 331
 newdef CharmBaryon1:MaxWeight 14 0.0142804
 newdef CharmBaryon1:I1 15 -0.408248
 newdef CharmBaryon1:I2 15 -0.408248
 newdef CharmBaryon1:I3 15 -0.816497
 newdef CharmBaryon1:I4 15 0.816497
 newdef CharmBaryon1:I5 15 0
 newdef CharmBaryon1:Ihat3 15 0
 newdef CharmBaryon1:Ihat4 15 0
 newdef CharmBaryon1:Incoming 15 4132
 newdef CharmBaryon1:OutgoingB 15 3312
 newdef CharmBaryon1:OutgoingM 15 211
 newdef CharmBaryon1:MaxWeight 15 0.0176031
 newdef CharmBaryon1:I1 16 1
 newdef CharmBaryon1:I2 16 -1
 newdef CharmBaryon1:I3 16 0
 newdef CharmBaryon1:I4 16 0
 newdef CharmBaryon1:I5 16 0
 newdef CharmBaryon1:Ihat3 16 2
 newdef CharmBaryon1:Ihat4 16 0
 newdef CharmBaryon1:Incoming 16 4332
 newdef CharmBaryon1:OutgoingB 16 3322
 newdef CharmBaryon1:OutgoingM 16 -311
 newdef CharmBaryon1:MaxWeight 16 0.0200215
 newdef CharmBaryon1:I1 17 -0.333333
 newdef CharmBaryon1:I2 17 -0.333333
 newdef CharmBaryon1:I3 17 -0.333333
 newdef CharmBaryon1:I4 17 0.666667
 newdef CharmBaryon1:I5 17 0.166667
 newdef CharmBaryon1:Ihat3 17 -0.333333
 newdef CharmBaryon1:Ihat4 17 0.666667
 newdef CharmBaryon1:Incoming 17 4122
 newdef CharmBaryon1:OutgoingB 17 3122
 newdef CharmBaryon1:OutgoingM 17 213
 newdef CharmBaryon1:MaxWeight 17 0.41
 newdef CharmBaryon1:I1 18 0
 newdef CharmBaryon1:I2 18 0
 newdef CharmBaryon1:I3 18 -0.57735
 newdef CharmBaryon1:I4 18 0
 newdef CharmBaryon1:I5 18 -0.288675
 newdef CharmBaryon1:Ihat3 18 0.57735
 newdef CharmBaryon1:Ihat4 18 -1.1547
 newdef CharmBaryon1:Incoming 18 4122
 newdef CharmBaryon1:OutgoingB 18 3212
 newdef CharmBaryon1:OutgoingM 18 213
 newdef CharmBaryon1:MaxWeight 18 0.0554171
 newdef CharmBaryon1:I1 19 0
 newdef CharmBaryon1:I2 19 0
 newdef CharmBaryon1:I3 19 0.57735
 newdef CharmBaryon1:I4 19 0
 newdef CharmBaryon1:I5 19 0.288675
 newdef CharmBaryon1:Ihat3 19 -0.57735
 newdef CharmBaryon1:Ihat4 19 1.1547
 newdef CharmBaryon1:Incoming 19 4122
 newdef CharmBaryon1:OutgoingB 19 3222
 newdef CharmBaryon1:OutgoingM 19 113
 newdef CharmBaryon1:MaxWeight 19 0.0550436
 newdef CharmBaryon1:I1 20 0
 newdef CharmBaryon1:I2 20 0
 newdef CharmBaryon1:I3 20 0.57735
 newdef CharmBaryon1:I4 20 0
 newdef CharmBaryon1:I5 20 0.288675
 newdef CharmBaryon1:Ihat3 20 0.57735
 newdef CharmBaryon1:Ihat4 20 -1.1547
 newdef CharmBaryon1:Incoming 20 4122
 newdef CharmBaryon1:OutgoingB 20 3222
 newdef CharmBaryon1:OutgoingM 20 223
 newdef CharmBaryon1:MaxWeight 20 0.201805
 newdef CharmBaryon1:I1 21 0
 newdef CharmBaryon1:I2 21 0
 newdef CharmBaryon1:I3 21 0.816497
 newdef CharmBaryon1:I4 21 -0.816497
 newdef CharmBaryon1:I5 21 0
 newdef CharmBaryon1:Ihat3 21 0
 newdef CharmBaryon1:Ihat4 21 0
 newdef CharmBaryon1:Incoming 21 4122
 newdef CharmBaryon1:OutgoingB 21 3222
 newdef CharmBaryon1:OutgoingM 21 333
 newdef CharmBaryon1:MaxWeight 21 0.00524444
 newdef CharmBaryon1:I1 22 -0.408248
 newdef CharmBaryon1:I2 22 -0.408248
 newdef CharmBaryon1:I3 22 -0.816497
 newdef CharmBaryon1:I4 22 0.816497
 newdef CharmBaryon1:I5 22 0
 newdef CharmBaryon1:Ihat3 22 0
 newdef CharmBaryon1:Ihat4 22 0
 newdef CharmBaryon1:Incoming 22 4122
 newdef CharmBaryon1:OutgoingB 22 2212
 newdef CharmBaryon1:OutgoingM 22 -313
 newdef CharmBaryon1:MaxWeight 22 0.0798045
 newdef CharmBaryon1:I1 23 0
 newdef CharmBaryon1:I2 23 0
 newdef CharmBaryon1:I3 23 0
 newdef CharmBaryon1:I4 23 0.816497
 newdef CharmBaryon1:I5 23 0.408248
 newdef CharmBaryon1:Ihat3 23 0
 newdef CharmBaryon1:Ihat4 23 0
 newdef CharmBaryon1:Incoming 23 4122
 newdef CharmBaryon1:OutgoingB 23 3322
 newdef CharmBaryon1:OutgoingM 23 323
 newdef CharmBaryon1:MaxWeight 23 0.00335682
 newdef CharmBaryon1:I1 24 -0.408248
 newdef CharmBaryon1:I2 24 -0.408248
 newdef CharmBaryon1:I3 24 0
 newdef CharmBaryon1:I4 24 0
 newdef CharmBaryon1:I5 24 0
 newdef CharmBaryon1:Ihat3 24 -0.816497
 newdef CharmBaryon1:Ihat4 24 1.63299
 newdef CharmBaryon1:Incoming 24 4232
 newdef CharmBaryon1:OutgoingB 24 3222
 newdef CharmBaryon1:OutgoingM 24 -313
 newdef CharmBaryon1:MaxWeight 24 0.0465517
 newdef CharmBaryon1:I1 25 0.408248
 newdef CharmBaryon1:I2 25 0.408248
 newdef CharmBaryon1:I3 25 0
 newdef CharmBaryon1:I4 25 0
 newdef CharmBaryon1:I5 25 0
 newdef CharmBaryon1:Ihat3 25 0.816497
 newdef CharmBaryon1:Ihat4 25 -1.63299
 newdef CharmBaryon1:Incoming 25 4232
 newdef CharmBaryon1:OutgoingB 25 3322
 newdef CharmBaryon1:OutgoingM 25 213
 newdef CharmBaryon1:MaxWeight 25 1.72674
 newdef CharmBaryon1:I1 26 0.166667
 newdef CharmBaryon1:I2 26 0.166667
 newdef CharmBaryon1:I3 26 0.666667
 newdef CharmBaryon1:I4 26 -0.333333
 newdef CharmBaryon1:I5 26 0.166667
 newdef CharmBaryon1:Ihat3 26 -0.333333
 newdef CharmBaryon1:Ihat4 26 0.666667
 newdef CharmBaryon1:Incoming 26 4132
 newdef CharmBaryon1:OutgoingB 26 3122
 newdef CharmBaryon1:OutgoingM 26 -313
 newdef CharmBaryon1:MaxWeight 26 0.0299461
 newdef CharmBaryon1:I1 27 0.288675
 newdef CharmBaryon1:I2 27 0.288675
 newdef CharmBaryon1:I3 27 0
 newdef CharmBaryon1:I4 27 -0.57735
 newdef CharmBaryon1:I5 27 -0.288675
 newdef CharmBaryon1:Ihat3 27 0.57735
 newdef CharmBaryon1:Ihat4 27 -1.1547
 newdef CharmBaryon1:Incoming 27 4132
 newdef CharmBaryon1:OutgoingB 27 3212
 newdef CharmBaryon1:OutgoingM 27 -313
 newdef CharmBaryon1:MaxWeight 27 0.0108903
 newdef CharmBaryon1:I1 28 0
 newdef CharmBaryon1:I2 28 0
 newdef CharmBaryon1:I3 28 0
 newdef CharmBaryon1:I4 28 0.816497
 newdef CharmBaryon1:I5 28 0.408248
 newdef CharmBaryon1:Ihat3 28 0
 newdef CharmBaryon1:Ihat4 28 0
 newdef CharmBaryon1:Incoming 28 4132
 newdef CharmBaryon1:OutgoingB 28 3222
 newdef CharmBaryon1:OutgoingM 28 -323
 newdef CharmBaryon1:MaxWeight 28 0.0072
 newdef CharmBaryon1:I1 29 0
 newdef CharmBaryon1:I2 29 0
 newdef CharmBaryon1:I3 29 0.57735
 newdef CharmBaryon1:I4 29 -0.57735
 newdef CharmBaryon1:I5 29 0
 newdef CharmBaryon1:Ihat3 29 -0.57735
 newdef CharmBaryon1:Ihat4 29 1.1547
 newdef CharmBaryon1:Incoming 29 4132
 newdef CharmBaryon1:OutgoingB 29 3322
 newdef CharmBaryon1:OutgoingM 29 113
 newdef CharmBaryon1:MaxWeight 29 0.0288654
 newdef CharmBaryon1:I1 30 0
 newdef CharmBaryon1:I2 30 0
 newdef CharmBaryon1:I3 30 0.57735
 newdef CharmBaryon1:I4 30 -0.57735
 newdef CharmBaryon1:I5 30 0
 newdef CharmBaryon1:Ihat3 30 0.57735
 newdef CharmBaryon1:Ihat4 30 -1.1547
 newdef CharmBaryon1:Incoming 30 4132
 newdef CharmBaryon1:OutgoingB 30 3322
 newdef CharmBaryon1:OutgoingM 30 223
 newdef CharmBaryon1:MaxWeight 30 0.12
 newdef CharmBaryon1:I1 31 0
 newdef CharmBaryon1:I2 31 0
 newdef CharmBaryon1:I3 31 0.816497
 newdef CharmBaryon1:I4 31 0
 newdef CharmBaryon1:I5 31 0.408248
 newdef CharmBaryon1:Ihat3 31 0
 newdef CharmBaryon1:Ihat4 31 0
 newdef CharmBaryon1:Incoming 31 4132
 newdef CharmBaryon1:OutgoingB 31 3322
 newdef CharmBaryon1:OutgoingM 31 333
 newdef CharmBaryon1:MaxWeight 31 0.00536368
 newdef CharmBaryon1:I1 32 -0.408248
 newdef CharmBaryon1:I2 32 -0.408248
 newdef CharmBaryon1:I3 32 -0.816497
 newdef CharmBaryon1:I4 32 0.816497
 newdef CharmBaryon1:I5 32 0
 newdef CharmBaryon1:Ihat3 32 0
 newdef CharmBaryon1:Ihat4 32 0
 newdef CharmBaryon1:Incoming 32 4132
 newdef CharmBaryon1:OutgoingB 32 3312
 newdef CharmBaryon1:OutgoingM 32 213
 newdef CharmBaryon1:MaxWeight 32 0.27
 newdef CharmBaryon1:I1 33 1
 newdef CharmBaryon1:I2 33 -1
 newdef CharmBaryon1:I3 33 0
 newdef CharmBaryon1:I4 33 0
 newdef CharmBaryon1:I5 33 0
 newdef CharmBaryon1:Ihat3 33 2
 newdef CharmBaryon1:Ihat4 33 0
 newdef CharmBaryon1:Incoming 33 4332
 newdef CharmBaryon1:OutgoingB 33 3322
 newdef CharmBaryon1:OutgoingM 33 -313
 newdef CharmBaryon1:MaxWeight 33 0.0159979
 newdef CharmBaryon1:I1 34 0
 newdef CharmBaryon1:I2 34 0.333333
 newdef CharmBaryon1:I3 34 0
 newdef CharmBaryon1:I4 34 0
 newdef CharmBaryon1:I5 34 0
 newdef CharmBaryon1:Ihat3 34 0
 newdef CharmBaryon1:Ihat4 34 0
 newdef CharmBaryon1:Incoming 34 4122
 newdef CharmBaryon1:OutgoingB 34 3214
 newdef CharmBaryon1:OutgoingM 34 211
 newdef CharmBaryon1:MaxWeight 34 0.0203127
 newdef CharmBaryon1:I1 35 0
 newdef CharmBaryon1:I2 35 0.333333
 newdef CharmBaryon1:I3 35 0
 newdef CharmBaryon1:I4 35 0
 newdef CharmBaryon1:I5 35 0
 newdef CharmBaryon1:Ihat3 35 0
 newdef CharmBaryon1:Ihat4 35 0
 newdef CharmBaryon1:Incoming 35 4122
 newdef CharmBaryon1:OutgoingB 35 3224
 newdef CharmBaryon1:OutgoingM 35 111
 newdef CharmBaryon1:MaxWeight 35 0.0206847
 newdef CharmBaryon1:I1 36 0
 newdef CharmBaryon1:I2 36 0.569036
 newdef CharmBaryon1:I3 36 0
 newdef CharmBaryon1:I4 36 0
 newdef CharmBaryon1:I5 36 0
 newdef CharmBaryon1:Ihat3 36 0
 newdef CharmBaryon1:Ihat4 36 0
 newdef CharmBaryon1:Incoming 36 4122
 newdef CharmBaryon1:OutgoingB 36 3224
 newdef CharmBaryon1:OutgoingM 36 221
 newdef CharmBaryon1:MaxWeight 36 0.0243183
 newdef CharmBaryon1:I1 37 0
 newdef CharmBaryon1:I2 37 -0.097631
 newdef CharmBaryon1:I3 37 0
 newdef CharmBaryon1:I4 37 0
 newdef CharmBaryon1:I5 37 0
 newdef CharmBaryon1:Ihat3 37 0
 newdef CharmBaryon1:Ihat4 37 0
 newdef CharmBaryon1:Incoming 37 4122
 newdef CharmBaryon1:OutgoingB 37 3224
 newdef CharmBaryon1:OutgoingM 37 331
 newdef CharmBaryon1:MaxWeight 37 3.90584e-07
 newdef CharmBaryon1:I1 38 0
 newdef CharmBaryon1:I2 38 -0.471405
 newdef CharmBaryon1:I3 38 0
 newdef CharmBaryon1:I4 38 0
 newdef CharmBaryon1:I5 38 0
 newdef CharmBaryon1:Ihat3 38 0
 newdef CharmBaryon1:Ihat4 38 0
 newdef CharmBaryon1:Incoming 38 4122
 newdef CharmBaryon1:OutgoingB 38 2214
 newdef CharmBaryon1:OutgoingM 38 -311
 newdef CharmBaryon1:MaxWeight 38 0.0172628
 newdef CharmBaryon1:I1 39 0
 newdef CharmBaryon1:I2 39 -0.816497
 newdef CharmBaryon1:I3 39 0
 newdef CharmBaryon1:I4 39 0
 newdef CharmBaryon1:I5 39 0
 newdef CharmBaryon1:Ihat3 39 0
 newdef CharmBaryon1:Ihat4 39 0
 newdef CharmBaryon1:Incoming 39 4122
 newdef CharmBaryon1:OutgoingB 39 2224
 newdef CharmBaryon1:OutgoingM 39 -321
 newdef CharmBaryon1:MaxWeight 39 0.0519786
 newdef CharmBaryon1:I1 40 0
 newdef CharmBaryon1:I2 40 0.471405
 newdef CharmBaryon1:I3 40 0
 newdef CharmBaryon1:I4 40 0
 newdef CharmBaryon1:I5 40 0
 newdef CharmBaryon1:Ihat3 40 0
 newdef CharmBaryon1:Ihat4 40 0
 newdef CharmBaryon1:Incoming 40 4122
 newdef CharmBaryon1:OutgoingB 40 3324
 newdef CharmBaryon1:OutgoingM 40 321
 newdef CharmBaryon1:MaxWeight 40 0.0160487
 newdef CharmBaryon1:I1 41 0
 newdef CharmBaryon1:I2 41 -0.333333
 newdef CharmBaryon1:I3 41 0
 newdef CharmBaryon1:I4 41 0
 newdef CharmBaryon1:I5 41 0
 newdef CharmBaryon1:Ihat3 41 0
 newdef CharmBaryon1:Ihat4 41 0
 newdef CharmBaryon1:Incoming 41 4132
 newdef CharmBaryon1:OutgoingB 41 3214
 newdef CharmBaryon1:OutgoingM 41 -311
 newdef CharmBaryon1:MaxWeight 41 0.00944063
 newdef CharmBaryon1:I1 42 0
 newdef CharmBaryon1:I2 42 -0.471405
 newdef CharmBaryon1:I3 42 0
 newdef CharmBaryon1:I4 42 0
 newdef CharmBaryon1:I5 42 0
 newdef CharmBaryon1:Ihat3 42 0
 newdef CharmBaryon1:Ihat4 42 0
 newdef CharmBaryon1:Incoming 42 4132
 newdef CharmBaryon1:OutgoingB 42 3224
 newdef CharmBaryon1:OutgoingM 42 -321
 newdef CharmBaryon1:MaxWeight 42 0.0193036
 newdef CharmBaryon1:I1 43 0
 newdef CharmBaryon1:I2 43 -0.333333
 newdef CharmBaryon1:I3 43 0
 newdef CharmBaryon1:I4 43 0
 newdef CharmBaryon1:I5 43 0
 newdef CharmBaryon1:Ihat3 43 0
 newdef CharmBaryon1:Ihat4 43 0
 newdef CharmBaryon1:Incoming 43 4132
 newdef CharmBaryon1:OutgoingB 43 3324
 newdef CharmBaryon1:OutgoingM 43 111
 newdef CharmBaryon1:MaxWeight 43 0.0138565
 newdef CharmBaryon1:I1 44 0
 newdef CharmBaryon1:I2 44 0.097631
 newdef CharmBaryon1:I3 44 0
 newdef CharmBaryon1:I4 44 0
 newdef CharmBaryon1:I5 44 0
 newdef CharmBaryon1:Ihat3 44 0
 newdef CharmBaryon1:Ihat4 44 0
 newdef CharmBaryon1:Incoming 44 4132
 newdef CharmBaryon1:OutgoingB 44 3324
 newdef CharmBaryon1:OutgoingM 44 221
 newdef CharmBaryon1:MaxWeight 44 0.000755889
 newdef CharmBaryon1:I1 45 0
 newdef CharmBaryon1:I2 45 -0.569036
 newdef CharmBaryon1:I3 45 0
 newdef CharmBaryon1:I4 45 0
 newdef CharmBaryon1:I5 45 0
 newdef CharmBaryon1:Ihat3 45 0
 newdef CharmBaryon1:Ihat4 45 0
 newdef CharmBaryon1:Incoming 45 4132
 newdef CharmBaryon1:OutgoingB 45 3324
 newdef CharmBaryon1:OutgoingM 45 331
 newdef CharmBaryon1:MaxWeight 45 9.59072e-06
 newdef CharmBaryon1:I1 46 0
 newdef CharmBaryon1:I2 46 0.471405
 newdef CharmBaryon1:I3 46 0
 newdef CharmBaryon1:I4 46 0
 newdef CharmBaryon1:I5 46 0
 newdef CharmBaryon1:Ihat3 46 0
 newdef CharmBaryon1:Ihat4 46 0
 newdef CharmBaryon1:Incoming 46 4132
 newdef CharmBaryon1:OutgoingB 46 3314
 newdef CharmBaryon1:OutgoingM 46 211
 newdef CharmBaryon1:MaxWeight 46 0.0273069
 newdef CharmBaryon1:I1 47 0
 newdef CharmBaryon1:I2 47 0.471405
 newdef CharmBaryon1:I3 47 0
 newdef CharmBaryon1:I4 47 0
 newdef CharmBaryon1:I5 47 0
 newdef CharmBaryon1:Ihat3 47 0
 newdef CharmBaryon1:Ihat4 47 0
 newdef CharmBaryon1:Incoming 47 4132
 newdef CharmBaryon1:OutgoingB 47 3334
 newdef CharmBaryon1:OutgoingM 47 321
 newdef CharmBaryon1:MaxWeight 47 0.00570461
 newdef CharmBaryon1:I1 48 -0.57735
 newdef CharmBaryon1:I2 48 0
 newdef CharmBaryon1:I3 48 0
 newdef CharmBaryon1:I4 48 0
 newdef CharmBaryon1:I5 48 0
 newdef CharmBaryon1:Ihat3 48 0
 newdef CharmBaryon1:Ihat4 48 0
 newdef CharmBaryon1:Incoming 48 4332
 newdef CharmBaryon1:OutgoingB 48 3324
 newdef CharmBaryon1:OutgoingM 48 -311
 newdef CharmBaryon1:MaxWeight 48 0.00685019
 newdef CharmBaryon1:I1 49 -0.57735
 newdef CharmBaryon1:I2 49 0
 newdef CharmBaryon1:I3 49 0
 newdef CharmBaryon1:I4 49 0
 newdef CharmBaryon1:I5 49 0
 newdef CharmBaryon1:Ihat3 49 0
 newdef CharmBaryon1:Ihat4 49 0
 newdef CharmBaryon1:Incoming 49 4332
 newdef CharmBaryon1:OutgoingB 49 3334
 newdef CharmBaryon1:OutgoingM 49 211
 newdef CharmBaryon1:MaxWeight 49 0.0101584
 newdef CharmBaryon1:I1 50 0
 newdef CharmBaryon1:I2 50 0.333333
 newdef CharmBaryon1:I3 50 0
 newdef CharmBaryon1:I4 50 0
 newdef CharmBaryon1:I5 50 0
 newdef CharmBaryon1:Ihat3 50 0
 newdef CharmBaryon1:Ihat4 50 0
 newdef CharmBaryon1:Incoming 50 4122
 newdef CharmBaryon1:OutgoingB 50 3214
 newdef CharmBaryon1:OutgoingM 50 213
 newdef CharmBaryon1:MaxWeight 50 0.0380711
 newdef CharmBaryon1:I1 51 0
 newdef CharmBaryon1:I2 51 0.333333
 newdef CharmBaryon1:I3 51 0
 newdef CharmBaryon1:I4 51 0
 newdef CharmBaryon1:I5 51 0
 newdef CharmBaryon1:Ihat3 51 0
 newdef CharmBaryon1:Ihat4 51 0
 newdef CharmBaryon1:Incoming 51 4122
 newdef CharmBaryon1:OutgoingB 51 3224
 newdef CharmBaryon1:OutgoingM 51 113
 newdef CharmBaryon1:MaxWeight 51 0.0380348
 newdef CharmBaryon1:I1 52 0
 newdef CharmBaryon1:I2 52 0.333333
 newdef CharmBaryon1:I3 52 0
 newdef CharmBaryon1:I4 52 0
 newdef CharmBaryon1:I5 52 0
 newdef CharmBaryon1:Ihat3 52 0
 newdef CharmBaryon1:Ihat4 52 0
 newdef CharmBaryon1:Incoming 52 4122
 newdef CharmBaryon1:OutgoingB 52 3224
 newdef CharmBaryon1:OutgoingM 52 223
 newdef CharmBaryon1:MaxWeight 52 0.0213052
 newdef CharmBaryon1:I1 53 0
 newdef CharmBaryon1:I2 53 -0.471405
 newdef CharmBaryon1:I3 53 0
 newdef CharmBaryon1:I4 53 0
 newdef CharmBaryon1:I5 53 0
 newdef CharmBaryon1:Ihat3 53 0
 newdef CharmBaryon1:Ihat4 53 0
 newdef CharmBaryon1:Incoming 53 4122
 newdef CharmBaryon1:OutgoingB 53 3224
 newdef CharmBaryon1:OutgoingM 53 333
 newdef CharmBaryon1:MaxWeight 53 3.89911e-07
 newdef CharmBaryon1:I1 54 0
 newdef CharmBaryon1:I2 54 -0.471405
 newdef CharmBaryon1:I3 54 0
 newdef CharmBaryon1:I4 54 0
 newdef CharmBaryon1:I5 54 0
 newdef CharmBaryon1:Ihat3 54 0
 newdef CharmBaryon1:Ihat4 54 0
 newdef CharmBaryon1:Incoming 54 4122
 newdef CharmBaryon1:OutgoingB 54 2214
 newdef CharmBaryon1:OutgoingM 54 -313
 newdef CharmBaryon1:MaxWeight 54 0.0797601
 newdef CharmBaryon1:I1 55 0
 newdef CharmBaryon1:I2 55 -0.816497
 newdef CharmBaryon1:I3 55 0
 newdef CharmBaryon1:I4 55 0
 newdef CharmBaryon1:I5 55 0
 newdef CharmBaryon1:Ihat3 55 0
 newdef CharmBaryon1:Ihat4 55 0
 newdef CharmBaryon1:Incoming 55 4122
 newdef CharmBaryon1:OutgoingB 55 2224
 newdef CharmBaryon1:OutgoingM 55 -323
 newdef CharmBaryon1:MaxWeight 55 0.244574
 newdef CharmBaryon1:I1 56 0
 newdef CharmBaryon1:I2 56 0.471405
 newdef CharmBaryon1:I3 56 0
 newdef CharmBaryon1:I4 56 0
 newdef CharmBaryon1:I5 56 0
 newdef CharmBaryon1:Ihat3 56 0
 newdef CharmBaryon1:Ihat4 56 0
 newdef CharmBaryon1:Incoming 56 4122
 newdef CharmBaryon1:OutgoingB 56 3324
 newdef CharmBaryon1:OutgoingM 56 323
 newdef CharmBaryon1:MaxWeight 56 8.19361e-05
 newdef CharmBaryon1:I1 57 0
 newdef CharmBaryon1:I2 57 -0.333333
 newdef CharmBaryon1:I3 57 0
 newdef CharmBaryon1:I4 57 0
 newdef CharmBaryon1:I5 57 0
 newdef CharmBaryon1:Ihat3 57 0
 newdef CharmBaryon1:Ihat4 57 0
 newdef CharmBaryon1:Incoming 57 4132
 newdef CharmBaryon1:OutgoingB 57 3214
 newdef CharmBaryon1:OutgoingM 57 -313
 newdef CharmBaryon1:MaxWeight 57 0.0224257
 newdef CharmBaryon1:I1 58 0
 newdef CharmBaryon1:I2 58 -0.471405
 newdef CharmBaryon1:I3 58 0
 newdef CharmBaryon1:I4 58 0
 newdef CharmBaryon1:I5 58 0
 newdef CharmBaryon1:Ihat3 58 0
 newdef CharmBaryon1:Ihat4 58 0
 newdef CharmBaryon1:Incoming 58 4132
 newdef CharmBaryon1:OutgoingB 58 3224
 newdef CharmBaryon1:OutgoingM 58 -323
 newdef CharmBaryon1:MaxWeight 58 0.0459226
 newdef CharmBaryon1:I1 59 0
 newdef CharmBaryon1:I2 59 -0.333333
 newdef CharmBaryon1:I3 59 0
 newdef CharmBaryon1:I4 59 0
 newdef CharmBaryon1:I5 59 0
 newdef CharmBaryon1:Ihat3 59 0
 newdef CharmBaryon1:Ihat4 59 0
 newdef CharmBaryon1:Incoming 59 4132
 newdef CharmBaryon1:OutgoingB 59 3324
 newdef CharmBaryon1:OutgoingM 59 113
 newdef CharmBaryon1:MaxWeight 59 0.0405582
 newdef CharmBaryon1:I1 60 0
 newdef CharmBaryon1:I2 60 -0.333333
 newdef CharmBaryon1:I3 60 0
 newdef CharmBaryon1:I4 60 0
 newdef CharmBaryon1:I5 60 0
 newdef CharmBaryon1:Ihat3 60 0
 newdef CharmBaryon1:Ihat4 60 0
 newdef CharmBaryon1:Incoming 60 4132
 newdef CharmBaryon1:OutgoingB 60 3324
 newdef CharmBaryon1:OutgoingM 60 223
 newdef CharmBaryon1:MaxWeight 60 0.0176579
 newdef CharmBaryon1:I1 61 0
 newdef CharmBaryon1:I2 61 -0.471405
 newdef CharmBaryon1:I3 61 0
 newdef CharmBaryon1:I4 61 0
 newdef CharmBaryon1:I5 61 0
 newdef CharmBaryon1:Ihat3 61 0
 newdef CharmBaryon1:Ihat4 61 0
 newdef CharmBaryon1:Incoming 61 4132
 newdef CharmBaryon1:OutgoingB 61 3324
 newdef CharmBaryon1:OutgoingM 61 333
 newdef CharmBaryon1:MaxWeight 61 2.00738e-09
 newdef CharmBaryon1:I1 62 0
 newdef CharmBaryon1:I2 62 0.471405
 newdef CharmBaryon1:I3 62 0
 newdef CharmBaryon1:I4 62 0
 newdef CharmBaryon1:I5 62 0
 newdef CharmBaryon1:Ihat3 62 0
 newdef CharmBaryon1:Ihat4 62 0
 newdef CharmBaryon1:Incoming 62 4132
 newdef CharmBaryon1:OutgoingB 62 3314
 newdef CharmBaryon1:OutgoingM 62 213
 newdef CharmBaryon1:MaxWeight 62 0.0742392
 newdef CharmBaryon1:I1 63 0
 newdef CharmBaryon1:I2 63 0.471405
 newdef CharmBaryon1:I3 63 0
 newdef CharmBaryon1:I4 63 0
 newdef CharmBaryon1:I5 63 0
 newdef CharmBaryon1:Ihat3 63 0
 newdef CharmBaryon1:Ihat4 63 0
 newdef CharmBaryon1:Incoming 63 4132
 newdef CharmBaryon1:OutgoingB 63 3334
 newdef CharmBaryon1:OutgoingM 63 323
 newdef CharmBaryon1:MaxWeight 63 0.000160371
 newdef CharmBaryon1:I1 64 -0.57735
 newdef CharmBaryon1:I2 64 0
 newdef CharmBaryon1:I3 64 0
 newdef CharmBaryon1:I4 64 0
 newdef CharmBaryon1:I5 64 0
 newdef CharmBaryon1:Ihat3 64 0
 newdef CharmBaryon1:Ihat4 64 0
 newdef CharmBaryon1:Incoming 64 4332
 newdef CharmBaryon1:OutgoingB 64 3324
 newdef CharmBaryon1:OutgoingM 64 -313
 newdef CharmBaryon1:MaxWeight 64 0.041161
 newdef CharmBaryon1:I1 65 -0.57735
 newdef CharmBaryon1:I2 65 0
 newdef CharmBaryon1:I3 65 0
 newdef CharmBaryon1:I4 65 0
 newdef CharmBaryon1:I5 65 0
 newdef CharmBaryon1:Ihat3 65 0
 newdef CharmBaryon1:Ihat4 65 0
 newdef CharmBaryon1:Incoming 65 4332
 newdef CharmBaryon1:OutgoingB 65 3334
 newdef CharmBaryon1:OutgoingM 65 213
 newdef CharmBaryon1:MaxWeight 65 0.0643286
 #
 create Herwig::SemiLeptonicBaryonDecayer  BaryonHeavy3
 newdef BaryonHeavy3:Iteration 1
 newdef BaryonHeavy3:Ntry 500
 newdef BaryonHeavy3:Points 10000
 insert BaryonHeavy3:MaximumWeight 0 0.155059
 insert BaryonHeavy3:MaximumWeight 1 0.154479
 insert BaryonHeavy3:MaximumWeight 2 0.0478423
 insert BaryonHeavy3:MaximumWeight 3 0.183107
 insert BaryonHeavy3:MaximumWeight 4 0.18242
 insert BaryonHeavy3:MaximumWeight 5 0.0558729
 insert BaryonHeavy3:MaximumWeight 6 0.183291
 insert BaryonHeavy3:MaximumWeight 7 0.182598
 insert BaryonHeavy3:MaximumWeight 8 0.0559255
 insert BaryonHeavy3:MaximumWeight 9 0.116825
 insert BaryonHeavy3:MaximumWeight 10 0.110605
 insert BaryonHeavy3:MaximumWeight 11 0.0267389
 insert BaryonHeavy3:MaximumWeight 12 0.132773
 insert BaryonHeavy3:MaximumWeight 13 0.132352
 insert BaryonHeavy3:MaximumWeight 14 0.0365608
 insert BaryonHeavy3:MaximumWeight 15 0.0227486
 insert BaryonHeavy3:MaximumWeight 16 0.0222433
 insert BaryonHeavy3:MaximumWeight 17 0.0338862
 insert BaryonHeavy3:MaximumWeight 18 0.0334095
 insert BaryonHeavy3:MaximumWeight 19 0.1
 insert BaryonHeavy3:MaximumWeight 20 0.097
 insert BaryonHeavy3:MaximumWeight 21 0.025
 insert BaryonHeavy3:MaximumWeight 22 0.025
 create Herwig::LeptonNeutrinoCurrent BaryonHeavy3Current  HwWeakCurrents.so
 newdef BaryonHeavy3Current:Quark 0  11
 newdef BaryonHeavy3Current:AntiQuark 0  -12
 newdef BaryonHeavy3Current:Quark 1  13
 newdef BaryonHeavy3Current:AntiQuark 1  -15
 newdef BaryonHeavy3Current:Quark 2  15
 newdef BaryonHeavy3Current:AntiQuark 2  -16
 newdef BaryonHeavy3:Current BaryonHeavy3Current
 create Herwig::ChengHeavyBaryonFormFactor BaryonHeavy3Form
 newdef BaryonHeavy3Form:DownMass     0.322
 newdef BaryonHeavy3Form:UpMass       0.338
 newdef BaryonHeavy3Form:StrangeMass  0.51
 newdef BaryonHeavy3Form:CharmMass    1.6
 newdef BaryonHeavy3Form:BottomMass   5
 newdef BaryonHeavy3Form:VectorMassbc 6.34
 newdef BaryonHeavy3Form:AxialMassbc  6.73
 newdef BaryonHeavy3Form:VectorMassbs 5.42
 newdef BaryonHeavy3Form:AxialMassbs  5.86
 newdef BaryonHeavy3Form:VectorMassbd 5.32
 newdef BaryonHeavy3Form:AxialMassbd  5.71
 newdef BaryonHeavy3Form:VectorMasscs 2.11
 newdef BaryonHeavy3Form:AxialMasscs  2.54
 newdef BaryonHeavy3Form:VectorMasscu 2.01
 newdef BaryonHeavy3Form:AxialMasscu  2.42
 newdef BaryonHeavy3Form:Nfi 0  1
 newdef BaryonHeavy3Form:Eta 0  1
 newdef BaryonHeavy3Form:Nfi 1  0.57735
 newdef BaryonHeavy3Form:Eta 1  1
 newdef BaryonHeavy3Form:Nfi 2  0.707107
 newdef BaryonHeavy3Form:Eta 2  1
 newdef BaryonHeavy3Form:Nfi 3  1
 newdef BaryonHeavy3Form:Eta 3  1
 newdef BaryonHeavy3Form:Nfi 4  1
 newdef BaryonHeavy3Form:Eta 4  1
 newdef BaryonHeavy3Form:Nfi 5  0.707107
 newdef BaryonHeavy3Form:Eta 5  1
 newdef BaryonHeavy3Form:Nfi 6  0.707107
 newdef BaryonHeavy3Form:Eta 6  1
 newdef BaryonHeavy3Form:Nfi 7  0.5
 newdef BaryonHeavy3Form:Eta 7  1
 newdef BaryonHeavy3Form:Nfi 8  0.5
 newdef BaryonHeavy3Form:Eta 8  1
 newdef BaryonHeavy3Form:Nfi 9  0.288675
 newdef BaryonHeavy3Form:Eta 9  1
 newdef BaryonHeavy3Form:Nfi 10  1
 newdef BaryonHeavy3Form:Eta 10  -0.333333
 newdef BaryonHeavy3Form:Nfi 11  0.57735
 newdef BaryonHeavy3Form:Eta 11  -0.333333
 newdef BaryonHeavy3Form:Nfi 12  1
 newdef BaryonHeavy3Form:Eta 12  0
 newdef BaryonHeavy3Form:Nfi 13  1
 newdef BaryonHeavy3Form:Eta 13  0
 newdef BaryonHeavy3Form:Nfi 14  0.57735
 newdef BaryonHeavy3Form:Eta 14  0
 newdef BaryonHeavy3Form:Nfi 15  1
 newdef BaryonHeavy3Form:Eta 15  0
 newdef BaryonHeavy3Form:Nfi 16  0.57735
 newdef BaryonHeavy3Form:Eta 16  0
 newdef BaryonHeavy3Form:Nfi 17  0.57735
 newdef BaryonHeavy3Form:Eta 17  1
 newdef BaryonHeavy3Form:Nfi 18  0.57735
 newdef BaryonHeavy3Form:Eta 18  1
 newdef BaryonHeavy3Form:Nfi 19  0.57735
 newdef BaryonHeavy3Form:Eta 19  1
 newdef BaryonHeavy3Form:Incoming 0 5122
 newdef BaryonHeavy3Form:Outgoing 0 4122
 newdef BaryonHeavy3Form:InSpin 0 2
 newdef BaryonHeavy3Form:OutSpin 0 2
 newdef BaryonHeavy3Form:Spectator1 0 1
 newdef BaryonHeavy3Form:Spectator2 0 2
 newdef BaryonHeavy3Form:InQuark 0 5
 newdef BaryonHeavy3Form:OutQuark 0 4
 newdef BaryonHeavy3Form:Incoming 1 5122
 newdef BaryonHeavy3Form:Outgoing 1 3122
 newdef BaryonHeavy3Form:InSpin 1 2
 newdef BaryonHeavy3Form:OutSpin 1 2
 newdef BaryonHeavy3Form:Spectator1 1 1
 newdef BaryonHeavy3Form:Spectator2 1 2
 newdef BaryonHeavy3Form:InQuark 1 5
 newdef BaryonHeavy3Form:OutQuark 1 3
 newdef BaryonHeavy3Form:Incoming 2 5122
 newdef BaryonHeavy3Form:Outgoing 2 2112
 newdef BaryonHeavy3Form:InSpin 2 2
 newdef BaryonHeavy3Form:OutSpin 2 2
 newdef BaryonHeavy3Form:Spectator1 2 1
 newdef BaryonHeavy3Form:Spectator2 2 2
 newdef BaryonHeavy3Form:InQuark 2 5
 newdef BaryonHeavy3Form:OutQuark 2 1
 newdef BaryonHeavy3Form:Incoming 3 5232
 newdef BaryonHeavy3Form:Outgoing 3 4232
 newdef BaryonHeavy3Form:InSpin 3 2
 newdef BaryonHeavy3Form:OutSpin 3 2
 newdef BaryonHeavy3Form:Spectator1 3 2
 newdef BaryonHeavy3Form:Spectator2 3 3
 newdef BaryonHeavy3Form:InQuark 3 5
 newdef BaryonHeavy3Form:OutQuark 3 4
 newdef BaryonHeavy3Form:Incoming 4 5132
 newdef BaryonHeavy3Form:Outgoing 4 4132
 newdef BaryonHeavy3Form:InSpin 4 2
 newdef BaryonHeavy3Form:OutSpin 4 2
 newdef BaryonHeavy3Form:Spectator1 4 1
 newdef BaryonHeavy3Form:Spectator2 4 3
 newdef BaryonHeavy3Form:InQuark 4 5
 newdef BaryonHeavy3Form:OutQuark 4 4
 newdef BaryonHeavy3Form:Incoming 5 5232
 newdef BaryonHeavy3Form:Outgoing 5 3322
 newdef BaryonHeavy3Form:InSpin 5 2
 newdef BaryonHeavy3Form:OutSpin 5 2
 newdef BaryonHeavy3Form:Spectator1 5 2
 newdef BaryonHeavy3Form:Spectator2 5 3
 newdef BaryonHeavy3Form:InQuark 5 5
 newdef BaryonHeavy3Form:OutQuark 5 3
 newdef BaryonHeavy3Form:Incoming 6 5132
 newdef BaryonHeavy3Form:Outgoing 6 3312
 newdef BaryonHeavy3Form:InSpin 6 2
 newdef BaryonHeavy3Form:OutSpin 6 2
 newdef BaryonHeavy3Form:Spectator1 6 1
 newdef BaryonHeavy3Form:Spectator2 6 3
 newdef BaryonHeavy3Form:InQuark 6 5
 newdef BaryonHeavy3Form:OutQuark 6 3
 newdef BaryonHeavy3Form:Incoming 7 5232
 newdef BaryonHeavy3Form:Outgoing 7 3212
 newdef BaryonHeavy3Form:InSpin 7 2
 newdef BaryonHeavy3Form:OutSpin 7 2
 newdef BaryonHeavy3Form:Spectator1 7 2
 newdef BaryonHeavy3Form:Spectator2 7 3
 newdef BaryonHeavy3Form:InQuark 7 5
 newdef BaryonHeavy3Form:OutQuark 7 1
 newdef BaryonHeavy3Form:Incoming 8 5132
 newdef BaryonHeavy3Form:Outgoing 8 3112
 newdef BaryonHeavy3Form:InSpin 8 2
 newdef BaryonHeavy3Form:OutSpin 8 2
 newdef BaryonHeavy3Form:Spectator1 8 1
 newdef BaryonHeavy3Form:Spectator2 8 3
 newdef BaryonHeavy3Form:InQuark 8 5
 newdef BaryonHeavy3Form:OutQuark 8 1
 newdef BaryonHeavy3Form:Incoming 9 5232
 newdef BaryonHeavy3Form:Outgoing 9 3122
 newdef BaryonHeavy3Form:InSpin 9 2
 newdef BaryonHeavy3Form:OutSpin 9 2
 newdef BaryonHeavy3Form:Spectator1 9 2
 newdef BaryonHeavy3Form:Spectator2 9 3
 newdef BaryonHeavy3Form:InQuark 9 5
 newdef BaryonHeavy3Form:OutQuark 9 1
 newdef BaryonHeavy3Form:Incoming 10 5332
 newdef BaryonHeavy3Form:Outgoing 10 4332
 newdef BaryonHeavy3Form:InSpin 10 2
 newdef BaryonHeavy3Form:OutSpin 10 2
 newdef BaryonHeavy3Form:Spectator1 10 3
 newdef BaryonHeavy3Form:Spectator2 10 3
 newdef BaryonHeavy3Form:InQuark 10 5
 newdef BaryonHeavy3Form:OutQuark 10 4
 newdef BaryonHeavy3Form:Incoming 11 5332
 newdef BaryonHeavy3Form:Outgoing 11 3312
 newdef BaryonHeavy3Form:InSpin 11 2
 newdef BaryonHeavy3Form:OutSpin 11 2
 newdef BaryonHeavy3Form:Spectator1 11 3
 newdef BaryonHeavy3Form:Spectator2 11 3
 newdef BaryonHeavy3Form:InQuark 11 5
 newdef BaryonHeavy3Form:OutQuark 11 1
 newdef BaryonHeavy3Form:Incoming 12 5332
 newdef BaryonHeavy3Form:Outgoing 12 4334
 newdef BaryonHeavy3Form:InSpin 12 2
 newdef BaryonHeavy3Form:OutSpin 12 4
 newdef BaryonHeavy3Form:Spectator1 12 3
 newdef BaryonHeavy3Form:Spectator2 12 3
 newdef BaryonHeavy3Form:InQuark 12 5
 newdef BaryonHeavy3Form:OutQuark 12 4
 newdef BaryonHeavy3Form:Incoming 13 5332
 newdef BaryonHeavy3Form:Outgoing 13 3334
 newdef BaryonHeavy3Form:InSpin 13 2
 newdef BaryonHeavy3Form:OutSpin 13 4
 newdef BaryonHeavy3Form:Spectator1 13 3
 newdef BaryonHeavy3Form:Spectator2 13 3
 newdef BaryonHeavy3Form:InQuark 13 5
 newdef BaryonHeavy3Form:OutQuark 13 3
 newdef BaryonHeavy3Form:Incoming 14 5332
 newdef BaryonHeavy3Form:Outgoing 14 3314
 newdef BaryonHeavy3Form:InSpin 14 2
 newdef BaryonHeavy3Form:OutSpin 14 4
 newdef BaryonHeavy3Form:Spectator1 14 3
 newdef BaryonHeavy3Form:Spectator2 14 3
 newdef BaryonHeavy3Form:InQuark 14 5
 newdef BaryonHeavy3Form:OutQuark 14 1
 newdef BaryonHeavy3Form:Incoming 15 4332
 newdef BaryonHeavy3Form:Outgoing 15 3334
 newdef BaryonHeavy3Form:InSpin 15 2
 newdef BaryonHeavy3Form:OutSpin 15 4
 newdef BaryonHeavy3Form:Spectator1 15 3
 newdef BaryonHeavy3Form:Spectator2 15 3
 newdef BaryonHeavy3Form:InQuark 15 4
 newdef BaryonHeavy3Form:OutQuark 15 3
 newdef BaryonHeavy3Form:Incoming 16 4332
 newdef BaryonHeavy3Form:Outgoing 16 3324
 newdef BaryonHeavy3Form:InSpin 16 2
 newdef BaryonHeavy3Form:OutSpin 16 4
 newdef BaryonHeavy3Form:Spectator1 16 3
 newdef BaryonHeavy3Form:Spectator2 16 3
 newdef BaryonHeavy3Form:InQuark 16 4
 newdef BaryonHeavy3Form:OutQuark 16 2
 newdef BaryonHeavy3Form:Incoming 17 4122
 newdef BaryonHeavy3Form:Outgoing 17 3122
 newdef BaryonHeavy3Form:InSpin 17 2
 newdef BaryonHeavy3Form:OutSpin 17 2
 newdef BaryonHeavy3Form:Spectator1 17 1
 newdef BaryonHeavy3Form:Spectator2 17 2
 newdef BaryonHeavy3Form:InQuark 17 4
 newdef BaryonHeavy3Form:OutQuark 17 3
 newdef BaryonHeavy3Form:Incoming 18 4232
 newdef BaryonHeavy3Form:Outgoing 18 3322
 newdef BaryonHeavy3Form:InSpin 18 2
 newdef BaryonHeavy3Form:OutSpin 18 2
 newdef BaryonHeavy3Form:Spectator1 18 2
 newdef BaryonHeavy3Form:Spectator2 18 3
 newdef BaryonHeavy3Form:InQuark 18 4
 newdef BaryonHeavy3Form:OutQuark 18 3
 newdef BaryonHeavy3Form:Incoming 19 4132
 newdef BaryonHeavy3Form:Outgoing 19 3312
 newdef BaryonHeavy3Form:InSpin 19 2
 newdef BaryonHeavy3Form:OutSpin 19 2
 newdef BaryonHeavy3Form:Spectator1 19 1
 newdef BaryonHeavy3Form:Spectator2 19 3
 newdef BaryonHeavy3Form:InQuark 19 4
 newdef BaryonHeavy3Form:OutQuark 19 3
 newdef BaryonHeavy3:FormFactor BaryonHeavy3Form
 #
 create Herwig::SemiLeptonicScalarDecayer  WSB
 newdef WSB:Iteration 1
 newdef WSB:Ntry 500
 newdef WSB:Points 10000
 newdef WSB:GenerateIntermediates 0
 insert WSB:MaximumWeight 0 0.21439
 insert WSB:MaximumWeight 1 0.0902162
 insert WSB:MaximumWeight 2 2.29241e-14
 insert WSB:MaximumWeight 3 9.67869e-15
 insert WSB:MaximumWeight 4 0.126126
 insert WSB:MaximumWeight 5 0.10663
 insert WSB:MaximumWeight 6 0.320113
 insert WSB:MaximumWeight 7 0.272174
 insert WSB:MaximumWeight 8 0.0107195
 insert WSB:MaximumWeight 9 0.00938398
 insert WSB:MaximumWeight 10 0.013847
 insert WSB:MaximumWeight 11 0.0121369
 insert WSB:MaximumWeight 12 0.00305138
 insert WSB:MaximumWeight 13 0.00258198
 insert WSB:MaximumWeight 14 0.000647596
 insert WSB:MaximumWeight 15 0.000490013
 insert WSB:MaximumWeight 16 0.0787667
 insert WSB:MaximumWeight 17 0.0764814
 insert WSB:MaximumWeight 18 0.19791
 insert WSB:MaximumWeight 19 0.193905
 insert WSB:MaximumWeight 20 0.00689828
 insert WSB:MaximumWeight 21 0.00673749
 insert WSB:MaximumWeight 22 0.00898338
 insert WSB:MaximumWeight 23 0.0087807
 insert WSB:MaximumWeight 24 0.0152457
 insert WSB:MaximumWeight 25 0.0144707
 insert WSB:MaximumWeight 26 0.0790222
 insert WSB:MaximumWeight 27 0.0674034
 insert WSB:MaximumWeight 28 0.0235821
 insert WSB:MaximumWeight 29 0.0185835
 insert WSB:MaximumWeight 30 0.00803963
 insert WSB:MaximumWeight 31 0.00695707
 insert WSB:MaximumWeight 32 0.00646112
 insert WSB:MaximumWeight 33 0.00630702
 insert WSB:MaximumWeight 34 0.183436
 insert WSB:MaximumWeight 35 0.188816
 insert WSB:MaximumWeight 36 0.0893685
 insert WSB:MaximumWeight 37 0.0834068
 insert WSB:MaximumWeight 38 0.0188587
 insert WSB:MaximumWeight 39 0.0814216
 insert WSB:MaximumWeight 40 0.0762031
 insert WSB:MaximumWeight 41 0.0171754
 insert WSB:MaximumWeight 42 0.000282313
 insert WSB:MaximumWeight 43 0.00027201
 insert WSB:MaximumWeight 44 0.000143382
 insert WSB:MaximumWeight 45 0.000516226
 insert WSB:MaximumWeight 46 0.000498686
 insert WSB:MaximumWeight 47 0.000262857
 insert WSB:MaximumWeight 48 0.000100106
 insert WSB:MaximumWeight 49 9.60475e-05
 insert WSB:MaximumWeight 50 4.7111e-05
 insert WSB:MaximumWeight 51 4.8426e-05
 insert WSB:MaximumWeight 52 4.66258e-05
 insert WSB:MaximumWeight 53 2.04411e-05
 insert WSB:MaximumWeight 54 0.115875
 insert WSB:MaximumWeight 55 0.114911
 insert WSB:MaximumWeight 56 0.0302228
 insert WSB:MaximumWeight 57 0.117263
 insert WSB:MaximumWeight 58 0.114856
 insert WSB:MaximumWeight 59 0.032145
 insert WSB:MaximumWeight 60 0.000700866
 insert WSB:MaximumWeight 61 0.000690372
 insert WSB:MaximumWeight 62 0.000331167
 insert WSB:MaximumWeight 63 0.00126096
 insert WSB:MaximumWeight 64 0.00130993
 insert WSB:MaximumWeight 65 0.000608944
 insert WSB:MaximumWeight 66 0.00170589
 insert WSB:MaximumWeight 67 0.00165399
 insert WSB:MaximumWeight 68 0.000855379
 create Herwig::LeptonNeutrinoCurrent WSBCurrent  HwWeakCurrents.so
 newdef WSBCurrent:Quark 0  11
 newdef WSBCurrent:AntiQuark 0  -12
 newdef WSBCurrent:Quark 1  13
 newdef WSBCurrent:AntiQuark 1  -15
 newdef WSBCurrent:Quark 2  15
 newdef WSBCurrent:AntiQuark 2  -16
 newdef WSB:Current WSBCurrent
 create Herwig::WSBFormFactor WSBFormFactor
 newdef WSBFormFactor:ThetaEtaEtaPrime -0.194
 newdef WSBFormFactor:F0 0  0.992
 newdef WSBFormFactor:V  0  0
 newdef WSBFormFactor:A0 0  0
 newdef WSBFormFactor:A1 0  0
 newdef WSBFormFactor:A2 0  0
 newdef WSBFormFactor:ScalarMass 0  0.494
 newdef WSBFormFactor:PseudoScalarMass 0  1.43
 newdef WSBFormFactor:VectorMass 0  0.892
 newdef WSBFormFactor:PseudoVectorMass 0  1.273
 newdef WSBFormFactor:F0 1  0.992
 newdef WSBFormFactor:V  1  0
 newdef WSBFormFactor:A0 1  0
 newdef WSBFormFactor:A1 1  0
 newdef WSBFormFactor:A2 1  0
 newdef WSBFormFactor:ScalarMass 1  0.494
 newdef WSBFormFactor:PseudoScalarMass 1  1.43
 newdef WSBFormFactor:VectorMass 1  0.892
 newdef WSBFormFactor:PseudoVectorMass 1  1.273
 newdef WSBFormFactor:F0 2  0.992
 newdef WSBFormFactor:V  2  0
 newdef WSBFormFactor:A0 2  0
 newdef WSBFormFactor:A1 2  0
 newdef WSBFormFactor:A2 2  0
 newdef WSBFormFactor:ScalarMass 2  0.494
 newdef WSBFormFactor:PseudoScalarMass 2  1.43
 newdef WSBFormFactor:VectorMass 2  0.892
 newdef WSBFormFactor:PseudoVectorMass 2  1.273
 newdef WSBFormFactor:F0 3  0.992
 newdef WSBFormFactor:V  3  0
 newdef WSBFormFactor:A0 3  0
 newdef WSBFormFactor:A1 3  0
 newdef WSBFormFactor:A2 3  0
 newdef WSBFormFactor:ScalarMass 3  0.494
 newdef WSBFormFactor:PseudoScalarMass 3  1.43
 newdef WSBFormFactor:VectorMass 3  0.892
 newdef WSBFormFactor:PseudoVectorMass 3  1.273
 newdef WSBFormFactor:F0 4  0.762
 newdef WSBFormFactor:V  4  0
 newdef WSBFormFactor:A0 4  0
 newdef WSBFormFactor:A1 4  0
 newdef WSBFormFactor:A2 4  0
 newdef WSBFormFactor:ScalarMass 4  1.97
 newdef WSBFormFactor:PseudoScalarMass 4  2.6
 newdef WSBFormFactor:VectorMass 4  2.11
 newdef WSBFormFactor:PseudoVectorMass 4  2.53
 newdef WSBFormFactor:F0 5  0.762
 newdef WSBFormFactor:V  5  0
 newdef WSBFormFactor:A0 5  0
 newdef WSBFormFactor:A1 5  0
 newdef WSBFormFactor:A2 5  0
 newdef WSBFormFactor:ScalarMass 5  1.97
 newdef WSBFormFactor:PseudoScalarMass 5  2.6
 newdef WSBFormFactor:VectorMass 5  2.11
 newdef WSBFormFactor:PseudoVectorMass 5  2.53
 newdef WSBFormFactor:F0 6  0.692
 newdef WSBFormFactor:V  6  0
 newdef WSBFormFactor:A0 6  0
 newdef WSBFormFactor:A1 6  0
 newdef WSBFormFactor:A2 6  0
 newdef WSBFormFactor:ScalarMass 6  1.87
 newdef WSBFormFactor:PseudoScalarMass 6  2.47
 newdef WSBFormFactor:VectorMass 6  2.01
 newdef WSBFormFactor:PseudoVectorMass 6  2.42
 newdef WSBFormFactor:F0 7  0.692
 newdef WSBFormFactor:V  7  0
 newdef WSBFormFactor:A0 7  0
 newdef WSBFormFactor:A1 7  0
 newdef WSBFormFactor:A2 7  0
 newdef WSBFormFactor:ScalarMass 7  1.87
 newdef WSBFormFactor:PseudoScalarMass 7  2.47
 newdef WSBFormFactor:VectorMass 7  2.01
 newdef WSBFormFactor:PseudoVectorMass 7  2.42
 newdef WSBFormFactor:F0 8  0.692
 newdef WSBFormFactor:V  8  0
 newdef WSBFormFactor:A0 8  0
 newdef WSBFormFactor:A1 8  0
 newdef WSBFormFactor:A2 8  0
 newdef WSBFormFactor:ScalarMass 8  1.87
 newdef WSBFormFactor:PseudoScalarMass 8  2.47
 newdef WSBFormFactor:VectorMass 8  2.01
 newdef WSBFormFactor:PseudoVectorMass 8  2.42
 newdef WSBFormFactor:F0 9  0.692
 newdef WSBFormFactor:V  9  0
 newdef WSBFormFactor:A0 9  0
 newdef WSBFormFactor:A1 9  0
 newdef WSBFormFactor:A2 9  0
 newdef WSBFormFactor:ScalarMass 9  1.87
 newdef WSBFormFactor:PseudoScalarMass 9  2.47
 newdef WSBFormFactor:VectorMass 9  2.01
 newdef WSBFormFactor:PseudoVectorMass 9  2.42
 newdef WSBFormFactor:F0 10  0.681
 newdef WSBFormFactor:V  10  0
 newdef WSBFormFactor:A0 10  0
 newdef WSBFormFactor:A1 10  0
 newdef WSBFormFactor:A2 10  0
 newdef WSBFormFactor:ScalarMass 10  1.87
 newdef WSBFormFactor:PseudoScalarMass 10  2.47
 newdef WSBFormFactor:VectorMass 10  2.01
 newdef WSBFormFactor:PseudoVectorMass 10  2.42
 newdef WSBFormFactor:F0 11  0.681
 newdef WSBFormFactor:V  11  0
 newdef WSBFormFactor:A0 11  0
 newdef WSBFormFactor:A1 11  0
 newdef WSBFormFactor:A2 11  0
 newdef WSBFormFactor:ScalarMass 11  1.87
 newdef WSBFormFactor:PseudoScalarMass 11  2.47
 newdef WSBFormFactor:VectorMass 11  2.01
 newdef WSBFormFactor:PseudoVectorMass 11  2.42
 newdef WSBFormFactor:F0 12  0.655
 newdef WSBFormFactor:V  12  0
 newdef WSBFormFactor:A0 12  0
 newdef WSBFormFactor:A1 12  0
 newdef WSBFormFactor:A2 12  0
 newdef WSBFormFactor:ScalarMass 12  1.87
 newdef WSBFormFactor:PseudoScalarMass 12  2.47
 newdef WSBFormFactor:VectorMass 12  2.01
 newdef WSBFormFactor:PseudoVectorMass 12  2.42
 newdef WSBFormFactor:F0 13  0.655
 newdef WSBFormFactor:V  13  0
 newdef WSBFormFactor:A0 13  0
 newdef WSBFormFactor:A1 13  0
 newdef WSBFormFactor:A2 13  0
 newdef WSBFormFactor:ScalarMass 13  1.87
 newdef WSBFormFactor:PseudoScalarMass 13  2.47
 newdef WSBFormFactor:VectorMass 13  2.01
 newdef WSBFormFactor:PseudoVectorMass 13  2.42
 newdef WSBFormFactor:F0 14  0
 newdef WSBFormFactor:V  14  1.226
 newdef WSBFormFactor:A0 14  0.733
 newdef WSBFormFactor:A1 14  0.88
 newdef WSBFormFactor:A2 14  1.147
 newdef WSBFormFactor:ScalarMass 14  1.97
 newdef WSBFormFactor:PseudoScalarMass 14  2.6
 newdef WSBFormFactor:VectorMass 14  2.11
 newdef WSBFormFactor:PseudoVectorMass 14  2.53
 newdef WSBFormFactor:F0 15  0
 newdef WSBFormFactor:V  15  1.226
 newdef WSBFormFactor:A0 15  0.733
 newdef WSBFormFactor:A1 15  0.88
 newdef WSBFormFactor:A2 15  1.147
 newdef WSBFormFactor:ScalarMass 15  1.97
 newdef WSBFormFactor:PseudoScalarMass 15  2.6
 newdef WSBFormFactor:VectorMass 15  2.11
 newdef WSBFormFactor:PseudoVectorMass 15  2.53
 newdef WSBFormFactor:F0 16  0
 newdef WSBFormFactor:V  16  1.225
 newdef WSBFormFactor:A0 16  0.669
 newdef WSBFormFactor:A1 16  0.775
 newdef WSBFormFactor:A2 16  0.923
 newdef WSBFormFactor:ScalarMass 16  1.87
 newdef WSBFormFactor:PseudoScalarMass 16  2.47
 newdef WSBFormFactor:VectorMass 16  2.01
 newdef WSBFormFactor:PseudoVectorMass 16  2.42
 newdef WSBFormFactor:F0 17  0
 newdef WSBFormFactor:V  17  1.225
 newdef WSBFormFactor:A0 17  0.669
 newdef WSBFormFactor:A1 17  0.775
 newdef WSBFormFactor:A2 17  0.923
 newdef WSBFormFactor:ScalarMass 17  1.87
 newdef WSBFormFactor:PseudoScalarMass 17  2.47
 newdef WSBFormFactor:VectorMass 17  2.01
 newdef WSBFormFactor:PseudoVectorMass 17  2.42
 newdef WSBFormFactor:F0 18  0
 newdef WSBFormFactor:V  18  1.225
 newdef WSBFormFactor:A0 18  0.669
 newdef WSBFormFactor:A1 18  0.775
 newdef WSBFormFactor:A2 18  0.923
 newdef WSBFormFactor:ScalarMass 18  1.87
 newdef WSBFormFactor:PseudoScalarMass 18  2.47
 newdef WSBFormFactor:VectorMass 18  2.01
 newdef WSBFormFactor:PseudoVectorMass 18  2.42
 newdef WSBFormFactor:F0 19  0
 newdef WSBFormFactor:V  19  1.225
 newdef WSBFormFactor:A0 19  0.669
 newdef WSBFormFactor:A1 19  0.775
 newdef WSBFormFactor:A2 19  0.923
 newdef WSBFormFactor:ScalarMass 19  1.87
 newdef WSBFormFactor:PseudoScalarMass 19  2.47
 newdef WSBFormFactor:VectorMass 19  2.01
 newdef WSBFormFactor:PseudoVectorMass 19  2.42
 newdef WSBFormFactor:F0 20  0
 newdef WSBFormFactor:V  20  1.236
 newdef WSBFormFactor:A0 20  0.669
 newdef WSBFormFactor:A1 20  0.772
 newdef WSBFormFactor:A2 20  0.92
 newdef WSBFormFactor:ScalarMass 20  1.87
 newdef WSBFormFactor:PseudoScalarMass 20  2.47
 newdef WSBFormFactor:VectorMass 20  2.01
 newdef WSBFormFactor:PseudoVectorMass 20  2.42
 newdef WSBFormFactor:F0 21  0
 newdef WSBFormFactor:V  21  1.236
 newdef WSBFormFactor:A0 21  0.669
 newdef WSBFormFactor:A1 21  0.772
 newdef WSBFormFactor:A2 21  0.92
 newdef WSBFormFactor:ScalarMass 21  1.87
 newdef WSBFormFactor:PseudoScalarMass 21  2.47
 newdef WSBFormFactor:VectorMass 21  2.01
 newdef WSBFormFactor:PseudoVectorMass 21  2.42
 newdef WSBFormFactor:F0 22  0.723
 newdef WSBFormFactor:V  22  0
 newdef WSBFormFactor:A0 22  0
 newdef WSBFormFactor:A1 22  0
 newdef WSBFormFactor:A2 22  0
 newdef WSBFormFactor:ScalarMass 22  1.97
 newdef WSBFormFactor:PseudoScalarMass 22  2.6
 newdef WSBFormFactor:VectorMass 22  2.11
 newdef WSBFormFactor:PseudoVectorMass 22  2.53
 newdef WSBFormFactor:F0 23  0.704
 newdef WSBFormFactor:V  23  0
 newdef WSBFormFactor:A0 23  0
 newdef WSBFormFactor:A1 23  0
 newdef WSBFormFactor:A2 23  0
 newdef WSBFormFactor:ScalarMass 23  1.97
 newdef WSBFormFactor:PseudoScalarMass 23  2.6
 newdef WSBFormFactor:VectorMass 23  2.11
 newdef WSBFormFactor:PseudoVectorMass 23  2.53
 newdef WSBFormFactor:F0 24  0.643
 newdef WSBFormFactor:V  24  0
 newdef WSBFormFactor:A0 24  0
 newdef WSBFormFactor:A1 24  0
 newdef WSBFormFactor:A2 24  0
 newdef WSBFormFactor:ScalarMass 24  1.87
 newdef WSBFormFactor:PseudoScalarMass 24  2.47
 newdef WSBFormFactor:VectorMass 24  2.01
 newdef WSBFormFactor:PseudoVectorMass 24  2.42
 newdef WSBFormFactor:F0 25  0.643
 newdef WSBFormFactor:V  25  0
 newdef WSBFormFactor:A0 25  0
 newdef WSBFormFactor:A1 25  0
 newdef WSBFormFactor:A2 25  0
 newdef WSBFormFactor:ScalarMass 25  1.87
 newdef WSBFormFactor:PseudoScalarMass 25  2.47
 newdef WSBFormFactor:VectorMass 25  2.01
 newdef WSBFormFactor:PseudoVectorMass 25  2.42
 newdef WSBFormFactor:F0 26  0
 newdef WSBFormFactor:V  26  1.25
 newdef WSBFormFactor:A0 26  0.634
 newdef WSBFormFactor:A1 26  0.717
 newdef WSBFormFactor:A2 26  0.853
 newdef WSBFormFactor:ScalarMass 26  1.87
 newdef WSBFormFactor:PseudoScalarMass 26  2.47
 newdef WSBFormFactor:VectorMass 26  2.01
 newdef WSBFormFactor:PseudoVectorMass 26  2.42
 newdef WSBFormFactor:F0 27  0
 newdef WSBFormFactor:V  27  1.25
 newdef WSBFormFactor:A0 27  0.634
 newdef WSBFormFactor:A1 27  0.717
 newdef WSBFormFactor:A2 27  0.853
 newdef WSBFormFactor:ScalarMass 27  1.87
 newdef WSBFormFactor:PseudoScalarMass 27  2.47
 newdef WSBFormFactor:VectorMass 27  2.01
 newdef WSBFormFactor:PseudoVectorMass 27  2.42
 newdef WSBFormFactor:F0 28  0
 newdef WSBFormFactor:V  28  1.319
 newdef WSBFormFactor:A0 28  0.7
 newdef WSBFormFactor:A1 28  0.82
 newdef WSBFormFactor:A2 28  1.076
 newdef WSBFormFactor:ScalarMass 28  1.97
 newdef WSBFormFactor:PseudoScalarMass 28  2.6
 newdef WSBFormFactor:VectorMass 28  2.11
 newdef WSBFormFactor:PseudoVectorMass 28  2.53
 newdef WSBFormFactor:F0 29  0.69
 newdef WSBFormFactor:V  29  0
 newdef WSBFormFactor:A0 29  0
 newdef WSBFormFactor:A1 29  0
 newdef WSBFormFactor:A2 29  0
 newdef WSBFormFactor:ScalarMass 29  6.3
 newdef WSBFormFactor:PseudoScalarMass 29  6.8
 newdef WSBFormFactor:VectorMass 29  6.34
 newdef WSBFormFactor:PseudoVectorMass 29  6.73
 newdef WSBFormFactor:F0 30  0.69
 newdef WSBFormFactor:V  30  0
 newdef WSBFormFactor:A0 30  0
 newdef WSBFormFactor:A1 30  0
 newdef WSBFormFactor:A2 30  0
 newdef WSBFormFactor:ScalarMass 30  6.3
 newdef WSBFormFactor:PseudoScalarMass 30  6.8
 newdef WSBFormFactor:VectorMass 30  6.34
 newdef WSBFormFactor:PseudoVectorMass 30  6.73
 newdef WSBFormFactor:F0 31  0.379
 newdef WSBFormFactor:V  31  0
 newdef WSBFormFactor:A0 31  0
 newdef WSBFormFactor:A1 31  0
 newdef WSBFormFactor:A2 31  0
 newdef WSBFormFactor:ScalarMass 31  5.38
 newdef WSBFormFactor:PseudoScalarMass 31  5.89
 newdef WSBFormFactor:VectorMass 31  5.43
 newdef WSBFormFactor:PseudoVectorMass 31  5.82
 newdef WSBFormFactor:F0 32  0.379
 newdef WSBFormFactor:V  32  0
 newdef WSBFormFactor:A0 32  0
 newdef WSBFormFactor:A1 32  0
 newdef WSBFormFactor:A2 32  0
 newdef WSBFormFactor:ScalarMass 32  5.38
 newdef WSBFormFactor:PseudoScalarMass 32  5.89
 newdef WSBFormFactor:VectorMass 32  5.43
 newdef WSBFormFactor:PseudoVectorMass 32  5.82
 newdef WSBFormFactor:F0 33  0.333
 newdef WSBFormFactor:V  33  0
 newdef WSBFormFactor:A0 33  0
 newdef WSBFormFactor:A1 33  0
 newdef WSBFormFactor:A2 33  0
 newdef WSBFormFactor:ScalarMass 33  5.27
 newdef WSBFormFactor:PseudoScalarMass 33  5.78
 newdef WSBFormFactor:VectorMass 33  5.32
 newdef WSBFormFactor:PseudoVectorMass 33  5.71
 newdef WSBFormFactor:F0 34  0.333
 newdef WSBFormFactor:V  34  0
 newdef WSBFormFactor:A0 34  0
 newdef WSBFormFactor:A1 34  0
 newdef WSBFormFactor:A2 34  0
 newdef WSBFormFactor:ScalarMass 34  5.27
 newdef WSBFormFactor:PseudoScalarMass 34  5.78
 newdef WSBFormFactor:VectorMass 34  5.32
 newdef WSBFormFactor:PseudoVectorMass 34  5.71
 newdef WSBFormFactor:F0 35  0.333
 newdef WSBFormFactor:V  35  0
 newdef WSBFormFactor:A0 35  0
 newdef WSBFormFactor:A1 35  0
 newdef WSBFormFactor:A2 35  0
 newdef WSBFormFactor:ScalarMass 35  5.27
 newdef WSBFormFactor:PseudoScalarMass 35  5.78
 newdef WSBFormFactor:VectorMass 35  5.32
 newdef WSBFormFactor:PseudoVectorMass 35  5.71
 newdef WSBFormFactor:F0 36  0.333
 newdef WSBFormFactor:V  36  0
 newdef WSBFormFactor:A0 36  0
 newdef WSBFormFactor:A1 36  0
 newdef WSBFormFactor:A2 36  0
 newdef WSBFormFactor:ScalarMass 36  5.27
 newdef WSBFormFactor:PseudoScalarMass 36  5.78
 newdef WSBFormFactor:VectorMass 36  5.32
 newdef WSBFormFactor:PseudoVectorMass 36  5.71
 newdef WSBFormFactor:F0 37  0.307
 newdef WSBFormFactor:V  37  0
 newdef WSBFormFactor:A0 37  0
 newdef WSBFormFactor:A1 37  0
 newdef WSBFormFactor:A2 37  0
 newdef WSBFormFactor:ScalarMass 37  5.27
 newdef WSBFormFactor:PseudoScalarMass 37  5.78
 newdef WSBFormFactor:VectorMass 37  5.32
 newdef WSBFormFactor:PseudoVectorMass 37  5.71
 newdef WSBFormFactor:F0 38  0.307
 newdef WSBFormFactor:V  38  0
 newdef WSBFormFactor:A0 38  0
 newdef WSBFormFactor:A1 38  0
 newdef WSBFormFactor:A2 38  0
 newdef WSBFormFactor:ScalarMass 38  5.27
 newdef WSBFormFactor:PseudoScalarMass 38  5.78
 newdef WSBFormFactor:VectorMass 38  5.32
 newdef WSBFormFactor:PseudoVectorMass 38  5.71
 newdef WSBFormFactor:F0 39  0.254
 newdef WSBFormFactor:V  39  0
 newdef WSBFormFactor:A0 39  0
 newdef WSBFormFactor:A1 39  0
 newdef WSBFormFactor:A2 39  0
 newdef WSBFormFactor:ScalarMass 39  5.27
 newdef WSBFormFactor:PseudoScalarMass 39  5.78
 newdef WSBFormFactor:VectorMass 39  5.32
 newdef WSBFormFactor:PseudoVectorMass 39  5.71
 newdef WSBFormFactor:F0 40  0.254
 newdef WSBFormFactor:V  40  0
 newdef WSBFormFactor:A0 40  0
 newdef WSBFormFactor:A1 40  0
 newdef WSBFormFactor:A2 40  0
 newdef WSBFormFactor:ScalarMass 40  5.27
 newdef WSBFormFactor:PseudoScalarMass 40  5.78
 newdef WSBFormFactor:VectorMass 40  5.32
 newdef WSBFormFactor:PseudoVectorMass 40  5.71
 newdef WSBFormFactor:F0 41  0
 newdef WSBFormFactor:V  41  0.705
 newdef WSBFormFactor:A0 41  0.623
 newdef WSBFormFactor:A1 41  0.651
 newdef WSBFormFactor:A2 41  0.686
 newdef WSBFormFactor:ScalarMass 41  6.3
 newdef WSBFormFactor:PseudoScalarMass 41  6.8
 newdef WSBFormFactor:VectorMass 41  6.34
 newdef WSBFormFactor:PseudoVectorMass 41  6.73
 newdef WSBFormFactor:F0 42  0
 newdef WSBFormFactor:V  42  0.705
 newdef WSBFormFactor:A0 42  0.623
 newdef WSBFormFactor:A1 42  0.651
 newdef WSBFormFactor:A2 42  0.686
 newdef WSBFormFactor:ScalarMass 42  6.3
 newdef WSBFormFactor:PseudoScalarMass 42  6.8
 newdef WSBFormFactor:VectorMass 42  6.34
 newdef WSBFormFactor:PseudoVectorMass 42  6.73
 newdef WSBFormFactor:F0 43  0
 newdef WSBFormFactor:V  43  0.369
 newdef WSBFormFactor:A0 43  0.321
 newdef WSBFormFactor:A1 43  0.328
 newdef WSBFormFactor:A2 43  0.331
 newdef WSBFormFactor:ScalarMass 43  5.38
 newdef WSBFormFactor:PseudoScalarMass 43  5.89
 newdef WSBFormFactor:VectorMass 43  5.43
 newdef WSBFormFactor:PseudoVectorMass 43  5.82
 newdef WSBFormFactor:F0 44  0
 newdef WSBFormFactor:V  44  0.369
 newdef WSBFormFactor:A0 44  0.321
 newdef WSBFormFactor:A1 44  0.328
 newdef WSBFormFactor:A2 44  0.331
 newdef WSBFormFactor:ScalarMass 44  5.38
 newdef WSBFormFactor:PseudoScalarMass 44  5.89
 newdef WSBFormFactor:VectorMass 44  5.43
 newdef WSBFormFactor:PseudoVectorMass 44  5.82
 newdef WSBFormFactor:F0 45  0
 newdef WSBFormFactor:V  45  0.329
 newdef WSBFormFactor:A0 45  0.281
 newdef WSBFormFactor:A1 45  0.283
 newdef WSBFormFactor:A2 45  0.283
 newdef WSBFormFactor:ScalarMass 45  5.27
 newdef WSBFormFactor:PseudoScalarMass 45  5.78
 newdef WSBFormFactor:VectorMass 45  5.32
 newdef WSBFormFactor:PseudoVectorMass 45  5.71
 newdef WSBFormFactor:F0 46  0
 newdef WSBFormFactor:V  46  0.329
 newdef WSBFormFactor:A0 46  0.281
 newdef WSBFormFactor:A1 46  0.283
 newdef WSBFormFactor:A2 46  0.283
 newdef WSBFormFactor:ScalarMass 46  5.27
 newdef WSBFormFactor:PseudoScalarMass 46  5.78
 newdef WSBFormFactor:VectorMass 46  5.32
 newdef WSBFormFactor:PseudoVectorMass 46  5.71
 newdef WSBFormFactor:F0 47  0
 newdef WSBFormFactor:V  47  0.329
 newdef WSBFormFactor:A0 47  0.281
 newdef WSBFormFactor:A1 47  0.283
 newdef WSBFormFactor:A2 47  0.283
 newdef WSBFormFactor:ScalarMass 47  5.27
 newdef WSBFormFactor:PseudoScalarMass 47  5.78
 newdef WSBFormFactor:VectorMass 47  5.32
 newdef WSBFormFactor:PseudoVectorMass 47  5.71
 newdef WSBFormFactor:F0 48  0
 newdef WSBFormFactor:V  48  0.329
 newdef WSBFormFactor:A0 48  0.281
 newdef WSBFormFactor:A1 48  0.283
 newdef WSBFormFactor:A2 48  0.283
 newdef WSBFormFactor:ScalarMass 48  5.27
 newdef WSBFormFactor:PseudoScalarMass 48  5.78
 newdef WSBFormFactor:VectorMass 48  5.32
 newdef WSBFormFactor:PseudoVectorMass 48  5.71
 newdef WSBFormFactor:F0 49  0
 newdef WSBFormFactor:V  49  0.328
 newdef WSBFormFactor:A0 49  0.28
 newdef WSBFormFactor:A1 49  0.281
 newdef WSBFormFactor:A2 49  0.281
 newdef WSBFormFactor:ScalarMass 49  5.27
 newdef WSBFormFactor:PseudoScalarMass 49  5.78
 newdef WSBFormFactor:VectorMass 49  5.32
 newdef WSBFormFactor:PseudoVectorMass 49  5.71
 newdef WSBFormFactor:F0 50  0
 newdef WSBFormFactor:V  50  0.328
 newdef WSBFormFactor:A0 50  0.28
 newdef WSBFormFactor:A1 50  0.281
 newdef WSBFormFactor:A2 50  0.281
 newdef WSBFormFactor:ScalarMass 50  5.27
 newdef WSBFormFactor:PseudoScalarMass 50  5.78
 newdef WSBFormFactor:VectorMass 50  5.32
 newdef WSBFormFactor:PseudoVectorMass 50  5.71
 newdef WSBFormFactor:Incoming 0 -321
 newdef WSBFormFactor:Outgoing 0 111
 newdef WSBFormFactor:Spin 0 0
 newdef WSBFormFactor:Spectator 0 -2
 newdef WSBFormFactor:InQuark 0 3
 newdef WSBFormFactor:OutQuark 0 2
 newdef WSBFormFactor:Incoming 1 -311
 newdef WSBFormFactor:Outgoing 1 211
 newdef WSBFormFactor:Spin 1 0
 newdef WSBFormFactor:Spectator 1 -1
 newdef WSBFormFactor:InQuark 1 3
 newdef WSBFormFactor:OutQuark 1 2
 newdef WSBFormFactor:Incoming 2 -321
 newdef WSBFormFactor:Outgoing 2 -211
 newdef WSBFormFactor:Spin 2 0
 newdef WSBFormFactor:Spectator 2 -2
 newdef WSBFormFactor:InQuark 2 3
 newdef WSBFormFactor:OutQuark 2 1
 newdef WSBFormFactor:Incoming 3 -311
 newdef WSBFormFactor:Outgoing 3 111
 newdef WSBFormFactor:Spin 3 0
 newdef WSBFormFactor:Spectator 3 -1
 newdef WSBFormFactor:InQuark 3 3
 newdef WSBFormFactor:OutQuark 3 1
 newdef WSBFormFactor:Incoming 4 421
 newdef WSBFormFactor:Outgoing 4 -321
 newdef WSBFormFactor:Spin 4 0
 newdef WSBFormFactor:Spectator 4 -2
 newdef WSBFormFactor:InQuark 4 4
 newdef WSBFormFactor:OutQuark 4 3
 newdef WSBFormFactor:Incoming 5 411
 newdef WSBFormFactor:Outgoing 5 -311
 newdef WSBFormFactor:Spin 5 0
 newdef WSBFormFactor:Spectator 5 -1
 newdef WSBFormFactor:InQuark 5 4
 newdef WSBFormFactor:OutQuark 5 3
 newdef WSBFormFactor:Incoming 6 421
 newdef WSBFormFactor:Outgoing 6 -211
 newdef WSBFormFactor:Spin 6 0
 newdef WSBFormFactor:Spectator 6 -2
 newdef WSBFormFactor:InQuark 6 4
 newdef WSBFormFactor:OutQuark 6 1
 newdef WSBFormFactor:Incoming 7 421
 newdef WSBFormFactor:Outgoing 7 111
 newdef WSBFormFactor:Spin 7 0
 newdef WSBFormFactor:Spectator 7 -2
 newdef WSBFormFactor:InQuark 7 4
 newdef WSBFormFactor:OutQuark 7 2
 newdef WSBFormFactor:Incoming 8 411
 newdef WSBFormFactor:Outgoing 8 111
 newdef WSBFormFactor:Spin 8 0
 newdef WSBFormFactor:Spectator 8 -1
 newdef WSBFormFactor:InQuark 8 4
 newdef WSBFormFactor:OutQuark 8 1
 newdef WSBFormFactor:Incoming 9 411
 newdef WSBFormFactor:Outgoing 9 211
 newdef WSBFormFactor:Spin 9 0
 newdef WSBFormFactor:Spectator 9 -1
 newdef WSBFormFactor:InQuark 9 4
 newdef WSBFormFactor:OutQuark 9 2
 newdef WSBFormFactor:Incoming 10 421
 newdef WSBFormFactor:Outgoing 10 221
 newdef WSBFormFactor:Spin 10 0
 newdef WSBFormFactor:Spectator 10 -2
 newdef WSBFormFactor:InQuark 10 4
 newdef WSBFormFactor:OutQuark 10 2
 newdef WSBFormFactor:Incoming 11 411
 newdef WSBFormFactor:Outgoing 11 221
 newdef WSBFormFactor:Spin 11 0
 newdef WSBFormFactor:Spectator 11 -1
 newdef WSBFormFactor:InQuark 11 4
 newdef WSBFormFactor:OutQuark 11 1
 newdef WSBFormFactor:Incoming 12 421
 newdef WSBFormFactor:Outgoing 12 331
 newdef WSBFormFactor:Spin 12 0
 newdef WSBFormFactor:Spectator 12 -2
 newdef WSBFormFactor:InQuark 12 4
 newdef WSBFormFactor:OutQuark 12 2
 newdef WSBFormFactor:Incoming 13 411
 newdef WSBFormFactor:Outgoing 13 331
 newdef WSBFormFactor:Spin 13 0
 newdef WSBFormFactor:Spectator 13 -1
 newdef WSBFormFactor:InQuark 13 4
 newdef WSBFormFactor:OutQuark 13 1
 newdef WSBFormFactor:Incoming 14 421
 newdef WSBFormFactor:Outgoing 14 -323
 newdef WSBFormFactor:Spin 14 1
 newdef WSBFormFactor:Spectator 14 -2
 newdef WSBFormFactor:InQuark 14 4
 newdef WSBFormFactor:OutQuark 14 3
 newdef WSBFormFactor:Incoming 15 411
 newdef WSBFormFactor:Outgoing 15 -313
 newdef WSBFormFactor:Spin 15 1
 newdef WSBFormFactor:Spectator 15 -1
 newdef WSBFormFactor:InQuark 15 4
 newdef WSBFormFactor:OutQuark 15 3
 newdef WSBFormFactor:Incoming 16 421
 newdef WSBFormFactor:Outgoing 16 -213
 newdef WSBFormFactor:Spin 16 1
 newdef WSBFormFactor:Spectator 16 -2
 newdef WSBFormFactor:InQuark 16 4
 newdef WSBFormFactor:OutQuark 16 1
 newdef WSBFormFactor:Incoming 17 421
 newdef WSBFormFactor:Outgoing 17 113
 newdef WSBFormFactor:Spin 17 1
 newdef WSBFormFactor:Spectator 17 -2
 newdef WSBFormFactor:InQuark 17 4
 newdef WSBFormFactor:OutQuark 17 2
 newdef WSBFormFactor:Incoming 18 411
 newdef WSBFormFactor:Outgoing 18 113
 newdef WSBFormFactor:Spin 18 1
 newdef WSBFormFactor:Spectator 18 -1
 newdef WSBFormFactor:InQuark 18 4
 newdef WSBFormFactor:OutQuark 18 1
 newdef WSBFormFactor:Incoming 19 411
 newdef WSBFormFactor:Outgoing 19 213
 newdef WSBFormFactor:Spin 19 1
 newdef WSBFormFactor:Spectator 19 -1
 newdef WSBFormFactor:InQuark 19 4
 newdef WSBFormFactor:OutQuark 19 2
 newdef WSBFormFactor:Incoming 20 411
 newdef WSBFormFactor:Outgoing 20 223
 newdef WSBFormFactor:Spin 20 1
 newdef WSBFormFactor:Spectator 20 -1
 newdef WSBFormFactor:InQuark 20 4
 newdef WSBFormFactor:OutQuark 20 1
 newdef WSBFormFactor:Incoming 21 421
 newdef WSBFormFactor:Outgoing 21 223
 newdef WSBFormFactor:Spin 21 1
 newdef WSBFormFactor:Spectator 21 -2
 newdef WSBFormFactor:InQuark 21 4
 newdef WSBFormFactor:OutQuark 21 2
 newdef WSBFormFactor:Incoming 22 431
 newdef WSBFormFactor:Outgoing 22 221
 newdef WSBFormFactor:Spin 22 0
 newdef WSBFormFactor:Spectator 22 -3
 newdef WSBFormFactor:InQuark 22 4
 newdef WSBFormFactor:OutQuark 22 3
 newdef WSBFormFactor:Incoming 23 431
 newdef WSBFormFactor:Outgoing 23 331
 newdef WSBFormFactor:Spin 23 0
 newdef WSBFormFactor:Spectator 23 -3
 newdef WSBFormFactor:InQuark 23 4
 newdef WSBFormFactor:OutQuark 23 3
 newdef WSBFormFactor:Incoming 24 431
 newdef WSBFormFactor:Outgoing 24 311
 newdef WSBFormFactor:Spin 24 0
 newdef WSBFormFactor:Spectator 24 -3
 newdef WSBFormFactor:InQuark 24 4
 newdef WSBFormFactor:OutQuark 24 1
 newdef WSBFormFactor:Incoming 25 431
 newdef WSBFormFactor:Outgoing 25 321
 newdef WSBFormFactor:Spin 25 0
 newdef WSBFormFactor:Spectator 25 -3
 newdef WSBFormFactor:InQuark 25 4
 newdef WSBFormFactor:OutQuark 25 2
 newdef WSBFormFactor:Incoming 26 431
 newdef WSBFormFactor:Outgoing 26 313
 newdef WSBFormFactor:Spin 26 1
 newdef WSBFormFactor:Spectator 26 -3
 newdef WSBFormFactor:InQuark 26 4
 newdef WSBFormFactor:OutQuark 26 1
 newdef WSBFormFactor:Incoming 27 431
 newdef WSBFormFactor:Outgoing 27 323
 newdef WSBFormFactor:Spin 27 1
 newdef WSBFormFactor:Spectator 27 -3
 newdef WSBFormFactor:InQuark 27 4
 newdef WSBFormFactor:OutQuark 27 2
 newdef WSBFormFactor:Incoming 28 431
 newdef WSBFormFactor:Outgoing 28 333
 newdef WSBFormFactor:Spin 28 1
 newdef WSBFormFactor:Spectator 28 -3
 newdef WSBFormFactor:InQuark 28 4
 newdef WSBFormFactor:OutQuark 28 3
 newdef WSBFormFactor:Incoming 29 -521
 newdef WSBFormFactor:Outgoing 29 421
 newdef WSBFormFactor:Spin 29 0
 newdef WSBFormFactor:Spectator 29 -2
 newdef WSBFormFactor:InQuark 29 5
 newdef WSBFormFactor:OutQuark 29 4
 newdef WSBFormFactor:Incoming 30 -511
 newdef WSBFormFactor:Outgoing 30 411
 newdef WSBFormFactor:Spin 30 0
 newdef WSBFormFactor:Spectator 30 -2
 newdef WSBFormFactor:InQuark 30 5
 newdef WSBFormFactor:OutQuark 30 4
 newdef WSBFormFactor:Incoming 31 -521
 newdef WSBFormFactor:Outgoing 31 -321
 newdef WSBFormFactor:Spin 31 0
 newdef WSBFormFactor:Spectator 31 -2
 newdef WSBFormFactor:InQuark 31 5
 newdef WSBFormFactor:OutQuark 31 3
 newdef WSBFormFactor:Incoming 32 -511
 newdef WSBFormFactor:Outgoing 32 -311
 newdef WSBFormFactor:Spin 32 0
 newdef WSBFormFactor:Spectator 32 -1
 newdef WSBFormFactor:InQuark 32 5
 newdef WSBFormFactor:OutQuark 32 3
 newdef WSBFormFactor:Incoming 33 -521
 newdef WSBFormFactor:Outgoing 33 111
 newdef WSBFormFactor:Spin 33 0
 newdef WSBFormFactor:Spectator 33 -2
 newdef WSBFormFactor:InQuark 33 5
 newdef WSBFormFactor:OutQuark 33 2
 newdef WSBFormFactor:Incoming 34 -511
 newdef WSBFormFactor:Outgoing 34 211
 newdef WSBFormFactor:Spin 34 0
 newdef WSBFormFactor:Spectator 34 -1
 newdef WSBFormFactor:InQuark 34 5
 newdef WSBFormFactor:OutQuark 34 2
 newdef WSBFormFactor:Incoming 35 -521
 newdef WSBFormFactor:Outgoing 35 -211
 newdef WSBFormFactor:Spin 35 0
 newdef WSBFormFactor:Spectator 35 -2
 newdef WSBFormFactor:InQuark 35 5
 newdef WSBFormFactor:OutQuark 35 1
 newdef WSBFormFactor:Incoming 36 -511
 newdef WSBFormFactor:Outgoing 36 111
 newdef WSBFormFactor:Spin 36 0
 newdef WSBFormFactor:Spectator 36 -1
 newdef WSBFormFactor:InQuark 36 5
 newdef WSBFormFactor:OutQuark 36 1
 newdef WSBFormFactor:Incoming 37 -521
 newdef WSBFormFactor:Outgoing 37 221
 newdef WSBFormFactor:Spin 37 0
 newdef WSBFormFactor:Spectator 37 -2
 newdef WSBFormFactor:InQuark 37 5
 newdef WSBFormFactor:OutQuark 37 2
 newdef WSBFormFactor:Incoming 38 -511
 newdef WSBFormFactor:Outgoing 38 221
 newdef WSBFormFactor:Spin 38 0
 newdef WSBFormFactor:Spectator 38 -1
 newdef WSBFormFactor:InQuark 38 5
 newdef WSBFormFactor:OutQuark 38 1
 newdef WSBFormFactor:Incoming 39 -521
 newdef WSBFormFactor:Outgoing 39 331
 newdef WSBFormFactor:Spin 39 0
 newdef WSBFormFactor:Spectator 39 -2
 newdef WSBFormFactor:InQuark 39 5
 newdef WSBFormFactor:OutQuark 39 2
 newdef WSBFormFactor:Incoming 40 -511
 newdef WSBFormFactor:Outgoing 40 331
 newdef WSBFormFactor:Spin 40 0
 newdef WSBFormFactor:Spectator 40 -1
 newdef WSBFormFactor:InQuark 40 5
 newdef WSBFormFactor:OutQuark 40 1
 newdef WSBFormFactor:Incoming 41 -521
 newdef WSBFormFactor:Outgoing 41 423
 newdef WSBFormFactor:Spin 41 1
 newdef WSBFormFactor:Spectator 41 -2
 newdef WSBFormFactor:InQuark 41 5
 newdef WSBFormFactor:OutQuark 41 4
 newdef WSBFormFactor:Incoming 42 -511
 newdef WSBFormFactor:Outgoing 42 413
 newdef WSBFormFactor:Spin 42 1
 newdef WSBFormFactor:Spectator 42 -1
 newdef WSBFormFactor:InQuark 42 5
 newdef WSBFormFactor:OutQuark 42 4
 newdef WSBFormFactor:Incoming 43 -521
 newdef WSBFormFactor:Outgoing 43 -323
 newdef WSBFormFactor:Spin 43 1
 newdef WSBFormFactor:Spectator 43 -2
 newdef WSBFormFactor:InQuark 43 5
 newdef WSBFormFactor:OutQuark 43 3
 newdef WSBFormFactor:Incoming 44 -511
 newdef WSBFormFactor:Outgoing 44 -313
 newdef WSBFormFactor:Spin 44 1
 newdef WSBFormFactor:Spectator 44 -1
 newdef WSBFormFactor:InQuark 44 5
 newdef WSBFormFactor:OutQuark 44 3
 newdef WSBFormFactor:Incoming 45 -521
 newdef WSBFormFactor:Outgoing 45 113
 newdef WSBFormFactor:Spin 45 1
 newdef WSBFormFactor:Spectator 45 -2
 newdef WSBFormFactor:InQuark 45 5
 newdef WSBFormFactor:OutQuark 45 2
 newdef WSBFormFactor:Incoming 46 -511
 newdef WSBFormFactor:Outgoing 46 213
 newdef WSBFormFactor:Spin 46 1
 newdef WSBFormFactor:Spectator 46 -1
 newdef WSBFormFactor:InQuark 46 5
 newdef WSBFormFactor:OutQuark 46 2
 newdef WSBFormFactor:Incoming 47 -521
 newdef WSBFormFactor:Outgoing 47 -213
 newdef WSBFormFactor:Spin 47 1
 newdef WSBFormFactor:Spectator 47 -2
 newdef WSBFormFactor:InQuark 47 5
 newdef WSBFormFactor:OutQuark 47 1
 newdef WSBFormFactor:Incoming 48 -511
 newdef WSBFormFactor:Outgoing 48 113
 newdef WSBFormFactor:Spin 48 1
 newdef WSBFormFactor:Spectator 48 -1
 newdef WSBFormFactor:InQuark 48 5
 newdef WSBFormFactor:OutQuark 48 1
 newdef WSBFormFactor:Incoming 49 -521
 newdef WSBFormFactor:Outgoing 49 223
 newdef WSBFormFactor:Spin 49 1
 newdef WSBFormFactor:Spectator 49 -2
 newdef WSBFormFactor:InQuark 49 5
 newdef WSBFormFactor:OutQuark 49 2
 newdef WSBFormFactor:Incoming 50 -511
 newdef WSBFormFactor:Outgoing 50 223
 newdef WSBFormFactor:Spin 50 1
 newdef WSBFormFactor:Spectator 50 -1
 newdef WSBFormFactor:InQuark 50 5
 newdef WSBFormFactor:OutQuark 50 1
 newdef WSB:FormFactor WSBFormFactor
 #
 create Herwig::BaryonFactorizedDecayer  BottomBaryonScalar
 newdef BottomBaryonScalar:Iteration 1
 newdef BottomBaryonScalar:Ntry 500
 newdef BottomBaryonScalar:Points 10000
 newdef BottomBaryonScalar:a1Bottom 1.23
 newdef BottomBaryonScalar:a2Bottom 0.33
 newdef BottomBaryonScalar:a1Charm 1.1
 newdef BottomBaryonScalar:a2Charm -0.5
 newdef BottomBaryonScalar:CKM /Herwig/CKM
 insert BottomBaryonScalar:WeightLocation 0 0
 insert BottomBaryonScalar:WeightLocation 1 0
 insert BottomBaryonScalar:WeightLocation 2 0
 insert BottomBaryonScalar:WeightLocation 3 0
 insert BottomBaryonScalar:WeightLocation 4 0
 insert BottomBaryonScalar:WeightLocation 5 0
 insert BottomBaryonScalar:WeightLocation 6 0
 insert BottomBaryonScalar:WeightLocation 7 0
 insert BottomBaryonScalar:WeightLocation 8 0
 insert BottomBaryonScalar:WeightLocation 9 0
 insert BottomBaryonScalar:WeightLocation 10 0
 insert BottomBaryonScalar:WeightLocation 11 0
 insert BottomBaryonScalar:WeightLocation 12 0
 insert BottomBaryonScalar:WeightLocation 13 0
 insert BottomBaryonScalar:WeightLocation 14 0
 insert BottomBaryonScalar:WeightLocation 15 0
 insert BottomBaryonScalar:WeightLocation 16 0
 insert BottomBaryonScalar:WeightLocation 17 0
 insert BottomBaryonScalar:WeightLocation 18 0
 insert BottomBaryonScalar:WeightLocation 19 0
 insert BottomBaryonScalar:WeightLocation 20 0
 insert BottomBaryonScalar:WeightLocation 21 0
 insert BottomBaryonScalar:WeightLocation 22 0
 insert BottomBaryonScalar:WeightLocation 23 0
 insert BottomBaryonScalar:WeightLocation 24 0
 insert BottomBaryonScalar:WeightLocation 25 0
 insert BottomBaryonScalar:WeightLocation 26 0
 insert BottomBaryonScalar:WeightLocation 27 0
 insert BottomBaryonScalar:WeightLocation 28 0
 insert BottomBaryonScalar:WeightLocation 29 0
 insert BottomBaryonScalar:WeightLocation 30 0
 insert BottomBaryonScalar:WeightLocation 31 0
 insert BottomBaryonScalar:WeightLocation 32 0
 insert BottomBaryonScalar:WeightLocation 33 0
 insert BottomBaryonScalar:WeightLocation 34 0
 insert BottomBaryonScalar:WeightLocation 35 0
 insert BottomBaryonScalar:WeightLocation 36 0
 insert BottomBaryonScalar:WeightLocation 37 0
 insert BottomBaryonScalar:WeightLocation 38 0
 insert BottomBaryonScalar:WeightLocation 39 0
 insert BottomBaryonScalar:WeightLocation 40 0
 insert BottomBaryonScalar:WeightLocation 41 0
 insert BottomBaryonScalar:WeightLocation 42 0
 insert BottomBaryonScalar:WeightLocation 43 0
 insert BottomBaryonScalar:WeightLocation 44 0
 insert BottomBaryonScalar:WeightLocation 45 0
 insert BottomBaryonScalar:WeightLocation 46 0
 insert BottomBaryonScalar:WeightLocation 47 0
 insert BottomBaryonScalar:WeightLocation 48 0
 insert BottomBaryonScalar:WeightLocation 49 0
 insert BottomBaryonScalar:WeightLocation 50 0
 insert BottomBaryonScalar:WeightLocation 51 0
 insert BottomBaryonScalar:WeightLocation 52 0
 insert BottomBaryonScalar:WeightLocation 53 0
 insert BottomBaryonScalar:WeightLocation 54 0
 insert BottomBaryonScalar:WeightLocation 55 0
 insert BottomBaryonScalar:WeightLocation 56 0
 insert BottomBaryonScalar:WeightLocation 57 0
 insert BottomBaryonScalar:WeightLocation 58 0
 insert BottomBaryonScalar:WeightLocation 59 0
 insert BottomBaryonScalar:WeightLocation 60 0
 insert BottomBaryonScalar:WeightLocation 61 0
 insert BottomBaryonScalar:WeightLocation 62 0
 insert BottomBaryonScalar:WeightLocation 63 0
 insert BottomBaryonScalar:WeightLocation 64 0
 insert BottomBaryonScalar:WeightLocation 65 0
 insert BottomBaryonScalar:WeightLocation 66 0
 insert BottomBaryonScalar:WeightLocation 67 0
 insert BottomBaryonScalar:WeightLocation 68 0
 insert BottomBaryonScalar:WeightLocation 69 0
 insert BottomBaryonScalar:WeightLocation 70 0
 insert BottomBaryonScalar:WeightLocation 71 0
 insert BottomBaryonScalar:WeightLocation 72 0
 insert BottomBaryonScalar:WeightLocation 73 0
 insert BottomBaryonScalar:WeightLocation 74 0
 insert BottomBaryonScalar:WeightLocation 75 0
 insert BottomBaryonScalar:WeightLocation 76 0
 insert BottomBaryonScalar:WeightLocation 77 0
 insert BottomBaryonScalar:WeightLocation 78 0
 insert BottomBaryonScalar:WeightLocation 79 0
 insert BottomBaryonScalar:WeightLocation 80 0
 insert BottomBaryonScalar:WeightLocation 81 0
 insert BottomBaryonScalar:WeightLocation 82 0
 insert BottomBaryonScalar:WeightLocation 83 0
 insert BottomBaryonScalar:WeightLocation 84 0
 insert BottomBaryonScalar:WeightLocation 85 0
 insert BottomBaryonScalar:WeightLocation 86 0
 insert BottomBaryonScalar:WeightLocation 87 0
 insert BottomBaryonScalar:MaximumWeight 0 0.021
 insert BottomBaryonScalar:MaximumWeight 1 0.0018
 insert BottomBaryonScalar:MaximumWeight 2 0.0024
 insert BottomBaryonScalar:MaximumWeight 3 0.070
 insert BottomBaryonScalar:MaximumWeight 4 0.006
 insert BottomBaryonScalar:MaximumWeight 5 8.56063e-09
 insert BottomBaryonScalar:MaximumWeight 6 4.41438e-09
 insert BottomBaryonScalar:MaximumWeight 7 4.27007e-09
 insert BottomBaryonScalar:MaximumWeight 8 6.07688e-06
 insert BottomBaryonScalar:MaximumWeight 9 9.19826e-07
 insert BottomBaryonScalar:MaximumWeight 10 1.19065e-07
 insert BottomBaryonScalar:MaximumWeight 11 6.16384e-08
 insert BottomBaryonScalar:MaximumWeight 12 6.01101e-08
 insert BottomBaryonScalar:MaximumWeight 13 8.8887e-05
 insert BottomBaryonScalar:MaximumWeight 14 3.7768e-08
 insert BottomBaryonScalar:MaximumWeight 15 0.027
 insert BottomBaryonScalar:MaximumWeight 16 0.0025
 insert BottomBaryonScalar:MaximumWeight 17 0.0035
 insert BottomBaryonScalar:MaximumWeight 18 0.09
 insert BottomBaryonScalar:MaximumWeight 19 0.0045673
 insert BottomBaryonScalar:MaximumWeight 20 0.028
 insert BottomBaryonScalar:MaximumWeight 21 0.0025
 insert BottomBaryonScalar:MaximumWeight 22 0.003
 insert BottomBaryonScalar:MaximumWeight 23 0.088
 insert BottomBaryonScalar:MaximumWeight 24 0.00457512
 insert BottomBaryonScalar:MaximumWeight 25 1.77806e-08
 insert BottomBaryonScalar:MaximumWeight 26 9.17422e-09
 insert BottomBaryonScalar:MaximumWeight 27 8.88518e-09
 insert BottomBaryonScalar:MaximumWeight 28 1.27117e-05
 insert BottomBaryonScalar:MaximumWeight 29 1.9241e-06
 insert BottomBaryonScalar:MaximumWeight 30 1.79105e-08
 insert BottomBaryonScalar:MaximumWeight 31 9.24135e-09
 insert BottomBaryonScalar:MaximumWeight 32 8.95234e-09
 insert BottomBaryonScalar:MaximumWeight 33 1.28062e-05
 insert BottomBaryonScalar:MaximumWeight 34 1.9384e-06
 insert BottomBaryonScalar:MaximumWeight 35 1.12622e-07
 insert BottomBaryonScalar:MaximumWeight 36 5.83167e-08
 insert BottomBaryonScalar:MaximumWeight 37 5.69376e-08
 insert BottomBaryonScalar:MaximumWeight 38 8.42658e-05
 insert BottomBaryonScalar:MaximumWeight 39 3.58044e-08
 insert BottomBaryonScalar:MaximumWeight 40 1.12936e-07
 insert BottomBaryonScalar:MaximumWeight 41 5.84801e-08
 insert BottomBaryonScalar:MaximumWeight 42 5.70908e-08
 insert BottomBaryonScalar:MaximumWeight 43 8.4519e-05
 insert BottomBaryonScalar:MaximumWeight 44 3.5912e-08
 insert BottomBaryonScalar:MaximumWeight 45 2.69015e-08
 insert BottomBaryonScalar:MaximumWeight 46 1.39361e-08
 insert BottomBaryonScalar:MaximumWeight 47 1.36195e-08
 insert BottomBaryonScalar:MaximumWeight 48 2.02555e-05
 insert BottomBaryonScalar:MaximumWeight 49 8.60654e-09
 insert BottomBaryonScalar:MaximumWeight 50 0.018
 insert BottomBaryonScalar:MaximumWeight 51 0.00110106
 insert BottomBaryonScalar:MaximumWeight 52 0.0023
 insert BottomBaryonScalar:MaximumWeight 53 0.07
 insert BottomBaryonScalar:MaximumWeight 54 0.00367262
 insert BottomBaryonScalar:MaximumWeight 55 1.43709e-07
 insert BottomBaryonScalar:MaximumWeight 56 7.35099e-08
 insert BottomBaryonScalar:MaximumWeight 57 6.98837e-08
 insert BottomBaryonScalar:MaximumWeight 58 9.30994e-05
 insert BottomBaryonScalar:MaximumWeight 59 3.95578e-08
 insert BottomBaryonScalar:MaximumWeight 60 0.00598854
 insert BottomBaryonScalar:MaximumWeight 61 0.000472722
 insert BottomBaryonScalar:MaximumWeight 62 0.000640993
 insert BottomBaryonScalar:MaximumWeight 63 0.0169935
 insert BottomBaryonScalar:MaximumWeight 64 0.00128473
 insert BottomBaryonScalar:MaximumWeight 65 1.61781e-08
 insert BottomBaryonScalar:MaximumWeight 66 7.84416e-09
 insert BottomBaryonScalar:MaximumWeight 67 6.68216e-09
 insert BottomBaryonScalar:MaximumWeight 68 6.88474e-06
 insert BottomBaryonScalar:MaximumWeight 69 1.04211e-06
 insert BottomBaryonScalar:MaximumWeight 70 8.01444e-07
 insert BottomBaryonScalar:MaximumWeight 71 3.82459e-07
 insert BottomBaryonScalar:MaximumWeight 72 3.05222e-07
 insert BottomBaryonScalar:MaximumWeight 73 0.000225103
 insert BottomBaryonScalar:MaximumWeight 74 9.43004e-08
 insert BottomBaryonScalar:MaximumWeight 75 0.0131163
 insert BottomBaryonScalar:MaximumWeight 76 0.000866485
 insert BottomBaryonScalar:MaximumWeight 77 0.000102483
 insert BottomBaryonScalar:MaximumWeight 78 0.0002451
 insert BottomBaryonScalar:MaximumWeight 79 2.59124e-06
 insert BottomBaryonScalar:MaximumWeight 80 1.44122e-05
 insert BottomBaryonScalar:MaximumWeight 81 0.00511908
 insert BottomBaryonScalar:MaximumWeight 82 0.020127
 insert BottomBaryonScalar:MaximumWeight 83 0.00153056
 insert BottomBaryonScalar:MaximumWeight 84 0.0501601
 insert BottomBaryonScalar:MaximumWeight 85 0.00379703
 insert BottomBaryonScalar:MaximumWeight 86 0.0128147
 insert BottomBaryonScalar:MaximumWeight 87 0.000969737
 create Herwig::ScalarMesonCurrent BottomBaryonScalarCurrent
 newdef BottomBaryonScalarCurrent:ThetaEtaEtaPrime -0.194
 newdef BottomBaryonScalarCurrent:ID 0 211
 newdef BottomBaryonScalarCurrent:Decay_Constant 0 130.7
 newdef BottomBaryonScalarCurrent:ID 1 111
 newdef BottomBaryonScalarCurrent:Decay_Constant 1 130.7
 newdef BottomBaryonScalarCurrent:ID 2 111
 newdef BottomBaryonScalarCurrent:Decay_Constant 2 130.7
 newdef BottomBaryonScalarCurrent:ID 3 221
 newdef BottomBaryonScalarCurrent:Decay_Constant 3 130.7
 newdef BottomBaryonScalarCurrent:ID 4 221
 newdef BottomBaryonScalarCurrent:Decay_Constant 4 130.7
 newdef BottomBaryonScalarCurrent:ID 5 221
 newdef BottomBaryonScalarCurrent:Decay_Constant 5 130.7
 newdef BottomBaryonScalarCurrent:ID 6 331
 newdef BottomBaryonScalarCurrent:Decay_Constant 6 130.7
 newdef BottomBaryonScalarCurrent:ID 7 331
 newdef BottomBaryonScalarCurrent:Decay_Constant 7 130.7
 newdef BottomBaryonScalarCurrent:ID 8 331
 newdef BottomBaryonScalarCurrent:Decay_Constant 8 130.7
 newdef BottomBaryonScalarCurrent:ID 9 311
 newdef BottomBaryonScalarCurrent:Decay_Constant 9 159.8
 newdef BottomBaryonScalarCurrent:ID 10 321
 newdef BottomBaryonScalarCurrent:Decay_Constant 10 159.8
 newdef BottomBaryonScalarCurrent:ID 11 411
 newdef BottomBaryonScalarCurrent:Decay_Constant 11 200
 newdef BottomBaryonScalarCurrent:ID 12 421
 newdef BottomBaryonScalarCurrent:Decay_Constant 12 200
 newdef BottomBaryonScalarCurrent:ID 13 431
 newdef BottomBaryonScalarCurrent:Decay_Constant 13 241
 newdef BottomBaryonScalarCurrent:ID 14 10431
 newdef BottomBaryonScalarCurrent:Decay_Constant 14 73.7
 newdef BottomBaryonScalarCurrent:Quark 0  2
 newdef BottomBaryonScalarCurrent:AntiQuark 0  -1
 newdef BottomBaryonScalarCurrent:Quark 1  1
 newdef BottomBaryonScalarCurrent:AntiQuark 1  -1
 newdef BottomBaryonScalarCurrent:Quark 2  2
 newdef BottomBaryonScalarCurrent:AntiQuark 2  -2
 newdef BottomBaryonScalarCurrent:Quark 3  1
 newdef BottomBaryonScalarCurrent:AntiQuark 3  -1
 newdef BottomBaryonScalarCurrent:Quark 4  2
 newdef BottomBaryonScalarCurrent:AntiQuark 4  -2
 newdef BottomBaryonScalarCurrent:Quark 5  3
 newdef BottomBaryonScalarCurrent:AntiQuark 5  -3
 newdef BottomBaryonScalarCurrent:Quark 6  1
 newdef BottomBaryonScalarCurrent:AntiQuark 6  -1
 newdef BottomBaryonScalarCurrent:Quark 7  2
 newdef BottomBaryonScalarCurrent:AntiQuark 7  -2
 newdef BottomBaryonScalarCurrent:Quark 8  3
 newdef BottomBaryonScalarCurrent:AntiQuark 8  -3
 newdef BottomBaryonScalarCurrent:Quark 9  1
 newdef BottomBaryonScalarCurrent:AntiQuark 9  -3
 newdef BottomBaryonScalarCurrent:Quark 10  2
 newdef BottomBaryonScalarCurrent:AntiQuark 10  -3
 newdef BottomBaryonScalarCurrent:Quark 11  4
 newdef BottomBaryonScalarCurrent:AntiQuark 11  -1
 newdef BottomBaryonScalarCurrent:Quark 12  4
 newdef BottomBaryonScalarCurrent:AntiQuark 12  -2
 newdef BottomBaryonScalarCurrent:Quark 13  4
 newdef BottomBaryonScalarCurrent:AntiQuark 13  -3
 newdef BottomBaryonScalarCurrent:Quark 14  4
 newdef BottomBaryonScalarCurrent:AntiQuark 14  -3
 newdef BottomBaryonScalar:Current BottomBaryonScalarCurrent
 create Herwig::ChengHeavyBaryonFormFactor BottomBaryonScalarForm
 newdef BottomBaryonScalarForm:DownMass     0.322
 newdef BottomBaryonScalarForm:UpMass       0.338
 newdef BottomBaryonScalarForm:StrangeMass  0.51
 newdef BottomBaryonScalarForm:CharmMass    1.6
 newdef BottomBaryonScalarForm:BottomMass   5
 newdef BottomBaryonScalarForm:VectorMassbc 6.34
 newdef BottomBaryonScalarForm:AxialMassbc  6.73
 newdef BottomBaryonScalarForm:VectorMassbs 5.42
 newdef BottomBaryonScalarForm:AxialMassbs  5.86
 newdef BottomBaryonScalarForm:VectorMassbd 5.32
 newdef BottomBaryonScalarForm:AxialMassbd  5.71
 newdef BottomBaryonScalarForm:VectorMasscs 2.11
 newdef BottomBaryonScalarForm:AxialMasscs  2.54
 newdef BottomBaryonScalarForm:VectorMasscu 2.01
 newdef BottomBaryonScalarForm:AxialMasscu  2.42
 newdef BottomBaryonScalarForm:Nfi 0  1
 newdef BottomBaryonScalarForm:Eta 0  1
 newdef BottomBaryonScalarForm:Nfi 1  0.57735
 newdef BottomBaryonScalarForm:Eta 1  1
 newdef BottomBaryonScalarForm:Nfi 2  0.707107
 newdef BottomBaryonScalarForm:Eta 2  1
 newdef BottomBaryonScalarForm:Nfi 3  1
 newdef BottomBaryonScalarForm:Eta 3  1
 newdef BottomBaryonScalarForm:Nfi 4  1
 newdef BottomBaryonScalarForm:Eta 4  1
 newdef BottomBaryonScalarForm:Nfi 5  0.707107
 newdef BottomBaryonScalarForm:Eta 5  1
 newdef BottomBaryonScalarForm:Nfi 6  0.707107
 newdef BottomBaryonScalarForm:Eta 6  1
 newdef BottomBaryonScalarForm:Nfi 7  0.5
 newdef BottomBaryonScalarForm:Eta 7  1
 newdef BottomBaryonScalarForm:Nfi 8  0.5
 newdef BottomBaryonScalarForm:Eta 8  1
 newdef BottomBaryonScalarForm:Nfi 9  0.288675
 newdef BottomBaryonScalarForm:Eta 9  1
 newdef BottomBaryonScalarForm:Nfi 10  1
 newdef BottomBaryonScalarForm:Eta 10  -0.333333
 newdef BottomBaryonScalarForm:Nfi 11  0.57735
 newdef BottomBaryonScalarForm:Eta 11  -0.333333
 newdef BottomBaryonScalarForm:Nfi 12  1
 newdef BottomBaryonScalarForm:Eta 12  0
 newdef BottomBaryonScalarForm:Nfi 13  1
 newdef BottomBaryonScalarForm:Eta 13  0
 newdef BottomBaryonScalarForm:Nfi 14  0.57735
 newdef BottomBaryonScalarForm:Eta 14  0
 newdef BottomBaryonScalarForm:Nfi 15  1
 newdef BottomBaryonScalarForm:Eta 15  0
 newdef BottomBaryonScalarForm:Nfi 16  0.57735
 newdef BottomBaryonScalarForm:Eta 16  0
 newdef BottomBaryonScalarForm:Nfi 17  0.57735
 newdef BottomBaryonScalarForm:Eta 17  1
 newdef BottomBaryonScalarForm:Nfi 18  0.57735
 newdef BottomBaryonScalarForm:Eta 18  1
 newdef BottomBaryonScalarForm:Nfi 19  0.57735
 newdef BottomBaryonScalarForm:Eta 19  1
 newdef BottomBaryonScalarForm:Incoming 0 5122
 newdef BottomBaryonScalarForm:Outgoing 0 4122
 newdef BottomBaryonScalarForm:InSpin 0 2
 newdef BottomBaryonScalarForm:OutSpin 0 2
 newdef BottomBaryonScalarForm:Spectator1 0 1
 newdef BottomBaryonScalarForm:Spectator2 0 2
 newdef BottomBaryonScalarForm:InQuark 0 5
 newdef BottomBaryonScalarForm:OutQuark 0 4
 newdef BottomBaryonScalarForm:Incoming 1 5122
 newdef BottomBaryonScalarForm:Outgoing 1 3122
 newdef BottomBaryonScalarForm:InSpin 1 2
 newdef BottomBaryonScalarForm:OutSpin 1 2
 newdef BottomBaryonScalarForm:Spectator1 1 1
 newdef BottomBaryonScalarForm:Spectator2 1 2
 newdef BottomBaryonScalarForm:InQuark 1 5
 newdef BottomBaryonScalarForm:OutQuark 1 3
 newdef BottomBaryonScalarForm:Incoming 2 5122
 newdef BottomBaryonScalarForm:Outgoing 2 2112
 newdef BottomBaryonScalarForm:InSpin 2 2
 newdef BottomBaryonScalarForm:OutSpin 2 2
 newdef BottomBaryonScalarForm:Spectator1 2 1
 newdef BottomBaryonScalarForm:Spectator2 2 2
 newdef BottomBaryonScalarForm:InQuark 2 5
 newdef BottomBaryonScalarForm:OutQuark 2 1
 newdef BottomBaryonScalarForm:Incoming 3 5232
 newdef BottomBaryonScalarForm:Outgoing 3 4232
 newdef BottomBaryonScalarForm:InSpin 3 2
 newdef BottomBaryonScalarForm:OutSpin 3 2
 newdef BottomBaryonScalarForm:Spectator1 3 2
 newdef BottomBaryonScalarForm:Spectator2 3 3
 newdef BottomBaryonScalarForm:InQuark 3 5
 newdef BottomBaryonScalarForm:OutQuark 3 4
 newdef BottomBaryonScalarForm:Incoming 4 5132
 newdef BottomBaryonScalarForm:Outgoing 4 4132
 newdef BottomBaryonScalarForm:InSpin 4 2
 newdef BottomBaryonScalarForm:OutSpin 4 2
 newdef BottomBaryonScalarForm:Spectator1 4 1
 newdef BottomBaryonScalarForm:Spectator2 4 3
 newdef BottomBaryonScalarForm:InQuark 4 5
 newdef BottomBaryonScalarForm:OutQuark 4 4
 newdef BottomBaryonScalarForm:Incoming 5 5232
 newdef BottomBaryonScalarForm:Outgoing 5 3322
 newdef BottomBaryonScalarForm:InSpin 5 2
 newdef BottomBaryonScalarForm:OutSpin 5 2
 newdef BottomBaryonScalarForm:Spectator1 5 2
 newdef BottomBaryonScalarForm:Spectator2 5 3
 newdef BottomBaryonScalarForm:InQuark 5 5
 newdef BottomBaryonScalarForm:OutQuark 5 3
 newdef BottomBaryonScalarForm:Incoming 6 5132
 newdef BottomBaryonScalarForm:Outgoing 6 3312
 newdef BottomBaryonScalarForm:InSpin 6 2
 newdef BottomBaryonScalarForm:OutSpin 6 2
 newdef BottomBaryonScalarForm:Spectator1 6 1
 newdef BottomBaryonScalarForm:Spectator2 6 3
 newdef BottomBaryonScalarForm:InQuark 6 5
 newdef BottomBaryonScalarForm:OutQuark 6 3
 newdef BottomBaryonScalarForm:Incoming 7 5232
 newdef BottomBaryonScalarForm:Outgoing 7 3212
 newdef BottomBaryonScalarForm:InSpin 7 2
 newdef BottomBaryonScalarForm:OutSpin 7 2
 newdef BottomBaryonScalarForm:Spectator1 7 2
 newdef BottomBaryonScalarForm:Spectator2 7 3
 newdef BottomBaryonScalarForm:InQuark 7 5
 newdef BottomBaryonScalarForm:OutQuark 7 1
 newdef BottomBaryonScalarForm:Incoming 8 5132
 newdef BottomBaryonScalarForm:Outgoing 8 3112
 newdef BottomBaryonScalarForm:InSpin 8 2
 newdef BottomBaryonScalarForm:OutSpin 8 2
 newdef BottomBaryonScalarForm:Spectator1 8 1
 newdef BottomBaryonScalarForm:Spectator2 8 3
 newdef BottomBaryonScalarForm:InQuark 8 5
 newdef BottomBaryonScalarForm:OutQuark 8 1
 newdef BottomBaryonScalarForm:Incoming 9 5232
 newdef BottomBaryonScalarForm:Outgoing 9 3122
 newdef BottomBaryonScalarForm:InSpin 9 2
 newdef BottomBaryonScalarForm:OutSpin 9 2
 newdef BottomBaryonScalarForm:Spectator1 9 2
 newdef BottomBaryonScalarForm:Spectator2 9 3
 newdef BottomBaryonScalarForm:InQuark 9 5
 newdef BottomBaryonScalarForm:OutQuark 9 1
 newdef BottomBaryonScalarForm:Incoming 10 5332
 newdef BottomBaryonScalarForm:Outgoing 10 4332
 newdef BottomBaryonScalarForm:InSpin 10 2
 newdef BottomBaryonScalarForm:OutSpin 10 2
 newdef BottomBaryonScalarForm:Spectator1 10 3
 newdef BottomBaryonScalarForm:Spectator2 10 3
 newdef BottomBaryonScalarForm:InQuark 10 5
 newdef BottomBaryonScalarForm:OutQuark 10 4
 newdef BottomBaryonScalarForm:Incoming 11 5332
 newdef BottomBaryonScalarForm:Outgoing 11 3312
 newdef BottomBaryonScalarForm:InSpin 11 2
 newdef BottomBaryonScalarForm:OutSpin 11 2
 newdef BottomBaryonScalarForm:Spectator1 11 3
 newdef BottomBaryonScalarForm:Spectator2 11 3
 newdef BottomBaryonScalarForm:InQuark 11 5
 newdef BottomBaryonScalarForm:OutQuark 11 1
 newdef BottomBaryonScalarForm:Incoming 12 5332
 newdef BottomBaryonScalarForm:Outgoing 12 4334
 newdef BottomBaryonScalarForm:InSpin 12 2
 newdef BottomBaryonScalarForm:OutSpin 12 4
 newdef BottomBaryonScalarForm:Spectator1 12 3
 newdef BottomBaryonScalarForm:Spectator2 12 3
 newdef BottomBaryonScalarForm:InQuark 12 5
 newdef BottomBaryonScalarForm:OutQuark 12 4
 newdef BottomBaryonScalarForm:Incoming 13 5332
 newdef BottomBaryonScalarForm:Outgoing 13 3334
 newdef BottomBaryonScalarForm:InSpin 13 2
 newdef BottomBaryonScalarForm:OutSpin 13 4
 newdef BottomBaryonScalarForm:Spectator1 13 3
 newdef BottomBaryonScalarForm:Spectator2 13 3
 newdef BottomBaryonScalarForm:InQuark 13 5
 newdef BottomBaryonScalarForm:OutQuark 13 3
 newdef BottomBaryonScalarForm:Incoming 14 5332
 newdef BottomBaryonScalarForm:Outgoing 14 3314
 newdef BottomBaryonScalarForm:InSpin 14 2
 newdef BottomBaryonScalarForm:OutSpin 14 4
 newdef BottomBaryonScalarForm:Spectator1 14 3
 newdef BottomBaryonScalarForm:Spectator2 14 3
 newdef BottomBaryonScalarForm:InQuark 14 5
 newdef BottomBaryonScalarForm:OutQuark 14 1
 newdef BottomBaryonScalarForm:Incoming 15 4332
 newdef BottomBaryonScalarForm:Outgoing 15 3334
 newdef BottomBaryonScalarForm:InSpin 15 2
 newdef BottomBaryonScalarForm:OutSpin 15 4
 newdef BottomBaryonScalarForm:Spectator1 15 3
 newdef BottomBaryonScalarForm:Spectator2 15 3
 newdef BottomBaryonScalarForm:InQuark 15 4
 newdef BottomBaryonScalarForm:OutQuark 15 3
 newdef BottomBaryonScalarForm:Incoming 16 4332
 newdef BottomBaryonScalarForm:Outgoing 16 3324
 newdef BottomBaryonScalarForm:InSpin 16 2
 newdef BottomBaryonScalarForm:OutSpin 16 4
 newdef BottomBaryonScalarForm:Spectator1 16 3
 newdef BottomBaryonScalarForm:Spectator2 16 3
 newdef BottomBaryonScalarForm:InQuark 16 4
 newdef BottomBaryonScalarForm:OutQuark 16 2
 newdef BottomBaryonScalarForm:Incoming 17 4122
 newdef BottomBaryonScalarForm:Outgoing 17 3122
 newdef BottomBaryonScalarForm:InSpin 17 2
 newdef BottomBaryonScalarForm:OutSpin 17 2
 newdef BottomBaryonScalarForm:Spectator1 17 1
 newdef BottomBaryonScalarForm:Spectator2 17 2
 newdef BottomBaryonScalarForm:InQuark 17 4
 newdef BottomBaryonScalarForm:OutQuark 17 3
 newdef BottomBaryonScalarForm:Incoming 18 4232
 newdef BottomBaryonScalarForm:Outgoing 18 3322
 newdef BottomBaryonScalarForm:InSpin 18 2
 newdef BottomBaryonScalarForm:OutSpin 18 2
 newdef BottomBaryonScalarForm:Spectator1 18 2
 newdef BottomBaryonScalarForm:Spectator2 18 3
 newdef BottomBaryonScalarForm:InQuark 18 4
 newdef BottomBaryonScalarForm:OutQuark 18 3
 newdef BottomBaryonScalarForm:Incoming 19 4132
 newdef BottomBaryonScalarForm:Outgoing 19 3312
 newdef BottomBaryonScalarForm:InSpin 19 2
 newdef BottomBaryonScalarForm:OutSpin 19 2
 newdef BottomBaryonScalarForm:Spectator1 19 1
 newdef BottomBaryonScalarForm:Spectator2 19 3
 newdef BottomBaryonScalarForm:InQuark 19 4
 newdef BottomBaryonScalarForm:OutQuark 19 3
 newdef BottomBaryonScalar:FormFactor BottomBaryonScalarForm
 #
 create Herwig::BaryonFactorizedDecayer  BottomBaryonVector
 newdef BottomBaryonVector:Iteration 1
 newdef BottomBaryonVector:Ntry 500
 newdef BottomBaryonVector:Points 10000
 newdef BottomBaryonVector:a1Bottom 1.23
 newdef BottomBaryonVector:a2Bottom 0.33
 newdef BottomBaryonVector:a1Charm 1.1
 newdef BottomBaryonVector:a2Charm -0.5
 newdef BottomBaryonVector:CKM /Herwig/CKM
 insert BottomBaryonVector:WeightLocation 0 0
 insert BottomBaryonVector:WeightLocation 1 0
 insert BottomBaryonVector:WeightLocation 2 0
 insert BottomBaryonVector:WeightLocation 3 0
 insert BottomBaryonVector:WeightLocation 4 0
 insert BottomBaryonVector:WeightLocation 5 0
 insert BottomBaryonVector:WeightLocation 6 0
 insert BottomBaryonVector:WeightLocation 7 0
 insert BottomBaryonVector:WeightLocation 8 0
 insert BottomBaryonVector:WeightLocation 9 0
 insert BottomBaryonVector:WeightLocation 10 0
 insert BottomBaryonVector:WeightLocation 11 0
 insert BottomBaryonVector:WeightLocation 12 0
 insert BottomBaryonVector:WeightLocation 13 0
 insert BottomBaryonVector:WeightLocation 14 0
 insert BottomBaryonVector:WeightLocation 15 0
 insert BottomBaryonVector:WeightLocation 16 0
 insert BottomBaryonVector:WeightLocation 17 0
 insert BottomBaryonVector:WeightLocation 18 0
 insert BottomBaryonVector:WeightLocation 19 0
 insert BottomBaryonVector:WeightLocation 20 0
 insert BottomBaryonVector:WeightLocation 21 0
 insert BottomBaryonVector:WeightLocation 22 0
 insert BottomBaryonVector:WeightLocation 23 0
 insert BottomBaryonVector:WeightLocation 24 0
 insert BottomBaryonVector:WeightLocation 25 0
 insert BottomBaryonVector:WeightLocation 26 0
 insert BottomBaryonVector:WeightLocation 27 0
 insert BottomBaryonVector:WeightLocation 28 0
 insert BottomBaryonVector:WeightLocation 29 0
 insert BottomBaryonVector:WeightLocation 30 0
 insert BottomBaryonVector:WeightLocation 31 0
 insert BottomBaryonVector:WeightLocation 32 0
 insert BottomBaryonVector:WeightLocation 33 0
 insert BottomBaryonVector:WeightLocation 34 0
 insert BottomBaryonVector:WeightLocation 35 0
 insert BottomBaryonVector:WeightLocation 36 0
 insert BottomBaryonVector:WeightLocation 37 0
 insert BottomBaryonVector:WeightLocation 38 0
 insert BottomBaryonVector:WeightLocation 39 0
 insert BottomBaryonVector:WeightLocation 40 0
 insert BottomBaryonVector:WeightLocation 41 0
 insert BottomBaryonVector:WeightLocation 42 0
 insert BottomBaryonVector:WeightLocation 43 0
 insert BottomBaryonVector:WeightLocation 44 0
 insert BottomBaryonVector:WeightLocation 45 0
 insert BottomBaryonVector:WeightLocation 46 0
 insert BottomBaryonVector:WeightLocation 47 0
 insert BottomBaryonVector:WeightLocation 48 0
 insert BottomBaryonVector:WeightLocation 49 0
 insert BottomBaryonVector:WeightLocation 50 0
 insert BottomBaryonVector:WeightLocation 51 0
 insert BottomBaryonVector:WeightLocation 52 0
 insert BottomBaryonVector:WeightLocation 53 0
 insert BottomBaryonVector:WeightLocation 54 0
 insert BottomBaryonVector:WeightLocation 55 0
 insert BottomBaryonVector:WeightLocation 56 0
 insert BottomBaryonVector:WeightLocation 57 0
 insert BottomBaryonVector:WeightLocation 58 0
 insert BottomBaryonVector:WeightLocation 59 0
 insert BottomBaryonVector:WeightLocation 60 0
 insert BottomBaryonVector:WeightLocation 61 0
 insert BottomBaryonVector:WeightLocation 62 0
 insert BottomBaryonVector:WeightLocation 63 0
 insert BottomBaryonVector:WeightLocation 64 0
 insert BottomBaryonVector:WeightLocation 65 0
 insert BottomBaryonVector:WeightLocation 66 0
 insert BottomBaryonVector:WeightLocation 67 0
 insert BottomBaryonVector:WeightLocation 68 0
 insert BottomBaryonVector:WeightLocation 69 0
 insert BottomBaryonVector:WeightLocation 70 0
 insert BottomBaryonVector:WeightLocation 71 0
 insert BottomBaryonVector:WeightLocation 72 0
 insert BottomBaryonVector:WeightLocation 73 0
 insert BottomBaryonVector:WeightLocation 74 0
 insert BottomBaryonVector:WeightLocation 75 0
 insert BottomBaryonVector:WeightLocation 76 0
 insert BottomBaryonVector:WeightLocation 77 0
 insert BottomBaryonVector:WeightLocation 78 0
 insert BottomBaryonVector:WeightLocation 79 0
 insert BottomBaryonVector:WeightLocation 80 0
 insert BottomBaryonVector:WeightLocation 81 0
 insert BottomBaryonVector:WeightLocation 82 0
 insert BottomBaryonVector:WeightLocation 83 0
 insert BottomBaryonVector:WeightLocation 84 0
 insert BottomBaryonVector:WeightLocation 85 0
 insert BottomBaryonVector:WeightLocation 86 0
 insert BottomBaryonVector:WeightLocation 87 0
 insert BottomBaryonVector:WeightLocation 88 0
 insert BottomBaryonVector:WeightLocation 89 0
 insert BottomBaryonVector:WeightLocation 90 0
 insert BottomBaryonVector:WeightLocation 91 0
 insert BottomBaryonVector:WeightLocation 92 0
 insert BottomBaryonVector:WeightLocation 93 0
 insert BottomBaryonVector:WeightLocation 94 0
 insert BottomBaryonVector:WeightLocation 95 0
 insert BottomBaryonVector:WeightLocation 96 0
 insert BottomBaryonVector:WeightLocation 97 0
 insert BottomBaryonVector:WeightLocation 98 0
 insert BottomBaryonVector:WeightLocation 99 0
 insert BottomBaryonVector:WeightLocation 100 0
 insert BottomBaryonVector:WeightLocation 101 0
 insert BottomBaryonVector:WeightLocation 102 0
 insert BottomBaryonVector:WeightLocation 103 0
 insert BottomBaryonVector:WeightLocation 104 0
 insert BottomBaryonVector:WeightLocation 105 0
 insert BottomBaryonVector:WeightLocation 106 0
 insert BottomBaryonVector:WeightLocation 107 0
 insert BottomBaryonVector:WeightLocation 108 0
 insert BottomBaryonVector:WeightLocation 109 0
 insert BottomBaryonVector:WeightLocation 110 0
 insert BottomBaryonVector:WeightLocation 111 0
 insert BottomBaryonVector:WeightLocation 112 0
 insert BottomBaryonVector:WeightLocation 113 0
 insert BottomBaryonVector:WeightLocation 114 0
 insert BottomBaryonVector:WeightLocation 115 0
 insert BottomBaryonVector:WeightLocation 116 0
 insert BottomBaryonVector:WeightLocation 117 0
 insert BottomBaryonVector:MaximumWeight 0 0.06
 insert BottomBaryonVector:MaximumWeight 1 0.00612163
 insert BottomBaryonVector:MaximumWeight 2 0.18
 insert BottomBaryonVector:MaximumWeight 3 0.00309077
 insert BottomBaryonVector:MaximumWeight 4 0.0695929
 insert BottomBaryonVector:MaximumWeight 5 0.0324241
 insert BottomBaryonVector:MaximumWeight 6 2.65172e-08
 insert BottomBaryonVector:MaximumWeight 7 8.37622e-08
 insert BottomBaryonVector:MaximumWeight 8 7.93362e-08
 insert BottomBaryonVector:MaximumWeight 9 8.953e-06
 insert BottomBaryonVector:MaximumWeight 10 1.3552e-06
 insert BottomBaryonVector:MaximumWeight 11 0.00115009
 insert BottomBaryonVector:MaximumWeight 12 0.000972447
 insert BottomBaryonVector:MaximumWeight 13 3.66488e-07
 insert BottomBaryonVector:MaximumWeight 14 1.13877e-06
 insert BottomBaryonVector:MaximumWeight 15 1.08871e-06
 insert BottomBaryonVector:MaximumWeight 16 0.000121201
 insert BottomBaryonVector:MaximumWeight 17 5.14972e-08
 insert BottomBaryonVector:MaximumWeight 18 4.50002e-05
 insert BottomBaryonVector:MaximumWeight 19 4.13094e-05
 insert BottomBaryonVector:MaximumWeight 20 0.08
 insert BottomBaryonVector:MaximumWeight 21 0.00731867
 insert BottomBaryonVector:MaximumWeight 22 0.23
 insert BottomBaryonVector:MaximumWeight 23 0.00368031
 insert BottomBaryonVector:MaximumWeight 24 0.0833327
 insert BottomBaryonVector:MaximumWeight 25 0.038913
 insert BottomBaryonVector:MaximumWeight 26 0.08
 insert BottomBaryonVector:MaximumWeight 27 0.00731593
 insert BottomBaryonVector:MaximumWeight 28 0.24
 insert BottomBaryonVector:MaximumWeight 29 0.00370561
 insert BottomBaryonVector:MaximumWeight 30 0.083468
 insert BottomBaryonVector:MaximumWeight 31 0.038978
 insert BottomBaryonVector:MaximumWeight 32 5.49863e-08
 insert BottomBaryonVector:MaximumWeight 33 1.72936e-07
 insert BottomBaryonVector:MaximumWeight 34 1.64202e-07
 insert BottomBaryonVector:MaximumWeight 35 1.84595e-05
 insert BottomBaryonVector:MaximumWeight 36 2.79291e-06
 insert BottomBaryonVector:MaximumWeight 37 0.00237386
 insert BottomBaryonVector:MaximumWeight 38 0.00201395
 insert BottomBaryonVector:MaximumWeight 39 5.53851e-08
 insert BottomBaryonVector:MaximumWeight 40 1.7474e-07
 insert BottomBaryonVector:MaximumWeight 41 1.65383e-07
 insert BottomBaryonVector:MaximumWeight 42 1.85805e-05
 insert BottomBaryonVector:MaximumWeight 43 2.81345e-06
 insert BottomBaryonVector:MaximumWeight 44 0.00239027
 insert BottomBaryonVector:MaximumWeight 45 0.00202752
 insert BottomBaryonVector:MaximumWeight 46 3.45745e-07
 insert BottomBaryonVector:MaximumWeight 47 1.08706e-06
 insert BottomBaryonVector:MaximumWeight 48 1.02367e-06
 insert BottomBaryonVector:MaximumWeight 49 0.000112858
 insert BottomBaryonVector:MaximumWeight 50 4.79645e-08
 insert BottomBaryonVector:MaximumWeight 51 4.13834e-05
 insert BottomBaryonVector:MaximumWeight 52 3.74634e-05
 insert BottomBaryonVector:MaximumWeight 53 3.46681e-07
 insert BottomBaryonVector:MaximumWeight 54 1.0836e-06
 insert BottomBaryonVector:MaximumWeight 55 1.02634e-06
 insert BottomBaryonVector:MaximumWeight 56 0.000113141
 insert BottomBaryonVector:MaximumWeight 57 4.80722e-08
 insert BottomBaryonVector:MaximumWeight 58 4.14795e-05
 insert BottomBaryonVector:MaximumWeight 59 3.75666e-05
 insert BottomBaryonVector:MaximumWeight 60 8.25592e-08
 insert BottomBaryonVector:MaximumWeight 61 2.59006e-07
 insert BottomBaryonVector:MaximumWeight 62 2.44365e-07
 insert BottomBaryonVector:MaximumWeight 63 2.69568e-05
 insert BottomBaryonVector:MaximumWeight 64 1.1447e-08
 insert BottomBaryonVector:MaximumWeight 65 9.97623e-06
 insert BottomBaryonVector:MaximumWeight 66 9.23672e-06
 insert BottomBaryonVector:MaximumWeight 67 0.05
 insert BottomBaryonVector:MaximumWeight 68 0.00425156
 insert BottomBaryonVector:MaximumWeight 69 0.15
 insert BottomBaryonVector:MaximumWeight 70 0.00155878
 insert BottomBaryonVector:MaximumWeight 71 0.041
 insert BottomBaryonVector:MaximumWeight 72 0.0119752
 insert BottomBaryonVector:MaximumWeight 73 4.20717e-07
 insert BottomBaryonVector:MaximumWeight 74 1.29436e-06
 insert BottomBaryonVector:MaximumWeight 75 1.16536e-06
 insert BottomBaryonVector:MaximumWeight 76 0.000100101
 insert BottomBaryonVector:MaximumWeight 77 4.25338e-08
 insert BottomBaryonVector:MaximumWeight 78 2.30658e-05
 insert BottomBaryonVector:MaximumWeight 79 1.52993e-05
 insert BottomBaryonVector:MaximumWeight 80 0.0225479
 insert BottomBaryonVector:MaximumWeight 81 0.00340359
 insert BottomBaryonVector:MaximumWeight 82 0.0670545
 insert BottomBaryonVector:MaximumWeight 83 0.00207781
 insert BottomBaryonVector:MaximumWeight 84 0.0485642
 insert BottomBaryonVector:MaximumWeight 85 0.0249597
 insert BottomBaryonVector:MaximumWeight 86 5.19428e-08
 insert BottomBaryonVector:MaximumWeight 87 1.602e-07
 insert BottomBaryonVector:MaximumWeight 88 1.55161e-07
 insert BottomBaryonVector:MaximumWeight 89 2.07183e-05
 insert BottomBaryonVector:MaximumWeight 90 3.13573e-06
 insert BottomBaryonVector:MaximumWeight 91 0.006
 insert BottomBaryonVector:MaximumWeight 92 0.00355305
 insert BottomBaryonVector:MaximumWeight 93 2.20399e-06
 insert BottomBaryonVector:MaximumWeight 94 4.56021e-06
 insert BottomBaryonVector:MaximumWeight 95 6.2865e-06
 insert BottomBaryonVector:MaximumWeight 96 0.000590819
 insert BottomBaryonVector:MaximumWeight 97 2.72562e-07
 insert BottomBaryonVector:MaximumWeight 98 0.000250635
 insert BottomBaryonVector:MaximumWeight 99 0.000233231
 insert BottomBaryonVector:MaximumWeight 100 0.0666776
 insert BottomBaryonVector:MaximumWeight 101 0.00385387
 insert BottomBaryonVector:MaximumWeight 102 0.00895393
 insert BottomBaryonVector:MaximumWeight 103 0.000482572
 insert BottomBaryonVector:MaximumWeight 104 0.000972852
 insert BottomBaryonVector:MaximumWeight 105 0.00180393
 insert BottomBaryonVector:MaximumWeight 106 6.10446e-05
 insert BottomBaryonVector:MaximumWeight 107 0.0217848
 insert BottomBaryonVector:MaximumWeight 108 0.000128913
 insert BottomBaryonVector:MaximumWeight 109 0.0832288
 insert BottomBaryonVector:MaximumWeight 110 0.00593006
 insert BottomBaryonVector:MaximumWeight 111 0.0408944
 insert BottomBaryonVector:MaximumWeight 112 0.203886
 insert BottomBaryonVector:MaximumWeight 113 0.0137325
 insert BottomBaryonVector:MaximumWeight 114 0.0871771
 insert BottomBaryonVector:MaximumWeight 115 0.0520421
 insert BottomBaryonVector:MaximumWeight 116 0.00349373
 insert BottomBaryonVector:MaximumWeight 117 0.0220737
 create Herwig::VectorMesonCurrent BottomBaryonVectorCurrent
 newdef BottomBaryonVectorCurrent:ID 0 213
 newdef BottomBaryonVectorCurrent:Decay_Constant 0 0.16632
 newdef BottomBaryonVectorCurrent:ID 1 113
 newdef BottomBaryonVectorCurrent:Decay_Constant 1 0.16632
 newdef BottomBaryonVectorCurrent:ID 2 113
 newdef BottomBaryonVectorCurrent:Decay_Constant 2 0.16632
 newdef BottomBaryonVectorCurrent:ID 3 223
 newdef BottomBaryonVectorCurrent:Decay_Constant 3 0.1764
 newdef BottomBaryonVectorCurrent:ID 4 223
 newdef BottomBaryonVectorCurrent:Decay_Constant 4 0.1764
 newdef BottomBaryonVectorCurrent:ID 5 333
 newdef BottomBaryonVectorCurrent:Decay_Constant 5 0.238
 newdef BottomBaryonVectorCurrent:ID 6 313
 newdef BottomBaryonVectorCurrent:Decay_Constant 6 0.2019
 newdef BottomBaryonVectorCurrent:ID 7 323
 newdef BottomBaryonVectorCurrent:Decay_Constant 7 0.2019
 newdef BottomBaryonVectorCurrent:ID 8 20213
 newdef BottomBaryonVectorCurrent:Decay_Constant 8 0.4626
 newdef BottomBaryonVectorCurrent:ID 9 20113
 newdef BottomBaryonVectorCurrent:Decay_Constant 9 0.4626
 newdef BottomBaryonVectorCurrent:ID 10 20113
 newdef BottomBaryonVectorCurrent:Decay_Constant 10 0.4626
 newdef BottomBaryonVectorCurrent:ID 11 413
 newdef BottomBaryonVectorCurrent:Decay_Constant 11 0.402
 newdef BottomBaryonVectorCurrent:ID 12 423
 newdef BottomBaryonVectorCurrent:Decay_Constant 12 0.402
 newdef BottomBaryonVectorCurrent:ID 13 433
 newdef BottomBaryonVectorCurrent:Decay_Constant 13 0.509
 newdef BottomBaryonVectorCurrent:ID 14 443
 newdef BottomBaryonVectorCurrent:Decay_Constant 14 1.223
 newdef BottomBaryonVectorCurrent:ID 15 100443
 newdef BottomBaryonVectorCurrent:Decay_Constant 15 1.08
 newdef BottomBaryonVectorCurrent:ID 16 20433
 newdef BottomBaryonVectorCurrent:Decay_Constant 16 0.397
 newdef BottomBaryonVectorCurrent:Quark 0  2
 newdef BottomBaryonVectorCurrent:AntiQuark 0  -1
 newdef BottomBaryonVectorCurrent:Quark 1  1
 newdef BottomBaryonVectorCurrent:AntiQuark 1  -1
 newdef BottomBaryonVectorCurrent:Quark 2  2
 newdef BottomBaryonVectorCurrent:AntiQuark 2  -2
 newdef BottomBaryonVectorCurrent:Quark 3  1
 newdef BottomBaryonVectorCurrent:AntiQuark 3  -1
 newdef BottomBaryonVectorCurrent:Quark 4  2
 newdef BottomBaryonVectorCurrent:AntiQuark 4  -2
 newdef BottomBaryonVectorCurrent:Quark 5  3
 newdef BottomBaryonVectorCurrent:AntiQuark 5  -3
 newdef BottomBaryonVectorCurrent:Quark 6  1
 newdef BottomBaryonVectorCurrent:AntiQuark 6  -3
 newdef BottomBaryonVectorCurrent:Quark 7  2
 newdef BottomBaryonVectorCurrent:AntiQuark 7  -3
 newdef BottomBaryonVectorCurrent:Quark 8  2
 newdef BottomBaryonVectorCurrent:AntiQuark 8  -1
 newdef BottomBaryonVectorCurrent:Quark 9  1
 newdef BottomBaryonVectorCurrent:AntiQuark 9  -1
 newdef BottomBaryonVectorCurrent:Quark 10  2
 newdef BottomBaryonVectorCurrent:AntiQuark 10  -2
 newdef BottomBaryonVectorCurrent:Quark 11  4
 newdef BottomBaryonVectorCurrent:AntiQuark 11  -1
 newdef BottomBaryonVectorCurrent:Quark 12  4
 newdef BottomBaryonVectorCurrent:AntiQuark 12  -2
 newdef BottomBaryonVectorCurrent:Quark 13  4
 newdef BottomBaryonVectorCurrent:AntiQuark 13  -3
 newdef BottomBaryonVectorCurrent:Quark 14  4
 newdef BottomBaryonVectorCurrent:AntiQuark 14  -4
 newdef BottomBaryonVectorCurrent:Quark 15  4
 newdef BottomBaryonVectorCurrent:AntiQuark 15  -4
 newdef BottomBaryonVectorCurrent:Quark 16  4
 newdef BottomBaryonVectorCurrent:AntiQuark 16  -3
 newdef BottomBaryonVector:Current BottomBaryonVectorCurrent
 create Herwig::ChengHeavyBaryonFormFactor BottomBaryonVectorForm
 newdef BottomBaryonVectorForm:DownMass     0.322
 newdef BottomBaryonVectorForm:UpMass       0.338
 newdef BottomBaryonVectorForm:StrangeMass  0.51
 newdef BottomBaryonVectorForm:CharmMass    1.6
 newdef BottomBaryonVectorForm:BottomMass   5
 newdef BottomBaryonVectorForm:VectorMassbc 6.34
 newdef BottomBaryonVectorForm:AxialMassbc  6.73
 newdef BottomBaryonVectorForm:VectorMassbs 5.42
 newdef BottomBaryonVectorForm:AxialMassbs  5.86
 newdef BottomBaryonVectorForm:VectorMassbd 5.32
 newdef BottomBaryonVectorForm:AxialMassbd  5.71
 newdef BottomBaryonVectorForm:VectorMasscs 2.11
 newdef BottomBaryonVectorForm:AxialMasscs  2.54
 newdef BottomBaryonVectorForm:VectorMasscu 2.01
 newdef BottomBaryonVectorForm:AxialMasscu  2.42
 newdef BottomBaryonVectorForm:Nfi 0  1
 newdef BottomBaryonVectorForm:Eta 0  1
 newdef BottomBaryonVectorForm:Nfi 1  0.57735
 newdef BottomBaryonVectorForm:Eta 1  1
 newdef BottomBaryonVectorForm:Nfi 2  0.707107
 newdef BottomBaryonVectorForm:Eta 2  1
 newdef BottomBaryonVectorForm:Nfi 3  1
 newdef BottomBaryonVectorForm:Eta 3  1
 newdef BottomBaryonVectorForm:Nfi 4  1
 newdef BottomBaryonVectorForm:Eta 4  1
 newdef BottomBaryonVectorForm:Nfi 5  0.707107
 newdef BottomBaryonVectorForm:Eta 5  1
 newdef BottomBaryonVectorForm:Nfi 6  0.707107
 newdef BottomBaryonVectorForm:Eta 6  1
 newdef BottomBaryonVectorForm:Nfi 7  0.5
 newdef BottomBaryonVectorForm:Eta 7  1
 newdef BottomBaryonVectorForm:Nfi 8  0.5
 newdef BottomBaryonVectorForm:Eta 8  1
 newdef BottomBaryonVectorForm:Nfi 9  0.288675
 newdef BottomBaryonVectorForm:Eta 9  1
 newdef BottomBaryonVectorForm:Nfi 10  1
 newdef BottomBaryonVectorForm:Eta 10  -0.333333
 newdef BottomBaryonVectorForm:Nfi 11  0.57735
 newdef BottomBaryonVectorForm:Eta 11  -0.333333
 newdef BottomBaryonVectorForm:Nfi 12  1
 newdef BottomBaryonVectorForm:Eta 12  0
 newdef BottomBaryonVectorForm:Nfi 13  1
 newdef BottomBaryonVectorForm:Eta 13  0
 newdef BottomBaryonVectorForm:Nfi 14  0.57735
 newdef BottomBaryonVectorForm:Eta 14  0
 newdef BottomBaryonVectorForm:Nfi 15  1
 newdef BottomBaryonVectorForm:Eta 15  0
 newdef BottomBaryonVectorForm:Nfi 16  0.57735
 newdef BottomBaryonVectorForm:Eta 16  0
 newdef BottomBaryonVectorForm:Nfi 17  0.57735
 newdef BottomBaryonVectorForm:Eta 17  1
 newdef BottomBaryonVectorForm:Nfi 18  0.57735
 newdef BottomBaryonVectorForm:Eta 18  1
 newdef BottomBaryonVectorForm:Nfi 19  0.57735
 newdef BottomBaryonVectorForm:Eta 19  1
 newdef BottomBaryonVectorForm:Incoming 0 5122
 newdef BottomBaryonVectorForm:Outgoing 0 4122
 newdef BottomBaryonVectorForm:InSpin 0 2
 newdef BottomBaryonVectorForm:OutSpin 0 2
 newdef BottomBaryonVectorForm:Spectator1 0 1
 newdef BottomBaryonVectorForm:Spectator2 0 2
 newdef BottomBaryonVectorForm:InQuark 0 5
 newdef BottomBaryonVectorForm:OutQuark 0 4
 newdef BottomBaryonVectorForm:Incoming 1 5122
 newdef BottomBaryonVectorForm:Outgoing 1 3122
 newdef BottomBaryonVectorForm:InSpin 1 2
 newdef BottomBaryonVectorForm:OutSpin 1 2
 newdef BottomBaryonVectorForm:Spectator1 1 1
 newdef BottomBaryonVectorForm:Spectator2 1 2
 newdef BottomBaryonVectorForm:InQuark 1 5
 newdef BottomBaryonVectorForm:OutQuark 1 3
 newdef BottomBaryonVectorForm:Incoming 2 5122
 newdef BottomBaryonVectorForm:Outgoing 2 2112
 newdef BottomBaryonVectorForm:InSpin 2 2
 newdef BottomBaryonVectorForm:OutSpin 2 2
 newdef BottomBaryonVectorForm:Spectator1 2 1
 newdef BottomBaryonVectorForm:Spectator2 2 2
 newdef BottomBaryonVectorForm:InQuark 2 5
 newdef BottomBaryonVectorForm:OutQuark 2 1
 newdef BottomBaryonVectorForm:Incoming 3 5232
 newdef BottomBaryonVectorForm:Outgoing 3 4232
 newdef BottomBaryonVectorForm:InSpin 3 2
 newdef BottomBaryonVectorForm:OutSpin 3 2
 newdef BottomBaryonVectorForm:Spectator1 3 2
 newdef BottomBaryonVectorForm:Spectator2 3 3
 newdef BottomBaryonVectorForm:InQuark 3 5
 newdef BottomBaryonVectorForm:OutQuark 3 4
 newdef BottomBaryonVectorForm:Incoming 4 5132
 newdef BottomBaryonVectorForm:Outgoing 4 4132
 newdef BottomBaryonVectorForm:InSpin 4 2
 newdef BottomBaryonVectorForm:OutSpin 4 2
 newdef BottomBaryonVectorForm:Spectator1 4 1
 newdef BottomBaryonVectorForm:Spectator2 4 3
 newdef BottomBaryonVectorForm:InQuark 4 5
 newdef BottomBaryonVectorForm:OutQuark 4 4
 newdef BottomBaryonVectorForm:Incoming 5 5232
 newdef BottomBaryonVectorForm:Outgoing 5 3322
 newdef BottomBaryonVectorForm:InSpin 5 2
 newdef BottomBaryonVectorForm:OutSpin 5 2
 newdef BottomBaryonVectorForm:Spectator1 5 2
 newdef BottomBaryonVectorForm:Spectator2 5 3
 newdef BottomBaryonVectorForm:InQuark 5 5
 newdef BottomBaryonVectorForm:OutQuark 5 3
 newdef BottomBaryonVectorForm:Incoming 6 5132
 newdef BottomBaryonVectorForm:Outgoing 6 3312
 newdef BottomBaryonVectorForm:InSpin 6 2
 newdef BottomBaryonVectorForm:OutSpin 6 2
 newdef BottomBaryonVectorForm:Spectator1 6 1
 newdef BottomBaryonVectorForm:Spectator2 6 3
 newdef BottomBaryonVectorForm:InQuark 6 5
 newdef BottomBaryonVectorForm:OutQuark 6 3
 newdef BottomBaryonVectorForm:Incoming 7 5232
 newdef BottomBaryonVectorForm:Outgoing 7 3212
 newdef BottomBaryonVectorForm:InSpin 7 2
 newdef BottomBaryonVectorForm:OutSpin 7 2
 newdef BottomBaryonVectorForm:Spectator1 7 2
 newdef BottomBaryonVectorForm:Spectator2 7 3
 newdef BottomBaryonVectorForm:InQuark 7 5
 newdef BottomBaryonVectorForm:OutQuark 7 1
 newdef BottomBaryonVectorForm:Incoming 8 5132
 newdef BottomBaryonVectorForm:Outgoing 8 3112
 newdef BottomBaryonVectorForm:InSpin 8 2
 newdef BottomBaryonVectorForm:OutSpin 8 2
 newdef BottomBaryonVectorForm:Spectator1 8 1
 newdef BottomBaryonVectorForm:Spectator2 8 3
 newdef BottomBaryonVectorForm:InQuark 8 5
 newdef BottomBaryonVectorForm:OutQuark 8 1
 newdef BottomBaryonVectorForm:Incoming 9 5232
 newdef BottomBaryonVectorForm:Outgoing 9 3122
 newdef BottomBaryonVectorForm:InSpin 9 2
 newdef BottomBaryonVectorForm:OutSpin 9 2
 newdef BottomBaryonVectorForm:Spectator1 9 2
 newdef BottomBaryonVectorForm:Spectator2 9 3
 newdef BottomBaryonVectorForm:InQuark 9 5
 newdef BottomBaryonVectorForm:OutQuark 9 1
 newdef BottomBaryonVectorForm:Incoming 10 5332
 newdef BottomBaryonVectorForm:Outgoing 10 4332
 newdef BottomBaryonVectorForm:InSpin 10 2
 newdef BottomBaryonVectorForm:OutSpin 10 2
 newdef BottomBaryonVectorForm:Spectator1 10 3
 newdef BottomBaryonVectorForm:Spectator2 10 3
 newdef BottomBaryonVectorForm:InQuark 10 5
 newdef BottomBaryonVectorForm:OutQuark 10 4
 newdef BottomBaryonVectorForm:Incoming 11 5332
 newdef BottomBaryonVectorForm:Outgoing 11 3312
 newdef BottomBaryonVectorForm:InSpin 11 2
 newdef BottomBaryonVectorForm:OutSpin 11 2
 newdef BottomBaryonVectorForm:Spectator1 11 3
 newdef BottomBaryonVectorForm:Spectator2 11 3
 newdef BottomBaryonVectorForm:InQuark 11 5
 newdef BottomBaryonVectorForm:OutQuark 11 1
 newdef BottomBaryonVectorForm:Incoming 12 5332
 newdef BottomBaryonVectorForm:Outgoing 12 4334
 newdef BottomBaryonVectorForm:InSpin 12 2
 newdef BottomBaryonVectorForm:OutSpin 12 4
 newdef BottomBaryonVectorForm:Spectator1 12 3
 newdef BottomBaryonVectorForm:Spectator2 12 3
 newdef BottomBaryonVectorForm:InQuark 12 5
 newdef BottomBaryonVectorForm:OutQuark 12 4
 newdef BottomBaryonVectorForm:Incoming 13 5332
 newdef BottomBaryonVectorForm:Outgoing 13 3334
 newdef BottomBaryonVectorForm:InSpin 13 2
 newdef BottomBaryonVectorForm:OutSpin 13 4
 newdef BottomBaryonVectorForm:Spectator1 13 3
 newdef BottomBaryonVectorForm:Spectator2 13 3
 newdef BottomBaryonVectorForm:InQuark 13 5
 newdef BottomBaryonVectorForm:OutQuark 13 3
 newdef BottomBaryonVectorForm:Incoming 14 5332
 newdef BottomBaryonVectorForm:Outgoing 14 3314
 newdef BottomBaryonVectorForm:InSpin 14 2
 newdef BottomBaryonVectorForm:OutSpin 14 4
 newdef BottomBaryonVectorForm:Spectator1 14 3
 newdef BottomBaryonVectorForm:Spectator2 14 3
 newdef BottomBaryonVectorForm:InQuark 14 5
 newdef BottomBaryonVectorForm:OutQuark 14 1
 newdef BottomBaryonVectorForm:Incoming 15 4332
 newdef BottomBaryonVectorForm:Outgoing 15 3334
 newdef BottomBaryonVectorForm:InSpin 15 2
 newdef BottomBaryonVectorForm:OutSpin 15 4
 newdef BottomBaryonVectorForm:Spectator1 15 3
 newdef BottomBaryonVectorForm:Spectator2 15 3
 newdef BottomBaryonVectorForm:InQuark 15 4
 newdef BottomBaryonVectorForm:OutQuark 15 3
 newdef BottomBaryonVectorForm:Incoming 16 4332
 newdef BottomBaryonVectorForm:Outgoing 16 3324
 newdef BottomBaryonVectorForm:InSpin 16 2
 newdef BottomBaryonVectorForm:OutSpin 16 4
 newdef BottomBaryonVectorForm:Spectator1 16 3
 newdef BottomBaryonVectorForm:Spectator2 16 3
 newdef BottomBaryonVectorForm:InQuark 16 4
 newdef BottomBaryonVectorForm:OutQuark 16 2
 newdef BottomBaryonVectorForm:Incoming 17 4122
 newdef BottomBaryonVectorForm:Outgoing 17 3122
 newdef BottomBaryonVectorForm:InSpin 17 2
 newdef BottomBaryonVectorForm:OutSpin 17 2
 newdef BottomBaryonVectorForm:Spectator1 17 1
 newdef BottomBaryonVectorForm:Spectator2 17 2
 newdef BottomBaryonVectorForm:InQuark 17 4
 newdef BottomBaryonVectorForm:OutQuark 17 3
 newdef BottomBaryonVectorForm:Incoming 18 4232
 newdef BottomBaryonVectorForm:Outgoing 18 3322
 newdef BottomBaryonVectorForm:InSpin 18 2
 newdef BottomBaryonVectorForm:OutSpin 18 2
 newdef BottomBaryonVectorForm:Spectator1 18 2
 newdef BottomBaryonVectorForm:Spectator2 18 3
 newdef BottomBaryonVectorForm:InQuark 18 4
 newdef BottomBaryonVectorForm:OutQuark 18 3
 newdef BottomBaryonVectorForm:Incoming 19 4132
 newdef BottomBaryonVectorForm:Outgoing 19 3312
 newdef BottomBaryonVectorForm:InSpin 19 2
 newdef BottomBaryonVectorForm:OutSpin 19 2
 newdef BottomBaryonVectorForm:Spectator1 19 1
 newdef BottomBaryonVectorForm:Spectator2 19 3
 newdef BottomBaryonVectorForm:InQuark 19 4
 newdef BottomBaryonVectorForm:OutQuark 19 3
 newdef BottomBaryonVector:FormFactor BottomBaryonVectorForm
 #
 create Herwig::StrongHeavyBaryonDecayer  HeavyStrong
 newdef HeavyStrong:Iteration 1
 newdef HeavyStrong:Ntry 500
 newdef HeavyStrong:Points 10000
 newdef HeavyStrong:GenerateIntermediates 0
 newdef HeavyStrong:gSigma_cLambda_cPi 8.88
 newdef HeavyStrong:gXiStar_cXi_cPi 8.34
 newdef HeavyStrong:fLambda_c1Sigma_cPi 0.52
 newdef HeavyStrong:fXi_c1Xi_cPi 0.36
 newdef HeavyStrong:fLambda_c1*Sigma_cPi 21.5
 newdef HeavyStrong:fXi_c1*Xi_cPi 20
 newdef HeavyStrong:gSigma_bLambda_bPi 8.88
 newdef HeavyStrong:gXiStar_bXi_bPi 8.34
 newdef HeavyStrong:fLambda_b1Sigma_bPi 0.52
 newdef HeavyStrong:fXi_b1Xi_bPi 0.36
 newdef HeavyStrong:fLambda_b1*Sigma_bPi 21.5
 newdef HeavyStrong:fXi_b1*Xi_bPi 20
 newdef HeavyStrong:Incoming 0 4222
 newdef HeavyStrong:OutgoingB 0 4122
 newdef HeavyStrong:OutgoingM 0 211
 newdef HeavyStrong:ModeType 0 1
 newdef HeavyStrong:MaxWeight 0 2.00656
 newdef HeavyStrong:Incoming 1 4212
 newdef HeavyStrong:OutgoingB 1 4122
 newdef HeavyStrong:OutgoingM 1 111
 newdef HeavyStrong:ModeType 1 1
 newdef HeavyStrong:MaxWeight 1 2.32796
 newdef HeavyStrong:Incoming 2 4112
 newdef HeavyStrong:OutgoingB 2 4122
 newdef HeavyStrong:OutgoingM 2 -211
 newdef HeavyStrong:ModeType 2 1
 newdef HeavyStrong:MaxWeight 2 2.00361
 newdef HeavyStrong:Incoming 3 4224
 newdef HeavyStrong:OutgoingB 3 4122
 newdef HeavyStrong:OutgoingM 3 211
 newdef HeavyStrong:ModeType 3 1
 newdef HeavyStrong:MaxWeight 3 2.25125
 newdef HeavyStrong:Incoming 4 4214
 newdef HeavyStrong:OutgoingB 4 4122
 newdef HeavyStrong:OutgoingM 4 111
 newdef HeavyStrong:ModeType 4 1
 newdef HeavyStrong:MaxWeight 4 2.16303
 newdef HeavyStrong:Incoming 5 4114
 newdef HeavyStrong:OutgoingB 5 4122
 newdef HeavyStrong:OutgoingM 5 -211
 newdef HeavyStrong:ModeType 5 1
 newdef HeavyStrong:MaxWeight 5 2.06737
 newdef HeavyStrong:Incoming 6 4324
 newdef HeavyStrong:OutgoingB 6 4232
 newdef HeavyStrong:OutgoingM 6 111
 newdef HeavyStrong:ModeType 6 1
 newdef HeavyStrong:MaxWeight 6 1.99324
 newdef HeavyStrong:Incoming 7 4324
 newdef HeavyStrong:OutgoingB 7 4132
 newdef HeavyStrong:OutgoingM 7 211
 newdef HeavyStrong:ModeType 7 1
 newdef HeavyStrong:MaxWeight 7 1.50601
 newdef HeavyStrong:Incoming 8 4314
 newdef HeavyStrong:OutgoingB 8 4132
 newdef HeavyStrong:OutgoingM 8 111
 newdef HeavyStrong:ModeType 8 1
 newdef HeavyStrong:MaxWeight 8 1.72816
 newdef HeavyStrong:Incoming 9 4314
 newdef HeavyStrong:OutgoingB 9 4232
 newdef HeavyStrong:OutgoingM 9 -211
 newdef HeavyStrong:ModeType 9 1
 newdef HeavyStrong:MaxWeight 9 1.68833
 newdef HeavyStrong:Incoming 10 101242
 newdef HeavyStrong:OutgoingB 10 4222
 newdef HeavyStrong:OutgoingM 10 -211
 newdef HeavyStrong:ModeType 10 0
 newdef HeavyStrong:MaxWeight 10 2.34015
 newdef HeavyStrong:Incoming 11 101242
 newdef HeavyStrong:OutgoingB 11 4212
 newdef HeavyStrong:OutgoingM 11 111
 newdef HeavyStrong:ModeType 11 0
 newdef HeavyStrong:MaxWeight 11 5.25433
 newdef HeavyStrong:Incoming 12 101242
 newdef HeavyStrong:OutgoingB 12 4112
 newdef HeavyStrong:OutgoingM 12 211
 newdef HeavyStrong:ModeType 12 0
 newdef HeavyStrong:MaxWeight 12 2.50106
 newdef HeavyStrong:Incoming 13 101244
 newdef HeavyStrong:OutgoingB 13 4222
 newdef HeavyStrong:OutgoingM 13 -211
 newdef HeavyStrong:ModeType 13 1
 newdef HeavyStrong:MaxWeight 13 11.5795
 newdef HeavyStrong:Incoming 14 101244
 newdef HeavyStrong:OutgoingB 14 4212
 newdef HeavyStrong:OutgoingM 14 111
 newdef HeavyStrong:ModeType 14 1
 newdef HeavyStrong:MaxWeight 14 13.7322
 newdef HeavyStrong:Incoming 15 101244
 newdef HeavyStrong:OutgoingB 15 4112
 newdef HeavyStrong:OutgoingM 15 211
 newdef HeavyStrong:ModeType 15 1
 newdef HeavyStrong:MaxWeight 15 11.5641
 newdef HeavyStrong:Incoming 16 5222
 newdef HeavyStrong:OutgoingB 16 5122
 newdef HeavyStrong:OutgoingM 16 211
 newdef HeavyStrong:ModeType 16 1
 newdef HeavyStrong:MaxWeight 16 1.60113
 newdef HeavyStrong:Incoming 17 5212
 newdef HeavyStrong:OutgoingB 17 5122
 newdef HeavyStrong:OutgoingM 17 111
 newdef HeavyStrong:ModeType 17 1
 newdef HeavyStrong:MaxWeight 17 1.59965
 newdef HeavyStrong:Incoming 18 5112
 newdef HeavyStrong:OutgoingB 18 5122
 newdef HeavyStrong:OutgoingM 18 -211
 newdef HeavyStrong:ModeType 18 1
 newdef HeavyStrong:MaxWeight 18 1.5982
 newdef HeavyStrong:Incoming 19 5224
 newdef HeavyStrong:OutgoingB 19 5122
 newdef HeavyStrong:OutgoingM 19 211
 newdef HeavyStrong:ModeType 19 1
 newdef HeavyStrong:MaxWeight 19 1.5944
 newdef HeavyStrong:Incoming 20 5214
 newdef HeavyStrong:OutgoingB 20 5122
 newdef HeavyStrong:OutgoingM 20 111
 newdef HeavyStrong:ModeType 20 1
 newdef HeavyStrong:MaxWeight 20 1.60103
 newdef HeavyStrong:Incoming 21 5114
 newdef HeavyStrong:OutgoingB 21 5122
 newdef HeavyStrong:OutgoingM 21 -211
 newdef HeavyStrong:ModeType 21 1
 newdef HeavyStrong:MaxWeight 21 1.60585
 newdef HeavyStrong:Incoming 22 5324
 newdef HeavyStrong:OutgoingB 22 5232
 newdef HeavyStrong:OutgoingM 22 111
 newdef HeavyStrong:ModeType 22 1
 newdef HeavyStrong:MaxWeight 22 1.88378
 newdef HeavyStrong:Incoming 23 5324
 newdef HeavyStrong:OutgoingB 23 5132
 newdef HeavyStrong:OutgoingM 23 211
 newdef HeavyStrong:ModeType 23 1
 newdef HeavyStrong:MaxWeight 23 1.42109
 newdef HeavyStrong:Incoming 24 5314
 newdef HeavyStrong:OutgoingB 24 5132
 newdef HeavyStrong:OutgoingM 24 111
 newdef HeavyStrong:ModeType 24 1
 newdef HeavyStrong:MaxWeight 24 1.63003
 newdef HeavyStrong:Incoming 25 5314
 newdef HeavyStrong:OutgoingB 25 5232
 newdef HeavyStrong:OutgoingM 25 -211
 newdef HeavyStrong:ModeType 25 1
 newdef HeavyStrong:MaxWeight 25 1.59544
 newdef HeavyStrong:Incoming 26 101252
 newdef HeavyStrong:OutgoingB 26 5222
 newdef HeavyStrong:OutgoingM 26 -211
 newdef HeavyStrong:ModeType 26 0
 newdef HeavyStrong:MaxWeight 26 4.22387
 newdef HeavyStrong:Incoming 27 101252
 newdef HeavyStrong:OutgoingB 27 5212
 newdef HeavyStrong:OutgoingM 27 111
 newdef HeavyStrong:ModeType 27 0
 newdef HeavyStrong:MaxWeight 27 4.21194
 newdef HeavyStrong:Incoming 28 101252
 newdef HeavyStrong:OutgoingB 28 5112
 newdef HeavyStrong:OutgoingM 28 211
 newdef HeavyStrong:ModeType 28 0
 newdef HeavyStrong:MaxWeight 28 1.96324
 newdef HeavyStrong:Incoming 29 101254
 newdef HeavyStrong:OutgoingB 29 5222
 newdef HeavyStrong:OutgoingM 29 -211
 newdef HeavyStrong:ModeType 29 2
 newdef HeavyStrong:MaxWeight 29 0.107134
 newdef HeavyStrong:Incoming 30 101254
 newdef HeavyStrong:OutgoingB 30 5212
 newdef HeavyStrong:OutgoingM 30 111
 newdef HeavyStrong:ModeType 30 2
 newdef HeavyStrong:MaxWeight 30 0.132231
 newdef HeavyStrong:Incoming 31 101254
 newdef HeavyStrong:OutgoingB 31 5112
 newdef HeavyStrong:OutgoingM 31 211
 newdef HeavyStrong:ModeType 31 2
 newdef HeavyStrong:MaxWeight 31 0.0747326
 newdef HeavyStrong:Incoming 32 102344
 newdef HeavyStrong:OutgoingB 32 4322
 newdef HeavyStrong:OutgoingM 32 111
 newdef HeavyStrong:ModeType 32 2
 newdef HeavyStrong:MaxWeight 32 1.50908
 newdef HeavyStrong:Incoming 33 102344
 newdef HeavyStrong:OutgoingB 33 4312
 newdef HeavyStrong:OutgoingM 33 211
 newdef HeavyStrong:ModeType 33 2
 newdef HeavyStrong:MaxWeight 33 1.5594
 newdef HeavyStrong:Incoming 34 101344
 newdef HeavyStrong:OutgoingB 34 4312
 newdef HeavyStrong:OutgoingM 34 111
 newdef HeavyStrong:ModeType 34 2
 newdef HeavyStrong:MaxWeight 34 1.48272
 newdef HeavyStrong:Incoming 35 101344
 newdef HeavyStrong:OutgoingB 35 4322
 newdef HeavyStrong:OutgoingM 35 -211
 newdef HeavyStrong:ModeType 35 2
 newdef HeavyStrong:MaxWeight 35 1.75973
 newdef HeavyStrong:Incoming 36 102344
 newdef HeavyStrong:OutgoingB 36 4324
 newdef HeavyStrong:OutgoingM 36 111
 newdef HeavyStrong:ModeType 36 0
 newdef HeavyStrong:MaxWeight 36 2.24229
 newdef HeavyStrong:Incoming 37 102344
 newdef HeavyStrong:OutgoingB 37 4314
 newdef HeavyStrong:OutgoingM 37 211
 newdef HeavyStrong:ModeType 37 0
 newdef HeavyStrong:MaxWeight 37 2.09263
 newdef HeavyStrong:Incoming 38 101344
 newdef HeavyStrong:OutgoingB 38 4314
 newdef HeavyStrong:OutgoingM 38 111
 newdef HeavyStrong:ModeType 38 0
 newdef HeavyStrong:MaxWeight 38 2.36559
 newdef HeavyStrong:Incoming 39 101344
 newdef HeavyStrong:OutgoingB 39 4324
 newdef HeavyStrong:OutgoingM 39 -211
 newdef HeavyStrong:ModeType 39 0
 newdef HeavyStrong:MaxWeight 39 2.18137
 newdef HeavyStrong:Incoming 40 102342
 newdef HeavyStrong:OutgoingB 40 4322
 newdef HeavyStrong:OutgoingM 40 111
 newdef HeavyStrong:ModeType 40 0
 newdef HeavyStrong:MaxWeight 40 1.56278
 newdef HeavyStrong:Incoming 41 102342
 newdef HeavyStrong:OutgoingB 41 4312
 newdef HeavyStrong:OutgoingM 41 211
 newdef HeavyStrong:ModeType 41 0
 newdef HeavyStrong:MaxWeight 41 1.49557
 newdef HeavyStrong:Incoming 42 101342
 newdef HeavyStrong:OutgoingB 42 4312
 newdef HeavyStrong:OutgoingM 42 111
 newdef HeavyStrong:ModeType 42 0
 newdef HeavyStrong:MaxWeight 42 1.56355
 newdef HeavyStrong:Incoming 43 101342
 newdef HeavyStrong:OutgoingB 43 4322
 newdef HeavyStrong:OutgoingM 43 -211
 newdef HeavyStrong:ModeType 43 0
 newdef HeavyStrong:MaxWeight 43 1.55762
 newdef HeavyStrong:Incoming 44 102342
 newdef HeavyStrong:OutgoingB 44 4324
 newdef HeavyStrong:OutgoingM 44 111
 newdef HeavyStrong:ModeType 44 2
 newdef HeavyStrong:MaxWeight 44 0.00928127
 newdef HeavyStrong:Incoming 45 102342
 newdef HeavyStrong:OutgoingB 45 4314
 newdef HeavyStrong:OutgoingM 45 211
 newdef HeavyStrong:ModeType 45 2
 newdef HeavyStrong:MaxWeight 45 0.0125624
 newdef HeavyStrong:Incoming 46 101342
 newdef HeavyStrong:OutgoingB 46 4314
 newdef HeavyStrong:OutgoingM 46 111
 newdef HeavyStrong:ModeType 46 2
 newdef HeavyStrong:MaxWeight 46 0.0120602
 newdef HeavyStrong:Incoming 47 101342
 newdef HeavyStrong:OutgoingB 47 4324
 newdef HeavyStrong:OutgoingM 47 -211
 newdef HeavyStrong:ModeType 47 2
 newdef HeavyStrong:MaxWeight 47 0.0167952
 newdef HeavyStrong:Incoming 48 102354
 newdef HeavyStrong:OutgoingB 48 5322
 newdef HeavyStrong:OutgoingM 48 111
 newdef HeavyStrong:ModeType 48 2
 newdef HeavyStrong:MaxWeight 48 1.87626
 newdef HeavyStrong:Incoming 49 102354
 newdef HeavyStrong:OutgoingB 49 5312
 newdef HeavyStrong:OutgoingM 49 211
 newdef HeavyStrong:ModeType 49 2
 newdef HeavyStrong:MaxWeight 49 1.616
 newdef HeavyStrong:Incoming 50 101354
 newdef HeavyStrong:OutgoingB 50 5312
 newdef HeavyStrong:OutgoingM 50 111
 newdef HeavyStrong:ModeType 50 2
 newdef HeavyStrong:MaxWeight 50 1.84227
 newdef HeavyStrong:Incoming 51 101354
 newdef HeavyStrong:OutgoingB 51 5322
 newdef HeavyStrong:OutgoingM 51 -211
 newdef HeavyStrong:ModeType 51 2
 newdef HeavyStrong:MaxWeight 51 1.82865
 newdef HeavyStrong:Incoming 52 102354
 newdef HeavyStrong:OutgoingB 52 5324
 newdef HeavyStrong:OutgoingM 52 111
 newdef HeavyStrong:ModeType 52 0
 newdef HeavyStrong:MaxWeight 52 2.77725
 newdef HeavyStrong:Incoming 53 102354
 newdef HeavyStrong:OutgoingB 53 5314
 newdef HeavyStrong:OutgoingM 53 211
 newdef HeavyStrong:ModeType 53 0
 newdef HeavyStrong:MaxWeight 53 2.5378
 newdef HeavyStrong:Incoming 54 101354
 newdef HeavyStrong:OutgoingB 54 5314
 newdef HeavyStrong:OutgoingM 54 111
 newdef HeavyStrong:ModeType 54 0
 newdef HeavyStrong:MaxWeight 54 2.93925
 newdef HeavyStrong:Incoming 55 101354
 newdef HeavyStrong:OutgoingB 55 5324
 newdef HeavyStrong:OutgoingM 55 -211
 newdef HeavyStrong:ModeType 55 0
 newdef HeavyStrong:MaxWeight 55 2.69015
 newdef HeavyStrong:Incoming 56 102352
 newdef HeavyStrong:OutgoingB 56 5322
 newdef HeavyStrong:OutgoingM 56 111
 newdef HeavyStrong:ModeType 56 0
 newdef HeavyStrong:MaxWeight 56 1.34628
 newdef HeavyStrong:Incoming 57 102352
 newdef HeavyStrong:OutgoingB 57 5312
 newdef HeavyStrong:OutgoingM 57 211
 newdef HeavyStrong:ModeType 57 0
 newdef HeavyStrong:MaxWeight 57 1.28732
 newdef HeavyStrong:Incoming 58 101352
 newdef HeavyStrong:OutgoingB 58 5312
 newdef HeavyStrong:OutgoingM 58 111
 newdef HeavyStrong:ModeType 58 0
 newdef HeavyStrong:MaxWeight 58 1.34676
 newdef HeavyStrong:Incoming 59 101352
 newdef HeavyStrong:OutgoingB 59 5322
 newdef HeavyStrong:OutgoingM 59 -211
 newdef HeavyStrong:ModeType 59 0
 newdef HeavyStrong:MaxWeight 59 1.34286
 newdef HeavyStrong:Incoming 60 102352
 newdef HeavyStrong:OutgoingB 60 5324
 newdef HeavyStrong:OutgoingM 60 111
 newdef HeavyStrong:ModeType 60 2
 newdef HeavyStrong:MaxWeight 60 0.00860417
 newdef HeavyStrong:Incoming 61 102352
 newdef HeavyStrong:OutgoingB 61 5314
 newdef HeavyStrong:OutgoingM 61 211
 newdef HeavyStrong:ModeType 61 2
 newdef HeavyStrong:MaxWeight 61 0.0153272
 newdef HeavyStrong:Incoming 62 101352
 newdef HeavyStrong:OutgoingB 62 5314
 newdef HeavyStrong:OutgoingM 62 111
 newdef HeavyStrong:ModeType 62 2
 newdef HeavyStrong:MaxWeight 62 0.0115148
 newdef HeavyStrong:Incoming 63 101352
 newdef HeavyStrong:OutgoingB 63 5324
 newdef HeavyStrong:OutgoingM 63 -211
 newdef HeavyStrong:ModeType 63 2
 newdef HeavyStrong:MaxWeight 63 0.0153888
 #
 create Herwig::SU3BaryonOctetOctetScalarDecayer  SU3StrongRoper
 newdef SU3StrongRoper:Iteration 1
 newdef SU3StrongRoper:Ntry 500
 newdef SU3StrongRoper:Points 10000
 newdef SU3StrongRoper:GenerateIntermediates 0
 newdef SU3StrongRoper:Fcoupling 0.11
 newdef SU3StrongRoper:Dcoupling 0.6
 newdef SU3StrongRoper:Parity 1
 newdef SU3StrongRoper:Fpi 130.7
 newdef SU3StrongRoper:Proton 2212
 newdef SU3StrongRoper:Neutron 2112
 newdef SU3StrongRoper:Sigma+ 3222
 newdef SU3StrongRoper:Sigma0 3212
 newdef SU3StrongRoper:Sigma- 3112
 newdef SU3StrongRoper:Lambda 3122
 newdef SU3StrongRoper:Xi0 3322
 newdef SU3StrongRoper:Xi- 3312
 newdef SU3StrongRoper:ExcitedProton 202212
 newdef SU3StrongRoper:ExcitedNeutron 202112
 newdef SU3StrongRoper:ExcitedSigma+ 203222
 newdef SU3StrongRoper:ExcitedSigma0 203212
 newdef SU3StrongRoper:ExcitedSigma- 203112
 newdef SU3StrongRoper:ExcitedLambda 203122
 newdef SU3StrongRoper:ExcitedXi0 203322
 newdef SU3StrongRoper:ExcitedXi- 203312
 insert SU3StrongRoper:MaxWeight 0 1.80705
 insert SU3StrongRoper:MaxWeight 1 1.83437
 insert SU3StrongRoper:MaxWeight 2 0.626841
 insert SU3StrongRoper:MaxWeight 3 0.315783
 insert SU3StrongRoper:MaxWeight 4 0.0801244
 insert SU3StrongRoper:MaxWeight 5 0.495582
 insert SU3StrongRoper:MaxWeight 6 1.81893
 insert SU3StrongRoper:MaxWeight 7 1.82169
 insert SU3StrongRoper:MaxWeight 8 0.796182
 insert SU3StrongRoper:MaxWeight 9 0.417085
 insert SU3StrongRoper:MaxWeight 10 0.0805194
 insert SU3StrongRoper:MaxWeight 11 0.473075
 insert SU3StrongRoper:MaxWeight 12 1.67933
 insert SU3StrongRoper:MaxWeight 13 1.69741
 insert SU3StrongRoper:MaxWeight 14 1.601
 insert SU3StrongRoper:MaxWeight 15 3.86444
 insert SU3StrongRoper:MaxWeight 16 0.114795
 insert SU3StrongRoper:MaxWeight 17 0.119024
 insert SU3StrongRoper:MaxWeight 18 3.04579
 insert SU3StrongRoper:MaxWeight 19 2.91748
 insert SU3StrongRoper:MaxWeight 20 0.469575
 insert SU3StrongRoper:MaxWeight 21 0.45577
 insert SU3StrongRoper:MaxWeight 22 6.20849
 insert SU3StrongRoper:MaxWeight 23 10.9318
 insert SU3StrongRoper:MaxWeight 24 3.41669
 insert SU3StrongRoper:MaxWeight 25 4.09249
 insert SU3StrongRoper:MaxWeight 26 0.444487
 insert SU3StrongRoper:MaxWeight 27 0.464752
 insert SU3StrongRoper:MaxWeight 28 2.93537
 insert SU3StrongRoper:MaxWeight 29 3.02507
 insert SU3StrongRoper:MaxWeight 30 11.1723
 insert SU3StrongRoper:MaxWeight 31 10.8365
 insert SU3StrongRoper:MaxWeight 32 4.04486
 insert SU3StrongRoper:MaxWeight 33 3.44034
 insert SU3StrongRoper:MaxWeight 34 0.45577
 insert SU3StrongRoper:MaxWeight 35 0.448599
 insert SU3StrongRoper:MaxWeight 36 5.93298
 insert SU3StrongRoper:MaxWeight 37 11.0765
 insert SU3StrongRoper:MaxWeight 38 3.41669
 insert SU3StrongRoper:MaxWeight 39 3.94553
 insert SU3StrongRoper:MaxWeight 40 2.10871
 insert SU3StrongRoper:MaxWeight 41 0.177081
 insert SU3StrongRoper:MaxWeight 42 10.815
 insert SU3StrongRoper:MaxWeight 43 5.22192
 insert SU3StrongRoper:MaxWeight 44 0.225516
 insert SU3StrongRoper:MaxWeight 45 0.46041
 insert SU3StrongRoper:MaxWeight 46 1.59995
 insert SU3StrongRoper:MaxWeight 47 10.3094
 insert SU3StrongRoper:MaxWeight 48 5.47674
 insert SU3StrongRoper:MaxWeight 49 0.210177
 #
 create Herwig::SU3BaryonOctetOctetScalarDecayer  SU3Strong2
 newdef SU3Strong2:Iteration 1
 newdef SU3Strong2:Ntry 500
 newdef SU3Strong2:Points 10000
 newdef SU3Strong2:GenerateIntermediates 0
 newdef SU3Strong2:Fcoupling -0.33
 newdef SU3Strong2:Dcoupling 0.6
 newdef SU3Strong2:Parity 0
 newdef SU3Strong2:Fpi 130.7
 newdef SU3Strong2:Proton 2212
 newdef SU3Strong2:Neutron 2112
 newdef SU3Strong2:Sigma+ 3222
 newdef SU3Strong2:Sigma0 3212
 newdef SU3Strong2:Sigma- 3112
 newdef SU3Strong2:Lambda 3122
 newdef SU3Strong2:Xi0 3322
 newdef SU3Strong2:Xi- 3312
 newdef SU3Strong2:ExcitedProton 102212
 newdef SU3Strong2:ExcitedNeutron 102112
 newdef SU3Strong2:ExcitedSigma+ 103222
 newdef SU3Strong2:ExcitedSigma0 103212
 newdef SU3Strong2:ExcitedSigma- 103112
 newdef SU3Strong2:ExcitedLambda 103122
 newdef SU3Strong2:ExcitedXi0 103322
 newdef SU3Strong2:ExcitedXi- 103312
 insert SU3Strong2:MaxWeight 0 1.62119
 insert SU3Strong2:MaxWeight 1 1.63297
 insert SU3Strong2:MaxWeight 2 13.6826
 insert SU3Strong2:MaxWeight 3 6.91591
 insert SU3Strong2:MaxWeight 4 7.5876
 insert SU3Strong2:MaxWeight 5 0.497088
 insert SU3Strong2:MaxWeight 6 1.62475
 insert SU3Strong2:MaxWeight 7 1.62009
 insert SU3Strong2:MaxWeight 8 11.8384
 insert SU3Strong2:MaxWeight 9 6.60507
 insert SU3Strong2:MaxWeight 10 7.74213
 insert SU3Strong2:MaxWeight 11 0.472179
 insert SU3Strong2:MaxWeight 12 18.252
 insert SU3Strong2:MaxWeight 13 18.5175
 insert SU3Strong2:MaxWeight 14 17.7211
 insert SU3Strong2:MaxWeight 15 11.4144
 insert SU3Strong2:MaxWeight 16 11.7404
 insert SU3Strong2:MaxWeight 17 11.9092
 insert SU3Strong2:MaxWeight 18 7.03876
 insert SU3Strong2:MaxWeight 19 6.94796
 insert SU3Strong2:MaxWeight 20 8.3926
 insert SU3Strong2:MaxWeight 21 8.33094
 insert SU3Strong2:MaxWeight 22 1.70959
 insert SU3Strong2:MaxWeight 23 52.0614
 insert SU3Strong2:MaxWeight 24 13.5324
 insert SU3Strong2:MaxWeight 25 3.05822
 insert SU3Strong2:MaxWeight 26 8.14647
 insert SU3Strong2:MaxWeight 27 8.37524
 insert SU3Strong2:MaxWeight 28 0.841043
 insert SU3Strong2:MaxWeight 29 0.854517
 insert SU3Strong2:MaxWeight 30 52.3542
 insert SU3Strong2:MaxWeight 31 51.8405
 insert SU3Strong2:MaxWeight 32 2.9055
 insert SU3Strong2:MaxWeight 33 13.5578
 insert SU3Strong2:MaxWeight 34 8.27111
 insert SU3Strong2:MaxWeight 35 8.18578
 insert SU3Strong2:MaxWeight 36 1.63768
 insert SU3Strong2:MaxWeight 37 52.1333
 insert SU3Strong2:MaxWeight 38 13.5324
 insert SU3Strong2:MaxWeight 39 1.94042
 insert SU3Strong2:MaxWeight 40 8.1767
 insert SU3Strong2:MaxWeight 41 4.11344
 insert SU3Strong2:MaxWeight 42 48.938
 insert SU3Strong2:MaxWeight 43 47.8208
 insert SU3Strong2:MaxWeight 44 23.6554
 insert SU3Strong2:MaxWeight 45 2.17309
 insert SU3Strong2:MaxWeight 46 8.21707
 insert SU3Strong2:MaxWeight 47 4.06565
 insert SU3Strong2:MaxWeight 48 47.7349
 insert SU3Strong2:MaxWeight 49 49.0244
 insert SU3Strong2:MaxWeight 50 23.5405
 insert SU3Strong2:MaxWeight 51 2.21665
 #
 create Herwig::SU3BaryonDecupletOctetScalarDecayer  SU3Decuplet
 newdef SU3Decuplet:Iteration 1
 newdef SU3Decuplet:Ntry 500
 newdef SU3Decuplet:Points 10000
 newdef SU3Decuplet:GenerateIntermediates 0
 newdef SU3Decuplet:Ccoupling 1.5
 newdef SU3Decuplet:Parity 1
 newdef SU3Decuplet:Fpi 92.4
 newdef SU3Decuplet:Proton 2212
 newdef SU3Decuplet:Neutron 2112
 newdef SU3Decuplet:Sigma+ 3222
 newdef SU3Decuplet:Sigma0 3212
 newdef SU3Decuplet:Sigma- 3112
 newdef SU3Decuplet:Lambda 3122
 newdef SU3Decuplet:Xi0 3322
 newdef SU3Decuplet:Xi- 3312
 newdef SU3Decuplet:Delta++ 2224
 newdef SU3Decuplet:Delta+ 2214
 newdef SU3Decuplet:Delta0 2114
 newdef SU3Decuplet:Delta- 1114
 newdef SU3Decuplet:Sigma*+ 3224
 newdef SU3Decuplet:Sigma*0 3214
 newdef SU3Decuplet:Sigma*- 3114
 newdef SU3Decuplet:Omega 3334
 newdef SU3Decuplet:Xi*0 3324
 newdef SU3Decuplet:Xi*- 3314
 insert SU3Decuplet:MaxWeight 0 2.20000
 insert SU3Decuplet:MaxWeight 1 4.52362
 insert SU3Decuplet:MaxWeight 2 2.20000
 insert SU3Decuplet:MaxWeight 3 2.20000
 insert SU3Decuplet:MaxWeight 4 2.64073
 insert SU3Decuplet:MaxWeight 5 1.44792
 insert SU3Decuplet:MaxWeight 6 2.20000
 insert SU3Decuplet:MaxWeight 7 2.20000
 insert SU3Decuplet:MaxWeight 8 2.63609
 insert SU3Decuplet:MaxWeight 9 1.41052
 insert SU3Decuplet:MaxWeight 10 2.20000
 insert SU3Decuplet:MaxWeight 11 4.06786
 insert SU3Decuplet:MaxWeight 12 4.8
 insert SU3Decuplet:MaxWeight 13 3.0
 insert SU3Decuplet:MaxWeight 14 12.761
 insert SU3Decuplet:MaxWeight 15 3.20000
 insert SU3Decuplet:MaxWeight 16 6.30188
 insert SU3Decuplet:MaxWeight 17 6.54799
 insert SU3Decuplet:MaxWeight 18 3.0
 insert SU3Decuplet:MaxWeight 19 3.8
 insert SU3Decuplet:MaxWeight 20 4.8
 insert SU3Decuplet:MaxWeight 21 3.0
 insert SU3Decuplet:MaxWeight 22 3.2
 insert SU3Decuplet:MaxWeight 23 14.29
 insert SU3Decuplet:MaxWeight 24 3.2
 insert SU3Decuplet:MaxWeight 25 4.2
 insert SU3Decuplet:MaxWeight 26 5.2
 insert SU3Decuplet:MaxWeight 27 0.356554
 insert SU3Decuplet:MaxWeight 28 4.8
 insert SU3Decuplet:MaxWeight 29 4.8
 insert SU3Decuplet:MaxWeight 30 1.72199
 #
 create Herwig::SU3BaryonOctetDecupletScalarDecayer  SU3RoperDecuplet
 newdef SU3RoperDecuplet:Iteration 1
 newdef SU3RoperDecuplet:Ntry 500
 newdef SU3RoperDecuplet:Points 10000
 newdef SU3RoperDecuplet:GenerateIntermediates 0
 newdef SU3RoperDecuplet:Coupling 1.35
 newdef SU3RoperDecuplet:Parity 1
 newdef SU3RoperDecuplet:Fpi 130.7
 newdef SU3RoperDecuplet:Proton 202212
 newdef SU3RoperDecuplet:Neutron 202112
 newdef SU3RoperDecuplet:Sigma+ 203222
 newdef SU3RoperDecuplet:Sigma0 203212
 newdef SU3RoperDecuplet:Sigma- 203112
 newdef SU3RoperDecuplet:Lambda 203122
 newdef SU3RoperDecuplet:Xi0 203322
 newdef SU3RoperDecuplet:Xi- 203312
 newdef SU3RoperDecuplet:Delta++ 2224
 newdef SU3RoperDecuplet:Delta+ 2214
 newdef SU3RoperDecuplet:Delta0 2114
 newdef SU3RoperDecuplet:Delta- 1114
 newdef SU3RoperDecuplet:Sigma*+ 3224
 newdef SU3RoperDecuplet:Sigma*0 3214
 newdef SU3RoperDecuplet:Sigma*- 3114
 newdef SU3RoperDecuplet:Omega 3334
 newdef SU3RoperDecuplet:Xi*0 3324
 newdef SU3RoperDecuplet:Xi*- 3314
 insert SU3RoperDecuplet:MaxWeight 0 2.56576
 insert SU3RoperDecuplet:MaxWeight 1 84.0227
 insert SU3RoperDecuplet:MaxWeight 2 2.56781
 insert SU3RoperDecuplet:MaxWeight 3 2.73098
 insert SU3RoperDecuplet:MaxWeight 4 56.7064
 insert SU3RoperDecuplet:MaxWeight 5 28.0791
 insert SU3RoperDecuplet:MaxWeight 6 2.57358
 insert SU3RoperDecuplet:MaxWeight 7 2.72882
 insert SU3RoperDecuplet:MaxWeight 8 57.6277
 insert SU3RoperDecuplet:MaxWeight 9 28.2219
 insert SU3RoperDecuplet:MaxWeight 10 2.56025
 insert SU3RoperDecuplet:MaxWeight 11 74.9779
 insert SU3RoperDecuplet:MaxWeight 12 16.1559
 insert SU3RoperDecuplet:MaxWeight 13 14.0751
 insert SU3RoperDecuplet:MaxWeight 14 0.791015
 insert SU3RoperDecuplet:MaxWeight 15 0.00104774
 insert SU3RoperDecuplet:MaxWeight 16 12.8492
 insert SU3RoperDecuplet:MaxWeight 17 43.7074
 insert SU3RoperDecuplet:MaxWeight 18 0.590208
 insert SU3RoperDecuplet:MaxWeight 19 0.608962
 insert SU3RoperDecuplet:MaxWeight 20 0.000397168
 insert SU3RoperDecuplet:MaxWeight 21 0.000528759
 insert SU3RoperDecuplet:MaxWeight 22 20.9576
 insert SU3RoperDecuplet:MaxWeight 23 12.4322
 insert SU3RoperDecuplet:MaxWeight 24 47.985
 insert SU3RoperDecuplet:MaxWeight 25 38.7633
 insert SU3RoperDecuplet:MaxWeight 26 12.8808
 insert SU3RoperDecuplet:MaxWeight 27 22.1448
 insert SU3RoperDecuplet:MaxWeight 28 1.10029
 insert SU3RoperDecuplet:MaxWeight 29 0.000365739
 insert SU3RoperDecuplet:MaxWeight 30 44.9148
 insert SU3RoperDecuplet:MaxWeight 31 12.3086
 insert SU3RoperDecuplet:MaxWeight 32 5.64695
 insert SU3RoperDecuplet:MaxWeight 33 2.7869
 insert SU3RoperDecuplet:MaxWeight 34 2.73645
 insert SU3RoperDecuplet:MaxWeight 35 1.57765
 insert SU3RoperDecuplet:MaxWeight 36 4.1449
 insert SU3RoperDecuplet:MaxWeight 37 5.09824
 insert SU3RoperDecuplet:MaxWeight 38 2.73002
 insert SU3RoperDecuplet:MaxWeight 39 2.48197
 insert SU3RoperDecuplet:MaxWeight 40 1.43915
 insert SU3RoperDecuplet:MaxWeight 41 4.43562
 #
 create Herwig::SU3BaryonOctetOctetScalarDecayer  SU3Strong3
 newdef SU3Strong3:Iteration 1
 newdef SU3Strong3:Ntry 500
 newdef SU3Strong3:Points 10000
 newdef SU3Strong3:GenerateIntermediates 0
 newdef SU3Strong3:Fcoupling -0.69
 newdef SU3Strong3:Dcoupling 1.75
 newdef SU3Strong3:Parity 1
 newdef SU3Strong3:Fpi 130.7
 newdef SU3Strong3:Proton 2212
 newdef SU3Strong3:Neutron 2112
 newdef SU3Strong3:Sigma+ 3222
 newdef SU3Strong3:Sigma0 3212
 newdef SU3Strong3:Sigma- 3112
 newdef SU3Strong3:Lambda 3122
 newdef SU3Strong3:Xi0 3322
 newdef SU3Strong3:Xi- 3312
 newdef SU3Strong3:ExcitedProton 102214
 newdef SU3Strong3:ExcitedNeutron 102114
 newdef SU3Strong3:ExcitedSigma+ 103224
 newdef SU3Strong3:ExcitedSigma0 103214
 newdef SU3Strong3:ExcitedSigma- 103114
 newdef SU3Strong3:ExcitedLambda 103124
 newdef SU3Strong3:ExcitedXi0 103324
 newdef SU3Strong3:ExcitedXi- 103314
 insert SU3Strong3:MaxWeight 0 3.76502
 insert SU3Strong3:MaxWeight 1 3.80624
 insert SU3Strong3:MaxWeight 2 15.886
 insert SU3Strong3:MaxWeight 3 8.10483
 insert SU3Strong3:MaxWeight 4 49.1548
 insert SU3Strong3:MaxWeight 5 0.056859
 insert SU3Strong3:MaxWeight 6 3.7818
 insert SU3Strong3:MaxWeight 7 3.78946
 insert SU3Strong3:MaxWeight 8 16.046
 insert SU3Strong3:MaxWeight 9 8.07833
 insert SU3Strong3:MaxWeight 10 46.8005
 insert SU3Strong3:MaxWeight 11 0.0570574
 insert SU3Strong3:MaxWeight 12 38.4119
 insert SU3Strong3:MaxWeight 13 38.6815
 insert SU3Strong3:MaxWeight 14 37.2037
 insert SU3Strong3:MaxWeight 15 5.04034
 insert SU3Strong3:MaxWeight 16 1.81489
 insert SU3Strong3:MaxWeight 17 1.85277
 insert SU3Strong3:MaxWeight 18 0.297424
 insert SU3Strong3:MaxWeight 19 0.289611
 insert SU3Strong3:MaxWeight 20 4.94361
 insert SU3Strong3:MaxWeight 21 4.81691
 insert SU3Strong3:MaxWeight 22 1.3823
 insert SU3Strong3:MaxWeight 23 95.9447
 insert SU3Strong3:MaxWeight 24 29.2431
 insert SU3Strong3:MaxWeight 25 4.33187
 insert SU3Strong3:MaxWeight 26 4.6988
 insert SU3Strong3:MaxWeight 27 4.89784
 insert SU3Strong3:MaxWeight 28 0.662332
 insert SU3Strong3:MaxWeight 29 0.682562
 insert SU3Strong3:MaxWeight 30 98.0671
 insert SU3Strong3:MaxWeight 31 95.2452
 insert SU3Strong3:MaxWeight 32 4.18468
 insert SU3Strong3:MaxWeight 33 29.4475
 insert SU3Strong3:MaxWeight 34 4.81691
 insert SU3Strong3:MaxWeight 35 4.7443
 insert SU3Strong3:MaxWeight 36 1.28206
 insert SU3Strong3:MaxWeight 37 97.3651
 insert SU3Strong3:MaxWeight 38 29.2431
 insert SU3Strong3:MaxWeight 39 4.11443
 insert SU3Strong3:MaxWeight 40 26.6185
 insert SU3Strong3:MaxWeight 41 29.2309
 insert SU3Strong3:MaxWeight 42 460.632
 insert SU3Strong3:MaxWeight 43 450.193
 insert SU3Strong3:MaxWeight 44 18.8397
 insert SU3Strong3:MaxWeight 45 0.0169732
 insert SU3Strong3:MaxWeight 46 30.2496
 insert SU3Strong3:MaxWeight 47 28.0834
 insert SU3Strong3:MaxWeight 48 446.415
 insert SU3Strong3:MaxWeight 49 464.428
 insert SU3Strong3:MaxWeight 50 18.3862
 insert SU3Strong3:MaxWeight 51 0.0191169
 #
 create Herwig::SU3BaryonOctetDecupletScalarDecayer  SU3OctetDecuplet2
 newdef SU3OctetDecuplet2:Iteration 1
 newdef SU3OctetDecuplet2:Ntry 500
 newdef SU3OctetDecuplet2:Points 10000
 newdef SU3OctetDecuplet2:GenerateIntermediates 0
 newdef SU3OctetDecuplet2:Coupling 0.085
 newdef SU3OctetDecuplet2:Parity 1
 newdef SU3OctetDecuplet2:Fpi 130.7
 newdef SU3OctetDecuplet2:Proton 102212
 newdef SU3OctetDecuplet2:Neutron 102112
 newdef SU3OctetDecuplet2:Sigma+ 103222
 newdef SU3OctetDecuplet2:Sigma0 103212
 newdef SU3OctetDecuplet2:Sigma- 103112
 newdef SU3OctetDecuplet2:Lambda 103122
 newdef SU3OctetDecuplet2:Xi0 103322
 newdef SU3OctetDecuplet2:Xi- 103312
 newdef SU3OctetDecuplet2:Delta++ 2224
 newdef SU3OctetDecuplet2:Delta+ 2214
 newdef SU3OctetDecuplet2:Delta0 2114
 newdef SU3OctetDecuplet2:Delta- 1114
 newdef SU3OctetDecuplet2:Sigma*+ 3224
 newdef SU3OctetDecuplet2:Sigma*0 3214
 newdef SU3OctetDecuplet2:Sigma*- 3114
 newdef SU3OctetDecuplet2:Omega 3334
 newdef SU3OctetDecuplet2:Xi*0 3324
 newdef SU3OctetDecuplet2:Xi*- 3314
 insert SU3OctetDecuplet2:MaxWeight 0 2.32934
 insert SU3OctetDecuplet2:MaxWeight 1 0.416437
 insert SU3OctetDecuplet2:MaxWeight 2 2.32724
 insert SU3OctetDecuplet2:MaxWeight 3 2.39008
 insert SU3OctetDecuplet2:MaxWeight 4 0.288323
 insert SU3OctetDecuplet2:MaxWeight 5 0.115812
 insert SU3OctetDecuplet2:MaxWeight 6 2.32373
 insert SU3OctetDecuplet2:MaxWeight 7 2.38921
 insert SU3OctetDecuplet2:MaxWeight 8 0.281336
 insert SU3OctetDecuplet2:MaxWeight 9 0.146149
 insert SU3OctetDecuplet2:MaxWeight 10 2.32736
 insert SU3OctetDecuplet2:MaxWeight 11 0.436271
 insert SU3OctetDecuplet2:MaxWeight 12 0.101687
 insert SU3OctetDecuplet2:MaxWeight 13 0.116201
 insert SU3OctetDecuplet2:MaxWeight 14 0.0246518
 insert SU3OctetDecuplet2:MaxWeight 15 0.748111
 insert SU3OctetDecuplet2:MaxWeight 16 0.0736602
 insert SU3OctetDecuplet2:MaxWeight 17 0.201734
 insert SU3OctetDecuplet2:MaxWeight 18 0.00868203
 insert SU3OctetDecuplet2:MaxWeight 19 0.00795239
 insert SU3OctetDecuplet2:MaxWeight 20 0.362188
 insert SU3OctetDecuplet2:MaxWeight 21 0.378257
 insert SU3OctetDecuplet2:MaxWeight 22 0.0641479
 insert SU3OctetDecuplet2:MaxWeight 23 0.08768
 insert SU3OctetDecuplet2:MaxWeight 24 0.215179
 insert SU3OctetDecuplet2:MaxWeight 25 0.302509
 insert SU3OctetDecuplet2:MaxWeight 26 0.0757243
 insert SU3OctetDecuplet2:MaxWeight 27 0.086701
 insert SU3OctetDecuplet2:MaxWeight 28 0.0197644
 insert SU3OctetDecuplet2:MaxWeight 29 0.83081
 insert SU3OctetDecuplet2:MaxWeight 30 0.27337
 insert SU3OctetDecuplet2:MaxWeight 31 0.0652819
 insert SU3OctetDecuplet2:MaxWeight 32 0.644853
 insert SU3OctetDecuplet2:MaxWeight 33 0.308066
 insert SU3OctetDecuplet2:MaxWeight 34 0.0241458
 insert SU3OctetDecuplet2:MaxWeight 35 0.00953046
 insert SU3OctetDecuplet2:MaxWeight 36 0.438785
 insert SU3OctetDecuplet2:MaxWeight 37 4.80464e-05
 insert SU3OctetDecuplet2:MaxWeight 38 0.713118
 insert SU3OctetDecuplet2:MaxWeight 39 0.298617
 insert SU3OctetDecuplet2:MaxWeight 40 0.0186567
 insert SU3OctetDecuplet2:MaxWeight 41 0.0109833
 insert SU3OctetDecuplet2:MaxWeight 42 0.341691
 insert SU3OctetDecuplet2:MaxWeight 43 5.03293e-05
 #
 create Herwig::SU3BaryonSingletOctetScalarDecayer  SU3SingletOctet1
 newdef SU3SingletOctet1:Iteration 1
 newdef SU3SingletOctet1:Ntry 500
 newdef SU3SingletOctet1:Points 10000
 newdef SU3SingletOctet1:GenerateIntermediates 0
 newdef SU3SingletOctet1:Coupling 0.39
 newdef SU3SingletOctet1:Parity 0
 newdef SU3SingletOctet1:Fpi 130.7
 newdef SU3SingletOctet1:Proton 2212
 newdef SU3SingletOctet1:Neutron 2112
 newdef SU3SingletOctet1:Sigma+ 3222
 newdef SU3SingletOctet1:Sigma0 3212
 newdef SU3SingletOctet1:Sigma- 3112
 newdef SU3SingletOctet1:Lambda 3122
 newdef SU3SingletOctet1:Xi0 3322
 newdef SU3SingletOctet1:Xi- 3312
 newdef SU3SingletOctet1:ExcitedLambda 101232
 insert SU3SingletOctet1:MaxWeight 0 1.60862
 insert SU3SingletOctet1:MaxWeight 1 1.65601
 insert SU3SingletOctet1:MaxWeight 2 1.44904
 insert SU3SingletOctet1:MaxWeight 3 10.9271
 insert SU3SingletOctet1:MaxWeight 4 10.791
 #
 create Herwig::SU3BaryonSingletOctetScalarDecayer  SU3SingletOctet2
 newdef SU3SingletOctet2:Iteration 1
 newdef SU3SingletOctet2:Ntry 500
 newdef SU3SingletOctet2:Points 10000
 newdef SU3SingletOctet2:GenerateIntermediates 0
 newdef SU3SingletOctet2:Coupling 1.5
 newdef SU3SingletOctet2:Parity 0
 newdef SU3SingletOctet2:Fpi 130.7
 newdef SU3SingletOctet2:Proton 2212
 newdef SU3SingletOctet2:Neutron 2112
 newdef SU3SingletOctet2:Sigma+ 3222
 newdef SU3SingletOctet2:Sigma0 3212
 newdef SU3SingletOctet2:Sigma- 3112
 newdef SU3SingletOctet2:Lambda 3122
 newdef SU3SingletOctet2:Xi0 3322
 newdef SU3SingletOctet2:Xi- 3312
 newdef SU3SingletOctet2:ExcitedLambda 101234
 insert SU3SingletOctet2:MaxWeight 0 1.84716
 insert SU3SingletOctet2:MaxWeight 1 1.88647
 insert SU3SingletOctet2:MaxWeight 2 1.63557
 insert SU3SingletOctet2:MaxWeight 3 0.00132433
 insert SU3SingletOctet2:MaxWeight 4 0.93801
 insert SU3SingletOctet2:MaxWeight 5 0.80882
 #
 create Herwig::SU3BaryonOctetOctetScalarDecayer  SU3Strong4
 newdef SU3Strong4:Iteration 1
 newdef SU3Strong4:Ntry 500
 newdef SU3Strong4:Points 10000
 newdef SU3Strong4:GenerateIntermediates 0
 newdef SU3Strong4:Fcoupling -0.48
 newdef SU3Strong4:Dcoupling 0.68
 newdef SU3Strong4:Parity 1
 newdef SU3Strong4:Fpi 130.7
 newdef SU3Strong4:Proton 202212
 newdef SU3Strong4:Neutron 202112
 newdef SU3Strong4:Sigma+ 203222
 newdef SU3Strong4:Sigma0 203212
 newdef SU3Strong4:Sigma- 203112
 newdef SU3Strong4:Lambda 203122
 newdef SU3Strong4:Xi0 203322
 newdef SU3Strong4:Xi- 203312
 newdef SU3Strong4:ExcitedProton 102212
 newdef SU3Strong4:ExcitedNeutron 102112
 newdef SU3Strong4:ExcitedSigma+ 103222
 newdef SU3Strong4:ExcitedSigma0 103212
 newdef SU3Strong4:ExcitedSigma- 103112
 newdef SU3Strong4:ExcitedLambda 103122
 newdef SU3Strong4:ExcitedXi0 103322
 newdef SU3Strong4:ExcitedXi- 103312
 insert SU3Strong4:MaxWeight 0 0.0639544
 insert SU3Strong4:MaxWeight 1 0.0683901
 insert SU3Strong4:MaxWeight 2 0.0719544
 insert SU3Strong4:MaxWeight 3 0.0190191
 insert SU3Strong4:MaxWeight 4 1.56023
 insert SU3Strong4:MaxWeight 5 0.0352242
 insert SU3Strong4:MaxWeight 6 0.063882
 insert SU3Strong4:MaxWeight 7 0.0681114
 insert SU3Strong4:MaxWeight 8 0.189404
 insert SU3Strong4:MaxWeight 9 0.0737446
 insert SU3Strong4:MaxWeight 10 1.43798
 insert SU3Strong4:MaxWeight 11 0.0475399
 insert SU3Strong4:MaxWeight 12 1.83818
 insert SU3Strong4:MaxWeight 13 2.27413
 insert SU3Strong4:MaxWeight 14 2.14365
 insert SU3Strong4:MaxWeight 15 0.00257397
 insert SU3Strong4:MaxWeight 16 0.439475
 insert SU3Strong4:MaxWeight 17 0.494001
 insert SU3Strong4:MaxWeight 18 3.83517
 insert SU3Strong4:MaxWeight 19 3.9436
 insert SU3Strong4:MaxWeight 20 0.00603613
 insert SU3Strong4:MaxWeight 21 14.2647
 insert SU3Strong4:MaxWeight 22 3.48259
 insert SU3Strong4:MaxWeight 23 0.0893589
 insert SU3Strong4:MaxWeight 24 3.94828
 insert SU3Strong4:MaxWeight 25 3.98963
 insert SU3Strong4:MaxWeight 26 0.00113937
 insert SU3Strong4:MaxWeight 27 0.000501017
 insert SU3Strong4:MaxWeight 28 4.56376
 insert SU3Strong4:MaxWeight 29 6.14187
 insert SU3Strong4:MaxWeight 30 0.119288
 insert SU3Strong4:MaxWeight 31 3.62416
 insert SU3Strong4:MaxWeight 32 3.74573
 insert SU3Strong4:MaxWeight 33 2.9989
 insert SU3Strong4:MaxWeight 34 0.00187852
 insert SU3Strong4:MaxWeight 35 13.8324
 insert SU3Strong4:MaxWeight 36 2.84881
 insert SU3Strong4:MaxWeight 37 0.117276
 insert SU3Strong4:MaxWeight 38 1.19996
 insert SU3Strong4:MaxWeight 39 0.609627
 insert SU3Strong4:MaxWeight 40 164.291
 insert SU3Strong4:MaxWeight 41 84.1802
 insert SU3Strong4:MaxWeight 42 27.2875
 insert SU3Strong4:MaxWeight 43 2.56877
 insert SU3Strong4:MaxWeight 44 1.25728
 insert SU3Strong4:MaxWeight 45 0.647119
 insert SU3Strong4:MaxWeight 46 187.091
 insert SU3Strong4:MaxWeight 47 77.3773
 insert SU3Strong4:MaxWeight 48 25.0159
 insert SU3Strong4:MaxWeight 49 5.49723
 #
 create Herwig::SU3BaryonOctetDecupletScalarDecayer  SU3OctetDecuplet3
 newdef SU3OctetDecuplet3:Iteration 1
 newdef SU3OctetDecuplet3:Ntry 500
 newdef SU3OctetDecuplet3:Points 10000
 newdef SU3OctetDecuplet3:GenerateIntermediates 0
 newdef SU3OctetDecuplet3:Coupling 0.35
 newdef SU3OctetDecuplet3:Parity 1
 newdef SU3OctetDecuplet3:Fpi 130.7
 newdef SU3OctetDecuplet3:Proton 102214
 newdef SU3OctetDecuplet3:Neutron 102114
 newdef SU3OctetDecuplet3:Sigma+ 103224
 newdef SU3OctetDecuplet3:Sigma0 103214
 newdef SU3OctetDecuplet3:Sigma- 103114
 newdef SU3OctetDecuplet3:Lambda 103124
 newdef SU3OctetDecuplet3:Xi0 103324
 newdef SU3OctetDecuplet3:Xi- 103314
 newdef SU3OctetDecuplet3:Delta++ 2224
 newdef SU3OctetDecuplet3:Delta+ 2214
 newdef SU3OctetDecuplet3:Delta0 2114
 newdef SU3OctetDecuplet3:Delta- 1114
 newdef SU3OctetDecuplet3:Sigma*+ 3224
 newdef SU3OctetDecuplet3:Sigma*0 3214
 newdef SU3OctetDecuplet3:Sigma*- 3114
 newdef SU3OctetDecuplet3:Omega 3334
 newdef SU3OctetDecuplet3:Xi*0 3324
 newdef SU3OctetDecuplet3:Xi*- 3314
 insert SU3OctetDecuplet3:MaxWeight 0 1.08203
 insert SU3OctetDecuplet3:MaxWeight 1 1.6621
 insert SU3OctetDecuplet3:MaxWeight 2 1.08106
 insert SU3OctetDecuplet3:MaxWeight 3 1.11398
 insert SU3OctetDecuplet3:MaxWeight 4 1.13352
 insert SU3OctetDecuplet3:MaxWeight 5 0.555956
 insert SU3OctetDecuplet3:MaxWeight 6 1.08058
 insert SU3OctetDecuplet3:MaxWeight 7 1.11181
 insert SU3OctetDecuplet3:MaxWeight 8 1.10991
 insert SU3OctetDecuplet3:MaxWeight 9 0.577804
 insert SU3OctetDecuplet3:MaxWeight 10 1.08122
 insert SU3OctetDecuplet3:MaxWeight 11 1.66787
 insert SU3OctetDecuplet3:MaxWeight 12 0.511277
 insert SU3OctetDecuplet3:MaxWeight 13 0.428777
 insert SU3OctetDecuplet3:MaxWeight 14 0.262264
 insert SU3OctetDecuplet3:MaxWeight 15 0.187729
 insert SU3OctetDecuplet3:MaxWeight 16 0.0581627
 insert SU3OctetDecuplet3:MaxWeight 17 1.16719
 insert SU3OctetDecuplet3:MaxWeight 18 0.134985
 insert SU3OctetDecuplet3:MaxWeight 19 0.132211
 insert SU3OctetDecuplet3:MaxWeight 20 0.0842445
 insert SU3OctetDecuplet3:MaxWeight 21 0.0831287
 insert SU3OctetDecuplet3:MaxWeight 22 0.405935
 insert SU3OctetDecuplet3:MaxWeight 23 0.429367
 insert SU3OctetDecuplet3:MaxWeight 24 1.07034
 insert SU3OctetDecuplet3:MaxWeight 25 1.26643
 insert SU3OctetDecuplet3:MaxWeight 26 0.442732
 insert SU3OctetDecuplet3:MaxWeight 27 0.385974
 insert SU3OctetDecuplet3:MaxWeight 28 0.201153
 insert SU3OctetDecuplet3:MaxWeight 29 0.15828
 insert SU3OctetDecuplet3:MaxWeight 30 0.941479
 insert SU3OctetDecuplet3:MaxWeight 31 0.0514224
 insert SU3OctetDecuplet3:MaxWeight 32 2.16926
 insert SU3OctetDecuplet3:MaxWeight 33 2.19241
 insert SU3OctetDecuplet3:MaxWeight 34 3.46377e-07
 insert SU3OctetDecuplet3:MaxWeight 35 8.02372e-08
 insert SU3OctetDecuplet3:MaxWeight 36 1.97192
 insert SU3OctetDecuplet3:MaxWeight 37 1.84709
 insert SU3OctetDecuplet3:MaxWeight 38 1.3873e-08
 insert SU3OctetDecuplet3:MaxWeight 39 3.14856e-07
 #
 create Herwig::OmegaXiStarPionDecayer  OmegaXiStar
 newdef OmegaXiStar:Iteration 1
 newdef OmegaXiStar:Ntry 500
 newdef OmegaXiStar:Points 10000
 newdef OmegaXiStar:GenerateIntermediates 0
 newdef OmegaXiStar:Acomm 2.091e-07
 newdef OmegaXiStar:AP -9.2e-08
 newdef OmegaXiStar:AS -6.32e-08
 newdef OmegaXiStar:BP 2.301e-06
 newdef OmegaXiStar:BS -1.008e-06
 newdef OmegaXiStar:MaximumWeight 0.00252403
 newdef OmegaXiStar:Incoming 3334
 newdef OmegaXiStar:Outgoing 3324
 #
 create Herwig::NonLeptonicOmegaDecayer  OmegaNL
 newdef OmegaNL:DStar -3.98e-07
 newdef OmegaNL:FStar 5e-08
 newdef OmegaNL:omegad -6.44444e-09
 newdef OmegaNL:omegaf 8.5e-09
 newdef OmegaNL:CBstar 1.35
 newdef OmegaNL:sc -0.85
 newdef OmegaNL:C 1.5
 newdef OmegaNL:Fpi 92.4
 newdef OmegaNL:hc 3.9e-08
 newdef OmegaNL:hpi 3.2e-07
 newdef OmegaNL:d 4.4e-08
 newdef OmegaNL:f -5e-08
 newdef OmegaNL:MLambda 1115.68
 newdef OmegaNL:MXi 1314.83
 newdef OmegaNL:MOmega 1672.45
 newdef OmegaNL:MXiStar 1531.8
 newdef OmegaNL:Mpiplus 139.57
 newdef OmegaNL:MKplus 493.667
 newdef OmegaNL:Mpi0 134.977
 newdef OmegaNL:MK0 497.648
 newdef OmegaNL:MBstar 1620
 newdef OmegaNL:MR 1500
 newdef OmegaNL:LocalMasses 1
 insert OmegaNL:MaxWeight 0 1.5
 insert OmegaNL:MaxWeight 1 0.40
 insert OmegaNL:MaxWeight 2 0.20
 newdef OmegaNL:Iteration 1
 newdef OmegaNL:Ntry 500
 newdef OmegaNL:Points 10000
 newdef OmegaNL:GenerateIntermediates 0
 #
 create Herwig::NonLeptonicHyperonDecayer  HyperonNL
 newdef HyperonNL:Iteration 1
 newdef HyperonNL:Ntry 500
 newdef HyperonNL:Points 10000
 newdef HyperonNL:GenerateIntermediates 0 
 do HyperonNL:SetUpDecayMode 3122 2212 -211 3.15441e-07 -2.56965e-06 1.02233
 do HyperonNL:SetUpDecayMode 3122 2112 111 -2.34823e-07 1.71077e-06 0.572769
 do HyperonNL:SetUpDecayMode 3222 2212 111 -2.6763e-07 -3.24965e-06 0.825223
 do HyperonNL:SetUpDecayMode 3222 2112 211 1.39742e-08 -4.2112e-06 0.773064
 do HyperonNL:SetUpDecayMode 3112 2112 -211 4.26814e-07 1.42866e-07 1.59759
 do HyperonNL:SetUpDecayMode 3322 3122 111 3.45387e-07 1.05341e-06 1.59532
 do HyperonNL:SetUpDecayMode 3312 3122 -211 -4.51957e-07 -1.5189e-06 1.59161
 do HyperonNL:SetUpDecayMode 4132 3312 211 2.89666e-07 2.71413e-06 0.0167771
 do HyperonNL:SetUpDecayMode 4122 3122 211 3.56697e-07 1.91559e-06 0.0205336
 do HyperonNL:SetUpDecayMode 4122 3222 111 2.10027e-07 2.23662e-06 0.0197528
 do HyperonNL:SetUpDecayMode 4122 3212 211 2.95892e-07 2.18669e-06 0.0203823
 do HyperonNL:SetUpDecayMode 4122 2212 211 -8.18977e-08 1.99027e-06 0.025117
 
 
 #
 create Herwig::SU3BaryonOctetOctetPhotonDecayer  SU3RoperGamma
 newdef SU3RoperGamma:Iteration 1
 newdef SU3RoperGamma:Ntry 500
 newdef SU3RoperGamma:Points 10000
 newdef SU3RoperGamma:GenerateIntermediates 0
 newdef SU3RoperGamma:Fcoupling -0.009
 newdef SU3RoperGamma:Dcoupling -0.024
 newdef SU3RoperGamma:Parity 1
 newdef SU3RoperGamma:Proton 2212
 newdef SU3RoperGamma:Neutron 2112
 newdef SU3RoperGamma:Sigma+ 3222
 newdef SU3RoperGamma:Sigma0 3212
 newdef SU3RoperGamma:Sigma- 3112
 newdef SU3RoperGamma:Lambda 3122
 newdef SU3RoperGamma:Xi0 3322
 newdef SU3RoperGamma:Xi- 3312
 newdef SU3RoperGamma:ExcitedProton 202212
 newdef SU3RoperGamma:ExcitedNeutron 202112
 newdef SU3RoperGamma:ExcitedSigma+ 203222
 newdef SU3RoperGamma:ExcitedSigma0 203212
 newdef SU3RoperGamma:ExcitedSigma- 203112
 newdef SU3RoperGamma:ExcitedLambda 203122
 newdef SU3RoperGamma:ExcitedXi0 203322
 newdef SU3RoperGamma:ExcitedXi- 203312
 insert SU3RoperGamma:MaxWeight 0 1.34534
 insert SU3RoperGamma:MaxWeight 1 2.3978
 insert SU3RoperGamma:MaxWeight 2 0.01954
 insert SU3RoperGamma:MaxWeight 3 0.00189107
 insert SU3RoperGamma:MaxWeight 4 0.00998248
 insert SU3RoperGamma:MaxWeight 5 0.000310286
 insert SU3RoperGamma:MaxWeight 6 0.0310247
 insert SU3RoperGamma:MaxWeight 7 0.024809
 insert SU3RoperGamma:MaxWeight 8 5.2804e-05
 insert SU3RoperGamma:MaxWeight 9 0.014572
 #
 create Herwig::SU3BaryonOctetOctetPhotonDecayer  SU3Gamma2
 newdef SU3Gamma2:Iteration 1
 newdef SU3Gamma2:Ntry 500
 newdef SU3Gamma2:Points 10000
 newdef SU3Gamma2:GenerateIntermediates 0
 newdef SU3Gamma2:Fcoupling -0.046
 newdef SU3Gamma2:Dcoupling 0.033
 newdef SU3Gamma2:Parity 0
 newdef SU3Gamma2:Proton 2212
 newdef SU3Gamma2:Neutron 2112
 newdef SU3Gamma2:Sigma+ 3222
 newdef SU3Gamma2:Sigma0 3212
 newdef SU3Gamma2:Sigma- 3112
 newdef SU3Gamma2:Lambda 3122
 newdef SU3Gamma2:Xi0 3322
 newdef SU3Gamma2:Xi- 3312
 newdef SU3Gamma2:ExcitedProton 102212
 newdef SU3Gamma2:ExcitedNeutron 102112
 newdef SU3Gamma2:ExcitedSigma+ 103222
 newdef SU3Gamma2:ExcitedSigma0 103212
 newdef SU3Gamma2:ExcitedSigma- 103112
 newdef SU3Gamma2:ExcitedLambda 103122
 newdef SU3Gamma2:ExcitedXi0 103322
 newdef SU3Gamma2:ExcitedXi- 103312
 insert SU3Gamma2:MaxWeight 0 2.9575
 insert SU3Gamma2:MaxWeight 1 1.97747
 insert SU3Gamma2:MaxWeight 2 0.0962338
 insert SU3Gamma2:MaxWeight 3 0.00969098
 insert SU3Gamma2:MaxWeight 4 0.0522884
 insert SU3Gamma2:MaxWeight 5 0.00991625
 insert SU3Gamma2:MaxWeight 6 0.0712376
 insert SU3Gamma2:MaxWeight 7 0.0130695
 insert SU3Gamma2:MaxWeight 8 0.36402
 insert SU3Gamma2:MaxWeight 9 0.0548153
 #
 create Herwig::SU3BaryonOctetOctetPhotonDecayer  SU3Gamma3
 newdef SU3Gamma3:Iteration 1
 newdef SU3Gamma3:Ntry 500
 newdef SU3Gamma3:Points 10000
 newdef SU3Gamma3:GenerateIntermediates 0
 newdef SU3Gamma3:Fcoupling 0
 newdef SU3Gamma3:Dcoupling 0.056
 newdef SU3Gamma3:Parity 1
 newdef SU3Gamma3:Proton 2212
 newdef SU3Gamma3:Neutron 2112
 newdef SU3Gamma3:Sigma+ 3222
 newdef SU3Gamma3:Sigma0 3212
 newdef SU3Gamma3:Sigma- 3112
 newdef SU3Gamma3:Lambda 3122
 newdef SU3Gamma3:Xi0 3322
 newdef SU3Gamma3:Xi- 3312
 newdef SU3Gamma3:ExcitedProton 2212
 newdef SU3Gamma3:ExcitedNeutron 2112
 newdef SU3Gamma3:ExcitedSigma+ 3222
 newdef SU3Gamma3:ExcitedSigma0 3212
 newdef SU3Gamma3:ExcitedSigma- 3112
 newdef SU3Gamma3:ExcitedLambda 3122
 newdef SU3Gamma3:ExcitedXi0 3322
 newdef SU3Gamma3:ExcitedXi- 3312
 insert SU3Gamma3:MaxWeight 0 1.58351
 #
 create Herwig::SU3BaryonDecupletOctetPhotonDecayer  DecupletGamma
 newdef DecupletGamma:Iteration 1
 newdef DecupletGamma:Ntry 500
 newdef DecupletGamma:Points 10000
 newdef DecupletGamma:GenerateIntermediates 0
 newdef DecupletGamma:Ccoupling 1
 newdef DecupletGamma:Parity 1
 newdef DecupletGamma:Proton 2212
 newdef DecupletGamma:Neutron 2112
 newdef DecupletGamma:Sigma+ 3222
 newdef DecupletGamma:Sigma0 3212
 newdef DecupletGamma:Sigma- 3112
 newdef DecupletGamma:Lambda 3122
 newdef DecupletGamma:Xi0 3322
 newdef DecupletGamma:Xi- 3312
 newdef DecupletGamma:Delta++ 2224
 newdef DecupletGamma:Delta+ 2214
 newdef DecupletGamma:Delta0 2114
 newdef DecupletGamma:Delta- 1114
 newdef DecupletGamma:Sigma*+ 3224
 newdef DecupletGamma:Sigma*0 3214
 newdef DecupletGamma:Sigma*- 3114
 newdef DecupletGamma:Omega 3334
 newdef DecupletGamma:Xi*0 3324
 newdef DecupletGamma:Xi*- 3314
 insert DecupletGamma:MaxWeight 0 1.35718
 insert DecupletGamma:MaxWeight 1 1.34224
 insert DecupletGamma:MaxWeight 2 0.0314619
 insert DecupletGamma:MaxWeight 3 3.09183
 insert DecupletGamma:MaxWeight 4 0.00772277
 insert DecupletGamma:MaxWeight 5 0.122963
 #
 create Herwig::SU3BaryonOctetOctetPhotonDecayer  SU3Gamma4
 newdef SU3Gamma4:Iteration 1
 newdef SU3Gamma4:Ntry 500
 newdef SU3Gamma4:Points 10000
 newdef SU3Gamma4:GenerateIntermediates 0
 newdef SU3Gamma4:Fcoupling -0.093
 newdef SU3Gamma4:Dcoupling 0.087
 newdef SU3Gamma4:Parity 1
 newdef SU3Gamma4:Proton 2212
 newdef SU3Gamma4:Neutron 2112
 newdef SU3Gamma4:Sigma+ 3222
 newdef SU3Gamma4:Sigma0 3212
 newdef SU3Gamma4:Sigma- 3112
 newdef SU3Gamma4:Lambda 3122
 newdef SU3Gamma4:Xi0 3322
 newdef SU3Gamma4:Xi- 3312
 newdef SU3Gamma4:ExcitedProton 102214
 newdef SU3Gamma4:ExcitedNeutron 102114
 newdef SU3Gamma4:ExcitedSigma+ 103224
 newdef SU3Gamma4:ExcitedSigma0 103214
 newdef SU3Gamma4:ExcitedSigma- 103114
 newdef SU3Gamma4:ExcitedLambda 103124
 newdef SU3Gamma4:ExcitedXi0 103324
 newdef SU3Gamma4:ExcitedXi- 103314
 insert SU3Gamma4:MaxWeight 0 0.415222
 insert SU3Gamma4:MaxWeight 1 0.417084
 insert SU3Gamma4:MaxWeight 2 0.0204893
 insert SU3Gamma4:MaxWeight 3 0.00210252
 insert SU3Gamma4:MaxWeight 4 0.00955353
 insert SU3Gamma4:MaxWeight 5 0.00222245
 insert SU3Gamma4:MaxWeight 6 0.0283485
 insert SU3Gamma4:MaxWeight 7 0.00715258
 insert SU3Gamma4:MaxWeight 8 0.0517918
 insert SU3Gamma4:MaxWeight 9 0.0120169
 #
 create Herwig::SU3BaryonSingletOctetPhotonDecayer  SU3Gamma5
 newdef SU3Gamma5:Iteration 1
 newdef SU3Gamma5:Ntry 500
 newdef SU3Gamma5:Points 10000
 newdef SU3Gamma5:GenerateIntermediates 0
 newdef SU3Gamma5:Coupling 0.252
 newdef SU3Gamma5:Parity 0
 newdef SU3Gamma5:Sigma0 3212
 newdef SU3Gamma5:Lambda 3122
 newdef SU3Gamma5:ExcitedLambda 101234
 insert SU3Gamma5:MaxWeight 0 1.60087
 insert SU3Gamma5:MaxWeight 1 2.20194
 #
 create Herwig::TauDecayer  Tau1Vector
 newdef Tau1Vector:Iteration 1
 newdef Tau1Vector:Ntry 500
 newdef Tau1Vector:Points 10000
 newdef Tau1Vector:GenerateIntermediates 0
 insert Tau1Vector:WeightLocation 0 0
 insert Tau1Vector:WeightLocation 1 0
 insert Tau1Vector:WeightLocation 2 0
 insert Tau1Vector:MaximumWeight 0 0.655878
 insert Tau1Vector:MaximumWeight 1 0.0320164
 insert Tau1Vector:MaximumWeight 2 1.05267
 create Herwig::VectorMesonCurrent Tau1VectorCurrent HwWeakCurrents.so
 newdef Tau1VectorCurrent:ID 0 213
 newdef Tau1VectorCurrent:Decay_Constant 0 0.1764
 newdef Tau1VectorCurrent:ID 1 113
 newdef Tau1VectorCurrent:Decay_Constant 1 0.1764
 newdef Tau1VectorCurrent:ID 2 113
 newdef Tau1VectorCurrent:Decay_Constant 2 0.1764
 newdef Tau1VectorCurrent:ID 3 223
 newdef Tau1VectorCurrent:Decay_Constant 3 0.1764
 newdef Tau1VectorCurrent:ID 4 223
 newdef Tau1VectorCurrent:Decay_Constant 4 0.1764
 newdef Tau1VectorCurrent:ID 5 333
 newdef Tau1VectorCurrent:Decay_Constant 5 0.238
 newdef Tau1VectorCurrent:ID 6 313
 newdef Tau1VectorCurrent:Decay_Constant 6 0.2019
 newdef Tau1VectorCurrent:ID 7 323
 newdef Tau1VectorCurrent:Decay_Constant 7 0.2019
 newdef Tau1VectorCurrent:ID 8 20213
 newdef Tau1VectorCurrent:Decay_Constant 8 0.4626
 newdef Tau1VectorCurrent:ID 9 20113
 newdef Tau1VectorCurrent:Decay_Constant 9 0.4626
 newdef Tau1VectorCurrent:ID 10 20113
 newdef Tau1VectorCurrent:Decay_Constant 10 0.4626
 newdef Tau1VectorCurrent:ID 11 413
 newdef Tau1VectorCurrent:Decay_Constant 11 0.402
 newdef Tau1VectorCurrent:ID 12 423
 newdef Tau1VectorCurrent:Decay_Constant 12 0.402
 newdef Tau1VectorCurrent:ID 13 433
 newdef Tau1VectorCurrent:Decay_Constant 13 0.509
 newdef Tau1VectorCurrent:ID 14 443
 newdef Tau1VectorCurrent:Decay_Constant 14 1.223
 newdef Tau1VectorCurrent:ID 15 100443
 newdef Tau1VectorCurrent:Decay_Constant 15 1.08
 newdef Tau1VectorCurrent:ID 16 20433
 newdef Tau1VectorCurrent:Decay_Constant 16 0.397
 newdef Tau1VectorCurrent:Quark 0  2
 newdef Tau1VectorCurrent:AntiQuark 0  -1
 newdef Tau1VectorCurrent:Quark 1  1
 newdef Tau1VectorCurrent:AntiQuark 1  -1
 newdef Tau1VectorCurrent:Quark 2  2
 newdef Tau1VectorCurrent:AntiQuark 2  -2
 newdef Tau1VectorCurrent:Quark 3  1
 newdef Tau1VectorCurrent:AntiQuark 3  -1
 newdef Tau1VectorCurrent:Quark 4  2
 newdef Tau1VectorCurrent:AntiQuark 4  -2
 newdef Tau1VectorCurrent:Quark 5  3
 newdef Tau1VectorCurrent:AntiQuark 5  -3
 newdef Tau1VectorCurrent:Quark 6  1
 newdef Tau1VectorCurrent:AntiQuark 6  -3
 newdef Tau1VectorCurrent:Quark 7  2
 newdef Tau1VectorCurrent:AntiQuark 7  -3
 newdef Tau1VectorCurrent:Quark 8  2
 newdef Tau1VectorCurrent:AntiQuark 8  -1
 newdef Tau1VectorCurrent:Quark 9  1
 newdef Tau1VectorCurrent:AntiQuark 9  -1
 newdef Tau1VectorCurrent:Quark 10  2
 newdef Tau1VectorCurrent:AntiQuark 10  -2
 newdef Tau1VectorCurrent:Quark 11  4
 newdef Tau1VectorCurrent:AntiQuark 11  -1
 newdef Tau1VectorCurrent:Quark 12  4
 newdef Tau1VectorCurrent:AntiQuark 12  -2
 newdef Tau1VectorCurrent:Quark 13  4
 newdef Tau1VectorCurrent:AntiQuark 13  -3
 newdef Tau1VectorCurrent:Quark 14  4
 newdef Tau1VectorCurrent:AntiQuark 14  -4
 newdef Tau1VectorCurrent:Quark 15  4
 newdef Tau1VectorCurrent:AntiQuark 15  -4
 newdef Tau1VectorCurrent:Quark 16  4
 newdef Tau1VectorCurrent:AntiQuark 16  -3
 newdef Tau1Vector:WeakCurrent Tau1VectorCurrent
 #
 create Herwig::SemiLeptonicScalarDecayer  BZVector
 newdef BZVector:Iteration 1
 newdef BZVector:Ntry 500
 newdef BZVector:Points 10000
 newdef BZVector:GenerateIntermediates 0
 insert BZVector:MaximumWeight 0 0.000599733
 insert BZVector:MaximumWeight 1 0.000579422
 insert BZVector:MaximumWeight 2 0.000339457
 insert BZVector:MaximumWeight 3 0.00104623
 insert BZVector:MaximumWeight 4 0.00103622
 insert BZVector:MaximumWeight 5 0.000630363
 insert BZVector:MaximumWeight 6 0.00128096
 insert BZVector:MaximumWeight 7 0.00124115
 insert BZVector:MaximumWeight 8 0.000739429
 insert BZVector:MaximumWeight 9 0.0022
 insert BZVector:MaximumWeight 10 0.0022
 insert BZVector:MaximumWeight 11 0.00122368
 create Herwig::LeptonNeutrinoCurrent BZVectorCurrent  HwWeakCurrents.so
 newdef BZVectorCurrent:Quark 0  11
 newdef BZVectorCurrent:AntiQuark 0  -12
 newdef BZVectorCurrent:Quark 1  13
 newdef BZVectorCurrent:AntiQuark 1  -15
 newdef BZVectorCurrent:Quark 2  15
 newdef BZVectorCurrent:AntiQuark 2  -16
 newdef BZVector:Current BZVectorCurrent
 create Herwig::BallZwickyVectorFormFactor BZVectorFormFactor
 newdef BZVectorFormFactor:CutOff 0.01
 newdef BZVectorFormFactor:Vr_1 0  0.738927
 newdef BZVectorFormFactor:Vr_2 0  -0.509824
 newdef BZVectorFormFactor:A0r_1 0  1.07975
 newdef BZVectorFormFactor:A0r_2 0  -0.86267
 newdef BZVectorFormFactor:A1r_1 0  0.169706
 newdef BZVectorFormFactor:A1r_2 0  0
 newdef BZVectorFormFactor:A2r_1 0  0.00636396
 newdef BZVectorFormFactor:A2r_2 0  0.149907
 newdef BZVectorFormFactor:T1r_1 0  0.634275
 newdef BZVectorFormFactor:T1r_2 0  -0.44477
 newdef BZVectorFormFactor:T2r_1 0  0.188798
 newdef BZVectorFormFactor:T2r_2 0  0
 newdef BZVectorFormFactor:T3r_1 0  0.0155563
 newdef BZVectorFormFactor:T3r_2 0  0.173241
 newdef BZVectorFormFactor:VmR2 0  28.3024
 newdef BZVectorFormFactor:Vmfit2 0  38.34
 newdef BZVectorFormFactor:A0mR2 0  27.8784
 newdef BZVectorFormFactor:A0mfit2 0  33.36
 newdef BZVectorFormFactor:A1mR2 0  -1
 newdef BZVectorFormFactor:A1mfit2 0  37.51
 newdef BZVectorFormFactor:A2mR2 0  -1
 newdef BZVectorFormFactor:A2mfit2 0  40.82
 newdef BZVectorFormFactor:T1mR2 0  28.3024
 newdef BZVectorFormFactor:T1mfit2 0  38.04
 newdef BZVectorFormFactor:T2mR2 0  -1
 newdef BZVectorFormFactor:T2mfit2 0  38.59
 newdef BZVectorFormFactor:T3mR2 0  -1
 newdef BZVectorFormFactor:T3mfit2 0  40.88
 newdef BZVectorFormFactor:Vr_1 1  -0.738927
 newdef BZVectorFormFactor:Vr_2 1  0.509824
 newdef BZVectorFormFactor:A0r_1 1  -1.07975
 newdef BZVectorFormFactor:A0r_2 1  0.86267
 newdef BZVectorFormFactor:A1r_1 1  -0.169706
 newdef BZVectorFormFactor:A1r_2 1  -0
 newdef BZVectorFormFactor:A2r_1 1  -0.00636396
 newdef BZVectorFormFactor:A2r_2 1  -0.149907
 newdef BZVectorFormFactor:T1r_1 1  -0.634275
 newdef BZVectorFormFactor:T1r_2 1  0.44477
 newdef BZVectorFormFactor:T2r_1 1  -0.188798
 newdef BZVectorFormFactor:T2r_2 1  -0
 newdef BZVectorFormFactor:T3r_1 1  -0.0155563
 newdef BZVectorFormFactor:T3r_2 1  -0.173241
 newdef BZVectorFormFactor:VmR2 1  28.3024
 newdef BZVectorFormFactor:Vmfit2 1  38.34
 newdef BZVectorFormFactor:A0mR2 1  27.8784
 newdef BZVectorFormFactor:A0mfit2 1  33.36
 newdef BZVectorFormFactor:A1mR2 1  -1
 newdef BZVectorFormFactor:A1mfit2 1  37.51
 newdef BZVectorFormFactor:A2mR2 1  -1
 newdef BZVectorFormFactor:A2mfit2 1  40.82
 newdef BZVectorFormFactor:T1mR2 1  28.3024
 newdef BZVectorFormFactor:T1mfit2 1  38.04
 newdef BZVectorFormFactor:T2mR2 1  -1
 newdef BZVectorFormFactor:T2mfit2 1  38.59
 newdef BZVectorFormFactor:T3mR2 1  -1
 newdef BZVectorFormFactor:T3mfit2 1  40.88
 newdef BZVectorFormFactor:Vr_1 2  1.045
 newdef BZVectorFormFactor:Vr_2 2  -0.721
 newdef BZVectorFormFactor:A0r_1 2  1.527
 newdef BZVectorFormFactor:A0r_2 2  -1.22
 newdef BZVectorFormFactor:A1r_1 2  0.24
 newdef BZVectorFormFactor:A1r_2 2  0
 newdef BZVectorFormFactor:A2r_1 2  0.009
 newdef BZVectorFormFactor:A2r_2 2  0.212
 newdef BZVectorFormFactor:T1r_1 2  0.897
 newdef BZVectorFormFactor:T1r_2 2  -0.629
 newdef BZVectorFormFactor:T2r_1 2  0.267
 newdef BZVectorFormFactor:T2r_2 2  0
 newdef BZVectorFormFactor:T3r_1 2  0.022
 newdef BZVectorFormFactor:T3r_2 2  0.245
 newdef BZVectorFormFactor:VmR2 2  28.3024
 newdef BZVectorFormFactor:Vmfit2 2  38.34
 newdef BZVectorFormFactor:A0mR2 2  27.8784
 newdef BZVectorFormFactor:A0mfit2 2  33.36
 newdef BZVectorFormFactor:A1mR2 2  -1
 newdef BZVectorFormFactor:A1mfit2 2  37.51
 newdef BZVectorFormFactor:A2mR2 2  -1
 newdef BZVectorFormFactor:A2mfit2 2  40.82
 newdef BZVectorFormFactor:T1mR2 2  28.3024
 newdef BZVectorFormFactor:T1mfit2 2  38.04
 newdef BZVectorFormFactor:T2mR2 2  -1
 newdef BZVectorFormFactor:T2mfit2 2  38.59
 newdef BZVectorFormFactor:T3mR2 2  -1
 newdef BZVectorFormFactor:T3mfit2 2  40.88
 newdef BZVectorFormFactor:Vr_1 3  1.045
 newdef BZVectorFormFactor:Vr_2 3  -0.721
 newdef BZVectorFormFactor:A0r_1 3  1.527
 newdef BZVectorFormFactor:A0r_2 3  -1.22
 newdef BZVectorFormFactor:A1r_1 3  0.24
 newdef BZVectorFormFactor:A1r_2 3  0
 newdef BZVectorFormFactor:A2r_1 3  0.009
 newdef BZVectorFormFactor:A2r_2 3  0.212
 newdef BZVectorFormFactor:T1r_1 3  0.897
 newdef BZVectorFormFactor:T1r_2 3  -0.629
 newdef BZVectorFormFactor:T2r_1 3  0.267
 newdef BZVectorFormFactor:T2r_2 3  0
 newdef BZVectorFormFactor:T3r_1 3  0.022
 newdef BZVectorFormFactor:T3r_2 3  0.245
 newdef BZVectorFormFactor:VmR2 3  28.3024
 newdef BZVectorFormFactor:Vmfit2 3  38.34
 newdef BZVectorFormFactor:A0mR2 3  27.8784
 newdef BZVectorFormFactor:A0mfit2 3  33.36
 newdef BZVectorFormFactor:A1mR2 3  -1
 newdef BZVectorFormFactor:A1mfit2 3  37.51
 newdef BZVectorFormFactor:A2mR2 3  -1
 newdef BZVectorFormFactor:A2mfit2 3  40.82
 newdef BZVectorFormFactor:T1mR2 3  28.3024
 newdef BZVectorFormFactor:T1mfit2 3  38.04
 newdef BZVectorFormFactor:T2mR2 3  -1
 newdef BZVectorFormFactor:T2mfit2 3  38.59
 newdef BZVectorFormFactor:T3mR2 3  -1
 newdef BZVectorFormFactor:T3mfit2 3  40.88
 newdef BZVectorFormFactor:Vr_1 4  0.923
 newdef BZVectorFormFactor:Vr_2 4  -0.511
 newdef BZVectorFormFactor:A0r_1 4  1.364
 newdef BZVectorFormFactor:A0r_2 4  -0.99
 newdef BZVectorFormFactor:A1r_1 4  0.29
 newdef BZVectorFormFactor:A1r_2 4  0
 newdef BZVectorFormFactor:A2r_1 4  -0.084
 newdef BZVectorFormFactor:A2r_2 4  0.342
 newdef BZVectorFormFactor:T1r_1 4  0.823
 newdef BZVectorFormFactor:T1r_2 4  -0.491
 newdef BZVectorFormFactor:T2r_1 4  0.333
 newdef BZVectorFormFactor:T2r_2 4  0
 newdef BZVectorFormFactor:T3r_1 4  -0.036
 newdef BZVectorFormFactor:T3r_2 4  0.369
 newdef BZVectorFormFactor:VmR2 4  28.3024
 newdef BZVectorFormFactor:Vmfit2 4  49.4
 newdef BZVectorFormFactor:A0mR2 4  27.8784
 newdef BZVectorFormFactor:A0mfit2 4  36.78
 newdef BZVectorFormFactor:A1mR2 4  -1
 newdef BZVectorFormFactor:A1mfit2 4  40.38
 newdef BZVectorFormFactor:A2mR2 4  -1
 newdef BZVectorFormFactor:A2mfit2 4  52
 newdef BZVectorFormFactor:T1mR2 4  28.3024
 newdef BZVectorFormFactor:T1mfit2 4  46.31
 newdef BZVectorFormFactor:T2mR2 4  -1
 newdef BZVectorFormFactor:T2mfit2 4  41.41
 newdef BZVectorFormFactor:T3mR2 4  -1
 newdef BZVectorFormFactor:T3mfit2 4  48.1
 newdef BZVectorFormFactor:Vr_1 5  0.923
 newdef BZVectorFormFactor:Vr_2 5  -0.511
 newdef BZVectorFormFactor:A0r_1 5  1.364
 newdef BZVectorFormFactor:A0r_2 5  -0.99
 newdef BZVectorFormFactor:A1r_1 5  0.29
 newdef BZVectorFormFactor:A1r_2 5  0
 newdef BZVectorFormFactor:A2r_1 5  -0.084
 newdef BZVectorFormFactor:A2r_2 5  0.342
 newdef BZVectorFormFactor:T1r_1 5  0.823
 newdef BZVectorFormFactor:T1r_2 5  -0.491
 newdef BZVectorFormFactor:T2r_1 5  0.333
 newdef BZVectorFormFactor:T2r_2 5  0
 newdef BZVectorFormFactor:T3r_1 5  -0.036
 newdef BZVectorFormFactor:T3r_2 5  0.369
 newdef BZVectorFormFactor:VmR2 5  28.3024
 newdef BZVectorFormFactor:Vmfit2 5  49.4
 newdef BZVectorFormFactor:A0mR2 5  27.8784
 newdef BZVectorFormFactor:A0mfit2 5  36.78
 newdef BZVectorFormFactor:A1mR2 5  -1
 newdef BZVectorFormFactor:A1mfit2 5  40.38
 newdef BZVectorFormFactor:A2mR2 5  -1
 newdef BZVectorFormFactor:A2mfit2 5  52
 newdef BZVectorFormFactor:T1mR2 5  28.3024
 newdef BZVectorFormFactor:T1mfit2 5  46.31
 newdef BZVectorFormFactor:T2mR2 5  -1
 newdef BZVectorFormFactor:T2mfit2 5  41.41
 newdef BZVectorFormFactor:T3mR2 5  -1
 newdef BZVectorFormFactor:T3mfit2 5  48.1
 newdef BZVectorFormFactor:Vr_1 6  0.711349
 newdef BZVectorFormFactor:Vr_2 6  -0.504167
 newdef BZVectorFormFactor:A0r_1 6  0.934088
 newdef BZVectorFormFactor:A0r_2 6  -0.735391
 newdef BZVectorFormFactor:A1r_1 6  0.153442
 newdef BZVectorFormFactor:A1r_2 6  0
 newdef BZVectorFormFactor:A2r_1 6  0.00424264
 newdef BZVectorFormFactor:A2r_2 6  0.135765
 newdef BZVectorFormFactor:T1r_1 6  0.611647
 newdef BZVectorFormFactor:T1r_2 6  -0.43982
 newdef BZVectorFormFactor:T2r_1 6  0.17112
 newdef BZVectorFormFactor:T2r_2 6  0
 newdef BZVectorFormFactor:T3r_1 6  0.0162635
 newdef BZVectorFormFactor:T3r_2 6  0.154856
 newdef BZVectorFormFactor:VmR2 6  28.3024
 newdef BZVectorFormFactor:Vmfit2 6  37.45
 newdef BZVectorFormFactor:A0mR2 6  27.8784
 newdef BZVectorFormFactor:A0mfit2 6  34.47
 newdef BZVectorFormFactor:A1mR2 6  -1
 newdef BZVectorFormFactor:A1mfit2 6  37.01
 newdef BZVectorFormFactor:A2mR2 6  -1
 newdef BZVectorFormFactor:A2mfit2 6  41.24
 newdef BZVectorFormFactor:T1mR2 6  28.3024
 newdef BZVectorFormFactor:T1mfit2 6  37.19
 newdef BZVectorFormFactor:T2mR2 6  -1
 newdef BZVectorFormFactor:T2mfit2 6  37.95
 newdef BZVectorFormFactor:T3mR2 6  -1
 newdef BZVectorFormFactor:T3mfit2 6  40.87
 newdef BZVectorFormFactor:Vr_1 7  2.351
 newdef BZVectorFormFactor:Vr_2 7  -2.039
 newdef BZVectorFormFactor:A0r_1 7  2.813
 newdef BZVectorFormFactor:A0r_2 7  -2.45
 newdef BZVectorFormFactor:A1r_1 7  0.231
 newdef BZVectorFormFactor:A1r_2 7  0
 newdef BZVectorFormFactor:A2r_1 7  -0.011
 newdef BZVectorFormFactor:A2r_2 7  0.192
 newdef BZVectorFormFactor:T1r_1 7  2.047
 newdef BZVectorFormFactor:T1r_2 7  -1.787
 newdef BZVectorFormFactor:T2r_1 7  0.26
 newdef BZVectorFormFactor:T2r_2 7  0
 newdef BZVectorFormFactor:T3r_1 7  0.043
 newdef BZVectorFormFactor:T3r_2 7  0.217
 newdef BZVectorFormFactor:VmR2 7  29.3764
 newdef BZVectorFormFactor:Vmfit2 7  33.1
 newdef BZVectorFormFactor:A0mR2 7  28.8369
 newdef BZVectorFormFactor:A0mfit2 7  31.58
 newdef BZVectorFormFactor:A1mR2 7  -1
 newdef BZVectorFormFactor:A1mfit2 7  32.94
 newdef BZVectorFormFactor:A2mR2 7  -1
 newdef BZVectorFormFactor:A2mfit2 7  40.14
 newdef BZVectorFormFactor:T1mR2 7  29.3764
 newdef BZVectorFormFactor:T1mfit2 7  32.83
 newdef BZVectorFormFactor:T2mR2 7  -1
 newdef BZVectorFormFactor:T2mfit2 7  33.01
 newdef BZVectorFormFactor:T3mR2 7  -1
 newdef BZVectorFormFactor:T3mfit2 7  39.38
 newdef BZVectorFormFactor:Vr_1 8  1.484
 newdef BZVectorFormFactor:Vr_2 8  -1.049
 newdef BZVectorFormFactor:A0r_1 8  3.31
 newdef BZVectorFormFactor:A0r_2 8  -2.835
 newdef BZVectorFormFactor:A1r_1 8  0.308
 newdef BZVectorFormFactor:A1r_2 8  0
 newdef BZVectorFormFactor:A2r_1 8  -0.054
 newdef BZVectorFormFactor:A2r_2 8  0.288
 newdef BZVectorFormFactor:T1r_1 8  1.303
 newdef BZVectorFormFactor:T1r_2 8  -0.954
 newdef BZVectorFormFactor:T2r_1 8  0.349
 newdef BZVectorFormFactor:T2r_2 8  0
 newdef BZVectorFormFactor:T3r_1 8  0.027
 newdef BZVectorFormFactor:T3r_2 8  0.322
 newdef BZVectorFormFactor:VmR2 8  29.3764
 newdef BZVectorFormFactor:Vmfit2 8  39.52
 newdef BZVectorFormFactor:A0mR2 8  28.8369
 newdef BZVectorFormFactor:A0mfit2 8  31.57
 newdef BZVectorFormFactor:A1mR2 8  -1
 newdef BZVectorFormFactor:A1mfit2 8  36.54
 newdef BZVectorFormFactor:A2mR2 8  -1
 newdef BZVectorFormFactor:A2mfit2 8  48.94
 newdef BZVectorFormFactor:T1mR2 8  29.3764
 newdef BZVectorFormFactor:T1mfit2 8  38.28
 newdef BZVectorFormFactor:T2mR2 8  -1
 newdef BZVectorFormFactor:T2mfit2 8  37.21
 newdef BZVectorFormFactor:T3mR2 8  -1
 newdef BZVectorFormFactor:T3mfit2 8  45.56
 newdef BZVectorFormFactor:Incoming 0 -521
 newdef BZVectorFormFactor:Outgoing 0 113
 newdef BZVectorFormFactor:Spin 0 1
 newdef BZVectorFormFactor:Spectator 0 -2
 newdef BZVectorFormFactor:InQuark 0 5
 newdef BZVectorFormFactor:OutQuark 0 2
 newdef BZVectorFormFactor:Incoming 1 -511
 newdef BZVectorFormFactor:Outgoing 1 113
 newdef BZVectorFormFactor:Spin 1 1
 newdef BZVectorFormFactor:Spectator 1 -2
 newdef BZVectorFormFactor:InQuark 1 5
 newdef BZVectorFormFactor:OutQuark 1 1
 newdef BZVectorFormFactor:Incoming 2 -511
 newdef BZVectorFormFactor:Outgoing 2 213
 newdef BZVectorFormFactor:Spin 2 1
 newdef BZVectorFormFactor:Spectator 2 -2
 newdef BZVectorFormFactor:InQuark 2 5
 newdef BZVectorFormFactor:OutQuark 2 2
 newdef BZVectorFormFactor:Incoming 3 -521
 newdef BZVectorFormFactor:Outgoing 3 213
 newdef BZVectorFormFactor:Spin 3 1
 newdef BZVectorFormFactor:Spectator 3 -2
 newdef BZVectorFormFactor:InQuark 3 5
 newdef BZVectorFormFactor:OutQuark 3 1
 newdef BZVectorFormFactor:Incoming 4 -521
 newdef BZVectorFormFactor:Outgoing 4 -323
 newdef BZVectorFormFactor:Spin 4 1
 newdef BZVectorFormFactor:Spectator 4 -2
 newdef BZVectorFormFactor:InQuark 4 5
 newdef BZVectorFormFactor:OutQuark 4 3
 newdef BZVectorFormFactor:Incoming 5 -511
 newdef BZVectorFormFactor:Outgoing 5 -313
 newdef BZVectorFormFactor:Spin 5 1
 newdef BZVectorFormFactor:Spectator 5 -2
 newdef BZVectorFormFactor:InQuark 5 5
 newdef BZVectorFormFactor:OutQuark 5 3
 newdef BZVectorFormFactor:Incoming 6 -521
 newdef BZVectorFormFactor:Outgoing 6 223
 newdef BZVectorFormFactor:Spin 6 1
 newdef BZVectorFormFactor:Spectator 6 -2
 newdef BZVectorFormFactor:InQuark 6 5
 newdef BZVectorFormFactor:OutQuark 6 2
 newdef BZVectorFormFactor:Incoming 7 -531
 newdef BZVectorFormFactor:Outgoing 7 323
 newdef BZVectorFormFactor:Spin 7 1
 newdef BZVectorFormFactor:Spectator 7 -3
 newdef BZVectorFormFactor:InQuark 7 5
 newdef BZVectorFormFactor:OutQuark 7 2
 newdef BZVectorFormFactor:Incoming 8 -531
 newdef BZVectorFormFactor:Outgoing 8 333
 newdef BZVectorFormFactor:Spin 8 1
 newdef BZVectorFormFactor:Spectator 8 -3
 newdef BZVectorFormFactor:InQuark 8 5
 newdef BZVectorFormFactor:OutQuark 8 3
 newdef BZVector:FormFactor BZVectorFormFactor
 #
 create Herwig::SemiLeptonicScalarDecayer  BZScalar
 newdef BZScalar:Iteration 1
 newdef BZScalar:Ntry 500
 newdef BZScalar:Points 10000
 newdef BZScalar:GenerateIntermediates 0
 insert BZScalar:MaximumWeight 0 0.000172345
 insert BZScalar:MaximumWeight 1 0.00017204
 insert BZScalar:MaximumWeight 2 0.00012728
 insert BZScalar:MaximumWeight 3 0.000315966
 insert BZScalar:MaximumWeight 4 0.000315402
 insert BZScalar:MaximumWeight 5 0.000233225
 insert BZScalar:MaximumWeight 6 0.000105173
 insert BZScalar:MaximumWeight 7 0.000104496
 insert BZScalar:MaximumWeight 8 7.67637e-05
 create Herwig::LeptonNeutrinoCurrent BZScalarCurrent  HwWeakCurrents.so
 newdef BZScalarCurrent:Quark 0  11
 newdef BZScalarCurrent:AntiQuark 0  -12
 newdef BZScalarCurrent:Quark 1  13
 newdef BZScalarCurrent:AntiQuark 1  -14
 newdef BZScalarCurrent:Quark 2  15
 newdef BZScalarCurrent:AntiQuark 2  -16
 newdef BZScalar:Current BZScalarCurrent
 create Herwig::BallZwickyScalarFormFactor BZScalarFormFactor
 newdef BZScalarFormFactor:ThetaEtaEtaPrime -0.349066
 newdef BZScalarFormFactor:r_10 0 0
 newdef BZScalarFormFactor:r_20 0 0.182434
 newdef BZScalarFormFactor:r_1plus 0 0.526087
 newdef BZScalarFormFactor:r_2plus 0 -0.343654
 newdef BZScalarFormFactor:r_1T 0 0.980757
 newdef BZScalarFormFactor:r_2T 0 -0.801859
 newdef BZScalarFormFactor:m_120 0 -1
 newdef BZScalarFormFactor:mfit20 0 33.81
 newdef BZScalarFormFactor:m_12plus 0 28.3024
 newdef BZScalarFormFactor:mfit2plus 0 40.73
 newdef BZScalarFormFactor:m_12T 0 28.3024
 newdef BZScalarFormFactor:mfit2T 0 32.22
 newdef BZScalarFormFactor:r_10 1 0
 newdef BZScalarFormFactor:r_20 1 -0.182434
 newdef BZScalarFormFactor:r_1plus 1 -0.526087
 newdef BZScalarFormFactor:r_2plus 1 0.343654
 newdef BZScalarFormFactor:r_1T 1 -0.980757
 newdef BZScalarFormFactor:r_2T 1 0.801859
 newdef BZScalarFormFactor:m_120 1 -1
 newdef BZScalarFormFactor:mfit20 1 33.81
 newdef BZScalarFormFactor:m_12plus 1 28.3024
 newdef BZScalarFormFactor:mfit2plus 1 40.73
 newdef BZScalarFormFactor:m_12T 1 28.3024
 newdef BZScalarFormFactor:mfit2T 1 32.22
 newdef BZScalarFormFactor:r_10 2 0
 newdef BZScalarFormFactor:r_20 2 0.258
 newdef BZScalarFormFactor:r_1plus 2 0.744
 newdef BZScalarFormFactor:r_2plus 2 -0.486
 newdef BZScalarFormFactor:r_1T 2 1.387
 newdef BZScalarFormFactor:r_2T 2 -1.134
 newdef BZScalarFormFactor:m_120 2 -1
 newdef BZScalarFormFactor:mfit20 2 33.81
 newdef BZScalarFormFactor:m_12plus 2 28.3024
 newdef BZScalarFormFactor:mfit2plus 2 40.73
 newdef BZScalarFormFactor:m_12T 2 28.3024
 newdef BZScalarFormFactor:mfit2T 2 32.22
 newdef BZScalarFormFactor:r_10 3 0
 newdef BZScalarFormFactor:r_20 3 0.258
 newdef BZScalarFormFactor:r_1plus 3 0.744
 newdef BZScalarFormFactor:r_2plus 3 -0.486
 newdef BZScalarFormFactor:r_1T 3 1.387
 newdef BZScalarFormFactor:r_2T 3 -1.134
 newdef BZScalarFormFactor:m_120 3 -1
 newdef BZScalarFormFactor:mfit20 3 33.81
 newdef BZScalarFormFactor:m_12plus 3 28.3024
 newdef BZScalarFormFactor:mfit2plus 3 40.73
 newdef BZScalarFormFactor:m_12T 3 28.3024
 newdef BZScalarFormFactor:mfit2T 3 32.22
 newdef BZScalarFormFactor:r_10 4 0
 newdef BZScalarFormFactor:r_20 4 0.33
 newdef BZScalarFormFactor:r_1plus 4 0.162
 newdef BZScalarFormFactor:r_2plus 4 0.173
 newdef BZScalarFormFactor:r_1T 4 0.161
 newdef BZScalarFormFactor:r_2T 4 0.198
 newdef BZScalarFormFactor:m_120 4 -1
 newdef BZScalarFormFactor:mfit20 4 37.46
 newdef BZScalarFormFactor:m_12plus 4 29.2681
 newdef BZScalarFormFactor:mfit2plus 4 -1
 newdef BZScalarFormFactor:m_12T 4 29.2681
 newdef BZScalarFormFactor:mfit2T 4 -1
 newdef BZScalarFormFactor:r_10 5 0
 newdef BZScalarFormFactor:r_20 5 0.33
 newdef BZScalarFormFactor:r_1plus 5 0.162
 newdef BZScalarFormFactor:r_2plus 5 0.173
 newdef BZScalarFormFactor:r_1T 5 0.161
 newdef BZScalarFormFactor:r_2T 5 0.198
 newdef BZScalarFormFactor:m_120 5 -1
 newdef BZScalarFormFactor:mfit20 5 37.46
 newdef BZScalarFormFactor:m_12plus 5 29.2681
 newdef BZScalarFormFactor:mfit2plus 5 -1
 newdef BZScalarFormFactor:m_12T 5 29.2681
 newdef BZScalarFormFactor:mfit2T 5 -1
 newdef BZScalarFormFactor:r_10 6 0
 newdef BZScalarFormFactor:r_20 6 0.273
 newdef BZScalarFormFactor:r_1plus 6 0.122
 newdef BZScalarFormFactor:r_2plus 6 0.155
 newdef BZScalarFormFactor:r_1T 6 0.111
 newdef BZScalarFormFactor:r_2T 6 0.175
 newdef BZScalarFormFactor:m_120 6 -1
 newdef BZScalarFormFactor:mfit20 6 31.03
 newdef BZScalarFormFactor:m_12plus 6 28.3024
 newdef BZScalarFormFactor:mfit2plus 6 -1
 newdef BZScalarFormFactor:m_12T 6 28.3024
 newdef BZScalarFormFactor:mfit2T 6 -1
 newdef BZScalarFormFactor:Incoming 0 -521
 newdef BZScalarFormFactor:Outgoing 0 111
 newdef BZScalarFormFactor:Spin 0 0
 newdef BZScalarFormFactor:Spectator 0 -2
 newdef BZScalarFormFactor:InQuark 0 5
 newdef BZScalarFormFactor:OutQuark 0 2
 newdef BZScalarFormFactor:Incoming 1 -511
 newdef BZScalarFormFactor:Outgoing 1 111
 newdef BZScalarFormFactor:Spin 1 0
 newdef BZScalarFormFactor:Spectator 1 -2
 newdef BZScalarFormFactor:InQuark 1 5
 newdef BZScalarFormFactor:OutQuark 1 1
 newdef BZScalarFormFactor:Incoming 2 -511
 newdef BZScalarFormFactor:Outgoing 2 211
 newdef BZScalarFormFactor:Spin 2 0
 newdef BZScalarFormFactor:Spectator 2 -2
 newdef BZScalarFormFactor:InQuark 2 5
 newdef BZScalarFormFactor:OutQuark 2 2
 newdef BZScalarFormFactor:Incoming 3 -521
 newdef BZScalarFormFactor:Outgoing 3 211
 newdef BZScalarFormFactor:Spin 3 0
 newdef BZScalarFormFactor:Spectator 3 -2
 newdef BZScalarFormFactor:InQuark 3 5
 newdef BZScalarFormFactor:OutQuark 3 1
 newdef BZScalarFormFactor:Incoming 4 -521
 newdef BZScalarFormFactor:Outgoing 4 -321
 newdef BZScalarFormFactor:Spin 4 0
 newdef BZScalarFormFactor:Spectator 4 -2
 newdef BZScalarFormFactor:InQuark 4 5
 newdef BZScalarFormFactor:OutQuark 4 3
 newdef BZScalarFormFactor:Incoming 5 -511
 newdef BZScalarFormFactor:Outgoing 5 -311
 newdef BZScalarFormFactor:Spin 5 0
 newdef BZScalarFormFactor:Spectator 5 -2
 newdef BZScalarFormFactor:InQuark 5 5
 newdef BZScalarFormFactor:OutQuark 5 3
 newdef BZScalarFormFactor:Incoming 6 521
 newdef BZScalarFormFactor:Outgoing 6 221
 newdef BZScalarFormFactor:Spin 6 0
 newdef BZScalarFormFactor:Spectator 6 2
 newdef BZScalarFormFactor:InQuark 6 -5
 newdef BZScalarFormFactor:OutQuark 6 -2
 newdef BZScalar:FormFactor BZScalarFormFactor
 #
 create Herwig::ScalarMesonFactorizedDecayer  WSBHadronic
 newdef WSBHadronic:Iteration 1
 newdef WSBHadronic:Ntry 500
 newdef WSBHadronic:Points 10000
 newdef WSBHadronic:GenerateIntermediates 0
 newdef WSBHadronic:a1Bottom 1.1
 newdef WSBHadronic:a2Bottom -0.24
 newdef WSBHadronic:a1Charm 1.3
 newdef WSBHadronic:a2Charm -0.55
 create Herwig::ScalarMesonCurrent WSBHadronicScalarCurrent HwWeakCurrents.so
 newdef WSBHadronicScalarCurrent:ThetaEtaEtaPrime -0.194
 newdef WSBHadronicScalarCurrent:ID 0 211
 newdef WSBHadronicScalarCurrent:Decay_Constant 0 130.7
 newdef WSBHadronicScalarCurrent:ID 1 111
 newdef WSBHadronicScalarCurrent:Decay_Constant 1 130.7
 newdef WSBHadronicScalarCurrent:ID 2 111
 newdef WSBHadronicScalarCurrent:Decay_Constant 2 130.7
 newdef WSBHadronicScalarCurrent:ID 3 221
 newdef WSBHadronicScalarCurrent:Decay_Constant 3 130.7
 newdef WSBHadronicScalarCurrent:ID 4 221
 newdef WSBHadronicScalarCurrent:Decay_Constant 4 130.7
 newdef WSBHadronicScalarCurrent:ID 5 221
 newdef WSBHadronicScalarCurrent:Decay_Constant 5 130.7
 newdef WSBHadronicScalarCurrent:ID 6 331
 newdef WSBHadronicScalarCurrent:Decay_Constant 6 130.7
 newdef WSBHadronicScalarCurrent:ID 7 331
 newdef WSBHadronicScalarCurrent:Decay_Constant 7 130.7
 newdef WSBHadronicScalarCurrent:ID 8 331
 newdef WSBHadronicScalarCurrent:Decay_Constant 8 130.7
 newdef WSBHadronicScalarCurrent:ID 9 311
 newdef WSBHadronicScalarCurrent:Decay_Constant 9 159.8
 newdef WSBHadronicScalarCurrent:ID 10 321
 newdef WSBHadronicScalarCurrent:Decay_Constant 10 159.8
 newdef WSBHadronicScalarCurrent:ID 11 411
 newdef WSBHadronicScalarCurrent:Decay_Constant 11 200
 newdef WSBHadronicScalarCurrent:ID 12 421
 newdef WSBHadronicScalarCurrent:Decay_Constant 12 200
 newdef WSBHadronicScalarCurrent:ID 13 431
 newdef WSBHadronicScalarCurrent:Decay_Constant 13 241
 newdef WSBHadronicScalarCurrent:ID 14 10431
 newdef WSBHadronicScalarCurrent:Decay_Constant 14 73.7
 newdef WSBHadronicScalarCurrent:Quark 0  2
 newdef WSBHadronicScalarCurrent:AntiQuark 0  -1
 newdef WSBHadronicScalarCurrent:Quark 1  1
 newdef WSBHadronicScalarCurrent:AntiQuark 1  -1
 newdef WSBHadronicScalarCurrent:Quark 2  2
 newdef WSBHadronicScalarCurrent:AntiQuark 2  -2
 newdef WSBHadronicScalarCurrent:Quark 3  1
 newdef WSBHadronicScalarCurrent:AntiQuark 3  -1
 newdef WSBHadronicScalarCurrent:Quark 4  2
 newdef WSBHadronicScalarCurrent:AntiQuark 4  -2
 newdef WSBHadronicScalarCurrent:Quark 5  3
 newdef WSBHadronicScalarCurrent:AntiQuark 5  -3
 newdef WSBHadronicScalarCurrent:Quark 6  1
 newdef WSBHadronicScalarCurrent:AntiQuark 6  -1
 newdef WSBHadronicScalarCurrent:Quark 7  2
 newdef WSBHadronicScalarCurrent:AntiQuark 7  -2
 newdef WSBHadronicScalarCurrent:Quark 8  3
 newdef WSBHadronicScalarCurrent:AntiQuark 8  -3
 newdef WSBHadronicScalarCurrent:Quark 9  1
 newdef WSBHadronicScalarCurrent:AntiQuark 9  -3
 newdef WSBHadronicScalarCurrent:Quark 10  2
 newdef WSBHadronicScalarCurrent:AntiQuark 10  -3
 newdef WSBHadronicScalarCurrent:Quark 11  4
 newdef WSBHadronicScalarCurrent:AntiQuark 11  -1
 newdef WSBHadronicScalarCurrent:Quark 12  4
 newdef WSBHadronicScalarCurrent:AntiQuark 12  -2
 newdef WSBHadronicScalarCurrent:Quark 13  4
 newdef WSBHadronicScalarCurrent:AntiQuark 13  -3
 newdef WSBHadronicScalarCurrent:Quark 14  4
 newdef WSBHadronicScalarCurrent:AntiQuark 14  -3
 insert WSBHadronic:Currents 0 WSBHadronicScalarCurrent
 create Herwig::VectorMesonCurrent WSBHadronicVectorCurrent HwWeakCurrents.so
 newdef WSBHadronicVectorCurrent:ID 0 213
 newdef WSBHadronicVectorCurrent:Decay_Constant 0 0.1764
 newdef WSBHadronicVectorCurrent:ID 1 113
 newdef WSBHadronicVectorCurrent:Decay_Constant 1 0.1764
 newdef WSBHadronicVectorCurrent:ID 2 113
 newdef WSBHadronicVectorCurrent:Decay_Constant 2 0.1764
 newdef WSBHadronicVectorCurrent:ID 3 223
 newdef WSBHadronicVectorCurrent:Decay_Constant 3 0.1764
 newdef WSBHadronicVectorCurrent:ID 4 223
 newdef WSBHadronicVectorCurrent:Decay_Constant 4 0.1764
 newdef WSBHadronicVectorCurrent:ID 5 333
 newdef WSBHadronicVectorCurrent:Decay_Constant 5 0.238
 newdef WSBHadronicVectorCurrent:ID 6 313
 newdef WSBHadronicVectorCurrent:Decay_Constant 6 0.2019
 newdef WSBHadronicVectorCurrent:ID 7 323
 newdef WSBHadronicVectorCurrent:Decay_Constant 7 0.2019
 newdef WSBHadronicVectorCurrent:ID 8 20213
 newdef WSBHadronicVectorCurrent:Decay_Constant 8 0.4626
 newdef WSBHadronicVectorCurrent:ID 9 20113
 newdef WSBHadronicVectorCurrent:Decay_Constant 9 0.4626
 newdef WSBHadronicVectorCurrent:ID 10 20113
 newdef WSBHadronicVectorCurrent:Decay_Constant 10 0.4626
 newdef WSBHadronicVectorCurrent:ID 11 413
 newdef WSBHadronicVectorCurrent:Decay_Constant 11 0.402
 newdef WSBHadronicVectorCurrent:ID 12 423
 newdef WSBHadronicVectorCurrent:Decay_Constant 12 0.402
 newdef WSBHadronicVectorCurrent:ID 13 433
 newdef WSBHadronicVectorCurrent:Decay_Constant 13 0.509
 newdef WSBHadronicVectorCurrent:ID 14 443
 newdef WSBHadronicVectorCurrent:Decay_Constant 14 1.223
 newdef WSBHadronicVectorCurrent:ID 15 100443
 newdef WSBHadronicVectorCurrent:Decay_Constant 15 1.08
 newdef WSBHadronicVectorCurrent:ID 16 20433
 newdef WSBHadronicVectorCurrent:Decay_Constant 16 0.397
 newdef WSBHadronicVectorCurrent:Quark 0  2
 newdef WSBHadronicVectorCurrent:AntiQuark 0  -1
 newdef WSBHadronicVectorCurrent:Quark 1  1
 newdef WSBHadronicVectorCurrent:AntiQuark 1  -1
 newdef WSBHadronicVectorCurrent:Quark 2  2
 newdef WSBHadronicVectorCurrent:AntiQuark 2  -2
 newdef WSBHadronicVectorCurrent:Quark 3  1
 newdef WSBHadronicVectorCurrent:AntiQuark 3  -1
 newdef WSBHadronicVectorCurrent:Quark 4  2
 newdef WSBHadronicVectorCurrent:AntiQuark 4  -2
 newdef WSBHadronicVectorCurrent:Quark 5  3
 newdef WSBHadronicVectorCurrent:AntiQuark 5  -3
 newdef WSBHadronicVectorCurrent:Quark 6  1
 newdef WSBHadronicVectorCurrent:AntiQuark 6  -3
 newdef WSBHadronicVectorCurrent:Quark 7  2
 newdef WSBHadronicVectorCurrent:AntiQuark 7  -3
 newdef WSBHadronicVectorCurrent:Quark 8  2
 newdef WSBHadronicVectorCurrent:AntiQuark 8  -1
 newdef WSBHadronicVectorCurrent:Quark 9  1
 newdef WSBHadronicVectorCurrent:AntiQuark 9  -1
 newdef WSBHadronicVectorCurrent:Quark 10  2
 newdef WSBHadronicVectorCurrent:AntiQuark 10  -2
 newdef WSBHadronicVectorCurrent:Quark 11  4
 newdef WSBHadronicVectorCurrent:AntiQuark 11  -1
 newdef WSBHadronicVectorCurrent:Quark 12  4
 newdef WSBHadronicVectorCurrent:AntiQuark 12  -2
 newdef WSBHadronicVectorCurrent:Quark 13  4
 newdef WSBHadronicVectorCurrent:AntiQuark 13  -3
 newdef WSBHadronicVectorCurrent:Quark 14  4
 newdef WSBHadronicVectorCurrent:AntiQuark 14  -4
 newdef WSBHadronicVectorCurrent:Quark 15  4
 newdef WSBHadronicVectorCurrent:AntiQuark 15  -4
 newdef WSBHadronicVectorCurrent:Quark 16  4
 newdef WSBHadronicVectorCurrent:AntiQuark 16  -3
 insert WSBHadronic:Currents 1 WSBHadronicVectorCurrent
 create Herwig::WSBFormFactor WSBHadronicFormFactor
 newdef WSBHadronicFormFactor:ThetaEtaEtaPrime -0.194
 newdef WSBHadronicFormFactor:F0 0  0.992
 newdef WSBHadronicFormFactor:V  0  0
 newdef WSBHadronicFormFactor:A0 0  0
 newdef WSBHadronicFormFactor:A1 0  0
 newdef WSBHadronicFormFactor:A2 0  0
 newdef WSBHadronicFormFactor:ScalarMass 0  0.494
 newdef WSBHadronicFormFactor:PseudoScalarMass 0  1.43
 newdef WSBHadronicFormFactor:VectorMass 0  0.892
 newdef WSBHadronicFormFactor:PseudoVectorMass 0  1.273
 newdef WSBHadronicFormFactor:F0 1  0.992
 newdef WSBHadronicFormFactor:V  1  0
 newdef WSBHadronicFormFactor:A0 1  0
 newdef WSBHadronicFormFactor:A1 1  0
 newdef WSBHadronicFormFactor:A2 1  0
 newdef WSBHadronicFormFactor:ScalarMass 1  0.494
 newdef WSBHadronicFormFactor:PseudoScalarMass 1  1.43
 newdef WSBHadronicFormFactor:VectorMass 1  0.892
 newdef WSBHadronicFormFactor:PseudoVectorMass 1  1.273
 newdef WSBHadronicFormFactor:F0 2  0.992
 newdef WSBHadronicFormFactor:V  2  0
 newdef WSBHadronicFormFactor:A0 2  0
 newdef WSBHadronicFormFactor:A1 2  0
 newdef WSBHadronicFormFactor:A2 2  0
 newdef WSBHadronicFormFactor:ScalarMass 2  0.494
 newdef WSBHadronicFormFactor:PseudoScalarMass 2  1.43
 newdef WSBHadronicFormFactor:VectorMass 2  0.892
 newdef WSBHadronicFormFactor:PseudoVectorMass 2  1.273
 newdef WSBHadronicFormFactor:F0 3  0.992
 newdef WSBHadronicFormFactor:V  3  0
 newdef WSBHadronicFormFactor:A0 3  0
 newdef WSBHadronicFormFactor:A1 3  0
 newdef WSBHadronicFormFactor:A2 3  0
 newdef WSBHadronicFormFactor:ScalarMass 3  0.494
 newdef WSBHadronicFormFactor:PseudoScalarMass 3  1.43
 newdef WSBHadronicFormFactor:VectorMass 3  0.892
 newdef WSBHadronicFormFactor:PseudoVectorMass 3  1.273
 newdef WSBHadronicFormFactor:F0 4  0.762
 newdef WSBHadronicFormFactor:V  4  0
 newdef WSBHadronicFormFactor:A0 4  0
 newdef WSBHadronicFormFactor:A1 4  0
 newdef WSBHadronicFormFactor:A2 4  0
 newdef WSBHadronicFormFactor:ScalarMass 4  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 4  2.6
 newdef WSBHadronicFormFactor:VectorMass 4  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 4  2.53
 newdef WSBHadronicFormFactor:F0 5  0.762
 newdef WSBHadronicFormFactor:V  5  0
 newdef WSBHadronicFormFactor:A0 5  0
 newdef WSBHadronicFormFactor:A1 5  0
 newdef WSBHadronicFormFactor:A2 5  0
 newdef WSBHadronicFormFactor:ScalarMass 5  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 5  2.6
 newdef WSBHadronicFormFactor:VectorMass 5  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 5  2.53
 newdef WSBHadronicFormFactor:F0 6  0.692
 newdef WSBHadronicFormFactor:V  6  0
 newdef WSBHadronicFormFactor:A0 6  0
 newdef WSBHadronicFormFactor:A1 6  0
 newdef WSBHadronicFormFactor:A2 6  0
 newdef WSBHadronicFormFactor:ScalarMass 6  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 6  2.47
 newdef WSBHadronicFormFactor:VectorMass 6  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 6  2.42
 newdef WSBHadronicFormFactor:F0 7  0.692
 newdef WSBHadronicFormFactor:V  7  0
 newdef WSBHadronicFormFactor:A0 7  0
 newdef WSBHadronicFormFactor:A1 7  0
 newdef WSBHadronicFormFactor:A2 7  0
 newdef WSBHadronicFormFactor:ScalarMass 7  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 7  2.47
 newdef WSBHadronicFormFactor:VectorMass 7  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 7  2.42
 newdef WSBHadronicFormFactor:F0 8  0.692
 newdef WSBHadronicFormFactor:V  8  0
 newdef WSBHadronicFormFactor:A0 8  0
 newdef WSBHadronicFormFactor:A1 8  0
 newdef WSBHadronicFormFactor:A2 8  0
 newdef WSBHadronicFormFactor:ScalarMass 8  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 8  2.47
 newdef WSBHadronicFormFactor:VectorMass 8  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 8  2.42
 newdef WSBHadronicFormFactor:F0 9  0.692
 newdef WSBHadronicFormFactor:V  9  0
 newdef WSBHadronicFormFactor:A0 9  0
 newdef WSBHadronicFormFactor:A1 9  0
 newdef WSBHadronicFormFactor:A2 9  0
 newdef WSBHadronicFormFactor:ScalarMass 9  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 9  2.47
 newdef WSBHadronicFormFactor:VectorMass 9  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 9  2.42
 newdef WSBHadronicFormFactor:F0 10  0.681
 newdef WSBHadronicFormFactor:V  10  0
 newdef WSBHadronicFormFactor:A0 10  0
 newdef WSBHadronicFormFactor:A1 10  0
 newdef WSBHadronicFormFactor:A2 10  0
 newdef WSBHadronicFormFactor:ScalarMass 10  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 10  2.47
 newdef WSBHadronicFormFactor:VectorMass 10  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 10  2.42
 newdef WSBHadronicFormFactor:F0 11  0.681
 newdef WSBHadronicFormFactor:V  11  0
 newdef WSBHadronicFormFactor:A0 11  0
 newdef WSBHadronicFormFactor:A1 11  0
 newdef WSBHadronicFormFactor:A2 11  0
 newdef WSBHadronicFormFactor:ScalarMass 11  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 11  2.47
 newdef WSBHadronicFormFactor:VectorMass 11  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 11  2.42
 newdef WSBHadronicFormFactor:F0 12  0.655
 newdef WSBHadronicFormFactor:V  12  0
 newdef WSBHadronicFormFactor:A0 12  0
 newdef WSBHadronicFormFactor:A1 12  0
 newdef WSBHadronicFormFactor:A2 12  0
 newdef WSBHadronicFormFactor:ScalarMass 12  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 12  2.47
 newdef WSBHadronicFormFactor:VectorMass 12  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 12  2.42
 newdef WSBHadronicFormFactor:F0 13  0.655
 newdef WSBHadronicFormFactor:V  13  0
 newdef WSBHadronicFormFactor:A0 13  0
 newdef WSBHadronicFormFactor:A1 13  0
 newdef WSBHadronicFormFactor:A2 13  0
 newdef WSBHadronicFormFactor:ScalarMass 13  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 13  2.47
 newdef WSBHadronicFormFactor:VectorMass 13  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 13  2.42
 newdef WSBHadronicFormFactor:F0 14  0
 newdef WSBHadronicFormFactor:V  14  1.226
 newdef WSBHadronicFormFactor:A0 14  0.733
 newdef WSBHadronicFormFactor:A1 14  0.88
 newdef WSBHadronicFormFactor:A2 14  1.147
 newdef WSBHadronicFormFactor:ScalarMass 14  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 14  2.6
 newdef WSBHadronicFormFactor:VectorMass 14  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 14  2.53
 newdef WSBHadronicFormFactor:F0 15  0
 newdef WSBHadronicFormFactor:V  15  1.226
 newdef WSBHadronicFormFactor:A0 15  0.733
 newdef WSBHadronicFormFactor:A1 15  0.88
 newdef WSBHadronicFormFactor:A2 15  1.147
 newdef WSBHadronicFormFactor:ScalarMass 15  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 15  2.6
 newdef WSBHadronicFormFactor:VectorMass 15  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 15  2.53
 newdef WSBHadronicFormFactor:F0 16  0
 newdef WSBHadronicFormFactor:V  16  1.225
 newdef WSBHadronicFormFactor:A0 16  0.669
 newdef WSBHadronicFormFactor:A1 16  0.775
 newdef WSBHadronicFormFactor:A2 16  0.923
 newdef WSBHadronicFormFactor:ScalarMass 16  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 16  2.47
 newdef WSBHadronicFormFactor:VectorMass 16  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 16  2.42
 newdef WSBHadronicFormFactor:F0 17  0
 newdef WSBHadronicFormFactor:V  17  1.225
 newdef WSBHadronicFormFactor:A0 17  0.669
 newdef WSBHadronicFormFactor:A1 17  0.775
 newdef WSBHadronicFormFactor:A2 17  0.923
 newdef WSBHadronicFormFactor:ScalarMass 17  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 17  2.47
 newdef WSBHadronicFormFactor:VectorMass 17  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 17  2.42
 newdef WSBHadronicFormFactor:F0 18  0
 newdef WSBHadronicFormFactor:V  18  1.225
 newdef WSBHadronicFormFactor:A0 18  0.669
 newdef WSBHadronicFormFactor:A1 18  0.775
 newdef WSBHadronicFormFactor:A2 18  0.923
 newdef WSBHadronicFormFactor:ScalarMass 18  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 18  2.47
 newdef WSBHadronicFormFactor:VectorMass 18  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 18  2.42
 newdef WSBHadronicFormFactor:F0 19  0
 newdef WSBHadronicFormFactor:V  19  1.225
 newdef WSBHadronicFormFactor:A0 19  0.669
 newdef WSBHadronicFormFactor:A1 19  0.775
 newdef WSBHadronicFormFactor:A2 19  0.923
 newdef WSBHadronicFormFactor:ScalarMass 19  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 19  2.47
 newdef WSBHadronicFormFactor:VectorMass 19  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 19  2.42
 newdef WSBHadronicFormFactor:F0 20  0
 newdef WSBHadronicFormFactor:V  20  1.236
 newdef WSBHadronicFormFactor:A0 20  0.669
 newdef WSBHadronicFormFactor:A1 20  0.772
 newdef WSBHadronicFormFactor:A2 20  0.92
 newdef WSBHadronicFormFactor:ScalarMass 20  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 20  2.47
 newdef WSBHadronicFormFactor:VectorMass 20  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 20  2.42
 newdef WSBHadronicFormFactor:F0 21  0
 newdef WSBHadronicFormFactor:V  21  1.236
 newdef WSBHadronicFormFactor:A0 21  0.669
 newdef WSBHadronicFormFactor:A1 21  0.772
 newdef WSBHadronicFormFactor:A2 21  0.92
 newdef WSBHadronicFormFactor:ScalarMass 21  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 21  2.47
 newdef WSBHadronicFormFactor:VectorMass 21  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 21  2.42
 newdef WSBHadronicFormFactor:F0 22  0.723
 newdef WSBHadronicFormFactor:V  22  0
 newdef WSBHadronicFormFactor:A0 22  0
 newdef WSBHadronicFormFactor:A1 22  0
 newdef WSBHadronicFormFactor:A2 22  0
 newdef WSBHadronicFormFactor:ScalarMass 22  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 22  2.6
 newdef WSBHadronicFormFactor:VectorMass 22  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 22  2.53
 newdef WSBHadronicFormFactor:F0 23  0.704
 newdef WSBHadronicFormFactor:V  23  0
 newdef WSBHadronicFormFactor:A0 23  0
 newdef WSBHadronicFormFactor:A1 23  0
 newdef WSBHadronicFormFactor:A2 23  0
 newdef WSBHadronicFormFactor:ScalarMass 23  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 23  2.6
 newdef WSBHadronicFormFactor:VectorMass 23  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 23  2.53
 newdef WSBHadronicFormFactor:F0 24  0.643
 newdef WSBHadronicFormFactor:V  24  0
 newdef WSBHadronicFormFactor:A0 24  0
 newdef WSBHadronicFormFactor:A1 24  0
 newdef WSBHadronicFormFactor:A2 24  0
 newdef WSBHadronicFormFactor:ScalarMass 24  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 24  2.47
 newdef WSBHadronicFormFactor:VectorMass 24  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 24  2.42
 newdef WSBHadronicFormFactor:F0 25  0.643
 newdef WSBHadronicFormFactor:V  25  0
 newdef WSBHadronicFormFactor:A0 25  0
 newdef WSBHadronicFormFactor:A1 25  0
 newdef WSBHadronicFormFactor:A2 25  0
 newdef WSBHadronicFormFactor:ScalarMass 25  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 25  2.47
 newdef WSBHadronicFormFactor:VectorMass 25  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 25  2.42
 newdef WSBHadronicFormFactor:F0 26  0
 newdef WSBHadronicFormFactor:V  26  1.25
 newdef WSBHadronicFormFactor:A0 26  0.634
 newdef WSBHadronicFormFactor:A1 26  0.717
 newdef WSBHadronicFormFactor:A2 26  0.853
 newdef WSBHadronicFormFactor:ScalarMass 26  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 26  2.47
 newdef WSBHadronicFormFactor:VectorMass 26  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 26  2.42
 newdef WSBHadronicFormFactor:F0 27  0
 newdef WSBHadronicFormFactor:V  27  1.25
 newdef WSBHadronicFormFactor:A0 27  0.634
 newdef WSBHadronicFormFactor:A1 27  0.717
 newdef WSBHadronicFormFactor:A2 27  0.853
 newdef WSBHadronicFormFactor:ScalarMass 27  1.87
 newdef WSBHadronicFormFactor:PseudoScalarMass 27  2.47
 newdef WSBHadronicFormFactor:VectorMass 27  2.01
 newdef WSBHadronicFormFactor:PseudoVectorMass 27  2.42
 newdef WSBHadronicFormFactor:F0 28  0
 newdef WSBHadronicFormFactor:V  28  1.319
 newdef WSBHadronicFormFactor:A0 28  0.7
 newdef WSBHadronicFormFactor:A1 28  0.82
 newdef WSBHadronicFormFactor:A2 28  1.076
 newdef WSBHadronicFormFactor:ScalarMass 28  1.97
 newdef WSBHadronicFormFactor:PseudoScalarMass 28  2.6
 newdef WSBHadronicFormFactor:VectorMass 28  2.11
 newdef WSBHadronicFormFactor:PseudoVectorMass 28  2.53
 newdef WSBHadronicFormFactor:F0 29  0.69
 newdef WSBHadronicFormFactor:V  29  0
 newdef WSBHadronicFormFactor:A0 29  0
 newdef WSBHadronicFormFactor:A1 29  0
 newdef WSBHadronicFormFactor:A2 29  0
 newdef WSBHadronicFormFactor:ScalarMass 29  6.3
 newdef WSBHadronicFormFactor:PseudoScalarMass 29  6.8
 newdef WSBHadronicFormFactor:VectorMass 29  6.34
 newdef WSBHadronicFormFactor:PseudoVectorMass 29  6.73
 newdef WSBHadronicFormFactor:F0 30  0.69
 newdef WSBHadronicFormFactor:V  30  0
 newdef WSBHadronicFormFactor:A0 30  0
 newdef WSBHadronicFormFactor:A1 30  0
 newdef WSBHadronicFormFactor:A2 30  0
 newdef WSBHadronicFormFactor:ScalarMass 30  6.3
 newdef WSBHadronicFormFactor:PseudoScalarMass 30  6.8
 newdef WSBHadronicFormFactor:VectorMass 30  6.34
 newdef WSBHadronicFormFactor:PseudoVectorMass 30  6.73
 newdef WSBHadronicFormFactor:F0 31  0.379
 newdef WSBHadronicFormFactor:V  31  0
 newdef WSBHadronicFormFactor:A0 31  0
 newdef WSBHadronicFormFactor:A1 31  0
 newdef WSBHadronicFormFactor:A2 31  0
 newdef WSBHadronicFormFactor:ScalarMass 31  5.38
 newdef WSBHadronicFormFactor:PseudoScalarMass 31  5.89
 newdef WSBHadronicFormFactor:VectorMass 31  5.43
 newdef WSBHadronicFormFactor:PseudoVectorMass 31  5.82
 newdef WSBHadronicFormFactor:F0 32  0.379
 newdef WSBHadronicFormFactor:V  32  0
 newdef WSBHadronicFormFactor:A0 32  0
 newdef WSBHadronicFormFactor:A1 32  0
 newdef WSBHadronicFormFactor:A2 32  0
 newdef WSBHadronicFormFactor:ScalarMass 32  5.38
 newdef WSBHadronicFormFactor:PseudoScalarMass 32  5.89
 newdef WSBHadronicFormFactor:VectorMass 32  5.43
 newdef WSBHadronicFormFactor:PseudoVectorMass 32  5.82
 newdef WSBHadronicFormFactor:F0 33  0.333
 newdef WSBHadronicFormFactor:V  33  0
 newdef WSBHadronicFormFactor:A0 33  0
 newdef WSBHadronicFormFactor:A1 33  0
 newdef WSBHadronicFormFactor:A2 33  0
 newdef WSBHadronicFormFactor:ScalarMass 33  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 33  5.78
 newdef WSBHadronicFormFactor:VectorMass 33  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 33  5.71
 newdef WSBHadronicFormFactor:F0 34  0.333
 newdef WSBHadronicFormFactor:V  34  0
 newdef WSBHadronicFormFactor:A0 34  0
 newdef WSBHadronicFormFactor:A1 34  0
 newdef WSBHadronicFormFactor:A2 34  0
 newdef WSBHadronicFormFactor:ScalarMass 34  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 34  5.78
 newdef WSBHadronicFormFactor:VectorMass 34  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 34  5.71
 newdef WSBHadronicFormFactor:F0 35  0.333
 newdef WSBHadronicFormFactor:V  35  0
 newdef WSBHadronicFormFactor:A0 35  0
 newdef WSBHadronicFormFactor:A1 35  0
 newdef WSBHadronicFormFactor:A2 35  0
 newdef WSBHadronicFormFactor:ScalarMass 35  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 35  5.78
 newdef WSBHadronicFormFactor:VectorMass 35  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 35  5.71
 newdef WSBHadronicFormFactor:F0 36  0.333
 newdef WSBHadronicFormFactor:V  36  0
 newdef WSBHadronicFormFactor:A0 36  0
 newdef WSBHadronicFormFactor:A1 36  0
 newdef WSBHadronicFormFactor:A2 36  0
 newdef WSBHadronicFormFactor:ScalarMass 36  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 36  5.78
 newdef WSBHadronicFormFactor:VectorMass 36  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 36  5.71
 newdef WSBHadronicFormFactor:F0 37  0.307
 newdef WSBHadronicFormFactor:V  37  0
 newdef WSBHadronicFormFactor:A0 37  0
 newdef WSBHadronicFormFactor:A1 37  0
 newdef WSBHadronicFormFactor:A2 37  0
 newdef WSBHadronicFormFactor:ScalarMass 37  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 37  5.78
 newdef WSBHadronicFormFactor:VectorMass 37  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 37  5.71
 newdef WSBHadronicFormFactor:F0 38  0.307
 newdef WSBHadronicFormFactor:V  38  0
 newdef WSBHadronicFormFactor:A0 38  0
 newdef WSBHadronicFormFactor:A1 38  0
 newdef WSBHadronicFormFactor:A2 38  0
 newdef WSBHadronicFormFactor:ScalarMass 38  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 38  5.78
 newdef WSBHadronicFormFactor:VectorMass 38  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 38  5.71
 newdef WSBHadronicFormFactor:F0 39  0.254
 newdef WSBHadronicFormFactor:V  39  0
 newdef WSBHadronicFormFactor:A0 39  0
 newdef WSBHadronicFormFactor:A1 39  0
 newdef WSBHadronicFormFactor:A2 39  0
 newdef WSBHadronicFormFactor:ScalarMass 39  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 39  5.78
 newdef WSBHadronicFormFactor:VectorMass 39  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 39  5.71
 newdef WSBHadronicFormFactor:F0 40  0.254
 newdef WSBHadronicFormFactor:V  40  0
 newdef WSBHadronicFormFactor:A0 40  0
 newdef WSBHadronicFormFactor:A1 40  0
 newdef WSBHadronicFormFactor:A2 40  0
 newdef WSBHadronicFormFactor:ScalarMass 40  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 40  5.78
 newdef WSBHadronicFormFactor:VectorMass 40  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 40  5.71
 newdef WSBHadronicFormFactor:F0 41  0
 newdef WSBHadronicFormFactor:V  41  0.705
 newdef WSBHadronicFormFactor:A0 41  0.623
 newdef WSBHadronicFormFactor:A1 41  0.651
 newdef WSBHadronicFormFactor:A2 41  0.686
 newdef WSBHadronicFormFactor:ScalarMass 41  6.3
 newdef WSBHadronicFormFactor:PseudoScalarMass 41  6.8
 newdef WSBHadronicFormFactor:VectorMass 41  6.34
 newdef WSBHadronicFormFactor:PseudoVectorMass 41  6.73
 newdef WSBHadronicFormFactor:F0 42  0
 newdef WSBHadronicFormFactor:V  42  0.705
 newdef WSBHadronicFormFactor:A0 42  0.623
 newdef WSBHadronicFormFactor:A1 42  0.651
 newdef WSBHadronicFormFactor:A2 42  0.686
 newdef WSBHadronicFormFactor:ScalarMass 42  6.3
 newdef WSBHadronicFormFactor:PseudoScalarMass 42  6.8
 newdef WSBHadronicFormFactor:VectorMass 42  6.34
 newdef WSBHadronicFormFactor:PseudoVectorMass 42  6.73
 newdef WSBHadronicFormFactor:F0 43  0
 newdef WSBHadronicFormFactor:V  43  0.369
 newdef WSBHadronicFormFactor:A0 43  0.321
 newdef WSBHadronicFormFactor:A1 43  0.328
 newdef WSBHadronicFormFactor:A2 43  0.331
 newdef WSBHadronicFormFactor:ScalarMass 43  5.38
 newdef WSBHadronicFormFactor:PseudoScalarMass 43  5.89
 newdef WSBHadronicFormFactor:VectorMass 43  5.43
 newdef WSBHadronicFormFactor:PseudoVectorMass 43  5.82
 newdef WSBHadronicFormFactor:F0 44  0
 newdef WSBHadronicFormFactor:V  44  0.369
 newdef WSBHadronicFormFactor:A0 44  0.321
 newdef WSBHadronicFormFactor:A1 44  0.328
 newdef WSBHadronicFormFactor:A2 44  0.331
 newdef WSBHadronicFormFactor:ScalarMass 44  5.38
 newdef WSBHadronicFormFactor:PseudoScalarMass 44  5.89
 newdef WSBHadronicFormFactor:VectorMass 44  5.43
 newdef WSBHadronicFormFactor:PseudoVectorMass 44  5.82
 newdef WSBHadronicFormFactor:F0 45  0
 newdef WSBHadronicFormFactor:V  45  0.329
 newdef WSBHadronicFormFactor:A0 45  0.281
 newdef WSBHadronicFormFactor:A1 45  0.283
 newdef WSBHadronicFormFactor:A2 45  0.283
 newdef WSBHadronicFormFactor:ScalarMass 45  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 45  5.78
 newdef WSBHadronicFormFactor:VectorMass 45  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 45  5.71
 newdef WSBHadronicFormFactor:F0 46  0
 newdef WSBHadronicFormFactor:V  46  0.329
 newdef WSBHadronicFormFactor:A0 46  0.281
 newdef WSBHadronicFormFactor:A1 46  0.283
 newdef WSBHadronicFormFactor:A2 46  0.283
 newdef WSBHadronicFormFactor:ScalarMass 46  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 46  5.78
 newdef WSBHadronicFormFactor:VectorMass 46  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 46  5.71
 newdef WSBHadronicFormFactor:F0 47  0
 newdef WSBHadronicFormFactor:V  47  0.329
 newdef WSBHadronicFormFactor:A0 47  0.281
 newdef WSBHadronicFormFactor:A1 47  0.283
 newdef WSBHadronicFormFactor:A2 47  0.283
 newdef WSBHadronicFormFactor:ScalarMass 47  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 47  5.78
 newdef WSBHadronicFormFactor:VectorMass 47  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 47  5.71
 newdef WSBHadronicFormFactor:F0 48  0
 newdef WSBHadronicFormFactor:V  48  0.329
 newdef WSBHadronicFormFactor:A0 48  0.281
 newdef WSBHadronicFormFactor:A1 48  0.283
 newdef WSBHadronicFormFactor:A2 48  0.283
 newdef WSBHadronicFormFactor:ScalarMass 48  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 48  5.78
 newdef WSBHadronicFormFactor:VectorMass 48  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 48  5.71
 newdef WSBHadronicFormFactor:F0 49  0
 newdef WSBHadronicFormFactor:V  49  0.328
 newdef WSBHadronicFormFactor:A0 49  0.28
 newdef WSBHadronicFormFactor:A1 49  0.281
 newdef WSBHadronicFormFactor:A2 49  0.281
 newdef WSBHadronicFormFactor:ScalarMass 49  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 49  5.78
 newdef WSBHadronicFormFactor:VectorMass 49  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 49  5.71
 newdef WSBHadronicFormFactor:F0 50  0
 newdef WSBHadronicFormFactor:V  50  0.328
 newdef WSBHadronicFormFactor:A0 50  0.28
 newdef WSBHadronicFormFactor:A1 50  0.281
 newdef WSBHadronicFormFactor:A2 50  0.281
 newdef WSBHadronicFormFactor:ScalarMass 50  5.27
 newdef WSBHadronicFormFactor:PseudoScalarMass 50  5.78
 newdef WSBHadronicFormFactor:VectorMass 50  5.32
 newdef WSBHadronicFormFactor:PseudoVectorMass 50  5.71
 newdef WSBHadronicFormFactor:Incoming 0 -321
 newdef WSBHadronicFormFactor:Outgoing 0 111
 newdef WSBHadronicFormFactor:Spin 0 0
 newdef WSBHadronicFormFactor:Spectator 0 -2
 newdef WSBHadronicFormFactor:InQuark 0 3
 newdef WSBHadronicFormFactor:OutQuark 0 2
 newdef WSBHadronicFormFactor:Incoming 1 -311
 newdef WSBHadronicFormFactor:Outgoing 1 211
 newdef WSBHadronicFormFactor:Spin 1 0
 newdef WSBHadronicFormFactor:Spectator 1 -1
 newdef WSBHadronicFormFactor:InQuark 1 3
 newdef WSBHadronicFormFactor:OutQuark 1 2
 newdef WSBHadronicFormFactor:Incoming 2 -321
 newdef WSBHadronicFormFactor:Outgoing 2 -211
 newdef WSBHadronicFormFactor:Spin 2 0
 newdef WSBHadronicFormFactor:Spectator 2 -2
 newdef WSBHadronicFormFactor:InQuark 2 3
 newdef WSBHadronicFormFactor:OutQuark 2 1
 newdef WSBHadronicFormFactor:Incoming 3 -311
 newdef WSBHadronicFormFactor:Outgoing 3 111
 newdef WSBHadronicFormFactor:Spin 3 0
 newdef WSBHadronicFormFactor:Spectator 3 -1
 newdef WSBHadronicFormFactor:InQuark 3 3
 newdef WSBHadronicFormFactor:OutQuark 3 1
 newdef WSBHadronicFormFactor:Incoming 4 421
 newdef WSBHadronicFormFactor:Outgoing 4 -321
 newdef WSBHadronicFormFactor:Spin 4 0
 newdef WSBHadronicFormFactor:Spectator 4 -2
 newdef WSBHadronicFormFactor:InQuark 4 4
 newdef WSBHadronicFormFactor:OutQuark 4 3
 newdef WSBHadronicFormFactor:Incoming 5 411
 newdef WSBHadronicFormFactor:Outgoing 5 -311
 newdef WSBHadronicFormFactor:Spin 5 0
 newdef WSBHadronicFormFactor:Spectator 5 -1
 newdef WSBHadronicFormFactor:InQuark 5 4
 newdef WSBHadronicFormFactor:OutQuark 5 3
 newdef WSBHadronicFormFactor:Incoming 6 421
 newdef WSBHadronicFormFactor:Outgoing 6 -211
 newdef WSBHadronicFormFactor:Spin 6 0
 newdef WSBHadronicFormFactor:Spectator 6 -2
 newdef WSBHadronicFormFactor:InQuark 6 4
 newdef WSBHadronicFormFactor:OutQuark 6 1
 newdef WSBHadronicFormFactor:Incoming 7 421
 newdef WSBHadronicFormFactor:Outgoing 7 111
 newdef WSBHadronicFormFactor:Spin 7 0
 newdef WSBHadronicFormFactor:Spectator 7 -2
 newdef WSBHadronicFormFactor:InQuark 7 4
 newdef WSBHadronicFormFactor:OutQuark 7 2
 newdef WSBHadronicFormFactor:Incoming 8 411
 newdef WSBHadronicFormFactor:Outgoing 8 111
 newdef WSBHadronicFormFactor:Spin 8 0
 newdef WSBHadronicFormFactor:Spectator 8 -1
 newdef WSBHadronicFormFactor:InQuark 8 4
 newdef WSBHadronicFormFactor:OutQuark 8 1
 newdef WSBHadronicFormFactor:Incoming 9 411
 newdef WSBHadronicFormFactor:Outgoing 9 211
 newdef WSBHadronicFormFactor:Spin 9 0
 newdef WSBHadronicFormFactor:Spectator 9 -1
 newdef WSBHadronicFormFactor:InQuark 9 4
 newdef WSBHadronicFormFactor:OutQuark 9 2
 newdef WSBHadronicFormFactor:Incoming 10 421
 newdef WSBHadronicFormFactor:Outgoing 10 221
 newdef WSBHadronicFormFactor:Spin 10 0
 newdef WSBHadronicFormFactor:Spectator 10 -2
 newdef WSBHadronicFormFactor:InQuark 10 4
 newdef WSBHadronicFormFactor:OutQuark 10 2
 newdef WSBHadronicFormFactor:Incoming 11 411
 newdef WSBHadronicFormFactor:Outgoing 11 221
 newdef WSBHadronicFormFactor:Spin 11 0
 newdef WSBHadronicFormFactor:Spectator 11 -1
 newdef WSBHadronicFormFactor:InQuark 11 4
 newdef WSBHadronicFormFactor:OutQuark 11 1
 newdef WSBHadronicFormFactor:Incoming 12 421
 newdef WSBHadronicFormFactor:Outgoing 12 331
 newdef WSBHadronicFormFactor:Spin 12 0
 newdef WSBHadronicFormFactor:Spectator 12 -2
 newdef WSBHadronicFormFactor:InQuark 12 4
 newdef WSBHadronicFormFactor:OutQuark 12 2
 newdef WSBHadronicFormFactor:Incoming 13 411
 newdef WSBHadronicFormFactor:Outgoing 13 331
 newdef WSBHadronicFormFactor:Spin 13 0
 newdef WSBHadronicFormFactor:Spectator 13 -1
 newdef WSBHadronicFormFactor:InQuark 13 4
 newdef WSBHadronicFormFactor:OutQuark 13 1
 newdef WSBHadronicFormFactor:Incoming 14 421
 newdef WSBHadronicFormFactor:Outgoing 14 -323
 newdef WSBHadronicFormFactor:Spin 14 1
 newdef WSBHadronicFormFactor:Spectator 14 -2
 newdef WSBHadronicFormFactor:InQuark 14 4
 newdef WSBHadronicFormFactor:OutQuark 14 3
 newdef WSBHadronicFormFactor:Incoming 15 411
 newdef WSBHadronicFormFactor:Outgoing 15 -313
 newdef WSBHadronicFormFactor:Spin 15 1
 newdef WSBHadronicFormFactor:Spectator 15 -1
 newdef WSBHadronicFormFactor:InQuark 15 4
 newdef WSBHadronicFormFactor:OutQuark 15 3
 newdef WSBHadronicFormFactor:Incoming 16 421
 newdef WSBHadronicFormFactor:Outgoing 16 -213
 newdef WSBHadronicFormFactor:Spin 16 1
 newdef WSBHadronicFormFactor:Spectator 16 -2
 newdef WSBHadronicFormFactor:InQuark 16 4
 newdef WSBHadronicFormFactor:OutQuark 16 1
 newdef WSBHadronicFormFactor:Incoming 17 421
 newdef WSBHadronicFormFactor:Outgoing 17 113
 newdef WSBHadronicFormFactor:Spin 17 1
 newdef WSBHadronicFormFactor:Spectator 17 -2
 newdef WSBHadronicFormFactor:InQuark 17 4
 newdef WSBHadronicFormFactor:OutQuark 17 2
 newdef WSBHadronicFormFactor:Incoming 18 411
 newdef WSBHadronicFormFactor:Outgoing 18 113
 newdef WSBHadronicFormFactor:Spin 18 1
 newdef WSBHadronicFormFactor:Spectator 18 -1
 newdef WSBHadronicFormFactor:InQuark 18 4
 newdef WSBHadronicFormFactor:OutQuark 18 1
 newdef WSBHadronicFormFactor:Incoming 19 411
 newdef WSBHadronicFormFactor:Outgoing 19 213
 newdef WSBHadronicFormFactor:Spin 19 1
 newdef WSBHadronicFormFactor:Spectator 19 -1
 newdef WSBHadronicFormFactor:InQuark 19 4
 newdef WSBHadronicFormFactor:OutQuark 19 2
 newdef WSBHadronicFormFactor:Incoming 20 411
 newdef WSBHadronicFormFactor:Outgoing 20 223
 newdef WSBHadronicFormFactor:Spin 20 1
 newdef WSBHadronicFormFactor:Spectator 20 -1
 newdef WSBHadronicFormFactor:InQuark 20 4
 newdef WSBHadronicFormFactor:OutQuark 20 1
 newdef WSBHadronicFormFactor:Incoming 21 421
 newdef WSBHadronicFormFactor:Outgoing 21 223
 newdef WSBHadronicFormFactor:Spin 21 1
 newdef WSBHadronicFormFactor:Spectator 21 -2
 newdef WSBHadronicFormFactor:InQuark 21 4
 newdef WSBHadronicFormFactor:OutQuark 21 2
 newdef WSBHadronicFormFactor:Incoming 22 431
 newdef WSBHadronicFormFactor:Outgoing 22 221
 newdef WSBHadronicFormFactor:Spin 22 0
 newdef WSBHadronicFormFactor:Spectator 22 -3
 newdef WSBHadronicFormFactor:InQuark 22 4
 newdef WSBHadronicFormFactor:OutQuark 22 3
 newdef WSBHadronicFormFactor:Incoming 23 431
 newdef WSBHadronicFormFactor:Outgoing 23 331
 newdef WSBHadronicFormFactor:Spin 23 0
 newdef WSBHadronicFormFactor:Spectator 23 -3
 newdef WSBHadronicFormFactor:InQuark 23 4
 newdef WSBHadronicFormFactor:OutQuark 23 3
 newdef WSBHadronicFormFactor:Incoming 24 431
 newdef WSBHadronicFormFactor:Outgoing 24 311
 newdef WSBHadronicFormFactor:Spin 24 0
 newdef WSBHadronicFormFactor:Spectator 24 -3
 newdef WSBHadronicFormFactor:InQuark 24 4
 newdef WSBHadronicFormFactor:OutQuark 24 1
 newdef WSBHadronicFormFactor:Incoming 25 431
 newdef WSBHadronicFormFactor:Outgoing 25 321
 newdef WSBHadronicFormFactor:Spin 25 0
 newdef WSBHadronicFormFactor:Spectator 25 -3
 newdef WSBHadronicFormFactor:InQuark 25 4
 newdef WSBHadronicFormFactor:OutQuark 25 2
 newdef WSBHadronicFormFactor:Incoming 26 431
 newdef WSBHadronicFormFactor:Outgoing 26 313
 newdef WSBHadronicFormFactor:Spin 26 1
 newdef WSBHadronicFormFactor:Spectator 26 -3
 newdef WSBHadronicFormFactor:InQuark 26 4
 newdef WSBHadronicFormFactor:OutQuark 26 1
 newdef WSBHadronicFormFactor:Incoming 27 431
 newdef WSBHadronicFormFactor:Outgoing 27 323
 newdef WSBHadronicFormFactor:Spin 27 1
 newdef WSBHadronicFormFactor:Spectator 27 -3
 newdef WSBHadronicFormFactor:InQuark 27 4
 newdef WSBHadronicFormFactor:OutQuark 27 2
 newdef WSBHadronicFormFactor:Incoming 28 431
 newdef WSBHadronicFormFactor:Outgoing 28 333
 newdef WSBHadronicFormFactor:Spin 28 1
 newdef WSBHadronicFormFactor:Spectator 28 -3
 newdef WSBHadronicFormFactor:InQuark 28 4
 newdef WSBHadronicFormFactor:OutQuark 28 3
 newdef WSBHadronicFormFactor:Incoming 29 -521
 newdef WSBHadronicFormFactor:Outgoing 29 421
 newdef WSBHadronicFormFactor:Spin 29 0
 newdef WSBHadronicFormFactor:Spectator 29 -2
 newdef WSBHadronicFormFactor:InQuark 29 5
 newdef WSBHadronicFormFactor:OutQuark 29 4
 newdef WSBHadronicFormFactor:Incoming 30 -511
 newdef WSBHadronicFormFactor:Outgoing 30 411
 newdef WSBHadronicFormFactor:Spin 30 0
 newdef WSBHadronicFormFactor:Spectator 30 -2
 newdef WSBHadronicFormFactor:InQuark 30 5
 newdef WSBHadronicFormFactor:OutQuark 30 4
 newdef WSBHadronicFormFactor:Incoming 31 -521
 newdef WSBHadronicFormFactor:Outgoing 31 -321
 newdef WSBHadronicFormFactor:Spin 31 0
 newdef WSBHadronicFormFactor:Spectator 31 -2
 newdef WSBHadronicFormFactor:InQuark 31 5
 newdef WSBHadronicFormFactor:OutQuark 31 3
 newdef WSBHadronicFormFactor:Incoming 32 -511
 newdef WSBHadronicFormFactor:Outgoing 32 -311
 newdef WSBHadronicFormFactor:Spin 32 0
 newdef WSBHadronicFormFactor:Spectator 32 -1
 newdef WSBHadronicFormFactor:InQuark 32 5
 newdef WSBHadronicFormFactor:OutQuark 32 3
 newdef WSBHadronicFormFactor:Incoming 33 -521
 newdef WSBHadronicFormFactor:Outgoing 33 111
 newdef WSBHadronicFormFactor:Spin 33 0
 newdef WSBHadronicFormFactor:Spectator 33 -2
 newdef WSBHadronicFormFactor:InQuark 33 5
 newdef WSBHadronicFormFactor:OutQuark 33 2
 newdef WSBHadronicFormFactor:Incoming 34 -511
 newdef WSBHadronicFormFactor:Outgoing 34 211
 newdef WSBHadronicFormFactor:Spin 34 0
 newdef WSBHadronicFormFactor:Spectator 34 -1
 newdef WSBHadronicFormFactor:InQuark 34 5
 newdef WSBHadronicFormFactor:OutQuark 34 2
 newdef WSBHadronicFormFactor:Incoming 35 -521
 newdef WSBHadronicFormFactor:Outgoing 35 -211
 newdef WSBHadronicFormFactor:Spin 35 0
 newdef WSBHadronicFormFactor:Spectator 35 -2
 newdef WSBHadronicFormFactor:InQuark 35 5
 newdef WSBHadronicFormFactor:OutQuark 35 1
 newdef WSBHadronicFormFactor:Incoming 36 -511
 newdef WSBHadronicFormFactor:Outgoing 36 111
 newdef WSBHadronicFormFactor:Spin 36 0
 newdef WSBHadronicFormFactor:Spectator 36 -1
 newdef WSBHadronicFormFactor:InQuark 36 5
 newdef WSBHadronicFormFactor:OutQuark 36 1
 newdef WSBHadronicFormFactor:Incoming 37 -521
 newdef WSBHadronicFormFactor:Outgoing 37 221
 newdef WSBHadronicFormFactor:Spin 37 0
 newdef WSBHadronicFormFactor:Spectator 37 -2
 newdef WSBHadronicFormFactor:InQuark 37 5
 newdef WSBHadronicFormFactor:OutQuark 37 2
 newdef WSBHadronicFormFactor:Incoming 38 -511
 newdef WSBHadronicFormFactor:Outgoing 38 221
 newdef WSBHadronicFormFactor:Spin 38 0
 newdef WSBHadronicFormFactor:Spectator 38 -1
 newdef WSBHadronicFormFactor:InQuark 38 5
 newdef WSBHadronicFormFactor:OutQuark 38 1
 newdef WSBHadronicFormFactor:Incoming 39 -521
 newdef WSBHadronicFormFactor:Outgoing 39 331
 newdef WSBHadronicFormFactor:Spin 39 0
 newdef WSBHadronicFormFactor:Spectator 39 -2
 newdef WSBHadronicFormFactor:InQuark 39 5
 newdef WSBHadronicFormFactor:OutQuark 39 2
 newdef WSBHadronicFormFactor:Incoming 40 -511
 newdef WSBHadronicFormFactor:Outgoing 40 331
 newdef WSBHadronicFormFactor:Spin 40 0
 newdef WSBHadronicFormFactor:Spectator 40 -1
 newdef WSBHadronicFormFactor:InQuark 40 5
 newdef WSBHadronicFormFactor:OutQuark 40 1
 newdef WSBHadronicFormFactor:Incoming 41 -521
 newdef WSBHadronicFormFactor:Outgoing 41 423
 newdef WSBHadronicFormFactor:Spin 41 1
 newdef WSBHadronicFormFactor:Spectator 41 -2
 newdef WSBHadronicFormFactor:InQuark 41 5
 newdef WSBHadronicFormFactor:OutQuark 41 4
 newdef WSBHadronicFormFactor:Incoming 42 -511
 newdef WSBHadronicFormFactor:Outgoing 42 413
 newdef WSBHadronicFormFactor:Spin 42 1
 newdef WSBHadronicFormFactor:Spectator 42 -1
 newdef WSBHadronicFormFactor:InQuark 42 5
 newdef WSBHadronicFormFactor:OutQuark 42 4
 newdef WSBHadronicFormFactor:Incoming 43 -521
 newdef WSBHadronicFormFactor:Outgoing 43 -323
 newdef WSBHadronicFormFactor:Spin 43 1
 newdef WSBHadronicFormFactor:Spectator 43 -2
 newdef WSBHadronicFormFactor:InQuark 43 5
 newdef WSBHadronicFormFactor:OutQuark 43 3
 newdef WSBHadronicFormFactor:Incoming 44 -511
 newdef WSBHadronicFormFactor:Outgoing 44 -313
 newdef WSBHadronicFormFactor:Spin 44 1
 newdef WSBHadronicFormFactor:Spectator 44 -1
 newdef WSBHadronicFormFactor:InQuark 44 5
 newdef WSBHadronicFormFactor:OutQuark 44 3
 newdef WSBHadronicFormFactor:Incoming 45 -521
 newdef WSBHadronicFormFactor:Outgoing 45 113
 newdef WSBHadronicFormFactor:Spin 45 1
 newdef WSBHadronicFormFactor:Spectator 45 -2
 newdef WSBHadronicFormFactor:InQuark 45 5
 newdef WSBHadronicFormFactor:OutQuark 45 2
 newdef WSBHadronicFormFactor:Incoming 46 -511
 newdef WSBHadronicFormFactor:Outgoing 46 213
 newdef WSBHadronicFormFactor:Spin 46 1
 newdef WSBHadronicFormFactor:Spectator 46 -1
 newdef WSBHadronicFormFactor:InQuark 46 5
 newdef WSBHadronicFormFactor:OutQuark 46 2
 newdef WSBHadronicFormFactor:Incoming 47 -521
 newdef WSBHadronicFormFactor:Outgoing 47 -213
 newdef WSBHadronicFormFactor:Spin 47 1
 newdef WSBHadronicFormFactor:Spectator 47 -2
 newdef WSBHadronicFormFactor:InQuark 47 5
 newdef WSBHadronicFormFactor:OutQuark 47 1
 newdef WSBHadronicFormFactor:Incoming 48 -511
 newdef WSBHadronicFormFactor:Outgoing 48 113
 newdef WSBHadronicFormFactor:Spin 48 1
 newdef WSBHadronicFormFactor:Spectator 48 -1
 newdef WSBHadronicFormFactor:InQuark 48 5
 newdef WSBHadronicFormFactor:OutQuark 48 1
 newdef WSBHadronicFormFactor:Incoming 49 -521
 newdef WSBHadronicFormFactor:Outgoing 49 223
 newdef WSBHadronicFormFactor:Spin 49 1
 newdef WSBHadronicFormFactor:Spectator 49 -2
 newdef WSBHadronicFormFactor:InQuark 49 5
 newdef WSBHadronicFormFactor:OutQuark 49 2
 newdef WSBHadronicFormFactor:Incoming 50 -511
 newdef WSBHadronicFormFactor:Outgoing 50 223
 newdef WSBHadronicFormFactor:Spin 50 1
 newdef WSBHadronicFormFactor:Spectator 50 -1
 newdef WSBHadronicFormFactor:InQuark 50 5
 newdef WSBHadronicFormFactor:OutQuark 50 1
 insert WSBHadronic:FormFactors 0 WSBHadronicFormFactor
 insert WSBHadronic:WeightLocation 0 0
 insert WSBHadronic:WeightLocation 1 0
 insert WSBHadronic:WeightLocation 2 0
 insert WSBHadronic:WeightLocation 3 0
 insert WSBHadronic:WeightLocation 4 0
 insert WSBHadronic:WeightLocation 5 0
 insert WSBHadronic:WeightLocation 6 0
 insert WSBHadronic:WeightLocation 7 0
 insert WSBHadronic:WeightLocation 8 0
 insert WSBHadronic:WeightLocation 9 0
 insert WSBHadronic:WeightLocation 10 0
 insert WSBHadronic:WeightLocation 11 0
 insert WSBHadronic:WeightLocation 12 0
 insert WSBHadronic:WeightLocation 13 0
 insert WSBHadronic:WeightLocation 14 0
 insert WSBHadronic:WeightLocation 15 0
 insert WSBHadronic:WeightLocation 16 0
 insert WSBHadronic:WeightLocation 17 0
 insert WSBHadronic:WeightLocation 18 0
 insert WSBHadronic:WeightLocation 19 0
 insert WSBHadronic:WeightLocation 20 0
 insert WSBHadronic:WeightLocation 21 0
 insert WSBHadronic:WeightLocation 22 0
 insert WSBHadronic:WeightLocation 23 0
 insert WSBHadronic:WeightLocation 24 0
 insert WSBHadronic:WeightLocation 25 0
 insert WSBHadronic:WeightLocation 26 0
 insert WSBHadronic:WeightLocation 27 0
 insert WSBHadronic:WeightLocation 28 0
 insert WSBHadronic:WeightLocation 29 0
 insert WSBHadronic:WeightLocation 30 0
 insert WSBHadronic:WeightLocation 31 0
 insert WSBHadronic:WeightLocation 32 0
 insert WSBHadronic:WeightLocation 33 0
 insert WSBHadronic:WeightLocation 34 0
 insert WSBHadronic:WeightLocation 35 0
 insert WSBHadronic:WeightLocation 36 0
 insert WSBHadronic:WeightLocation 37 0
 insert WSBHadronic:WeightLocation 38 0
 insert WSBHadronic:WeightLocation 39 0
 insert WSBHadronic:WeightLocation 40 0
 insert WSBHadronic:WeightLocation 41 0
 insert WSBHadronic:WeightLocation 42 0
 insert WSBHadronic:WeightLocation 43 0
 insert WSBHadronic:WeightLocation 44 0
 insert WSBHadronic:WeightLocation 45 0
 insert WSBHadronic:WeightLocation 46 0
 insert WSBHadronic:WeightLocation 47 0
 insert WSBHadronic:WeightLocation 48 0
 insert WSBHadronic:WeightLocation 49 0
 insert WSBHadronic:WeightLocation 50 0
 insert WSBHadronic:WeightLocation 51 0
 insert WSBHadronic:WeightLocation 52 0
 insert WSBHadronic:WeightLocation 53 0
 insert WSBHadronic:WeightLocation 54 0
 insert WSBHadronic:WeightLocation 55 0
 insert WSBHadronic:WeightLocation 56 0
 insert WSBHadronic:WeightLocation 57 0
 insert WSBHadronic:WeightLocation 58 0
 insert WSBHadronic:WeightLocation 59 0
 insert WSBHadronic:WeightLocation 60 0
 insert WSBHadronic:WeightLocation 61 0
 insert WSBHadronic:WeightLocation 62 0
 insert WSBHadronic:WeightLocation 63 0
 insert WSBHadronic:WeightLocation 64 0
 insert WSBHadronic:WeightLocation 65 0
 insert WSBHadronic:WeightLocation 66 0
 insert WSBHadronic:WeightLocation 67 0
 insert WSBHadronic:WeightLocation 68 0
 insert WSBHadronic:WeightLocation 69 0
 insert WSBHadronic:WeightLocation 70 0
 insert WSBHadronic:WeightLocation 71 0
 insert WSBHadronic:WeightLocation 72 0
 insert WSBHadronic:WeightLocation 73 0
 insert WSBHadronic:WeightLocation 74 0
 insert WSBHadronic:WeightLocation 75 0
 insert WSBHadronic:WeightLocation 76 0
 insert WSBHadronic:WeightLocation 77 0
 insert WSBHadronic:WeightLocation 78 0
 insert WSBHadronic:WeightLocation 79 0
 insert WSBHadronic:WeightLocation 80 0
 insert WSBHadronic:WeightLocation 81 0
 insert WSBHadronic:WeightLocation 82 0
 insert WSBHadronic:WeightLocation 83 0
 insert WSBHadronic:WeightLocation 84 0
 insert WSBHadronic:WeightLocation 85 0
 insert WSBHadronic:WeightLocation 86 0
 insert WSBHadronic:WeightLocation 87 0
 insert WSBHadronic:WeightLocation 88 0
 insert WSBHadronic:WeightLocation 89 0
 insert WSBHadronic:WeightLocation 90 0
 insert WSBHadronic:WeightLocation 91 0
 insert WSBHadronic:WeightLocation 92 0
 insert WSBHadronic:WeightLocation 93 0
 insert WSBHadronic:WeightLocation 94 0
 insert WSBHadronic:WeightLocation 95 0
 insert WSBHadronic:WeightLocation 96 0
 insert WSBHadronic:WeightLocation 97 0
 insert WSBHadronic:WeightLocation 98 0
 insert WSBHadronic:WeightLocation 99 0
 insert WSBHadronic:WeightLocation 100 0
 insert WSBHadronic:WeightLocation 101 0
 insert WSBHadronic:WeightLocation 102 0
 insert WSBHadronic:WeightLocation 103 0
 insert WSBHadronic:WeightLocation 104 0
 insert WSBHadronic:WeightLocation 105 0
 insert WSBHadronic:WeightLocation 106 0
 insert WSBHadronic:WeightLocation 107 0
 insert WSBHadronic:WeightLocation 108 0
 insert WSBHadronic:WeightLocation 109 0
 insert WSBHadronic:WeightLocation 110 0
 insert WSBHadronic:WeightLocation 111 0
 insert WSBHadronic:WeightLocation 112 0
 insert WSBHadronic:WeightLocation 113 0
 insert WSBHadronic:WeightLocation 114 0
 insert WSBHadronic:WeightLocation 115 0
 insert WSBHadronic:WeightLocation 116 0
 insert WSBHadronic:WeightLocation 117 0
 insert WSBHadronic:WeightLocation 118 0
 insert WSBHadronic:WeightLocation 119 0
 insert WSBHadronic:WeightLocation 120 0
 insert WSBHadronic:WeightLocation 121 0
 insert WSBHadronic:WeightLocation 122 0
 insert WSBHadronic:WeightLocation 123 0
 insert WSBHadronic:WeightLocation 124 0
 insert WSBHadronic:WeightLocation 125 0
 insert WSBHadronic:WeightLocation 126 0
 insert WSBHadronic:WeightLocation 127 0
 insert WSBHadronic:WeightLocation 128 0
 insert WSBHadronic:WeightLocation 129 0
 insert WSBHadronic:WeightLocation 130 0
 insert WSBHadronic:WeightLocation 131 0
 insert WSBHadronic:WeightLocation 132 0
 insert WSBHadronic:WeightLocation 133 0
 insert WSBHadronic:WeightLocation 134 0
 insert WSBHadronic:WeightLocation 135 0
 insert WSBHadronic:WeightLocation 136 0
 insert WSBHadronic:WeightLocation 137 0
 insert WSBHadronic:WeightLocation 138 0
 insert WSBHadronic:WeightLocation 139 0
 insert WSBHadronic:WeightLocation 140 0
 insert WSBHadronic:WeightLocation 141 0
 insert WSBHadronic:WeightLocation 142 0
 insert WSBHadronic:WeightLocation 143 0
 insert WSBHadronic:WeightLocation 144 0
 insert WSBHadronic:WeightLocation 145 0
 insert WSBHadronic:WeightLocation 146 0
 insert WSBHadronic:WeightLocation 147 0
 insert WSBHadronic:WeightLocation 148 0
 insert WSBHadronic:WeightLocation 149 0
 insert WSBHadronic:WeightLocation 150 0
 insert WSBHadronic:WeightLocation 151 0
 insert WSBHadronic:WeightLocation 152 0
 insert WSBHadronic:WeightLocation 153 0
 insert WSBHadronic:WeightLocation 154 0
 insert WSBHadronic:WeightLocation 155 0
 insert WSBHadronic:WeightLocation 156 0
 insert WSBHadronic:WeightLocation 157 0
 insert WSBHadronic:WeightLocation 158 0
 insert WSBHadronic:WeightLocation 159 0
 insert WSBHadronic:WeightLocation 160 0
 insert WSBHadronic:WeightLocation 161 0
 insert WSBHadronic:WeightLocation 162 0
 insert WSBHadronic:WeightLocation 163 0
 insert WSBHadronic:WeightLocation 164 0
 insert WSBHadronic:WeightLocation 165 0
 insert WSBHadronic:WeightLocation 166 0
 insert WSBHadronic:WeightLocation 167 0
 insert WSBHadronic:WeightLocation 168 0
 insert WSBHadronic:WeightLocation 169 0
 insert WSBHadronic:WeightLocation 170 0
 insert WSBHadronic:WeightLocation 171 0
 insert WSBHadronic:WeightLocation 172 0
 insert WSBHadronic:WeightLocation 173 0
 insert WSBHadronic:WeightLocation 174 0
 insert WSBHadronic:WeightLocation 175 0
 insert WSBHadronic:WeightLocation 176 0
 insert WSBHadronic:WeightLocation 177 0
 insert WSBHadronic:WeightLocation 178 0
 insert WSBHadronic:WeightLocation 179 0
 insert WSBHadronic:WeightLocation 180 0
 insert WSBHadronic:WeightLocation 181 0
 insert WSBHadronic:WeightLocation 182 0
 insert WSBHadronic:WeightLocation 183 0
 insert WSBHadronic:WeightLocation 184 0
 insert WSBHadronic:WeightLocation 185 0
 insert WSBHadronic:WeightLocation 186 0
 insert WSBHadronic:WeightLocation 187 0
 insert WSBHadronic:WeightLocation 188 0
 insert WSBHadronic:WeightLocation 189 0
 insert WSBHadronic:WeightLocation 190 0
 insert WSBHadronic:WeightLocation 191 0
 insert WSBHadronic:WeightLocation 192 0
 insert WSBHadronic:WeightLocation 193 0
 insert WSBHadronic:WeightLocation 194 0
 insert WSBHadronic:WeightLocation 195 0
 insert WSBHadronic:WeightLocation 196 0
 insert WSBHadronic:WeightLocation 197 0
 insert WSBHadronic:WeightLocation 198 0
 insert WSBHadronic:WeightLocation 199 0
 insert WSBHadronic:WeightLocation 200 0
 insert WSBHadronic:WeightLocation 201 0
 insert WSBHadronic:WeightLocation 202 0
 insert WSBHadronic:WeightLocation 203 0
 insert WSBHadronic:WeightLocation 204 0
 insert WSBHadronic:WeightLocation 205 0
 insert WSBHadronic:WeightLocation 206 0
 insert WSBHadronic:WeightLocation 207 0
 insert WSBHadronic:WeightLocation 208 0
 insert WSBHadronic:WeightLocation 209 0
 insert WSBHadronic:WeightLocation 210 0
 insert WSBHadronic:WeightLocation 211 0
 insert WSBHadronic:WeightLocation 212 0
 insert WSBHadronic:WeightLocation 213 0
 insert WSBHadronic:WeightLocation 214 0
 insert WSBHadronic:WeightLocation 215 0
 insert WSBHadronic:WeightLocation 216 0
 insert WSBHadronic:WeightLocation 217 0
 insert WSBHadronic:WeightLocation 218 0
 insert WSBHadronic:WeightLocation 219 0
 insert WSBHadronic:WeightLocation 220 0
 insert WSBHadronic:WeightLocation 221 0
 insert WSBHadronic:WeightLocation 222 0
 insert WSBHadronic:WeightLocation 223 0
 insert WSBHadronic:WeightLocation 224 0
 insert WSBHadronic:WeightLocation 225 0
 insert WSBHadronic:WeightLocation 226 0
 insert WSBHadronic:WeightLocation 227 0
 insert WSBHadronic:WeightLocation 228 0
 insert WSBHadronic:WeightLocation 229 0
 insert WSBHadronic:WeightLocation 230 0
 insert WSBHadronic:WeightLocation 231 0
 insert WSBHadronic:WeightLocation 232 0
 insert WSBHadronic:WeightLocation 233 0
 insert WSBHadronic:WeightLocation 234 0
 insert WSBHadronic:WeightLocation 235 0
 insert WSBHadronic:WeightLocation 236 0
 insert WSBHadronic:WeightLocation 237 0
 insert WSBHadronic:WeightLocation 238 0
 insert WSBHadronic:WeightLocation 239 0
 insert WSBHadronic:WeightLocation 240 0
 insert WSBHadronic:WeightLocation 241 0
 insert WSBHadronic:WeightLocation 242 0
 insert WSBHadronic:WeightLocation 243 0
 insert WSBHadronic:WeightLocation 244 0
 insert WSBHadronic:WeightLocation 245 0
 insert WSBHadronic:WeightLocation 246 0
 insert WSBHadronic:WeightLocation 247 0
 insert WSBHadronic:WeightLocation 248 0
 insert WSBHadronic:WeightLocation 249 0
 insert WSBHadronic:WeightLocation 250 0
 insert WSBHadronic:WeightLocation 251 0
 insert WSBHadronic:WeightLocation 252 0
 insert WSBHadronic:WeightLocation 253 0
 insert WSBHadronic:WeightLocation 254 0
 insert WSBHadronic:WeightLocation 255 0
 insert WSBHadronic:WeightLocation 256 0
 insert WSBHadronic:WeightLocation 257 0
 insert WSBHadronic:WeightLocation 258 0
 insert WSBHadronic:WeightLocation 259 0
 insert WSBHadronic:WeightLocation 260 0
 insert WSBHadronic:WeightLocation 261 0
 insert WSBHadronic:WeightLocation 262 0
 insert WSBHadronic:WeightLocation 263 0
 insert WSBHadronic:WeightLocation 264 0
 insert WSBHadronic:WeightLocation 265 0
 insert WSBHadronic:WeightLocation 266 0
 insert WSBHadronic:WeightLocation 267 0
 insert WSBHadronic:WeightLocation 268 0
 insert WSBHadronic:WeightLocation 269 0
 insert WSBHadronic:WeightLocation 270 0
 insert WSBHadronic:WeightLocation 271 0
 insert WSBHadronic:WeightLocation 272 0
 insert WSBHadronic:WeightLocation 273 0
 insert WSBHadronic:WeightLocation 274 0
 insert WSBHadronic:WeightLocation 275 0
 insert WSBHadronic:WeightLocation 276 0
 insert WSBHadronic:WeightLocation 277 0
 insert WSBHadronic:WeightLocation 278 0
 insert WSBHadronic:WeightLocation 279 0
 insert WSBHadronic:WeightLocation 280 0
 insert WSBHadronic:WeightLocation 281 0
 insert WSBHadronic:WeightLocation 282 0
 insert WSBHadronic:WeightLocation 283 0
 insert WSBHadronic:WeightLocation 284 0
 insert WSBHadronic:WeightLocation 285 0
 insert WSBHadronic:WeightLocation 286 0
 insert WSBHadronic:WeightLocation 287 0
 insert WSBHadronic:WeightLocation 288 0
 insert WSBHadronic:WeightLocation 289 0
 insert WSBHadronic:WeightLocation 290 0
 insert WSBHadronic:WeightLocation 291 0
 insert WSBHadronic:WeightLocation 292 0
 insert WSBHadronic:WeightLocation 293 0
 insert WSBHadronic:WeightLocation 294 0
 insert WSBHadronic:WeightLocation 295 0
 insert WSBHadronic:WeightLocation 296 0
 insert WSBHadronic:WeightLocation 297 0
 insert WSBHadronic:WeightLocation 298 0
 insert WSBHadronic:WeightLocation 299 0
 insert WSBHadronic:WeightLocation 300 0
 insert WSBHadronic:WeightLocation 301 0
 insert WSBHadronic:WeightLocation 302 0
 insert WSBHadronic:WeightLocation 303 0
 insert WSBHadronic:WeightLocation 304 0
 insert WSBHadronic:WeightLocation 305 0
 insert WSBHadronic:WeightLocation 306 0
 insert WSBHadronic:WeightLocation 307 0
 insert WSBHadronic:WeightLocation 308 0
 insert WSBHadronic:WeightLocation 309 0
 insert WSBHadronic:WeightLocation 310 0
 insert WSBHadronic:WeightLocation 311 0
 insert WSBHadronic:WeightLocation 312 0
 insert WSBHadronic:WeightLocation 313 0
 insert WSBHadronic:WeightLocation 314 0
 insert WSBHadronic:WeightLocation 315 0
 insert WSBHadronic:WeightLocation 316 0
 insert WSBHadronic:WeightLocation 317 0
 insert WSBHadronic:WeightLocation 318 0
 insert WSBHadronic:WeightLocation 319 0
 insert WSBHadronic:WeightLocation 320 0
 insert WSBHadronic:WeightLocation 321 0
 insert WSBHadronic:WeightLocation 322 0
 insert WSBHadronic:WeightLocation 323 0
 insert WSBHadronic:WeightLocation 324 0
 insert WSBHadronic:WeightLocation 325 0
 insert WSBHadronic:WeightLocation 326 0
 insert WSBHadronic:WeightLocation 327 0
 insert WSBHadronic:WeightLocation 328 0
 insert WSBHadronic:WeightLocation 329 0
 insert WSBHadronic:WeightLocation 330 0
 insert WSBHadronic:WeightLocation 331 0
 insert WSBHadronic:WeightLocation 332 0
 insert WSBHadronic:WeightLocation 333 0
 insert WSBHadronic:WeightLocation 334 0
 insert WSBHadronic:WeightLocation 335 0
 insert WSBHadronic:WeightLocation 336 0
 insert WSBHadronic:WeightLocation 337 0
 insert WSBHadronic:WeightLocation 338 0
 insert WSBHadronic:WeightLocation 339 0
 insert WSBHadronic:WeightLocation 340 0
 insert WSBHadronic:WeightLocation 341 0
 insert WSBHadronic:WeightLocation 342 0
 insert WSBHadronic:WeightLocation 343 0
 insert WSBHadronic:WeightLocation 344 0
 insert WSBHadronic:WeightLocation 345 0
 insert WSBHadronic:WeightLocation 346 0
 insert WSBHadronic:WeightLocation 347 0
 insert WSBHadronic:WeightLocation 348 0
 insert WSBHadronic:WeightLocation 349 0
 insert WSBHadronic:WeightLocation 350 0
 insert WSBHadronic:WeightLocation 351 0
 insert WSBHadronic:WeightLocation 352 0
 insert WSBHadronic:WeightLocation 353 0
 insert WSBHadronic:WeightLocation 354 0
 insert WSBHadronic:WeightLocation 355 0
 insert WSBHadronic:WeightLocation 356 0
 insert WSBHadronic:WeightLocation 357 0
 insert WSBHadronic:WeightLocation 358 0
 insert WSBHadronic:WeightLocation 359 0
 insert WSBHadronic:WeightLocation 360 0
 insert WSBHadronic:MaximumWeight 0 0.557009
 insert WSBHadronic:MaximumWeight 1 1.78347e-13
 insert WSBHadronic:MaximumWeight 2 1.63561e-14
 insert WSBHadronic:MaximumWeight 3 0.0728997
 insert WSBHadronic:MaximumWeight 4 0.00567313
 insert WSBHadronic:MaximumWeight 5 0.164288
 insert WSBHadronic:MaximumWeight 6 0.00633936
 insert WSBHadronic:MaximumWeight 7 0.154232
 insert WSBHadronic:MaximumWeight 8 0.0423515
 insert WSBHadronic:MaximumWeight 9 0.0144604
 insert WSBHadronic:MaximumWeight 10 0.253468
 insert WSBHadronic:MaximumWeight 11 0.0162035
 insert WSBHadronic:MaximumWeight 12 0.395527
 insert WSBHadronic:MaximumWeight 13 0.00390394
 insert WSBHadronic:MaximumWeight 14 0.000311206
 insert WSBHadronic:MaximumWeight 15 0.0102362
 insert WSBHadronic:MaximumWeight 16 0.000521172
 insert WSBHadronic:MaximumWeight 17 0.0195025
 insert WSBHadronic:MaximumWeight 18 0.00034976
 insert WSBHadronic:MaximumWeight 19 0.000197375
 insert WSBHadronic:MaximumWeight 20 9.7655e-05
 insert WSBHadronic:MaximumWeight 21 2.78878e-05
 insert WSBHadronic:MaximumWeight 22 0.00993469
 insert WSBHadronic:MaximumWeight 23 0.00096261
 insert WSBHadronic:MaximumWeight 24 0.000267229
 insert WSBHadronic:MaximumWeight 25 0.00196102
 insert WSBHadronic:MaximumWeight 26 4.55158e-05
 insert WSBHadronic:MaximumWeight 27 0.0162144
 insert WSBHadronic:MaximumWeight 28 0.000877908
 insert WSBHadronic:MaximumWeight 29 0.0016631
 insert WSBHadronic:MaximumWeight 30 0.000398163
 insert WSBHadronic:MaximumWeight 31 0.00865771
 insert WSBHadronic:MaximumWeight 32 0.000674851
 insert WSBHadronic:MaximumWeight 33 0.025273
 insert WSBHadronic:MaximumWeight 34 4.31676e-05
 insert WSBHadronic:MaximumWeight 35 0.00153867
 insert WSBHadronic:MaximumWeight 36 0.000142386
 insert WSBHadronic:MaximumWeight 37 0.000131464
 insert WSBHadronic:MaximumWeight 38 0.000228226
 insert WSBHadronic:MaximumWeight 39 0.0099712
 insert WSBHadronic:MaximumWeight 40 0.000233923
 insert WSBHadronic:MaximumWeight 41 0.00563139
 insert WSBHadronic:MaximumWeight 42 0.00450505
 insert WSBHadronic:MaximumWeight 43 0.000364691
 insert WSBHadronic:MaximumWeight 44 3.56039e-05
 insert WSBHadronic:MaximumWeight 45 1.03757e-05
 insert WSBHadronic:MaximumWeight 46 0.00369622
 insert WSBHadronic:MaximumWeight 47 1.00154e-05
 insert WSBHadronic:MaximumWeight 48 0.00164718
 insert WSBHadronic:MaximumWeight 49 0.000373777
 insert WSBHadronic:MaximumWeight 50 1.09145e-05
 insert WSBHadronic:MaximumWeight 51 0.00388833
 insert WSBHadronic:MaximumWeight 52 0.000114629
 insert WSBHadronic:MaximumWeight 53 0.000148446
 insert WSBHadronic:MaximumWeight 54 0.00133781
 insert WSBHadronic:MaximumWeight 55 0.000160792
 insert WSBHadronic:MaximumWeight 56 0.00336156
 insert WSBHadronic:MaximumWeight 57 4.23374e-06
 insert WSBHadronic:MaximumWeight 58 0.00150806
 insert WSBHadronic:MaximumWeight 59 5.30379e-05
 insert WSBHadronic:MaximumWeight 60 6.38052e-06
 insert WSBHadronic:MaximumWeight 61 4.87735e-07
 insert WSBHadronic:MaximumWeight 62 0.000173241
 insert WSBHadronic:MaximumWeight 63 3.40529e-07
 insert WSBHadronic:MaximumWeight 64 6.10353e-05
 insert WSBHadronic:MaximumWeight 65 0.00121756
 insert WSBHadronic:MaximumWeight 66 8.4437e-06
 insert WSBHadronic:MaximumWeight 67 1.04425e-05
 insert WSBHadronic:MaximumWeight 68 0.0527204
 insert WSBHadronic:MaximumWeight 69 0.00224479
 insert WSBHadronic:MaximumWeight 70 0.280061
 insert WSBHadronic:MaximumWeight 71 0.012778
 insert WSBHadronic:MaximumWeight 72 0.0708723
 insert WSBHadronic:MaximumWeight 73 0.00567116
 insert WSBHadronic:MaximumWeight 74 0.230608
 insert WSBHadronic:MaximumWeight 75 0.0325325
 insert WSBHadronic:MaximumWeight 76 0.184892
 insert WSBHadronic:MaximumWeight 77 0.0020894
 insert WSBHadronic:MaximumWeight 78 0.000134383
 insert WSBHadronic:MaximumWeight 79 0.0158326
 insert WSBHadronic:MaximumWeight 80 0.00098963
 insert WSBHadronic:MaximumWeight 81 0.0168167
 insert WSBHadronic:MaximumWeight 82 1.19813e-05
 insert WSBHadronic:MaximumWeight 83 0.0042682
 insert WSBHadronic:MaximumWeight 84 0.00141805
 insert WSBHadronic:MaximumWeight 85 4.71951e-05
 insert WSBHadronic:MaximumWeight 86 0.00311744
 insert WSBHadronic:MaximumWeight 87 8.60579e-05
 insert WSBHadronic:MaximumWeight 88 0.0306552
 insert WSBHadronic:MaximumWeight 89 0.000747719
 insert WSBHadronic:MaximumWeight 90 0.000172703
 insert WSBHadronic:MaximumWeight 91 0.0067618
 insert WSBHadronic:MaximumWeight 92 0.00128433
 insert WSBHadronic:MaximumWeight 93 0.0218434
 insert WSBHadronic:MaximumWeight 94 6.15586e-05
 insert WSBHadronic:MaximumWeight 95 0.018769
 insert WSBHadronic:MaximumWeight 96 0.0164155
 insert WSBHadronic:MaximumWeight 97 0.000447911
 insert WSBHadronic:MaximumWeight 98 0.00393579
 insert WSBHadronic:MaximumWeight 99 0.000478632
 insert WSBHadronic:MaximumWeight 100 0.00267122
 insert WSBHadronic:MaximumWeight 101 0.0127802
 insert WSBHadronic:MaximumWeight 102 3.29165e-05
 insert WSBHadronic:MaximumWeight 103 0.0117301
 insert WSBHadronic:MaximumWeight 104 0.00805338
 insert WSBHadronic:MaximumWeight 105 0.00201896
 insert WSBHadronic:MaximumWeight 106 0.000180546
 insert WSBHadronic:MaximumWeight 107 0.0640599
 insert WSBHadronic:MaximumWeight 108 0.000425624
 insert WSBHadronic:MaximumWeight 109 0.0424012
 insert WSBHadronic:MaximumWeight 110 0.000666888
 insert WSBHadronic:MaximumWeight 111 0.100724
 insert WSBHadronic:MaximumWeight 112 0.00181883
 insert WSBHadronic:MaximumWeight 113 0.115609
 insert WSBHadronic:MaximumWeight 114 0.0255546
 insert WSBHadronic:MaximumWeight 115 0.00137845
 insert WSBHadronic:MaximumWeight 116 0.0373765
 insert WSBHadronic:MaximumWeight 117 0.000573224
 insert WSBHadronic:MaximumWeight 118 0.0018898
 insert WSBHadronic:MaximumWeight 119 0.00403168
 insert WSBHadronic:MaximumWeight 120 0.000106079
 insert WSBHadronic:MaximumWeight 121 0.0100848
 insert WSBHadronic:MaximumWeight 122 0.000237637
 insert WSBHadronic:MaximumWeight 123 0.0138073
 insert WSBHadronic:MaximumWeight 124 0.000362
 insert WSBHadronic:MaximumWeight 125 0.0204465
 insert WSBHadronic:MaximumWeight 126 0.000907068
 insert WSBHadronic:MaximumWeight 127 0.00209602
 insert WSBHadronic:MaximumWeight 128 0.000561256
 insert WSBHadronic:MaximumWeight 129 2.06348e-05
 insert WSBHadronic:MaximumWeight 130 0.0268117
 insert WSBHadronic:MaximumWeight 131 0.00125649
 insert WSBHadronic:MaximumWeight 132 0.00358176
 insert WSBHadronic:MaximumWeight 133 0.0202186
 insert WSBHadronic:MaximumWeight 134 0.000302234
 insert WSBHadronic:MaximumWeight 135 0.00955449
 insert WSBHadronic:MaximumWeight 136 0.000330813
 insert WSBHadronic:MaximumWeight 137 0.0112905
 insert WSBHadronic:MaximumWeight 138 0.00186137
 insert WSBHadronic:MaximumWeight 139 0.00438625
 insert WSBHadronic:MaximumWeight 140 0.0082771
 insert WSBHadronic:MaximumWeight 141 0.0579115
 insert WSBHadronic:MaximumWeight 142 0.000890613
 insert WSBHadronic:MaximumWeight 143 0.126085
 insert WSBHadronic:MaximumWeight 144 0.791607
 insert WSBHadronic:MaximumWeight 145 0.0405113
 insert WSBHadronic:MaximumWeight 146 0.00375097
 insert WSBHadronic:MaximumWeight 147 0.000309481
 insert WSBHadronic:MaximumWeight 148 0.000695472
 insert WSBHadronic:MaximumWeight 149 0.0188644
 insert WSBHadronic:MaximumWeight 150 0.00162422
 insert WSBHadronic:MaximumWeight 151 0.0154084
 insert WSBHadronic:MaximumWeight 152 0.00116469
 insert WSBHadronic:MaximumWeight 153 0.0458991
 insert WSBHadronic:MaximumWeight 154 0.000514126
 insert WSBHadronic:MaximumWeight 155 0.0105728
 insert WSBHadronic:MaximumWeight 156 0.00335736
 insert WSBHadronic:MaximumWeight 157 0.00544205
 insert WSBHadronic:MaximumWeight 158 0.00042991
 insert WSBHadronic:MaximumWeight 159 0.000637019
 insert WSBHadronic:MaximumWeight 160 0.0172774
 insert WSBHadronic:MaximumWeight 161 0.00148694
 insert WSBHadronic:MaximumWeight 162 0.0167193
 insert WSBHadronic:MaximumWeight 163 0.00148333
 insert WSBHadronic:MaximumWeight 164 0.0420472
 insert WSBHadronic:MaximumWeight 165 0.000470778
 insert WSBHadronic:MaximumWeight 166 0.00966728
 insert WSBHadronic:MaximumWeight 167 0.00306477
 insert WSBHadronic:MaximumWeight 168 4.21318e-07
 insert WSBHadronic:MaximumWeight 169 1.67109e-07
 insert WSBHadronic:MaximumWeight 170 8.55296e-08
 insert WSBHadronic:MaximumWeight 171 2.50422e-06
 insert WSBHadronic:MaximumWeight 172 5.1013e-07
 insert WSBHadronic:MaximumWeight 173 5.88594e-07
 insert WSBHadronic:MaximumWeight 174 2.20376e-07
 insert WSBHadronic:MaximumWeight 175 0.00024117
 insert WSBHadronic:MaximumWeight 176 2.0473e-06
 insert WSBHadronic:MaximumWeight 177 0.000639815
 insert WSBHadronic:MaximumWeight 178 0.000251343
 insert WSBHadronic:MaximumWeight 179 2.42005e-08
 insert WSBHadronic:MaximumWeight 180 1.23536e-08
 insert WSBHadronic:MaximumWeight 181 1.16893e-08
 insert WSBHadronic:MaximumWeight 182 1.51866e-05
 insert WSBHadronic:MaximumWeight 183 2.29872e-06
 insert WSBHadronic:MaximumWeight 184 7.69508e-08
 insert WSBHadronic:MaximumWeight 185 2.07139e-07
 insert WSBHadronic:MaximumWeight 186 2.02295e-07
 insert WSBHadronic:MaximumWeight 187 1.24153e-05
 insert WSBHadronic:MaximumWeight 188 1.87898e-06
 insert WSBHadronic:MaximumWeight 189 0.000586926
 insert WSBHadronic:MaximumWeight 190 0.000230364
 insert WSBHadronic:MaximumWeight 191 5.05645e-06
 insert WSBHadronic:MaximumWeight 192 1.1171e-06
 insert WSBHadronic:MaximumWeight 193 3.09059e-05
 insert WSBHadronic:MaximumWeight 194 2.91272e-06
 insert WSBHadronic:MaximumWeight 195 2.15663e-05
 insert WSBHadronic:MaximumWeight 196 1.78876e-06
 insert WSBHadronic:MaximumWeight 197 6.9607e-05
 insert WSBHadronic:MaximumWeight 198 1.05599e-06
 insert WSBHadronic:MaximumWeight 199 2.29413e-05
 insert WSBHadronic:MaximumWeight 200 9.4595e-06
 insert WSBHadronic:MaximumWeight 201 1.51916e-05
 insert WSBHadronic:MaximumWeight 202 1.20926e-06
 insert WSBHadronic:MaximumWeight 203 2.05155e-06
 insert WSBHadronic:MaximumWeight 204 5.67586e-05
 insert WSBHadronic:MaximumWeight 205 5.3492e-06
 insert WSBHadronic:MaximumWeight 206 4.84362e-05
 insert WSBHadronic:MaximumWeight 207 4.83883e-06
 insert WSBHadronic:MaximumWeight 208 0.000127833
 insert WSBHadronic:MaximumWeight 209 1.939e-06
 insert WSBHadronic:MaximumWeight 210 4.21346e-05
 insert WSBHadronic:MaximumWeight 211 1.73721e-05
 insert WSBHadronic:MaximumWeight 212 1.99322e-06
 insert WSBHadronic:MaximumWeight 213 1.00113e-06
 insert WSBHadronic:MaximumWeight 214 1.0629e-07
 insert WSBHadronic:MaximumWeight 215 6.10961e-06
 insert WSBHadronic:MaximumWeight 216 6.66537e-06
 insert WSBHadronic:MaximumWeight 217 3.31242e-06
 insert WSBHadronic:MaximumWeight 218 0.0029994
 insert WSBHadronic:MaximumWeight 219 8.81898e-08
 insert WSBHadronic:MaximumWeight 220 2.94592e-05
 insert WSBHadronic:MaximumWeight 221 1.27859e-05
 insert WSBHadronic:MaximumWeight 222 3.61624e-07
 insert WSBHadronic:MaximumWeight 223 8.35368e-10
 insert WSBHadronic:MaximumWeight 224 6.9609e-09
 insert WSBHadronic:MaximumWeight 225 0.000114887
 insert WSBHadronic:MaximumWeight 226 4.88155e-08
 insert WSBHadronic:MaximumWeight 227 1.44343e-06
 insert WSBHadronic:MaximumWeight 228 3.48502e-07
 insert WSBHadronic:MaximumWeight 229 1.52128e-06
 insert WSBHadronic:MaximumWeight 230 9.528e-05
 insert WSBHadronic:MaximumWeight 231 4.04999e-08
 insert WSBHadronic:MaximumWeight 232 1.35363e-05
 insert WSBHadronic:MaximumWeight 233 5.87803e-06
 insert WSBHadronic:MaximumWeight 234 4.65095e-07
 insert WSBHadronic:MaximumWeight 235 1.28586e-05
 insert WSBHadronic:MaximumWeight 236 1.208e-06
 insert WSBHadronic:MaximumWeight 237 8.82559e-06
 insert WSBHadronic:MaximumWeight 238 7.12659e-07
 insert WSBHadronic:MaximumWeight 239 2.90052e-05
 insert WSBHadronic:MaximumWeight 240 4.32948e-07
 insert WSBHadronic:MaximumWeight 241 9.40713e-06
 insert WSBHadronic:MaximumWeight 242 3.83708e-06
 insert WSBHadronic:MaximumWeight 243 7.72687e-08
 insert WSBHadronic:MaximumWeight 244 1.17734e-07
 insert WSBHadronic:MaximumWeight 245 4.78341e-05
 insert WSBHadronic:MaximumWeight 246 2.03247e-08
 insert WSBHadronic:MaximumWeight 247 6.99655e-08
 insert WSBHadronic:MaximumWeight 248 1.61131e-06
 insert WSBHadronic:MaximumWeight 249 6.33857e-07
 insert WSBHadronic:MaximumWeight 250 3.91856e-05
 insert WSBHadronic:MaximumWeight 251 1.66465e-08
 insert WSBHadronic:MaximumWeight 252 5.2945e-06
 insert WSBHadronic:MaximumWeight 253 2.10942e-06
 insert WSBHadronic:MaximumWeight 254 2.74357e-07
 insert WSBHadronic:MaximumWeight 255 7.57677e-06
 insert WSBHadronic:MaximumWeight 256 7.06115e-07
 insert WSBHadronic:MaximumWeight 257 4.94403e-06
 insert WSBHadronic:MaximumWeight 258 3.6335e-07
 insert WSBHadronic:MaximumWeight 259 1.70184e-05
 insert WSBHadronic:MaximumWeight 260 2.4168e-07
 insert WSBHadronic:MaximumWeight 261 5.33038e-06
 insert WSBHadronic:MaximumWeight 262 2.12479e-06
 insert WSBHadronic:MaximumWeight 263 4.29607e-08
 insert WSBHadronic:MaximumWeight 264 2.82302e-05
 insert WSBHadronic:MaximumWeight 265 1.19968e-08
 insert WSBHadronic:MaximumWeight 266 3.07128e-08
 insert WSBHadronic:MaximumWeight 267 1.09718e-06
 insert WSBHadronic:MaximumWeight 268 3.72352e-07
 insert WSBHadronic:MaximumWeight 269 2.19064e-05
 insert WSBHadronic:MaximumWeight 270 9.44089e-09
 insert WSBHadronic:MaximumWeight 271 2.66611e-06
 insert WSBHadronic:MaximumWeight 272 8.02166e-07
 insert WSBHadronic:MaximumWeight 273 0.000356451
 insert WSBHadronic:MaximumWeight 274 0.00909298
 insert WSBHadronic:MaximumWeight 275 0.000591044
 insert WSBHadronic:MaximumWeight 276 0.0130001
 insert WSBHadronic:MaximumWeight 277 0.00146361
 insert WSBHadronic:MaximumWeight 278 0.0538321
 insert WSBHadronic:MaximumWeight 279 0.00125783
 insert WSBHadronic:MaximumWeight 280 0.0305713
 insert WSBHadronic:MaximumWeight 281 0.0145916
 insert WSBHadronic:MaximumWeight 282 0.00501841
 insert WSBHadronic:MaximumWeight 283 0.000386697
 insert WSBHadronic:MaximumWeight 284 0.00037333
 insert WSBHadronic:MaximumWeight 285 0.00952274
 insert WSBHadronic:MaximumWeight 286 0.000617276
 insert WSBHadronic:MaximumWeight 287 0.0183709
 insert WSBHadronic:MaximumWeight 288 0.00210945
 insert WSBHadronic:MaximumWeight 289 0.0561577
 insert WSBHadronic:MaximumWeight 290 0.00125504
 insert WSBHadronic:MaximumWeight 291 0.032033
 insert WSBHadronic:MaximumWeight 292 0.0152999
 insert WSBHadronic:MaximumWeight 293 5.67462e-06
 insert WSBHadronic:MaximumWeight 294 3.32679e-06
 insert WSBHadronic:MaximumWeight 295 2.94639e-06
 insert WSBHadronic:MaximumWeight 296 8.82582e-07
 insert WSBHadronic:MaximumWeight 297 1.45723e-05
 insert WSBHadronic:MaximumWeight 298 0.0100071
 insert WSBHadronic:MaximumWeight 299 0.00428907
 insert WSBHadronic:MaximumWeight 300 7.30277e-08
 insert WSBHadronic:MaximumWeight 301 3.66623e-08
 insert WSBHadronic:MaximumWeight 302 3.21478e-08
 insert WSBHadronic:MaximumWeight 303 3.33074e-05
 insert WSBHadronic:MaximumWeight 304 5.0465e-06
 insert WSBHadronic:MaximumWeight 305 2.78834e-07
 insert WSBHadronic:MaximumWeight 306 4.83759e-07
 insert WSBHadronic:MaximumWeight 307 8.37436e-07
 insert WSBHadronic:MaximumWeight 308 8.58625e-05
 insert WSBHadronic:MaximumWeight 309 1.32262e-05
 insert WSBHadronic:MaximumWeight 310 0.0088891
 insert WSBHadronic:MaximumWeight 311 0.00389875
 insert WSBHadronic:MaximumWeight 312 1.2021e-06
 insert WSBHadronic:MaximumWeight 313 3.19538e-05
 insert WSBHadronic:MaximumWeight 314 2.54088e-06
 insert WSBHadronic:MaximumWeight 315 3.18195e-05
 insert WSBHadronic:MaximumWeight 316 0.000139886
 insert WSBHadronic:MaximumWeight 317 3.51218e-06
 insert WSBHadronic:MaximumWeight 318 8.72898e-05
 insert WSBHadronic:MaximumWeight 319 4.55348e-05
 insert WSBHadronic:MaximumWeight 320 2.22658e-05
 insert WSBHadronic:MaximumWeight 321 1.74051e-06
 insert WSBHadronic:MaximumWeight 322 2.19717e-06
 insert WSBHadronic:MaximumWeight 323 5.8463e-05
 insert WSBHadronic:MaximumWeight 324 4.67133e-06
 insert WSBHadronic:MaximumWeight 325 8.3142e-05
 insert WSBHadronic:MaximumWeight 326 9.33899e-06
 insert WSBHadronic:MaximumWeight 327 0.000259491
 insert WSBHadronic:MaximumWeight 328 6.11303e-06
 insert WSBHadronic:MaximumWeight 329 0.000160028
 insert WSBHadronic:MaximumWeight 330 8.33209e-05
 insert WSBHadronic:MaximumWeight 331 1.13692e-07
 insert WSBHadronic:MaximumWeight 332 4.39093e-05
 insert WSBHadronic:MaximumWeight 333 6.67366e-06
 insert WSBHadronic:MaximumWeight 334 3.00292e-07
 insert WSBHadronic:MaximumWeight 335 0.000206543
 insert WSBHadronic:MaximumWeight 336 0.00010703
 insert WSBHadronic:MaximumWeight 337 0.000123779
 insert WSBHadronic:MaximumWeight 338 5.25496e-08
 insert WSBHadronic:MaximumWeight 339 1.96087e-06
 insert WSBHadronic:MaximumWeight 340 1.15348e-07
 insert WSBHadronic:MaximumWeight 341 3.01429e-06
 insert WSBHadronic:MaximumWeight 342 0.000318598
 insert WSBHadronic:MaximumWeight 343 1.35584e-07
 insert WSBHadronic:MaximumWeight 344 9.56531e-05
 insert WSBHadronic:MaximumWeight 345 4.91327e-05
 insert WSBHadronic:MaximumWeight 346 2.05039e-06
 insert WSBHadronic:MaximumWeight 347 5.47924e-05
 insert WSBHadronic:MaximumWeight 348 4.50713e-06
 insert WSBHadronic:MaximumWeight 349 0.000207201
 insert WSBHadronic:MaximumWeight 350 5.52843e-06
 insert WSBHadronic:MaximumWeight 351 0.000159173
 insert WSBHadronic:MaximumWeight 352 8.48333e-05
 insert WSBHadronic:MaximumWeight 353 0.000211542
 insert WSBHadronic:MaximumWeight 354 8.94187e-08
 insert WSBHadronic:MaximumWeight 355 4.96693e-06
 insert WSBHadronic:MaximumWeight 356 4.87691e-06
 insert WSBHadronic:MaximumWeight 357 0.000568379
 insert WSBHadronic:MaximumWeight 358 2.4122e-07
 insert WSBHadronic:MaximumWeight 359 0.000188805
 insert WSBHadronic:MaximumWeight 360 0.000117368
 #
 create Herwig::SemiLeptonicScalarDecayer  Melikhov
 newdef Melikhov:Iteration 1
 newdef Melikhov:Ntry 500
 newdef Melikhov:Points 10000
 newdef Melikhov:GenerateIntermediates 0
 insert Melikhov:MaximumWeight 0 0.000574253
 insert Melikhov:MaximumWeight 1 0.000523847
 insert Melikhov:MaximumWeight 2 0.000240896
 insert Melikhov:MaximumWeight 3 0.000999546
 insert Melikhov:MaximumWeight 4 0.00102111
 insert Melikhov:MaximumWeight 5 0.000430377
 insert Melikhov:MaximumWeight 6 0.000224393
 insert Melikhov:MaximumWeight 7 0.000224168
 insert Melikhov:MaximumWeight 8 0.000271174
 insert Melikhov:MaximumWeight 9 0.000411405
 insert Melikhov:MaximumWeight 10 0.000411092
 insert Melikhov:MaximumWeight 11 0.000496488
 create Herwig::LeptonNeutrinoCurrent MelikhovCurrent  HwWeakCurrents.so
 newdef MelikhovCurrent:Quark 0  11
 newdef MelikhovCurrent:AntiQuark 0  -12
 newdef MelikhovCurrent:Quark 1  13
 newdef MelikhovCurrent:AntiQuark 1  -15
 newdef MelikhovCurrent:Quark 2  15
 newdef MelikhovCurrent:AntiQuark 2  -16
 newdef Melikhov:Current MelikhovCurrent
 create Herwig::MelikhovFormFactor MelikhovFormFactor
 newdef MelikhovFormFactor:Fit 1
 newdef MelikhovFormFactor:Incoming 0 -521
 newdef MelikhovFormFactor:Outgoing 0 113
 newdef MelikhovFormFactor:Spin 0 1
 newdef MelikhovFormFactor:Spectator 0 2
 newdef MelikhovFormFactor:InQuark 0 5
 newdef MelikhovFormFactor:OutQuark 0 2
 newdef MelikhovFormFactor:Incoming 1 -511
 newdef MelikhovFormFactor:Outgoing 1 213
 newdef MelikhovFormFactor:Spin 1 1
 newdef MelikhovFormFactor:Spectator 1 1
 newdef MelikhovFormFactor:InQuark 1 5
 newdef MelikhovFormFactor:OutQuark 1 2
 newdef MelikhovFormFactor:Incoming 2 -521
 newdef MelikhovFormFactor:Outgoing 2 -213
 newdef MelikhovFormFactor:Spin 2 1
 newdef MelikhovFormFactor:Spectator 2 2
 newdef MelikhovFormFactor:InQuark 2 5
 newdef MelikhovFormFactor:OutQuark 2 1
 newdef MelikhovFormFactor:Incoming 3 -511
 newdef MelikhovFormFactor:Outgoing 3 113
 newdef MelikhovFormFactor:Spin 3 1
 newdef MelikhovFormFactor:Spectator 3 1
 newdef MelikhovFormFactor:InQuark 3 5
 newdef MelikhovFormFactor:OutQuark 3 1
 newdef MelikhovFormFactor:Incoming 4 -521
 newdef MelikhovFormFactor:Outgoing 4 111
 newdef MelikhovFormFactor:Spin 4 0
 newdef MelikhovFormFactor:Spectator 4 2
 newdef MelikhovFormFactor:InQuark 4 5
 newdef MelikhovFormFactor:OutQuark 4 2
 newdef MelikhovFormFactor:Incoming 5 -511
 newdef MelikhovFormFactor:Outgoing 5 211
 newdef MelikhovFormFactor:Spin 5 0
 newdef MelikhovFormFactor:Spectator 5 1
 newdef MelikhovFormFactor:InQuark 5 5
 newdef MelikhovFormFactor:OutQuark 5 2
 newdef MelikhovFormFactor:Incoming 6 -521
 newdef MelikhovFormFactor:Outgoing 6 -211
 newdef MelikhovFormFactor:Spin 6 0
 newdef MelikhovFormFactor:Spectator 6 2
 newdef MelikhovFormFactor:InQuark 6 5
 newdef MelikhovFormFactor:OutQuark 6 1
 newdef MelikhovFormFactor:Incoming 7 -511
 newdef MelikhovFormFactor:Outgoing 7 111
 newdef MelikhovFormFactor:Spin 7 0
 newdef MelikhovFormFactor:Spectator 7 1
 newdef MelikhovFormFactor:InQuark 7 5
 newdef MelikhovFormFactor:OutQuark 7 1
 newdef Melikhov:FormFactor MelikhovFormFactor
 #
 create Herwig::SemiLeptonicScalarDecayer  MelikhovStech
 newdef MelikhovStech:Iteration 1
 newdef MelikhovStech:Ntry 500
 newdef MelikhovStech:Points 10000
 newdef MelikhovStech:GenerateIntermediates 0
 insert MelikhovStech:MaximumWeight 0 0.132629
 insert MelikhovStech:MaximumWeight 1 0.113122
 insert MelikhovStech:MaximumWeight 2 0.337711
 insert MelikhovStech:MaximumWeight 3 0.288721
 insert MelikhovStech:MaximumWeight 4 0.043953
 insert MelikhovStech:MaximumWeight 5 0.0431442
 insert MelikhovStech:MaximumWeight 6 0.11173
 insert MelikhovStech:MaximumWeight 7 0.109121
 insert MelikhovStech:MaximumWeight 8 0.0106357
 insert MelikhovStech:MaximumWeight 9 0.00957266
 insert MelikhovStech:MaximumWeight 10 0.0137684
 insert MelikhovStech:MaximumWeight 11 0.0123875
 insert MelikhovStech:MaximumWeight 12 0.00391499
 insert MelikhovStech:MaximumWeight 13 0.00386552
 insert MelikhovStech:MaximumWeight 14 0.0051021
 insert MelikhovStech:MaximumWeight 15 0.00504751
 insert MelikhovStech:MaximumWeight 16 0.0843044
 insert MelikhovStech:MaximumWeight 17 0.0792922
 insert MelikhovStech:MaximumWeight 18 0.0187027
 insert MelikhovStech:MaximumWeight 19 0.0770893
 insert MelikhovStech:MaximumWeight 20 0.072427
 insert MelikhovStech:MaximumWeight 21 0.0169877
 insert MelikhovStech:MaximumWeight 22 0.124776
 insert MelikhovStech:MaximumWeight 23 0.121677
 insert MelikhovStech:MaximumWeight 24 0.0305758
 insert MelikhovStech:MaximumWeight 25 0.125676
 insert MelikhovStech:MaximumWeight 26 0.125481
 insert MelikhovStech:MaximumWeight 27 0.0311555
 insert MelikhovStech:MaximumWeight 28 0.000214676
 insert MelikhovStech:MaximumWeight 29 0.000211978
 insert MelikhovStech:MaximumWeight 30 0.000128561
 insert MelikhovStech:MaximumWeight 31 0.000394065
 insert MelikhovStech:MaximumWeight 32 0.000388644
 insert MelikhovStech:MaximumWeight 33 0.000235631
 insert MelikhovStech:MaximumWeight 34 0.000598245
 insert MelikhovStech:MaximumWeight 35 0.000610799
 insert MelikhovStech:MaximumWeight 36 0.000268044
 insert MelikhovStech:MaximumWeight 37 0.00112259
 insert MelikhovStech:MaximumWeight 38 0.0011597
 insert MelikhovStech:MaximumWeight 39 0.000483222
 insert MelikhovStech:MaximumWeight 40 0.0100923
 insert MelikhovStech:MaximumWeight 41 0.00884077
 insert MelikhovStech:MaximumWeight 42 0.00381443
 insert MelikhovStech:MaximumWeight 43 0.00374616
 insert MelikhovStech:MaximumWeight 44 0.0794698
 insert MelikhovStech:MaximumWeight 45 0.068976
 insert MelikhovStech:MaximumWeight 46 0.0324752
 insert MelikhovStech:MaximumWeight 47 0.0258154
 insert MelikhovStech:MaximumWeight 48 0.118027
 insert MelikhovStech:MaximumWeight 49 0.113887
 insert MelikhovStech:MaximumWeight 50 0.000401303
 insert MelikhovStech:MaximumWeight 51 0.000399862
 insert MelikhovStech:MaximumWeight 52 0.000234707
 insert MelikhovStech:MaximumWeight 53 0.0028559
 insert MelikhovStech:MaximumWeight 54 0.00274908
 insert MelikhovStech:MaximumWeight 55 0.00116194
 create Herwig::LeptonNeutrinoCurrent MelikhovStechCurrent  HwWeakCurrents.so
 newdef MelikhovStechCurrent:Quark 0  11
 newdef MelikhovStechCurrent:AntiQuark 0  -12
 newdef MelikhovStechCurrent:Quark 1  13
 newdef MelikhovStechCurrent:AntiQuark 1  -15
 newdef MelikhovStechCurrent:Quark 2  15
 newdef MelikhovStechCurrent:AntiQuark 2  -16
 newdef MelikhovStech:Current MelikhovStechCurrent
 create Herwig::MelikhovStechFormFactor MelikhovStechFormFactor
 newdef MelikhovStechFormFactor:ThetaEtaEtaPrime 0.698132
 newdef MelikhovStechFormFactor:FPlus0 0  0.78
 newdef MelikhovStechFormFactor:F+sigma_1 0  0.24
 newdef MelikhovStechFormFactor:F+sigma_2 0  0
 newdef MelikhovStechFormFactor:F00 0  0.78
 newdef MelikhovStechFormFactor:F0sigma_1 0  0.38
 newdef MelikhovStechFormFactor:F0sigma_2 0  0.46
 newdef MelikhovStechFormFactor:FT0 0  0.75
 newdef MelikhovStechFormFactor:FTsigma_1 0  0.27
 newdef MelikhovStechFormFactor:FTsigma_2 0  0
 newdef MelikhovStechFormFactor:V00 0  0
 newdef MelikhovStechFormFactor:V0sigma_1 0  0
 newdef MelikhovStechFormFactor:V0sigma_2 0  0
 newdef MelikhovStechFormFactor:A00 0  0
 newdef MelikhovStechFormFactor:A0sigma_1 0  0
 newdef MelikhovStechFormFactor:A0sigma_2 0  0
 newdef MelikhovStechFormFactor:A10 0  0
 newdef MelikhovStechFormFactor:A1sigma_1 0  0
 newdef MelikhovStechFormFactor:A1sigma_2 0  0
 newdef MelikhovStechFormFactor:A20 0  0
 newdef MelikhovStechFormFactor:A2sigma_1 0  0
 newdef MelikhovStechFormFactor:A2sigma_2 0  0
 newdef MelikhovStechFormFactor:T10 0  0
 newdef MelikhovStechFormFactor:T1sigma_1 0  0
 newdef MelikhovStechFormFactor:T1sigma_2 0  0
 newdef MelikhovStechFormFactor:T20 0  0
 newdef MelikhovStechFormFactor:T2sigma_1 0  0
 newdef MelikhovStechFormFactor:T2sigma_2 0  0
 newdef MelikhovStechFormFactor:T30 0  0
 newdef MelikhovStechFormFactor:T3sigma_1 0  0
 newdef MelikhovStechFormFactor:T3sigma_2 0  0
 newdef MelikhovStechFormFactor:MassP 0  1.97
 newdef MelikhovStechFormFactor:MassV 0  2.11
 newdef MelikhovStechFormFactor:FPlus0 1  0.78
 newdef MelikhovStechFormFactor:F+sigma_1 1  0.24
 newdef MelikhovStechFormFactor:F+sigma_2 1  0
 newdef MelikhovStechFormFactor:F00 1  0.78
 newdef MelikhovStechFormFactor:F0sigma_1 1  0.38
 newdef MelikhovStechFormFactor:F0sigma_2 1  0.46
 newdef MelikhovStechFormFactor:FT0 1  0.75
 newdef MelikhovStechFormFactor:FTsigma_1 1  0.27
 newdef MelikhovStechFormFactor:FTsigma_2 1  0
 newdef MelikhovStechFormFactor:V00 1  0
 newdef MelikhovStechFormFactor:V0sigma_1 1  0
 newdef MelikhovStechFormFactor:V0sigma_2 1  0
 newdef MelikhovStechFormFactor:A00 1  0
 newdef MelikhovStechFormFactor:A0sigma_1 1  0
 newdef MelikhovStechFormFactor:A0sigma_2 1  0
 newdef MelikhovStechFormFactor:A10 1  0
 newdef MelikhovStechFormFactor:A1sigma_1 1  0
 newdef MelikhovStechFormFactor:A1sigma_2 1  0
 newdef MelikhovStechFormFactor:A20 1  0
 newdef MelikhovStechFormFactor:A2sigma_1 1  0
 newdef MelikhovStechFormFactor:A2sigma_2 1  0
 newdef MelikhovStechFormFactor:T10 1  0
 newdef MelikhovStechFormFactor:T1sigma_1 1  0
 newdef MelikhovStechFormFactor:T1sigma_2 1  0
 newdef MelikhovStechFormFactor:T20 1  0
 newdef MelikhovStechFormFactor:T2sigma_1 1  0
 newdef MelikhovStechFormFactor:T2sigma_2 1  0
 newdef MelikhovStechFormFactor:T30 1  0
 newdef MelikhovStechFormFactor:T3sigma_1 1  0
 newdef MelikhovStechFormFactor:T3sigma_2 1  0
 newdef MelikhovStechFormFactor:MassP 1  1.97
 newdef MelikhovStechFormFactor:MassV 1  2.11
 newdef MelikhovStechFormFactor:FPlus0 2  0
 newdef MelikhovStechFormFactor:F+sigma_1 2  0
 newdef MelikhovStechFormFactor:F+sigma_2 2  0
 newdef MelikhovStechFormFactor:F00 2  0
 newdef MelikhovStechFormFactor:F0sigma_1 2  0
 newdef MelikhovStechFormFactor:F0sigma_2 2  0
 newdef MelikhovStechFormFactor:FT0 2  0
 newdef MelikhovStechFormFactor:FTsigma_1 2  0
 newdef MelikhovStechFormFactor:FTsigma_2 2  0
 newdef MelikhovStechFormFactor:V00 2  1.03
 newdef MelikhovStechFormFactor:V0sigma_1 2  0.27
 newdef MelikhovStechFormFactor:V0sigma_2 2  0
 newdef MelikhovStechFormFactor:A00 2  0.76
 newdef MelikhovStechFormFactor:A0sigma_1 2  0.17
 newdef MelikhovStechFormFactor:A0sigma_2 2  0
 newdef MelikhovStechFormFactor:A10 2  0.66
 newdef MelikhovStechFormFactor:A1sigma_1 2  0.3
 newdef MelikhovStechFormFactor:A1sigma_2 2  0.2
 newdef MelikhovStechFormFactor:A20 2  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 2  0.67
 newdef MelikhovStechFormFactor:A2sigma_2 2  0.16
 newdef MelikhovStechFormFactor:T10 2  0.78
 newdef MelikhovStechFormFactor:T1sigma_1 2  0.25
 newdef MelikhovStechFormFactor:T1sigma_2 2  0
 newdef MelikhovStechFormFactor:T20 2  0.78
 newdef MelikhovStechFormFactor:T2sigma_1 2  0.02
 newdef MelikhovStechFormFactor:T2sigma_2 2  1.8
 newdef MelikhovStechFormFactor:T30 2  0.45
 newdef MelikhovStechFormFactor:T3sigma_1 2  1.23
 newdef MelikhovStechFormFactor:T3sigma_2 2  0.34
 newdef MelikhovStechFormFactor:MassP 2  1.97
 newdef MelikhovStechFormFactor:MassV 2  2.11
 newdef MelikhovStechFormFactor:FPlus0 3  0
 newdef MelikhovStechFormFactor:F+sigma_1 3  0
 newdef MelikhovStechFormFactor:F+sigma_2 3  0
 newdef MelikhovStechFormFactor:F00 3  0
 newdef MelikhovStechFormFactor:F0sigma_1 3  0
 newdef MelikhovStechFormFactor:F0sigma_2 3  0
 newdef MelikhovStechFormFactor:FT0 3  0
 newdef MelikhovStechFormFactor:FTsigma_1 3  0
 newdef MelikhovStechFormFactor:FTsigma_2 3  0
 newdef MelikhovStechFormFactor:V00 3  1.03
 newdef MelikhovStechFormFactor:V0sigma_1 3  0.27
 newdef MelikhovStechFormFactor:V0sigma_2 3  0
 newdef MelikhovStechFormFactor:A00 3  0.76
 newdef MelikhovStechFormFactor:A0sigma_1 3  0.17
 newdef MelikhovStechFormFactor:A0sigma_2 3  0
 newdef MelikhovStechFormFactor:A10 3  0.66
 newdef MelikhovStechFormFactor:A1sigma_1 3  0.3
 newdef MelikhovStechFormFactor:A1sigma_2 3  0.2
 newdef MelikhovStechFormFactor:A20 3  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 3  0.67
 newdef MelikhovStechFormFactor:A2sigma_2 3  0.16
 newdef MelikhovStechFormFactor:T10 3  0.78
 newdef MelikhovStechFormFactor:T1sigma_1 3  0.25
 newdef MelikhovStechFormFactor:T1sigma_2 3  0
 newdef MelikhovStechFormFactor:T20 3  0.78
 newdef MelikhovStechFormFactor:T2sigma_1 3  0.02
 newdef MelikhovStechFormFactor:T2sigma_2 3  1.8
 newdef MelikhovStechFormFactor:T30 3  0.45
 newdef MelikhovStechFormFactor:T3sigma_1 3  1.23
 newdef MelikhovStechFormFactor:T3sigma_2 3  0.34
 newdef MelikhovStechFormFactor:MassP 3  1.97
 newdef MelikhovStechFormFactor:MassV 3  2.11
 newdef MelikhovStechFormFactor:FPlus0 4  0.69
 newdef MelikhovStechFormFactor:F+sigma_1 4  0.3
 newdef MelikhovStechFormFactor:F+sigma_2 4  0
 newdef MelikhovStechFormFactor:F00 4  0.69
 newdef MelikhovStechFormFactor:F0sigma_1 4  0.54
 newdef MelikhovStechFormFactor:F0sigma_2 4  0.32
 newdef MelikhovStechFormFactor:FT0 4  0.6
 newdef MelikhovStechFormFactor:FTsigma_1 4  0.34
 newdef MelikhovStechFormFactor:FTsigma_2 4  0
 newdef MelikhovStechFormFactor:V00 4  0
 newdef MelikhovStechFormFactor:V0sigma_1 4  0
 newdef MelikhovStechFormFactor:V0sigma_2 4  0
 newdef MelikhovStechFormFactor:A00 4  0
 newdef MelikhovStechFormFactor:A0sigma_1 4  0
 newdef MelikhovStechFormFactor:A0sigma_2 4  0
 newdef MelikhovStechFormFactor:A10 4  0
 newdef MelikhovStechFormFactor:A1sigma_1 4  0
 newdef MelikhovStechFormFactor:A1sigma_2 4  0
 newdef MelikhovStechFormFactor:A20 4  0
 newdef MelikhovStechFormFactor:A2sigma_1 4  0
 newdef MelikhovStechFormFactor:A2sigma_2 4  0
 newdef MelikhovStechFormFactor:T10 4  0
 newdef MelikhovStechFormFactor:T1sigma_1 4  0
 newdef MelikhovStechFormFactor:T1sigma_2 4  0
 newdef MelikhovStechFormFactor:T20 4  0
 newdef MelikhovStechFormFactor:T2sigma_1 4  0
 newdef MelikhovStechFormFactor:T2sigma_2 4  0
 newdef MelikhovStechFormFactor:T30 4  0
 newdef MelikhovStechFormFactor:T3sigma_1 4  0
 newdef MelikhovStechFormFactor:T3sigma_2 4  0
 newdef MelikhovStechFormFactor:MassP 4  1.87
 newdef MelikhovStechFormFactor:MassV 4  2.01
 newdef MelikhovStechFormFactor:FPlus0 5  0.69
 newdef MelikhovStechFormFactor:F+sigma_1 5  0.3
 newdef MelikhovStechFormFactor:F+sigma_2 5  0
 newdef MelikhovStechFormFactor:F00 5  0.69
 newdef MelikhovStechFormFactor:F0sigma_1 5  0.54
 newdef MelikhovStechFormFactor:F0sigma_2 5  0.32
 newdef MelikhovStechFormFactor:FT0 5  0.6
 newdef MelikhovStechFormFactor:FTsigma_1 5  0.34
 newdef MelikhovStechFormFactor:FTsigma_2 5  0
 newdef MelikhovStechFormFactor:V00 5  0
 newdef MelikhovStechFormFactor:V0sigma_1 5  0
 newdef MelikhovStechFormFactor:V0sigma_2 5  0
 newdef MelikhovStechFormFactor:A00 5  0
 newdef MelikhovStechFormFactor:A0sigma_1 5  0
 newdef MelikhovStechFormFactor:A0sigma_2 5  0
 newdef MelikhovStechFormFactor:A10 5  0
 newdef MelikhovStechFormFactor:A1sigma_1 5  0
 newdef MelikhovStechFormFactor:A1sigma_2 5  0
 newdef MelikhovStechFormFactor:A20 5  0
 newdef MelikhovStechFormFactor:A2sigma_1 5  0
 newdef MelikhovStechFormFactor:A2sigma_2 5  0
 newdef MelikhovStechFormFactor:T10 5  0
 newdef MelikhovStechFormFactor:T1sigma_1 5  0
 newdef MelikhovStechFormFactor:T1sigma_2 5  0
 newdef MelikhovStechFormFactor:T20 5  0
 newdef MelikhovStechFormFactor:T2sigma_1 5  0
 newdef MelikhovStechFormFactor:T2sigma_2 5  0
 newdef MelikhovStechFormFactor:T30 5  0
 newdef MelikhovStechFormFactor:T3sigma_1 5  0
 newdef MelikhovStechFormFactor:T3sigma_2 5  0
 newdef MelikhovStechFormFactor:MassP 5  1.87
 newdef MelikhovStechFormFactor:MassV 5  2.01
 newdef MelikhovStechFormFactor:FPlus0 6  0.69
 newdef MelikhovStechFormFactor:F+sigma_1 6  0.3
 newdef MelikhovStechFormFactor:F+sigma_2 6  0
 newdef MelikhovStechFormFactor:F00 6  0.69
 newdef MelikhovStechFormFactor:F0sigma_1 6  0.54
 newdef MelikhovStechFormFactor:F0sigma_2 6  0.32
 newdef MelikhovStechFormFactor:FT0 6  0.6
 newdef MelikhovStechFormFactor:FTsigma_1 6  0.34
 newdef MelikhovStechFormFactor:FTsigma_2 6  0
 newdef MelikhovStechFormFactor:V00 6  0
 newdef MelikhovStechFormFactor:V0sigma_1 6  0
 newdef MelikhovStechFormFactor:V0sigma_2 6  0
 newdef MelikhovStechFormFactor:A00 6  0
 newdef MelikhovStechFormFactor:A0sigma_1 6  0
 newdef MelikhovStechFormFactor:A0sigma_2 6  0
 newdef MelikhovStechFormFactor:A10 6  0
 newdef MelikhovStechFormFactor:A1sigma_1 6  0
 newdef MelikhovStechFormFactor:A1sigma_2 6  0
 newdef MelikhovStechFormFactor:A20 6  0
 newdef MelikhovStechFormFactor:A2sigma_1 6  0
 newdef MelikhovStechFormFactor:A2sigma_2 6  0
 newdef MelikhovStechFormFactor:T10 6  0
 newdef MelikhovStechFormFactor:T1sigma_1 6  0
 newdef MelikhovStechFormFactor:T1sigma_2 6  0
 newdef MelikhovStechFormFactor:T20 6  0
 newdef MelikhovStechFormFactor:T2sigma_1 6  0
 newdef MelikhovStechFormFactor:T2sigma_2 6  0
 newdef MelikhovStechFormFactor:T30 6  0
 newdef MelikhovStechFormFactor:T3sigma_1 6  0
 newdef MelikhovStechFormFactor:T3sigma_2 6  0
 newdef MelikhovStechFormFactor:MassP 6  1.87
 newdef MelikhovStechFormFactor:MassV 6  2.01
 newdef MelikhovStechFormFactor:FPlus0 7  0.69
 newdef MelikhovStechFormFactor:F+sigma_1 7  0.3
 newdef MelikhovStechFormFactor:F+sigma_2 7  0
 newdef MelikhovStechFormFactor:F00 7  0.69
 newdef MelikhovStechFormFactor:F0sigma_1 7  0.54
 newdef MelikhovStechFormFactor:F0sigma_2 7  0.32
 newdef MelikhovStechFormFactor:FT0 7  0.6
 newdef MelikhovStechFormFactor:FTsigma_1 7  0.34
 newdef MelikhovStechFormFactor:FTsigma_2 7  0
 newdef MelikhovStechFormFactor:V00 7  0
 newdef MelikhovStechFormFactor:V0sigma_1 7  0
 newdef MelikhovStechFormFactor:V0sigma_2 7  0
 newdef MelikhovStechFormFactor:A00 7  0
 newdef MelikhovStechFormFactor:A0sigma_1 7  0
 newdef MelikhovStechFormFactor:A0sigma_2 7  0
 newdef MelikhovStechFormFactor:A10 7  0
 newdef MelikhovStechFormFactor:A1sigma_1 7  0
 newdef MelikhovStechFormFactor:A1sigma_2 7  0
 newdef MelikhovStechFormFactor:A20 7  0
 newdef MelikhovStechFormFactor:A2sigma_1 7  0
 newdef MelikhovStechFormFactor:A2sigma_2 7  0
 newdef MelikhovStechFormFactor:T10 7  0
 newdef MelikhovStechFormFactor:T1sigma_1 7  0
 newdef MelikhovStechFormFactor:T1sigma_2 7  0
 newdef MelikhovStechFormFactor:T20 7  0
 newdef MelikhovStechFormFactor:T2sigma_1 7  0
 newdef MelikhovStechFormFactor:T2sigma_2 7  0
 newdef MelikhovStechFormFactor:T30 7  0
 newdef MelikhovStechFormFactor:T3sigma_1 7  0
 newdef MelikhovStechFormFactor:T3sigma_2 7  0
 newdef MelikhovStechFormFactor:MassP 7  1.87
 newdef MelikhovStechFormFactor:MassV 7  2.01
 newdef MelikhovStechFormFactor:FPlus0 8  0
 newdef MelikhovStechFormFactor:F+sigma_1 8  0
 newdef MelikhovStechFormFactor:F+sigma_2 8  0
 newdef MelikhovStechFormFactor:F00 8  0
 newdef MelikhovStechFormFactor:F0sigma_1 8  0
 newdef MelikhovStechFormFactor:F0sigma_2 8  0
 newdef MelikhovStechFormFactor:FT0 8  0
 newdef MelikhovStechFormFactor:FTsigma_1 8  0
 newdef MelikhovStechFormFactor:FTsigma_2 8  0
 newdef MelikhovStechFormFactor:V00 8  0.9
 newdef MelikhovStechFormFactor:V0sigma_1 8  0.46
 newdef MelikhovStechFormFactor:V0sigma_2 8  0
 newdef MelikhovStechFormFactor:A00 8  0.66
 newdef MelikhovStechFormFactor:A0sigma_1 8  0.36
 newdef MelikhovStechFormFactor:A0sigma_2 8  0
 newdef MelikhovStechFormFactor:A10 8  0.59
 newdef MelikhovStechFormFactor:A1sigma_1 8  0.5
 newdef MelikhovStechFormFactor:A1sigma_2 8  0
 newdef MelikhovStechFormFactor:A20 8  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 8  0.89
 newdef MelikhovStechFormFactor:A2sigma_2 8  0
 newdef MelikhovStechFormFactor:T10 8  0.66
 newdef MelikhovStechFormFactor:T1sigma_1 8  0.44
 newdef MelikhovStechFormFactor:T1sigma_2 8  0
 newdef MelikhovStechFormFactor:T20 8  0.66
 newdef MelikhovStechFormFactor:T2sigma_1 8  0.38
 newdef MelikhovStechFormFactor:T2sigma_2 8  0.5
 newdef MelikhovStechFormFactor:T30 8  0.31
 newdef MelikhovStechFormFactor:T3sigma_1 8  1.1
 newdef MelikhovStechFormFactor:T3sigma_2 8  0.17
 newdef MelikhovStechFormFactor:MassP 8  1.87
 newdef MelikhovStechFormFactor:MassV 8  2.01
 newdef MelikhovStechFormFactor:FPlus0 9  0
 newdef MelikhovStechFormFactor:F+sigma_1 9  0
 newdef MelikhovStechFormFactor:F+sigma_2 9  0
 newdef MelikhovStechFormFactor:F00 9  0
 newdef MelikhovStechFormFactor:F0sigma_1 9  0
 newdef MelikhovStechFormFactor:F0sigma_2 9  0
 newdef MelikhovStechFormFactor:FT0 9  0
 newdef MelikhovStechFormFactor:FTsigma_1 9  0
 newdef MelikhovStechFormFactor:FTsigma_2 9  0
 newdef MelikhovStechFormFactor:V00 9  0.9
 newdef MelikhovStechFormFactor:V0sigma_1 9  0.46
 newdef MelikhovStechFormFactor:V0sigma_2 9  0
 newdef MelikhovStechFormFactor:A00 9  0.66
 newdef MelikhovStechFormFactor:A0sigma_1 9  0.36
 newdef MelikhovStechFormFactor:A0sigma_2 9  0
 newdef MelikhovStechFormFactor:A10 9  0.59
 newdef MelikhovStechFormFactor:A1sigma_1 9  0.5
 newdef MelikhovStechFormFactor:A1sigma_2 9  0
 newdef MelikhovStechFormFactor:A20 9  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 9  0.89
 newdef MelikhovStechFormFactor:A2sigma_2 9  0
 newdef MelikhovStechFormFactor:T10 9  0.66
 newdef MelikhovStechFormFactor:T1sigma_1 9  0.44
 newdef MelikhovStechFormFactor:T1sigma_2 9  0
 newdef MelikhovStechFormFactor:T20 9  0.66
 newdef MelikhovStechFormFactor:T2sigma_1 9  0.38
 newdef MelikhovStechFormFactor:T2sigma_2 9  0.5
 newdef MelikhovStechFormFactor:T30 9  0.31
 newdef MelikhovStechFormFactor:T3sigma_1 9  1.1
 newdef MelikhovStechFormFactor:T3sigma_2 9  0.17
 newdef MelikhovStechFormFactor:MassP 9  1.87
 newdef MelikhovStechFormFactor:MassV 9  2.01
 newdef MelikhovStechFormFactor:FPlus0 10  0
 newdef MelikhovStechFormFactor:F+sigma_1 10  0
 newdef MelikhovStechFormFactor:F+sigma_2 10  0
 newdef MelikhovStechFormFactor:F00 10  0
 newdef MelikhovStechFormFactor:F0sigma_1 10  0
 newdef MelikhovStechFormFactor:F0sigma_2 10  0
 newdef MelikhovStechFormFactor:FT0 10  0
 newdef MelikhovStechFormFactor:FTsigma_1 10  0
 newdef MelikhovStechFormFactor:FTsigma_2 10  0
 newdef MelikhovStechFormFactor:V00 10  0.9
 newdef MelikhovStechFormFactor:V0sigma_1 10  0.46
 newdef MelikhovStechFormFactor:V0sigma_2 10  0
 newdef MelikhovStechFormFactor:A00 10  0.66
 newdef MelikhovStechFormFactor:A0sigma_1 10  0.36
 newdef MelikhovStechFormFactor:A0sigma_2 10  0
 newdef MelikhovStechFormFactor:A10 10  0.59
 newdef MelikhovStechFormFactor:A1sigma_1 10  0.5
 newdef MelikhovStechFormFactor:A1sigma_2 10  0
 newdef MelikhovStechFormFactor:A20 10  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 10  0.89
 newdef MelikhovStechFormFactor:A2sigma_2 10  0
 newdef MelikhovStechFormFactor:T10 10  0.66
 newdef MelikhovStechFormFactor:T1sigma_1 10  0.44
 newdef MelikhovStechFormFactor:T1sigma_2 10  0
 newdef MelikhovStechFormFactor:T20 10  0.66
 newdef MelikhovStechFormFactor:T2sigma_1 10  0.38
 newdef MelikhovStechFormFactor:T2sigma_2 10  0.5
 newdef MelikhovStechFormFactor:T30 10  0.31
 newdef MelikhovStechFormFactor:T3sigma_1 10  1.1
 newdef MelikhovStechFormFactor:T3sigma_2 10  0.17
 newdef MelikhovStechFormFactor:MassP 10  1.87
 newdef MelikhovStechFormFactor:MassV 10  2.01
 newdef MelikhovStechFormFactor:FPlus0 11  0
 newdef MelikhovStechFormFactor:F+sigma_1 11  0
 newdef MelikhovStechFormFactor:F+sigma_2 11  0
 newdef MelikhovStechFormFactor:F00 11  0
 newdef MelikhovStechFormFactor:F0sigma_1 11  0
 newdef MelikhovStechFormFactor:F0sigma_2 11  0
 newdef MelikhovStechFormFactor:FT0 11  0
 newdef MelikhovStechFormFactor:FTsigma_1 11  0
 newdef MelikhovStechFormFactor:FTsigma_2 11  0
 newdef MelikhovStechFormFactor:V00 11  0.9
 newdef MelikhovStechFormFactor:V0sigma_1 11  0.46
 newdef MelikhovStechFormFactor:V0sigma_2 11  0
 newdef MelikhovStechFormFactor:A00 11  0.66
 newdef MelikhovStechFormFactor:A0sigma_1 11  0.36
 newdef MelikhovStechFormFactor:A0sigma_2 11  0
 newdef MelikhovStechFormFactor:A10 11  0.59
 newdef MelikhovStechFormFactor:A1sigma_1 11  0.5
 newdef MelikhovStechFormFactor:A1sigma_2 11  0
 newdef MelikhovStechFormFactor:A20 11  0.49
 newdef MelikhovStechFormFactor:A2sigma_1 11  0.89
 newdef MelikhovStechFormFactor:A2sigma_2 11  0
 newdef MelikhovStechFormFactor:T10 11  0.66
 newdef MelikhovStechFormFactor:T1sigma_1 11  0.44
 newdef MelikhovStechFormFactor:T1sigma_2 11  0
 newdef MelikhovStechFormFactor:T20 11  0.66
 newdef MelikhovStechFormFactor:T2sigma_1 11  0.38
 newdef MelikhovStechFormFactor:T2sigma_2 11  0.5
 newdef MelikhovStechFormFactor:T30 11  0.31
 newdef MelikhovStechFormFactor:T3sigma_1 11  1.1
 newdef MelikhovStechFormFactor:T3sigma_2 11  0.17
 newdef MelikhovStechFormFactor:MassP 11  1.87
 newdef MelikhovStechFormFactor:MassV 11  2.01
 newdef MelikhovStechFormFactor:FPlus0 12  0.67
 newdef MelikhovStechFormFactor:F+sigma_1 12  0.57
 newdef MelikhovStechFormFactor:F+sigma_2 12  0
 newdef MelikhovStechFormFactor:F00 12  0.67
 newdef MelikhovStechFormFactor:F0sigma_1 12  0.78
 newdef MelikhovStechFormFactor:F0sigma_2 12  0
 newdef MelikhovStechFormFactor:FT0 12  0.69
 newdef MelikhovStechFormFactor:FTsigma_1 12  0.56
 newdef MelikhovStechFormFactor:FTsigma_2 12  0
 newdef MelikhovStechFormFactor:V00 12  0
 newdef MelikhovStechFormFactor:V0sigma_1 12  0
 newdef MelikhovStechFormFactor:V0sigma_2 12  0
 newdef MelikhovStechFormFactor:A00 12  0
 newdef MelikhovStechFormFactor:A0sigma_1 12  0
 newdef MelikhovStechFormFactor:A0sigma_2 12  0
 newdef MelikhovStechFormFactor:A10 12  0
 newdef MelikhovStechFormFactor:A1sigma_1 12  0
 newdef MelikhovStechFormFactor:A1sigma_2 12  0
 newdef MelikhovStechFormFactor:A20 12  0
 newdef MelikhovStechFormFactor:A2sigma_1 12  0
 newdef MelikhovStechFormFactor:A2sigma_2 12  0
 newdef MelikhovStechFormFactor:T10 12  0
 newdef MelikhovStechFormFactor:T1sigma_1 12  0
 newdef MelikhovStechFormFactor:T1sigma_2 12  0
 newdef MelikhovStechFormFactor:T20 12  0
 newdef MelikhovStechFormFactor:T2sigma_1 12  0
 newdef MelikhovStechFormFactor:T2sigma_2 12  0
 newdef MelikhovStechFormFactor:T30 12  0
 newdef MelikhovStechFormFactor:T3sigma_1 12  0
 newdef MelikhovStechFormFactor:T3sigma_2 12  0
 newdef MelikhovStechFormFactor:MassP 12  6.4
 newdef MelikhovStechFormFactor:MassV 12  6.4
 newdef MelikhovStechFormFactor:FPlus0 13  0.67
 newdef MelikhovStechFormFactor:F+sigma_1 13  0.57
 newdef MelikhovStechFormFactor:F+sigma_2 13  0
 newdef MelikhovStechFormFactor:F00 13  0.67
 newdef MelikhovStechFormFactor:F0sigma_1 13  0.78
 newdef MelikhovStechFormFactor:F0sigma_2 13  0
 newdef MelikhovStechFormFactor:FT0 13  0.69
 newdef MelikhovStechFormFactor:FTsigma_1 13  0.56
 newdef MelikhovStechFormFactor:FTsigma_2 13  0
 newdef MelikhovStechFormFactor:V00 13  0
 newdef MelikhovStechFormFactor:V0sigma_1 13  0
 newdef MelikhovStechFormFactor:V0sigma_2 13  0
 newdef MelikhovStechFormFactor:A00 13  0
 newdef MelikhovStechFormFactor:A0sigma_1 13  0
 newdef MelikhovStechFormFactor:A0sigma_2 13  0
 newdef MelikhovStechFormFactor:A10 13  0
 newdef MelikhovStechFormFactor:A1sigma_1 13  0
 newdef MelikhovStechFormFactor:A1sigma_2 13  0
 newdef MelikhovStechFormFactor:A20 13  0
 newdef MelikhovStechFormFactor:A2sigma_1 13  0
 newdef MelikhovStechFormFactor:A2sigma_2 13  0
 newdef MelikhovStechFormFactor:T10 13  0
 newdef MelikhovStechFormFactor:T1sigma_1 13  0
 newdef MelikhovStechFormFactor:T1sigma_2 13  0
 newdef MelikhovStechFormFactor:T20 13  0
 newdef MelikhovStechFormFactor:T2sigma_1 13  0
 newdef MelikhovStechFormFactor:T2sigma_2 13  0
 newdef MelikhovStechFormFactor:T30 13  0
 newdef MelikhovStechFormFactor:T3sigma_1 13  0
 newdef MelikhovStechFormFactor:T3sigma_2 13  0
 newdef MelikhovStechFormFactor:MassP 13  6.4
 newdef MelikhovStechFormFactor:MassV 13  6.4
 newdef MelikhovStechFormFactor:FPlus0 14  0
 newdef MelikhovStechFormFactor:F+sigma_1 14  0
 newdef MelikhovStechFormFactor:F+sigma_2 14  0
 newdef MelikhovStechFormFactor:F00 14  0
 newdef MelikhovStechFormFactor:F0sigma_1 14  0
 newdef MelikhovStechFormFactor:F0sigma_2 14  0
 newdef MelikhovStechFormFactor:FT0 14  0
 newdef MelikhovStechFormFactor:FTsigma_1 14  0
 newdef MelikhovStechFormFactor:FTsigma_2 14  0
 newdef MelikhovStechFormFactor:V00 14  0.76
 newdef MelikhovStechFormFactor:V0sigma_1 14  0.57
 newdef MelikhovStechFormFactor:V0sigma_2 14  0
 newdef MelikhovStechFormFactor:A00 14  0.69
 newdef MelikhovStechFormFactor:A0sigma_1 14  0.58
 newdef MelikhovStechFormFactor:A0sigma_2 14  0
 newdef MelikhovStechFormFactor:A10 14  0.66
 newdef MelikhovStechFormFactor:A1sigma_1 14  0.78
 newdef MelikhovStechFormFactor:A1sigma_2 14  0
 newdef MelikhovStechFormFactor:A20 14  0.62
 newdef MelikhovStechFormFactor:A2sigma_1 14  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 14  0.41
 newdef MelikhovStechFormFactor:T10 14  0.68
 newdef MelikhovStechFormFactor:T1sigma_1 14  0.57
 newdef MelikhovStechFormFactor:T1sigma_2 14  0
 newdef MelikhovStechFormFactor:T20 14  0.68
 newdef MelikhovStechFormFactor:T2sigma_1 14  0.64
 newdef MelikhovStechFormFactor:T2sigma_2 14  0
 newdef MelikhovStechFormFactor:T30 14  0.33
 newdef MelikhovStechFormFactor:T3sigma_1 14  1.46
 newdef MelikhovStechFormFactor:T3sigma_2 14  0.5
 newdef MelikhovStechFormFactor:MassP 14  6.4
 newdef MelikhovStechFormFactor:MassV 14  6.4
 newdef MelikhovStechFormFactor:FPlus0 15  0
 newdef MelikhovStechFormFactor:F+sigma_1 15  0
 newdef MelikhovStechFormFactor:F+sigma_2 15  0
 newdef MelikhovStechFormFactor:F00 15  0
 newdef MelikhovStechFormFactor:F0sigma_1 15  0
 newdef MelikhovStechFormFactor:F0sigma_2 15  0
 newdef MelikhovStechFormFactor:FT0 15  0
 newdef MelikhovStechFormFactor:FTsigma_1 15  0
 newdef MelikhovStechFormFactor:FTsigma_2 15  0
 newdef MelikhovStechFormFactor:V00 15  0.76
 newdef MelikhovStechFormFactor:V0sigma_1 15  0.57
 newdef MelikhovStechFormFactor:V0sigma_2 15  0
 newdef MelikhovStechFormFactor:A00 15  0.69
 newdef MelikhovStechFormFactor:A0sigma_1 15  0.58
 newdef MelikhovStechFormFactor:A0sigma_2 15  0
 newdef MelikhovStechFormFactor:A10 15  0.66
 newdef MelikhovStechFormFactor:A1sigma_1 15  0.78
 newdef MelikhovStechFormFactor:A1sigma_2 15  0
 newdef MelikhovStechFormFactor:A20 15  0.62
 newdef MelikhovStechFormFactor:A2sigma_1 15  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 15  0.41
 newdef MelikhovStechFormFactor:T10 15  0.68
 newdef MelikhovStechFormFactor:T1sigma_1 15  0.57
 newdef MelikhovStechFormFactor:T1sigma_2 15  0
 newdef MelikhovStechFormFactor:T20 15  0.68
 newdef MelikhovStechFormFactor:T2sigma_1 15  0.64
 newdef MelikhovStechFormFactor:T2sigma_2 15  0
 newdef MelikhovStechFormFactor:T30 15  0.33
 newdef MelikhovStechFormFactor:T3sigma_1 15  1.46
 newdef MelikhovStechFormFactor:T3sigma_2 15  0.5
 newdef MelikhovStechFormFactor:MassP 15  6.4
 newdef MelikhovStechFormFactor:MassV 15  6.4
 newdef MelikhovStechFormFactor:FPlus0 16  0.36
 newdef MelikhovStechFormFactor:F+sigma_1 16  0.43
 newdef MelikhovStechFormFactor:F+sigma_2 16  0
 newdef MelikhovStechFormFactor:F00 16  0.36
 newdef MelikhovStechFormFactor:F0sigma_1 16  0.7
 newdef MelikhovStechFormFactor:F0sigma_2 16  0.27
 newdef MelikhovStechFormFactor:FT0 16  0.35
 newdef MelikhovStechFormFactor:FTsigma_1 16  0.43
 newdef MelikhovStechFormFactor:FTsigma_2 16  0
 newdef MelikhovStechFormFactor:V00 16  0
 newdef MelikhovStechFormFactor:V0sigma_1 16  0
 newdef MelikhovStechFormFactor:V0sigma_2 16  0
 newdef MelikhovStechFormFactor:A00 16  0
 newdef MelikhovStechFormFactor:A0sigma_1 16  0
 newdef MelikhovStechFormFactor:A0sigma_2 16  0
 newdef MelikhovStechFormFactor:A10 16  0
 newdef MelikhovStechFormFactor:A1sigma_1 16  0
 newdef MelikhovStechFormFactor:A1sigma_2 16  0
 newdef MelikhovStechFormFactor:A20 16  0
 newdef MelikhovStechFormFactor:A2sigma_1 16  0
 newdef MelikhovStechFormFactor:A2sigma_2 16  0
 newdef MelikhovStechFormFactor:T10 16  0
 newdef MelikhovStechFormFactor:T1sigma_1 16  0
 newdef MelikhovStechFormFactor:T1sigma_2 16  0
 newdef MelikhovStechFormFactor:T20 16  0
 newdef MelikhovStechFormFactor:T2sigma_1 16  0
 newdef MelikhovStechFormFactor:T2sigma_2 16  0
 newdef MelikhovStechFormFactor:T30 16  0
 newdef MelikhovStechFormFactor:T3sigma_1 16  0
 newdef MelikhovStechFormFactor:T3sigma_2 16  0
 newdef MelikhovStechFormFactor:MassP 16  5.37
 newdef MelikhovStechFormFactor:MassV 16  5.42
 newdef MelikhovStechFormFactor:FPlus0 17  0.36
 newdef MelikhovStechFormFactor:F+sigma_1 17  0.43
 newdef MelikhovStechFormFactor:F+sigma_2 17  0
 newdef MelikhovStechFormFactor:F00 17  0.36
 newdef MelikhovStechFormFactor:F0sigma_1 17  0.7
 newdef MelikhovStechFormFactor:F0sigma_2 17  0.27
 newdef MelikhovStechFormFactor:FT0 17  0.35
 newdef MelikhovStechFormFactor:FTsigma_1 17  0.43
 newdef MelikhovStechFormFactor:FTsigma_2 17  0
 newdef MelikhovStechFormFactor:V00 17  0
 newdef MelikhovStechFormFactor:V0sigma_1 17  0
 newdef MelikhovStechFormFactor:V0sigma_2 17  0
 newdef MelikhovStechFormFactor:A00 17  0
 newdef MelikhovStechFormFactor:A0sigma_1 17  0
 newdef MelikhovStechFormFactor:A0sigma_2 17  0
 newdef MelikhovStechFormFactor:A10 17  0
 newdef MelikhovStechFormFactor:A1sigma_1 17  0
 newdef MelikhovStechFormFactor:A1sigma_2 17  0
 newdef MelikhovStechFormFactor:A20 17  0
 newdef MelikhovStechFormFactor:A2sigma_1 17  0
 newdef MelikhovStechFormFactor:A2sigma_2 17  0
 newdef MelikhovStechFormFactor:T10 17  0
 newdef MelikhovStechFormFactor:T1sigma_1 17  0
 newdef MelikhovStechFormFactor:T1sigma_2 17  0
 newdef MelikhovStechFormFactor:T20 17  0
 newdef MelikhovStechFormFactor:T2sigma_1 17  0
 newdef MelikhovStechFormFactor:T2sigma_2 17  0
 newdef MelikhovStechFormFactor:T30 17  0
 newdef MelikhovStechFormFactor:T3sigma_1 17  0
 newdef MelikhovStechFormFactor:T3sigma_2 17  0
 newdef MelikhovStechFormFactor:MassP 17  5.37
 newdef MelikhovStechFormFactor:MassV 17  5.42
 newdef MelikhovStechFormFactor:FPlus0 18  0
 newdef MelikhovStechFormFactor:F+sigma_1 18  0
 newdef MelikhovStechFormFactor:F+sigma_2 18  0
 newdef MelikhovStechFormFactor:F00 18  0
 newdef MelikhovStechFormFactor:F0sigma_1 18  0
 newdef MelikhovStechFormFactor:F0sigma_2 18  0
 newdef MelikhovStechFormFactor:FT0 18  0
 newdef MelikhovStechFormFactor:FTsigma_1 18  0
 newdef MelikhovStechFormFactor:FTsigma_2 18  0
 newdef MelikhovStechFormFactor:V00 18  0.44
 newdef MelikhovStechFormFactor:V0sigma_1 18  0.45
 newdef MelikhovStechFormFactor:V0sigma_2 18  0
 newdef MelikhovStechFormFactor:A00 18  0.45
 newdef MelikhovStechFormFactor:A0sigma_1 18  0.46
 newdef MelikhovStechFormFactor:A0sigma_2 18  0
 newdef MelikhovStechFormFactor:A10 18  0.36
 newdef MelikhovStechFormFactor:A1sigma_1 18  0.64
 newdef MelikhovStechFormFactor:A1sigma_2 18  0.36
 newdef MelikhovStechFormFactor:A20 18  0.32
 newdef MelikhovStechFormFactor:A2sigma_1 18  1.23
 newdef MelikhovStechFormFactor:A2sigma_2 18  0.38
 newdef MelikhovStechFormFactor:T10 18  0.39
 newdef MelikhovStechFormFactor:T1sigma_1 18  0.45
 newdef MelikhovStechFormFactor:T1sigma_2 18  0
 newdef MelikhovStechFormFactor:T20 18  0.39
 newdef MelikhovStechFormFactor:T2sigma_1 18  0.72
 newdef MelikhovStechFormFactor:T2sigma_2 18  0.62
 newdef MelikhovStechFormFactor:T30 18  0.27
 newdef MelikhovStechFormFactor:T3sigma_1 18  1.31
 newdef MelikhovStechFormFactor:T3sigma_2 18  0.41
 newdef MelikhovStechFormFactor:MassP 18  5.37
 newdef MelikhovStechFormFactor:MassV 18  5.42
 newdef MelikhovStechFormFactor:FPlus0 19  0
 newdef MelikhovStechFormFactor:F+sigma_1 19  0
 newdef MelikhovStechFormFactor:F+sigma_2 19  0
 newdef MelikhovStechFormFactor:F00 19  0
 newdef MelikhovStechFormFactor:F0sigma_1 19  0
 newdef MelikhovStechFormFactor:F0sigma_2 19  0
 newdef MelikhovStechFormFactor:FT0 19  0
 newdef MelikhovStechFormFactor:FTsigma_1 19  0
 newdef MelikhovStechFormFactor:FTsigma_2 19  0
 newdef MelikhovStechFormFactor:V00 19  0.44
 newdef MelikhovStechFormFactor:V0sigma_1 19  0.45
 newdef MelikhovStechFormFactor:V0sigma_2 19  0
 newdef MelikhovStechFormFactor:A00 19  0.45
 newdef MelikhovStechFormFactor:A0sigma_1 19  0.46
 newdef MelikhovStechFormFactor:A0sigma_2 19  0
 newdef MelikhovStechFormFactor:A10 19  0.36
 newdef MelikhovStechFormFactor:A1sigma_1 19  0.64
 newdef MelikhovStechFormFactor:A1sigma_2 19  0.36
 newdef MelikhovStechFormFactor:A20 19  0.32
 newdef MelikhovStechFormFactor:A2sigma_1 19  1.23
 newdef MelikhovStechFormFactor:A2sigma_2 19  0.38
 newdef MelikhovStechFormFactor:T10 19  0.39
 newdef MelikhovStechFormFactor:T1sigma_1 19  0.45
 newdef MelikhovStechFormFactor:T1sigma_2 19  0
 newdef MelikhovStechFormFactor:T20 19  0.39
 newdef MelikhovStechFormFactor:T2sigma_1 19  0.72
 newdef MelikhovStechFormFactor:T2sigma_2 19  0.62
 newdef MelikhovStechFormFactor:T30 19  0.27
 newdef MelikhovStechFormFactor:T3sigma_1 19  1.31
 newdef MelikhovStechFormFactor:T3sigma_2 19  0.41
 newdef MelikhovStechFormFactor:MassP 19  5.37
 newdef MelikhovStechFormFactor:MassV 19  5.42
 newdef MelikhovStechFormFactor:FPlus0 20  0.29
 newdef MelikhovStechFormFactor:F+sigma_1 20  0.48
 newdef MelikhovStechFormFactor:F+sigma_2 20  0
 newdef MelikhovStechFormFactor:F00 20  0.29
 newdef MelikhovStechFormFactor:F0sigma_1 20  0.76
 newdef MelikhovStechFormFactor:F0sigma_2 20  0.28
 newdef MelikhovStechFormFactor:FT0 20  0.28
 newdef MelikhovStechFormFactor:FTsigma_1 20  0.48
 newdef MelikhovStechFormFactor:FTsigma_2 20  0
 newdef MelikhovStechFormFactor:V00 20  0
 newdef MelikhovStechFormFactor:V0sigma_1 20  0
 newdef MelikhovStechFormFactor:V0sigma_2 20  0
 newdef MelikhovStechFormFactor:A00 20  0
 newdef MelikhovStechFormFactor:A0sigma_1 20  0
 newdef MelikhovStechFormFactor:A0sigma_2 20  0
 newdef MelikhovStechFormFactor:A10 20  0
 newdef MelikhovStechFormFactor:A1sigma_1 20  0
 newdef MelikhovStechFormFactor:A1sigma_2 20  0
 newdef MelikhovStechFormFactor:A20 20  0
 newdef MelikhovStechFormFactor:A2sigma_1 20  0
 newdef MelikhovStechFormFactor:A2sigma_2 20  0
 newdef MelikhovStechFormFactor:T10 20  0
 newdef MelikhovStechFormFactor:T1sigma_1 20  0
 newdef MelikhovStechFormFactor:T1sigma_2 20  0
 newdef MelikhovStechFormFactor:T20 20  0
 newdef MelikhovStechFormFactor:T2sigma_1 20  0
 newdef MelikhovStechFormFactor:T2sigma_2 20  0
 newdef MelikhovStechFormFactor:T30 20  0
 newdef MelikhovStechFormFactor:T3sigma_1 20  0
 newdef MelikhovStechFormFactor:T3sigma_2 20  0
 newdef MelikhovStechFormFactor:MassP 20  5.27
 newdef MelikhovStechFormFactor:MassV 20  5.32
 newdef MelikhovStechFormFactor:FPlus0 21  0.29
 newdef MelikhovStechFormFactor:F+sigma_1 21  0.48
 newdef MelikhovStechFormFactor:F+sigma_2 21  0
 newdef MelikhovStechFormFactor:F00 21  0.29
 newdef MelikhovStechFormFactor:F0sigma_1 21  0.76
 newdef MelikhovStechFormFactor:F0sigma_2 21  0.28
 newdef MelikhovStechFormFactor:FT0 21  0.28
 newdef MelikhovStechFormFactor:FTsigma_1 21  0.48
 newdef MelikhovStechFormFactor:FTsigma_2 21  0
 newdef MelikhovStechFormFactor:V00 21  0
 newdef MelikhovStechFormFactor:V0sigma_1 21  0
 newdef MelikhovStechFormFactor:V0sigma_2 21  0
 newdef MelikhovStechFormFactor:A00 21  0
 newdef MelikhovStechFormFactor:A0sigma_1 21  0
 newdef MelikhovStechFormFactor:A0sigma_2 21  0
 newdef MelikhovStechFormFactor:A10 21  0
 newdef MelikhovStechFormFactor:A1sigma_1 21  0
 newdef MelikhovStechFormFactor:A1sigma_2 21  0
 newdef MelikhovStechFormFactor:A20 21  0
 newdef MelikhovStechFormFactor:A2sigma_1 21  0
 newdef MelikhovStechFormFactor:A2sigma_2 21  0
 newdef MelikhovStechFormFactor:T10 21  0
 newdef MelikhovStechFormFactor:T1sigma_1 21  0
 newdef MelikhovStechFormFactor:T1sigma_2 21  0
 newdef MelikhovStechFormFactor:T20 21  0
 newdef MelikhovStechFormFactor:T2sigma_1 21  0
 newdef MelikhovStechFormFactor:T2sigma_2 21  0
 newdef MelikhovStechFormFactor:T30 21  0
 newdef MelikhovStechFormFactor:T3sigma_1 21  0
 newdef MelikhovStechFormFactor:T3sigma_2 21  0
 newdef MelikhovStechFormFactor:MassP 21  5.27
 newdef MelikhovStechFormFactor:MassV 21  5.32
 newdef MelikhovStechFormFactor:FPlus0 22  0.29
 newdef MelikhovStechFormFactor:F+sigma_1 22  0.48
 newdef MelikhovStechFormFactor:F+sigma_2 22  0
 newdef MelikhovStechFormFactor:F00 22  0.29
 newdef MelikhovStechFormFactor:F0sigma_1 22  0.76
 newdef MelikhovStechFormFactor:F0sigma_2 22  0.28
 newdef MelikhovStechFormFactor:FT0 22  0.28
 newdef MelikhovStechFormFactor:FTsigma_1 22  0.48
 newdef MelikhovStechFormFactor:FTsigma_2 22  0
 newdef MelikhovStechFormFactor:V00 22  0
 newdef MelikhovStechFormFactor:V0sigma_1 22  0
 newdef MelikhovStechFormFactor:V0sigma_2 22  0
 newdef MelikhovStechFormFactor:A00 22  0
 newdef MelikhovStechFormFactor:A0sigma_1 22  0
 newdef MelikhovStechFormFactor:A0sigma_2 22  0
 newdef MelikhovStechFormFactor:A10 22  0
 newdef MelikhovStechFormFactor:A1sigma_1 22  0
 newdef MelikhovStechFormFactor:A1sigma_2 22  0
 newdef MelikhovStechFormFactor:A20 22  0
 newdef MelikhovStechFormFactor:A2sigma_1 22  0
 newdef MelikhovStechFormFactor:A2sigma_2 22  0
 newdef MelikhovStechFormFactor:T10 22  0
 newdef MelikhovStechFormFactor:T1sigma_1 22  0
 newdef MelikhovStechFormFactor:T1sigma_2 22  0
 newdef MelikhovStechFormFactor:T20 22  0
 newdef MelikhovStechFormFactor:T2sigma_1 22  0
 newdef MelikhovStechFormFactor:T2sigma_2 22  0
 newdef MelikhovStechFormFactor:T30 22  0
 newdef MelikhovStechFormFactor:T3sigma_1 22  0
 newdef MelikhovStechFormFactor:T3sigma_2 22  0
 newdef MelikhovStechFormFactor:MassP 22  5.27
 newdef MelikhovStechFormFactor:MassV 22  5.32
 newdef MelikhovStechFormFactor:FPlus0 23  0.29
 newdef MelikhovStechFormFactor:F+sigma_1 23  0.48
 newdef MelikhovStechFormFactor:F+sigma_2 23  0
 newdef MelikhovStechFormFactor:F00 23  0.29
 newdef MelikhovStechFormFactor:F0sigma_1 23  0.76
 newdef MelikhovStechFormFactor:F0sigma_2 23  0.28
 newdef MelikhovStechFormFactor:FT0 23  0.28
 newdef MelikhovStechFormFactor:FTsigma_1 23  0.48
 newdef MelikhovStechFormFactor:FTsigma_2 23  0
 newdef MelikhovStechFormFactor:V00 23  0
 newdef MelikhovStechFormFactor:V0sigma_1 23  0
 newdef MelikhovStechFormFactor:V0sigma_2 23  0
 newdef MelikhovStechFormFactor:A00 23  0
 newdef MelikhovStechFormFactor:A0sigma_1 23  0
 newdef MelikhovStechFormFactor:A0sigma_2 23  0
 newdef MelikhovStechFormFactor:A10 23  0
 newdef MelikhovStechFormFactor:A1sigma_1 23  0
 newdef MelikhovStechFormFactor:A1sigma_2 23  0
 newdef MelikhovStechFormFactor:A20 23  0
 newdef MelikhovStechFormFactor:A2sigma_1 23  0
 newdef MelikhovStechFormFactor:A2sigma_2 23  0
 newdef MelikhovStechFormFactor:T10 23  0
 newdef MelikhovStechFormFactor:T1sigma_1 23  0
 newdef MelikhovStechFormFactor:T1sigma_2 23  0
 newdef MelikhovStechFormFactor:T20 23  0
 newdef MelikhovStechFormFactor:T2sigma_1 23  0
 newdef MelikhovStechFormFactor:T2sigma_2 23  0
 newdef MelikhovStechFormFactor:T30 23  0
 newdef MelikhovStechFormFactor:T3sigma_1 23  0
 newdef MelikhovStechFormFactor:T3sigma_2 23  0
 newdef MelikhovStechFormFactor:MassP 23  5.27
 newdef MelikhovStechFormFactor:MassV 23  5.32
 newdef MelikhovStechFormFactor:FPlus0 24  0
 newdef MelikhovStechFormFactor:F+sigma_1 24  0
 newdef MelikhovStechFormFactor:F+sigma_2 24  0
 newdef MelikhovStechFormFactor:F00 24  0
 newdef MelikhovStechFormFactor:F0sigma_1 24  0
 newdef MelikhovStechFormFactor:F0sigma_2 24  0
 newdef MelikhovStechFormFactor:FT0 24  0
 newdef MelikhovStechFormFactor:FTsigma_1 24  0
 newdef MelikhovStechFormFactor:FTsigma_2 24  0
 newdef MelikhovStechFormFactor:V00 24  0.31
 newdef MelikhovStechFormFactor:V0sigma_1 24  0.59
 newdef MelikhovStechFormFactor:V0sigma_2 24  0
 newdef MelikhovStechFormFactor:A00 24  0.3
 newdef MelikhovStechFormFactor:A0sigma_1 24  0.54
 newdef MelikhovStechFormFactor:A0sigma_2 24  0
 newdef MelikhovStechFormFactor:A10 24  0.26
 newdef MelikhovStechFormFactor:A1sigma_1 24  0.73
 newdef MelikhovStechFormFactor:A1sigma_2 24  0.1
 newdef MelikhovStechFormFactor:A20 24  0.24
 newdef MelikhovStechFormFactor:A2sigma_1 24  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 24  0.5
 newdef MelikhovStechFormFactor:T10 24  0.27
 newdef MelikhovStechFormFactor:T1sigma_1 24  0.6
 newdef MelikhovStechFormFactor:T1sigma_2 24  0
 newdef MelikhovStechFormFactor:T20 24  0.27
 newdef MelikhovStechFormFactor:T2sigma_1 24  0.74
 newdef MelikhovStechFormFactor:T2sigma_2 24  0.19
 newdef MelikhovStechFormFactor:T30 24  0.19
 newdef MelikhovStechFormFactor:T3sigma_1 24  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 24  0.51
 newdef MelikhovStechFormFactor:MassP 24  5.27
 newdef MelikhovStechFormFactor:MassV 24  5.32
 newdef MelikhovStechFormFactor:FPlus0 25  0
 newdef MelikhovStechFormFactor:F+sigma_1 25  0
 newdef MelikhovStechFormFactor:F+sigma_2 25  0
 newdef MelikhovStechFormFactor:F00 25  0
 newdef MelikhovStechFormFactor:F0sigma_1 25  0
 newdef MelikhovStechFormFactor:F0sigma_2 25  0
 newdef MelikhovStechFormFactor:FT0 25  0
 newdef MelikhovStechFormFactor:FTsigma_1 25  0
 newdef MelikhovStechFormFactor:FTsigma_2 25  0
 newdef MelikhovStechFormFactor:V00 25  0.31
 newdef MelikhovStechFormFactor:V0sigma_1 25  0.59
 newdef MelikhovStechFormFactor:V0sigma_2 25  0
 newdef MelikhovStechFormFactor:A00 25  0.3
 newdef MelikhovStechFormFactor:A0sigma_1 25  0.54
 newdef MelikhovStechFormFactor:A0sigma_2 25  0
 newdef MelikhovStechFormFactor:A10 25  0.26
 newdef MelikhovStechFormFactor:A1sigma_1 25  0.73
 newdef MelikhovStechFormFactor:A1sigma_2 25  0.1
 newdef MelikhovStechFormFactor:A20 25  0.24
 newdef MelikhovStechFormFactor:A2sigma_1 25  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 25  0.5
 newdef MelikhovStechFormFactor:T10 25  0.27
 newdef MelikhovStechFormFactor:T1sigma_1 25  0.6
 newdef MelikhovStechFormFactor:T1sigma_2 25  0
 newdef MelikhovStechFormFactor:T20 25  0.27
 newdef MelikhovStechFormFactor:T2sigma_1 25  0.74
 newdef MelikhovStechFormFactor:T2sigma_2 25  0.19
 newdef MelikhovStechFormFactor:T30 25  0.19
 newdef MelikhovStechFormFactor:T3sigma_1 25  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 25  0.51
 newdef MelikhovStechFormFactor:MassP 25  5.27
 newdef MelikhovStechFormFactor:MassV 25  5.32
 newdef MelikhovStechFormFactor:FPlus0 26  0
 newdef MelikhovStechFormFactor:F+sigma_1 26  0
 newdef MelikhovStechFormFactor:F+sigma_2 26  0
 newdef MelikhovStechFormFactor:F00 26  0
 newdef MelikhovStechFormFactor:F0sigma_1 26  0
 newdef MelikhovStechFormFactor:F0sigma_2 26  0
 newdef MelikhovStechFormFactor:FT0 26  0
 newdef MelikhovStechFormFactor:FTsigma_1 26  0
 newdef MelikhovStechFormFactor:FTsigma_2 26  0
 newdef MelikhovStechFormFactor:V00 26  0.31
 newdef MelikhovStechFormFactor:V0sigma_1 26  0.59
 newdef MelikhovStechFormFactor:V0sigma_2 26  0
 newdef MelikhovStechFormFactor:A00 26  0.3
 newdef MelikhovStechFormFactor:A0sigma_1 26  0.54
 newdef MelikhovStechFormFactor:A0sigma_2 26  0
 newdef MelikhovStechFormFactor:A10 26  0.26
 newdef MelikhovStechFormFactor:A1sigma_1 26  0.73
 newdef MelikhovStechFormFactor:A1sigma_2 26  0.1
 newdef MelikhovStechFormFactor:A20 26  0.24
 newdef MelikhovStechFormFactor:A2sigma_1 26  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 26  0.5
 newdef MelikhovStechFormFactor:T10 26  0.27
 newdef MelikhovStechFormFactor:T1sigma_1 26  0.6
 newdef MelikhovStechFormFactor:T1sigma_2 26  0
 newdef MelikhovStechFormFactor:T20 26  0.27
 newdef MelikhovStechFormFactor:T2sigma_1 26  0.74
 newdef MelikhovStechFormFactor:T2sigma_2 26  0.19
 newdef MelikhovStechFormFactor:T30 26  0.19
 newdef MelikhovStechFormFactor:T3sigma_1 26  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 26  0.51
 newdef MelikhovStechFormFactor:MassP 26  5.27
 newdef MelikhovStechFormFactor:MassV 26  5.32
 newdef MelikhovStechFormFactor:FPlus0 27  0
 newdef MelikhovStechFormFactor:F+sigma_1 27  0
 newdef MelikhovStechFormFactor:F+sigma_2 27  0
 newdef MelikhovStechFormFactor:F00 27  0
 newdef MelikhovStechFormFactor:F0sigma_1 27  0
 newdef MelikhovStechFormFactor:F0sigma_2 27  0
 newdef MelikhovStechFormFactor:FT0 27  0
 newdef MelikhovStechFormFactor:FTsigma_1 27  0
 newdef MelikhovStechFormFactor:FTsigma_2 27  0
 newdef MelikhovStechFormFactor:V00 27  0.31
 newdef MelikhovStechFormFactor:V0sigma_1 27  0.59
 newdef MelikhovStechFormFactor:V0sigma_2 27  0
 newdef MelikhovStechFormFactor:A00 27  0.3
 newdef MelikhovStechFormFactor:A0sigma_1 27  0.54
 newdef MelikhovStechFormFactor:A0sigma_2 27  0
 newdef MelikhovStechFormFactor:A10 27  0.26
 newdef MelikhovStechFormFactor:A1sigma_1 27  0.73
 newdef MelikhovStechFormFactor:A1sigma_2 27  0.1
 newdef MelikhovStechFormFactor:A20 27  0.24
 newdef MelikhovStechFormFactor:A2sigma_1 27  1.4
 newdef MelikhovStechFormFactor:A2sigma_2 27  0.5
 newdef MelikhovStechFormFactor:T10 27  0.27
 newdef MelikhovStechFormFactor:T1sigma_1 27  0.6
 newdef MelikhovStechFormFactor:T1sigma_2 27  0
 newdef MelikhovStechFormFactor:T20 27  0.27
 newdef MelikhovStechFormFactor:T2sigma_1 27  0.74
 newdef MelikhovStechFormFactor:T2sigma_2 27  0.19
 newdef MelikhovStechFormFactor:T30 27  0.19
 newdef MelikhovStechFormFactor:T3sigma_1 27  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 27  0.51
 newdef MelikhovStechFormFactor:MassP 27  5.27
 newdef MelikhovStechFormFactor:MassV 27  5.32
 newdef MelikhovStechFormFactor:FPlus0 28  0.72
 newdef MelikhovStechFormFactor:F+sigma_1 28  0.2
 newdef MelikhovStechFormFactor:F+sigma_2 28  0
 newdef MelikhovStechFormFactor:F00 28  0.72
 newdef MelikhovStechFormFactor:F0sigma_1 28  0.41
 newdef MelikhovStechFormFactor:F0sigma_2 28  0.7
 newdef MelikhovStechFormFactor:FT0 28  0.77
 newdef MelikhovStechFormFactor:FTsigma_1 28  0.24
 newdef MelikhovStechFormFactor:FTsigma_2 28  0
 newdef MelikhovStechFormFactor:V00 28  0
 newdef MelikhovStechFormFactor:V0sigma_1 28  0
 newdef MelikhovStechFormFactor:V0sigma_2 28  0
 newdef MelikhovStechFormFactor:A00 28  0
 newdef MelikhovStechFormFactor:A0sigma_1 28  0
 newdef MelikhovStechFormFactor:A0sigma_2 28  0
 newdef MelikhovStechFormFactor:A10 28  0
 newdef MelikhovStechFormFactor:A1sigma_1 28  0
 newdef MelikhovStechFormFactor:A1sigma_2 28  0
 newdef MelikhovStechFormFactor:A20 28  0
 newdef MelikhovStechFormFactor:A2sigma_1 28  0
 newdef MelikhovStechFormFactor:A2sigma_2 28  0
 newdef MelikhovStechFormFactor:T10 28  0
 newdef MelikhovStechFormFactor:T1sigma_1 28  0
 newdef MelikhovStechFormFactor:T1sigma_2 28  0
 newdef MelikhovStechFormFactor:T20 28  0
 newdef MelikhovStechFormFactor:T2sigma_1 28  0
 newdef MelikhovStechFormFactor:T2sigma_2 28  0
 newdef MelikhovStechFormFactor:T30 28  0
 newdef MelikhovStechFormFactor:T3sigma_1 28  0
 newdef MelikhovStechFormFactor:T3sigma_2 28  0
 newdef MelikhovStechFormFactor:MassP 28  1.87
 newdef MelikhovStechFormFactor:MassV 28  2.01
 newdef MelikhovStechFormFactor:FPlus0 29  0.72
 newdef MelikhovStechFormFactor:F+sigma_1 29  0.2
 newdef MelikhovStechFormFactor:F+sigma_2 29  0
 newdef MelikhovStechFormFactor:F00 29  0.72
 newdef MelikhovStechFormFactor:F0sigma_1 29  0.41
 newdef MelikhovStechFormFactor:F0sigma_2 29  0.7
 newdef MelikhovStechFormFactor:FT0 29  0.77
 newdef MelikhovStechFormFactor:FTsigma_1 29  0.24
 newdef MelikhovStechFormFactor:FTsigma_2 29  0
 newdef MelikhovStechFormFactor:V00 29  0
 newdef MelikhovStechFormFactor:V0sigma_1 29  0
 newdef MelikhovStechFormFactor:V0sigma_2 29  0
 newdef MelikhovStechFormFactor:A00 29  0
 newdef MelikhovStechFormFactor:A0sigma_1 29  0
 newdef MelikhovStechFormFactor:A0sigma_2 29  0
 newdef MelikhovStechFormFactor:A10 29  0
 newdef MelikhovStechFormFactor:A1sigma_1 29  0
 newdef MelikhovStechFormFactor:A1sigma_2 29  0
 newdef MelikhovStechFormFactor:A20 29  0
 newdef MelikhovStechFormFactor:A2sigma_1 29  0
 newdef MelikhovStechFormFactor:A2sigma_2 29  0
 newdef MelikhovStechFormFactor:T10 29  0
 newdef MelikhovStechFormFactor:T1sigma_1 29  0
 newdef MelikhovStechFormFactor:T1sigma_2 29  0
 newdef MelikhovStechFormFactor:T20 29  0
 newdef MelikhovStechFormFactor:T2sigma_1 29  0
 newdef MelikhovStechFormFactor:T2sigma_2 29  0
 newdef MelikhovStechFormFactor:T30 29  0
 newdef MelikhovStechFormFactor:T3sigma_1 29  0
 newdef MelikhovStechFormFactor:T3sigma_2 29  0
 newdef MelikhovStechFormFactor:MassP 29  1.87
 newdef MelikhovStechFormFactor:MassV 29  2.01
 newdef MelikhovStechFormFactor:FPlus0 30  0
 newdef MelikhovStechFormFactor:F+sigma_1 30  0
 newdef MelikhovStechFormFactor:F+sigma_2 30  0
 newdef MelikhovStechFormFactor:F00 30  0
 newdef MelikhovStechFormFactor:F0sigma_1 30  0
 newdef MelikhovStechFormFactor:F0sigma_2 30  0
 newdef MelikhovStechFormFactor:FT0 30  0
 newdef MelikhovStechFormFactor:FTsigma_1 30  0
 newdef MelikhovStechFormFactor:FTsigma_2 30  0
 newdef MelikhovStechFormFactor:V00 30  1.04
 newdef MelikhovStechFormFactor:V0sigma_1 30  0.24
 newdef MelikhovStechFormFactor:V0sigma_2 30  0
 newdef MelikhovStechFormFactor:A00 30  0.67
 newdef MelikhovStechFormFactor:A0sigma_1 30  0.2
 newdef MelikhovStechFormFactor:A0sigma_2 30  0
 newdef MelikhovStechFormFactor:A10 30  0.57
 newdef MelikhovStechFormFactor:A1sigma_1 30  0.29
 newdef MelikhovStechFormFactor:A1sigma_2 30  0.42
 newdef MelikhovStechFormFactor:A20 30  0.42
 newdef MelikhovStechFormFactor:A2sigma_1 30  0.58
 newdef MelikhovStechFormFactor:A2sigma_2 30  0
 newdef MelikhovStechFormFactor:T10 30  0.71
 newdef MelikhovStechFormFactor:T1sigma_1 30  0.22
 newdef MelikhovStechFormFactor:T1sigma_2 30  0
 newdef MelikhovStechFormFactor:T20 30  0.71
 newdef MelikhovStechFormFactor:T2sigma_1 30  -0.06
 newdef MelikhovStechFormFactor:T2sigma_2 30  0.44
 newdef MelikhovStechFormFactor:T30 30  0.45
 newdef MelikhovStechFormFactor:T3sigma_1 30  1.08
 newdef MelikhovStechFormFactor:T3sigma_2 30  0.68
 newdef MelikhovStechFormFactor:MassP 30  1.87
 newdef MelikhovStechFormFactor:MassV 30  2.01
 newdef MelikhovStechFormFactor:FPlus0 31  0
 newdef MelikhovStechFormFactor:F+sigma_1 31  0
 newdef MelikhovStechFormFactor:F+sigma_2 31  0
 newdef MelikhovStechFormFactor:F00 31  0
 newdef MelikhovStechFormFactor:F0sigma_1 31  0
 newdef MelikhovStechFormFactor:F0sigma_2 31  0
 newdef MelikhovStechFormFactor:FT0 31  0
 newdef MelikhovStechFormFactor:FTsigma_1 31  0
 newdef MelikhovStechFormFactor:FTsigma_2 31  0
 newdef MelikhovStechFormFactor:V00 31  1.04
 newdef MelikhovStechFormFactor:V0sigma_1 31  0.24
 newdef MelikhovStechFormFactor:V0sigma_2 31  0
 newdef MelikhovStechFormFactor:A00 31  0.67
 newdef MelikhovStechFormFactor:A0sigma_1 31  0.2
 newdef MelikhovStechFormFactor:A0sigma_2 31  0
 newdef MelikhovStechFormFactor:A10 31  0.57
 newdef MelikhovStechFormFactor:A1sigma_1 31  0.29
 newdef MelikhovStechFormFactor:A1sigma_2 31  0.42
 newdef MelikhovStechFormFactor:A20 31  0.42
 newdef MelikhovStechFormFactor:A2sigma_1 31  0.58
 newdef MelikhovStechFormFactor:A2sigma_2 31  0
 newdef MelikhovStechFormFactor:T10 31  0.71
 newdef MelikhovStechFormFactor:T1sigma_1 31  0.22
 newdef MelikhovStechFormFactor:T1sigma_2 31  0
 newdef MelikhovStechFormFactor:T20 31  0.71
 newdef MelikhovStechFormFactor:T2sigma_1 31  -0.06
 newdef MelikhovStechFormFactor:T2sigma_2 31  0.44
 newdef MelikhovStechFormFactor:T30 31  0.45
 newdef MelikhovStechFormFactor:T3sigma_1 31  1.08
 newdef MelikhovStechFormFactor:T3sigma_2 31  0.68
 newdef MelikhovStechFormFactor:MassP 31  1.87
 newdef MelikhovStechFormFactor:MassV 31  2.01
 newdef MelikhovStechFormFactor:FPlus0 32  0.78
 newdef MelikhovStechFormFactor:F+sigma_1 32  0.23
 newdef MelikhovStechFormFactor:F+sigma_2 32  0
 newdef MelikhovStechFormFactor:F00 32  0.78
 newdef MelikhovStechFormFactor:F0sigma_1 32  0.33
 newdef MelikhovStechFormFactor:F0sigma_2 32  0.38
 newdef MelikhovStechFormFactor:FT0 32  0.8
 newdef MelikhovStechFormFactor:FTsigma_1 32  0.24
 newdef MelikhovStechFormFactor:FTsigma_2 32  0
 newdef MelikhovStechFormFactor:V00 32  0
 newdef MelikhovStechFormFactor:V0sigma_1 32  0
 newdef MelikhovStechFormFactor:V0sigma_2 32  0
 newdef MelikhovStechFormFactor:A00 32  0
 newdef MelikhovStechFormFactor:A0sigma_1 32  0
 newdef MelikhovStechFormFactor:A0sigma_2 32  0
 newdef MelikhovStechFormFactor:A10 32  0
 newdef MelikhovStechFormFactor:A1sigma_1 32  0
 newdef MelikhovStechFormFactor:A1sigma_2 32  0
 newdef MelikhovStechFormFactor:A20 32  0
 newdef MelikhovStechFormFactor:A2sigma_1 32  0
 newdef MelikhovStechFormFactor:A2sigma_2 32  0
 newdef MelikhovStechFormFactor:T10 32  0
 newdef MelikhovStechFormFactor:T1sigma_1 32  0
 newdef MelikhovStechFormFactor:T1sigma_2 32  0
 newdef MelikhovStechFormFactor:T20 32  0
 newdef MelikhovStechFormFactor:T2sigma_1 32  0
 newdef MelikhovStechFormFactor:T2sigma_2 32  0
 newdef MelikhovStechFormFactor:T30 32  0
 newdef MelikhovStechFormFactor:T3sigma_1 32  0
 newdef MelikhovStechFormFactor:T3sigma_2 32  0
 newdef MelikhovStechFormFactor:MassP 32  1.97
 newdef MelikhovStechFormFactor:MassV 32  2.11
 newdef MelikhovStechFormFactor:FPlus0 33  0.78
 newdef MelikhovStechFormFactor:F+sigma_1 33  0.23
 newdef MelikhovStechFormFactor:F+sigma_2 33  0
 newdef MelikhovStechFormFactor:F00 33  0.78
 newdef MelikhovStechFormFactor:F0sigma_1 33  0.21
 newdef MelikhovStechFormFactor:F0sigma_2 33  0.76
 newdef MelikhovStechFormFactor:FT0 33  0.94
 newdef MelikhovStechFormFactor:FTsigma_1 33  0.24
 newdef MelikhovStechFormFactor:FTsigma_2 33  0
 newdef MelikhovStechFormFactor:V00 33  0
 newdef MelikhovStechFormFactor:V0sigma_1 33  0
 newdef MelikhovStechFormFactor:V0sigma_2 33  0
 newdef MelikhovStechFormFactor:A00 33  0
 newdef MelikhovStechFormFactor:A0sigma_1 33  0
 newdef MelikhovStechFormFactor:A0sigma_2 33  0
 newdef MelikhovStechFormFactor:A10 33  0
 newdef MelikhovStechFormFactor:A1sigma_1 33  0
 newdef MelikhovStechFormFactor:A1sigma_2 33  0
 newdef MelikhovStechFormFactor:A20 33  0
 newdef MelikhovStechFormFactor:A2sigma_1 33  0
 newdef MelikhovStechFormFactor:A2sigma_2 33  0
 newdef MelikhovStechFormFactor:T10 33  0
 newdef MelikhovStechFormFactor:T1sigma_1 33  0
 newdef MelikhovStechFormFactor:T1sigma_2 33  0
 newdef MelikhovStechFormFactor:T20 33  0
 newdef MelikhovStechFormFactor:T2sigma_1 33  0
 newdef MelikhovStechFormFactor:T2sigma_2 33  0
 newdef MelikhovStechFormFactor:T30 33  0
 newdef MelikhovStechFormFactor:T3sigma_1 33  0
 newdef MelikhovStechFormFactor:T3sigma_2 33  0
 newdef MelikhovStechFormFactor:MassP 33  1.97
 newdef MelikhovStechFormFactor:MassV 33  2.11
 newdef MelikhovStechFormFactor:FPlus0 34  0
 newdef MelikhovStechFormFactor:F+sigma_1 34  0
 newdef MelikhovStechFormFactor:F+sigma_2 34  0
 newdef MelikhovStechFormFactor:F00 34  0
 newdef MelikhovStechFormFactor:F0sigma_1 34  0
 newdef MelikhovStechFormFactor:F0sigma_2 34  0
 newdef MelikhovStechFormFactor:FT0 34  0
 newdef MelikhovStechFormFactor:FTsigma_1 34  0
 newdef MelikhovStechFormFactor:FTsigma_2 34  0
 newdef MelikhovStechFormFactor:V00 34  1.1
 newdef MelikhovStechFormFactor:V0sigma_1 34  0.26
 newdef MelikhovStechFormFactor:V0sigma_2 34  0
 newdef MelikhovStechFormFactor:A00 34  0.73
 newdef MelikhovStechFormFactor:A0sigma_1 34  0.1
 newdef MelikhovStechFormFactor:A0sigma_2 34  0
 newdef MelikhovStechFormFactor:A10 34  0.64
 newdef MelikhovStechFormFactor:A1sigma_1 34  0.29
 newdef MelikhovStechFormFactor:A1sigma_2 34  0
 newdef MelikhovStechFormFactor:A20 34  0.47
 newdef MelikhovStechFormFactor:A2sigma_1 34  0.63
 newdef MelikhovStechFormFactor:A2sigma_2 34  0
 newdef MelikhovStechFormFactor:T10 34  0.77
 newdef MelikhovStechFormFactor:T1sigma_1 34  0.25
 newdef MelikhovStechFormFactor:T1sigma_2 34  0
 newdef MelikhovStechFormFactor:T20 34  0.77
 newdef MelikhovStechFormFactor:T2sigma_1 34  0.02
 newdef MelikhovStechFormFactor:T2sigma_2 34  2.01
 newdef MelikhovStechFormFactor:T30 34  0.46
 newdef MelikhovStechFormFactor:T3sigma_1 34  1.34
 newdef MelikhovStechFormFactor:T3sigma_2 34  0.45
 newdef MelikhovStechFormFactor:MassP 34  1.97
 newdef MelikhovStechFormFactor:MassV 34  2.11
 newdef MelikhovStechFormFactor:FPlus0 35  0.31
 newdef MelikhovStechFormFactor:F+sigma_1 35  0.63
 newdef MelikhovStechFormFactor:F+sigma_2 35  0.33
 newdef MelikhovStechFormFactor:F00 35  0.31
 newdef MelikhovStechFormFactor:F0sigma_1 35  0.93
 newdef MelikhovStechFormFactor:F0sigma_2 35  0.7
 newdef MelikhovStechFormFactor:FT0 35  0.31
 newdef MelikhovStechFormFactor:FTsigma_1 35  0.61
 newdef MelikhovStechFormFactor:FTsigma_2 35  0.3
 newdef MelikhovStechFormFactor:V00 35  0
 newdef MelikhovStechFormFactor:V0sigma_1 35  0
 newdef MelikhovStechFormFactor:V0sigma_2 35  0
 newdef MelikhovStechFormFactor:A00 35  0
 newdef MelikhovStechFormFactor:A0sigma_1 35  0
 newdef MelikhovStechFormFactor:A0sigma_2 35  0
 newdef MelikhovStechFormFactor:A10 35  0
 newdef MelikhovStechFormFactor:A1sigma_1 35  0
 newdef MelikhovStechFormFactor:A1sigma_2 35  0
 newdef MelikhovStechFormFactor:A20 35  0
 newdef MelikhovStechFormFactor:A2sigma_1 35  0
 newdef MelikhovStechFormFactor:A2sigma_2 35  0
 newdef MelikhovStechFormFactor:T10 35  0
 newdef MelikhovStechFormFactor:T1sigma_1 35  0
 newdef MelikhovStechFormFactor:T1sigma_2 35  0
 newdef MelikhovStechFormFactor:T20 35  0
 newdef MelikhovStechFormFactor:T2sigma_1 35  0
 newdef MelikhovStechFormFactor:T2sigma_2 35  0
 newdef MelikhovStechFormFactor:T30 35  0
 newdef MelikhovStechFormFactor:T3sigma_1 35  0
 newdef MelikhovStechFormFactor:T3sigma_2 35  0
 newdef MelikhovStechFormFactor:MassP 35  5.27
 newdef MelikhovStechFormFactor:MassV 35  5.32
 newdef MelikhovStechFormFactor:FPlus0 36  0.31
 newdef MelikhovStechFormFactor:F+sigma_1 36  0.63
 newdef MelikhovStechFormFactor:F+sigma_2 36  0.33
 newdef MelikhovStechFormFactor:F00 36  0.31
 newdef MelikhovStechFormFactor:F0sigma_1 36  0.93
 newdef MelikhovStechFormFactor:F0sigma_2 36  0.7
 newdef MelikhovStechFormFactor:FT0 36  0.31
 newdef MelikhovStechFormFactor:FTsigma_1 36  0.61
 newdef MelikhovStechFormFactor:FTsigma_2 36  0.3
 newdef MelikhovStechFormFactor:V00 36  0
 newdef MelikhovStechFormFactor:V0sigma_1 36  0
 newdef MelikhovStechFormFactor:V0sigma_2 36  0
 newdef MelikhovStechFormFactor:A00 36  0
 newdef MelikhovStechFormFactor:A0sigma_1 36  0
 newdef MelikhovStechFormFactor:A0sigma_2 36  0
 newdef MelikhovStechFormFactor:A10 36  0
 newdef MelikhovStechFormFactor:A1sigma_1 36  0
 newdef MelikhovStechFormFactor:A1sigma_2 36  0
 newdef MelikhovStechFormFactor:A20 36  0
 newdef MelikhovStechFormFactor:A2sigma_1 36  0
 newdef MelikhovStechFormFactor:A2sigma_2 36  0
 newdef MelikhovStechFormFactor:T10 36  0
 newdef MelikhovStechFormFactor:T1sigma_1 36  0
 newdef MelikhovStechFormFactor:T1sigma_2 36  0
 newdef MelikhovStechFormFactor:T20 36  0
 newdef MelikhovStechFormFactor:T2sigma_1 36  0
 newdef MelikhovStechFormFactor:T2sigma_2 36  0
 newdef MelikhovStechFormFactor:T30 36  0
 newdef MelikhovStechFormFactor:T3sigma_1 36  0
 newdef MelikhovStechFormFactor:T3sigma_2 36  0
 newdef MelikhovStechFormFactor:MassP 36  5.27
 newdef MelikhovStechFormFactor:MassV 36  5.32
 newdef MelikhovStechFormFactor:FPlus0 37  0
 newdef MelikhovStechFormFactor:F+sigma_1 37  0
 newdef MelikhovStechFormFactor:F+sigma_2 37  0
 newdef MelikhovStechFormFactor:F00 37  0
 newdef MelikhovStechFormFactor:F0sigma_1 37  0
 newdef MelikhovStechFormFactor:F0sigma_2 37  0
 newdef MelikhovStechFormFactor:FT0 37  0
 newdef MelikhovStechFormFactor:FTsigma_1 37  0
 newdef MelikhovStechFormFactor:FTsigma_2 37  0
 newdef MelikhovStechFormFactor:V00 37  0.38
 newdef MelikhovStechFormFactor:V0sigma_1 37  0.66
 newdef MelikhovStechFormFactor:V0sigma_2 37  0.3
 newdef MelikhovStechFormFactor:A00 37  0.37
 newdef MelikhovStechFormFactor:A0sigma_1 37  0.6
 newdef MelikhovStechFormFactor:A0sigma_2 37  0.16
 newdef MelikhovStechFormFactor:A10 37  0.29
 newdef MelikhovStechFormFactor:A1sigma_1 37  0.86
 newdef MelikhovStechFormFactor:A1sigma_2 37  0.6
 newdef MelikhovStechFormFactor:A20 37  0.26
 newdef MelikhovStechFormFactor:A2sigma_1 37  1.32
 newdef MelikhovStechFormFactor:A2sigma_2 37  0.54
 newdef MelikhovStechFormFactor:T10 37  0.32
 newdef MelikhovStechFormFactor:T1sigma_1 37  0.66
 newdef MelikhovStechFormFactor:T1sigma_2 37  0.31
 newdef MelikhovStechFormFactor:T20 37  0.32
 newdef MelikhovStechFormFactor:T2sigma_1 37  0.98
 newdef MelikhovStechFormFactor:T2sigma_2 37  0.9
 newdef MelikhovStechFormFactor:T30 37  0.23
 newdef MelikhovStechFormFactor:T3sigma_1 37  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 37  0.62
 newdef MelikhovStechFormFactor:MassP 37  5.27
 newdef MelikhovStechFormFactor:MassV 37  5.32
 newdef MelikhovStechFormFactor:FPlus0 38  0
 newdef MelikhovStechFormFactor:F+sigma_1 38  0
 newdef MelikhovStechFormFactor:F+sigma_2 38  0
 newdef MelikhovStechFormFactor:F00 38  0
 newdef MelikhovStechFormFactor:F0sigma_1 38  0
 newdef MelikhovStechFormFactor:F0sigma_2 38  0
 newdef MelikhovStechFormFactor:FT0 38  0
 newdef MelikhovStechFormFactor:FTsigma_1 38  0
 newdef MelikhovStechFormFactor:FTsigma_2 38  0
 newdef MelikhovStechFormFactor:V00 38  0.38
 newdef MelikhovStechFormFactor:V0sigma_1 38  0.66
 newdef MelikhovStechFormFactor:V0sigma_2 38  0.3
 newdef MelikhovStechFormFactor:A00 38  0.37
 newdef MelikhovStechFormFactor:A0sigma_1 38  0.6
 newdef MelikhovStechFormFactor:A0sigma_2 38  0.16
 newdef MelikhovStechFormFactor:A10 38  0.29
 newdef MelikhovStechFormFactor:A1sigma_1 38  0.86
 newdef MelikhovStechFormFactor:A1sigma_2 38  0.6
 newdef MelikhovStechFormFactor:A20 38  0.26
 newdef MelikhovStechFormFactor:A2sigma_1 38  1.32
 newdef MelikhovStechFormFactor:A2sigma_2 38  0.54
 newdef MelikhovStechFormFactor:T10 38  0.32
 newdef MelikhovStechFormFactor:T1sigma_1 38  0.66
 newdef MelikhovStechFormFactor:T1sigma_2 38  0.31
 newdef MelikhovStechFormFactor:T20 38  0.32
 newdef MelikhovStechFormFactor:T2sigma_1 38  0.98
 newdef MelikhovStechFormFactor:T2sigma_2 38  0.9
 newdef MelikhovStechFormFactor:T30 38  0.23
 newdef MelikhovStechFormFactor:T3sigma_1 38  1.42
 newdef MelikhovStechFormFactor:T3sigma_2 38  0.62
 newdef MelikhovStechFormFactor:MassP 38  5.27
 newdef MelikhovStechFormFactor:MassV 38  5.32
 newdef MelikhovStechFormFactor:FPlus0 39  0.36
 newdef MelikhovStechFormFactor:F+sigma_1 39  0.6
 newdef MelikhovStechFormFactor:F+sigma_2 39  0.2
 newdef MelikhovStechFormFactor:F00 39  0.36
 newdef MelikhovStechFormFactor:F0sigma_1 39  0.8
 newdef MelikhovStechFormFactor:F0sigma_2 39  0.4
 newdef MelikhovStechFormFactor:FT0 39  0.36
 newdef MelikhovStechFormFactor:FTsigma_1 39  0.58
 newdef MelikhovStechFormFactor:FTsigma_2 39  0.18
 newdef MelikhovStechFormFactor:V00 39  0
 newdef MelikhovStechFormFactor:V0sigma_1 39  0
 newdef MelikhovStechFormFactor:V0sigma_2 39  0
 newdef MelikhovStechFormFactor:A00 39  0
 newdef MelikhovStechFormFactor:A0sigma_1 39  0
 newdef MelikhovStechFormFactor:A0sigma_2 39  0
 newdef MelikhovStechFormFactor:A10 39  0
 newdef MelikhovStechFormFactor:A1sigma_1 39  0
 newdef MelikhovStechFormFactor:A1sigma_2 39  0
 newdef MelikhovStechFormFactor:A20 39  0
 newdef MelikhovStechFormFactor:A2sigma_1 39  0
 newdef MelikhovStechFormFactor:A2sigma_2 39  0
 newdef MelikhovStechFormFactor:T10 39  0
 newdef MelikhovStechFormFactor:T1sigma_1 39  0
 newdef MelikhovStechFormFactor:T1sigma_2 39  0
 newdef MelikhovStechFormFactor:T20 39  0
 newdef MelikhovStechFormFactor:T2sigma_1 39  0
 newdef MelikhovStechFormFactor:T2sigma_2 39  0
 newdef MelikhovStechFormFactor:T30 39  0
 newdef MelikhovStechFormFactor:T3sigma_1 39  0
 newdef MelikhovStechFormFactor:T3sigma_2 39  0
 newdef MelikhovStechFormFactor:MassP 39  5.37
 newdef MelikhovStechFormFactor:MassV 39  5.42
 newdef MelikhovStechFormFactor:FPlus0 40  0.36
 newdef MelikhovStechFormFactor:F+sigma_1 40  0.6
 newdef MelikhovStechFormFactor:F+sigma_2 40  0.2
 newdef MelikhovStechFormFactor:F00 40  0.36
 newdef MelikhovStechFormFactor:F0sigma_1 40  0.8
 newdef MelikhovStechFormFactor:F0sigma_2 40  0.45
 newdef MelikhovStechFormFactor:FT0 40  0.39
 newdef MelikhovStechFormFactor:FTsigma_1 40  0.58
 newdef MelikhovStechFormFactor:FTsigma_2 40  0.18
 newdef MelikhovStechFormFactor:V00 40  0
 newdef MelikhovStechFormFactor:V0sigma_1 40  0
 newdef MelikhovStechFormFactor:V0sigma_2 40  0
 newdef MelikhovStechFormFactor:A00 40  0
 newdef MelikhovStechFormFactor:A0sigma_1 40  0
 newdef MelikhovStechFormFactor:A0sigma_2 40  0
 newdef MelikhovStechFormFactor:A10 40  0
 newdef MelikhovStechFormFactor:A1sigma_1 40  0
 newdef MelikhovStechFormFactor:A1sigma_2 40  0
 newdef MelikhovStechFormFactor:A20 40  0
 newdef MelikhovStechFormFactor:A2sigma_1 40  0
 newdef MelikhovStechFormFactor:A2sigma_2 40  0
 newdef MelikhovStechFormFactor:T10 40  0
 newdef MelikhovStechFormFactor:T1sigma_1 40  0
 newdef MelikhovStechFormFactor:T1sigma_2 40  0
 newdef MelikhovStechFormFactor:T20 40  0
 newdef MelikhovStechFormFactor:T2sigma_1 40  0
 newdef MelikhovStechFormFactor:T2sigma_2 40  0
 newdef MelikhovStechFormFactor:T30 40  0
 newdef MelikhovStechFormFactor:T3sigma_1 40  0
 newdef MelikhovStechFormFactor:T3sigma_2 40  0
 newdef MelikhovStechFormFactor:MassP 40  5.37
 newdef MelikhovStechFormFactor:MassV 40  5.42
 newdef MelikhovStechFormFactor:FPlus0 41  0
 newdef MelikhovStechFormFactor:F+sigma_1 41  0
 newdef MelikhovStechFormFactor:F+sigma_2 41  0
 newdef MelikhovStechFormFactor:F00 41  0
 newdef MelikhovStechFormFactor:F0sigma_1 41  0
 newdef MelikhovStechFormFactor:F0sigma_2 41  0
 newdef MelikhovStechFormFactor:FT0 41  0
 newdef MelikhovStechFormFactor:FTsigma_1 41  0
 newdef MelikhovStechFormFactor:FTsigma_2 41  0
 newdef MelikhovStechFormFactor:V00 41  0.44
 newdef MelikhovStechFormFactor:V0sigma_1 41  0.62
 newdef MelikhovStechFormFactor:V0sigma_2 41  0.2
 newdef MelikhovStechFormFactor:A00 41  0.42
 newdef MelikhovStechFormFactor:A0sigma_1 41  0.55
 newdef MelikhovStechFormFactor:A0sigma_2 41  0.12
 newdef MelikhovStechFormFactor:A10 41  0.34
 newdef MelikhovStechFormFactor:A1sigma_1 41  0.73
 newdef MelikhovStechFormFactor:A1sigma_2 41  0.42
 newdef MelikhovStechFormFactor:A20 41  0.31
 newdef MelikhovStechFormFactor:A2sigma_1 41  1.3
 newdef MelikhovStechFormFactor:A2sigma_2 41  0.52
 newdef MelikhovStechFormFactor:T10 41  0.38
 newdef MelikhovStechFormFactor:T1sigma_1 41  0.62
 newdef MelikhovStechFormFactor:T1sigma_2 41  0.2
 newdef MelikhovStechFormFactor:T20 41  0.38
 newdef MelikhovStechFormFactor:T2sigma_1 41  0.83
 newdef MelikhovStechFormFactor:T2sigma_2 41  0.71
 newdef MelikhovStechFormFactor:T30 41  0.26
 newdef MelikhovStechFormFactor:T3sigma_1 41  1.41
 newdef MelikhovStechFormFactor:T3sigma_2 41  0.57
 newdef MelikhovStechFormFactor:MassP 41  5.37
 newdef MelikhovStechFormFactor:MassV 41  5.42
 newdef MelikhovStechFormFactor:Incoming 0 421
 newdef MelikhovStechFormFactor:Outgoing 0 -321
 newdef MelikhovStechFormFactor:Spin 0 0
 newdef MelikhovStechFormFactor:Spectator 0 -2
 newdef MelikhovStechFormFactor:InQuark 0 4
 newdef MelikhovStechFormFactor:OutQuark 0 3
 newdef MelikhovStechFormFactor:Incoming 1 411
 newdef MelikhovStechFormFactor:Outgoing 1 -311
 newdef MelikhovStechFormFactor:Spin 1 0
 newdef MelikhovStechFormFactor:Spectator 1 -1
 newdef MelikhovStechFormFactor:InQuark 1 4
 newdef MelikhovStechFormFactor:OutQuark 1 3
 newdef MelikhovStechFormFactor:Incoming 2 421
 newdef MelikhovStechFormFactor:Outgoing 2 -323
 newdef MelikhovStechFormFactor:Spin 2 1
 newdef MelikhovStechFormFactor:Spectator 2 -2
 newdef MelikhovStechFormFactor:InQuark 2 4
 newdef MelikhovStechFormFactor:OutQuark 2 3
 newdef MelikhovStechFormFactor:Incoming 3 411
 newdef MelikhovStechFormFactor:Outgoing 3 -313
 newdef MelikhovStechFormFactor:Spin 3 1
 newdef MelikhovStechFormFactor:Spectator 3 -1
 newdef MelikhovStechFormFactor:InQuark 3 4
 newdef MelikhovStechFormFactor:OutQuark 3 3
 newdef MelikhovStechFormFactor:Incoming 4 421
 newdef MelikhovStechFormFactor:Outgoing 4 -211
 newdef MelikhovStechFormFactor:Spin 4 0
 newdef MelikhovStechFormFactor:Spectator 4 -2
 newdef MelikhovStechFormFactor:InQuark 4 4
 newdef MelikhovStechFormFactor:OutQuark 4 1
 newdef MelikhovStechFormFactor:Incoming 5 421
 newdef MelikhovStechFormFactor:Outgoing 5 111
 newdef MelikhovStechFormFactor:Spin 5 0
 newdef MelikhovStechFormFactor:Spectator 5 -2
 newdef MelikhovStechFormFactor:InQuark 5 4
 newdef MelikhovStechFormFactor:OutQuark 5 2
 newdef MelikhovStechFormFactor:Incoming 6 411
 newdef MelikhovStechFormFactor:Outgoing 6 111
 newdef MelikhovStechFormFactor:Spin 6 0
 newdef MelikhovStechFormFactor:Spectator 6 -1
 newdef MelikhovStechFormFactor:InQuark 6 4
 newdef MelikhovStechFormFactor:OutQuark 6 1
 newdef MelikhovStechFormFactor:Incoming 7 411
 newdef MelikhovStechFormFactor:Outgoing 7 211
 newdef MelikhovStechFormFactor:Spin 7 0
 newdef MelikhovStechFormFactor:Spectator 7 -1
 newdef MelikhovStechFormFactor:InQuark 7 4
 newdef MelikhovStechFormFactor:OutQuark 7 2
 newdef MelikhovStechFormFactor:Incoming 8 421
 newdef MelikhovStechFormFactor:Outgoing 8 -213
 newdef MelikhovStechFormFactor:Spin 8 1
 newdef MelikhovStechFormFactor:Spectator 8 -2
 newdef MelikhovStechFormFactor:InQuark 8 4
 newdef MelikhovStechFormFactor:OutQuark 8 1
 newdef MelikhovStechFormFactor:Incoming 9 421
 newdef MelikhovStechFormFactor:Outgoing 9 113
 newdef MelikhovStechFormFactor:Spin 9 1
 newdef MelikhovStechFormFactor:Spectator 9 -2
 newdef MelikhovStechFormFactor:InQuark 9 4
 newdef MelikhovStechFormFactor:OutQuark 9 2
 newdef MelikhovStechFormFactor:Incoming 10 411
 newdef MelikhovStechFormFactor:Outgoing 10 113
 newdef MelikhovStechFormFactor:Spin 10 1
 newdef MelikhovStechFormFactor:Spectator 10 -1
 newdef MelikhovStechFormFactor:InQuark 10 4
 newdef MelikhovStechFormFactor:OutQuark 10 1
 newdef MelikhovStechFormFactor:Incoming 11 411
 newdef MelikhovStechFormFactor:Outgoing 11 213
 newdef MelikhovStechFormFactor:Spin 11 1
 newdef MelikhovStechFormFactor:Spectator 11 -1
 newdef MelikhovStechFormFactor:InQuark 11 4
 newdef MelikhovStechFormFactor:OutQuark 11 2
 newdef MelikhovStechFormFactor:Incoming 12 -521
 newdef MelikhovStechFormFactor:Outgoing 12 421
 newdef MelikhovStechFormFactor:Spin 12 0
 newdef MelikhovStechFormFactor:Spectator 12 -2
 newdef MelikhovStechFormFactor:InQuark 12 5
 newdef MelikhovStechFormFactor:OutQuark 12 4
 newdef MelikhovStechFormFactor:Incoming 13 -511
 newdef MelikhovStechFormFactor:Outgoing 13 411
 newdef MelikhovStechFormFactor:Spin 13 0
 newdef MelikhovStechFormFactor:Spectator 13 -2
 newdef MelikhovStechFormFactor:InQuark 13 5
 newdef MelikhovStechFormFactor:OutQuark 13 4
 newdef MelikhovStechFormFactor:Incoming 14 -521
 newdef MelikhovStechFormFactor:Outgoing 14 423
 newdef MelikhovStechFormFactor:Spin 14 1
 newdef MelikhovStechFormFactor:Spectator 14 -2
 newdef MelikhovStechFormFactor:InQuark 14 5
 newdef MelikhovStechFormFactor:OutQuark 14 4
 newdef MelikhovStechFormFactor:Incoming 15 -511
 newdef MelikhovStechFormFactor:Outgoing 15 413
 newdef MelikhovStechFormFactor:Spin 15 1
 newdef MelikhovStechFormFactor:Spectator 15 -1
 newdef MelikhovStechFormFactor:InQuark 15 5
 newdef MelikhovStechFormFactor:OutQuark 15 4
 newdef MelikhovStechFormFactor:Incoming 16 -521
 newdef MelikhovStechFormFactor:Outgoing 16 -321
 newdef MelikhovStechFormFactor:Spin 16 0
 newdef MelikhovStechFormFactor:Spectator 16 -2
 newdef MelikhovStechFormFactor:InQuark 16 5
 newdef MelikhovStechFormFactor:OutQuark 16 3
 newdef MelikhovStechFormFactor:Incoming 17 -511
 newdef MelikhovStechFormFactor:Outgoing 17 -311
 newdef MelikhovStechFormFactor:Spin 17 0
 newdef MelikhovStechFormFactor:Spectator 17 -1
 newdef MelikhovStechFormFactor:InQuark 17 5
 newdef MelikhovStechFormFactor:OutQuark 17 3
 newdef MelikhovStechFormFactor:Incoming 18 -521
 newdef MelikhovStechFormFactor:Outgoing 18 -323
 newdef MelikhovStechFormFactor:Spin 18 1
 newdef MelikhovStechFormFactor:Spectator 18 -2
 newdef MelikhovStechFormFactor:InQuark 18 5
 newdef MelikhovStechFormFactor:OutQuark 18 3
 newdef MelikhovStechFormFactor:Incoming 19 -511
 newdef MelikhovStechFormFactor:Outgoing 19 -313
 newdef MelikhovStechFormFactor:Spin 19 1
 newdef MelikhovStechFormFactor:Spectator 19 -1
 newdef MelikhovStechFormFactor:InQuark 19 5
 newdef MelikhovStechFormFactor:OutQuark 19 3
 newdef MelikhovStechFormFactor:Incoming 20 -521
 newdef MelikhovStechFormFactor:Outgoing 20 111
 newdef MelikhovStechFormFactor:Spin 20 0
 newdef MelikhovStechFormFactor:Spectator 20 -2
 newdef MelikhovStechFormFactor:InQuark 20 5
 newdef MelikhovStechFormFactor:OutQuark 20 2
 newdef MelikhovStechFormFactor:Incoming 21 -511
 newdef MelikhovStechFormFactor:Outgoing 21 211
 newdef MelikhovStechFormFactor:Spin 21 0
 newdef MelikhovStechFormFactor:Spectator 21 -1
 newdef MelikhovStechFormFactor:InQuark 21 5
 newdef MelikhovStechFormFactor:OutQuark 21 2
 newdef MelikhovStechFormFactor:Incoming 22 -521
 newdef MelikhovStechFormFactor:Outgoing 22 -211
 newdef MelikhovStechFormFactor:Spin 22 0
 newdef MelikhovStechFormFactor:Spectator 22 -2
 newdef MelikhovStechFormFactor:InQuark 22 5
 newdef MelikhovStechFormFactor:OutQuark 22 1
 newdef MelikhovStechFormFactor:Incoming 23 -511
 newdef MelikhovStechFormFactor:Outgoing 23 111
 newdef MelikhovStechFormFactor:Spin 23 0
 newdef MelikhovStechFormFactor:Spectator 23 -1
 newdef MelikhovStechFormFactor:InQuark 23 5
 newdef MelikhovStechFormFactor:OutQuark 23 1
 newdef MelikhovStechFormFactor:Incoming 24 -521
 newdef MelikhovStechFormFactor:Outgoing 24 113
 newdef MelikhovStechFormFactor:Spin 24 1
 newdef MelikhovStechFormFactor:Spectator 24 -2
 newdef MelikhovStechFormFactor:InQuark 24 5
 newdef MelikhovStechFormFactor:OutQuark 24 2
 newdef MelikhovStechFormFactor:Incoming 25 -511
 newdef MelikhovStechFormFactor:Outgoing 25 213
 newdef MelikhovStechFormFactor:Spin 25 1
 newdef MelikhovStechFormFactor:Spectator 25 -1
 newdef MelikhovStechFormFactor:InQuark 25 5
 newdef MelikhovStechFormFactor:OutQuark 25 2
 newdef MelikhovStechFormFactor:Incoming 26 -521
 newdef MelikhovStechFormFactor:Outgoing 26 -213
 newdef MelikhovStechFormFactor:Spin 26 1
 newdef MelikhovStechFormFactor:Spectator 26 -2
 newdef MelikhovStechFormFactor:InQuark 26 5
 newdef MelikhovStechFormFactor:OutQuark 26 1
 newdef MelikhovStechFormFactor:Incoming 27 -511
 newdef MelikhovStechFormFactor:Outgoing 27 113
 newdef MelikhovStechFormFactor:Spin 27 1
 newdef MelikhovStechFormFactor:Spectator 27 -1
 newdef MelikhovStechFormFactor:InQuark 27 5
 newdef MelikhovStechFormFactor:OutQuark 27 1
 newdef MelikhovStechFormFactor:Incoming 28 431
 newdef MelikhovStechFormFactor:Outgoing 28 311
 newdef MelikhovStechFormFactor:Spin 28 0
 newdef MelikhovStechFormFactor:Spectator 28 -3
 newdef MelikhovStechFormFactor:InQuark 28 4
 newdef MelikhovStechFormFactor:OutQuark 28 1
 newdef MelikhovStechFormFactor:Incoming 29 431
 newdef MelikhovStechFormFactor:Outgoing 29 321
 newdef MelikhovStechFormFactor:Spin 29 0
 newdef MelikhovStechFormFactor:Spectator 29 -3
 newdef MelikhovStechFormFactor:InQuark 29 4
 newdef MelikhovStechFormFactor:OutQuark 29 2
 newdef MelikhovStechFormFactor:Incoming 30 431
 newdef MelikhovStechFormFactor:Outgoing 30 313
 newdef MelikhovStechFormFactor:Spin 30 1
 newdef MelikhovStechFormFactor:Spectator 30 -3
 newdef MelikhovStechFormFactor:InQuark 30 4
 newdef MelikhovStechFormFactor:OutQuark 30 1
 newdef MelikhovStechFormFactor:Incoming 31 431
 newdef MelikhovStechFormFactor:Outgoing 31 323
 newdef MelikhovStechFormFactor:Spin 31 1
 newdef MelikhovStechFormFactor:Spectator 31 -3
 newdef MelikhovStechFormFactor:InQuark 31 4
 newdef MelikhovStechFormFactor:OutQuark 31 2
 newdef MelikhovStechFormFactor:Incoming 32 431
 newdef MelikhovStechFormFactor:Outgoing 32 221
 newdef MelikhovStechFormFactor:Spin 32 0
 newdef MelikhovStechFormFactor:Spectator 32 -3
 newdef MelikhovStechFormFactor:InQuark 32 4
 newdef MelikhovStechFormFactor:OutQuark 32 3
 newdef MelikhovStechFormFactor:Incoming 33 431
 newdef MelikhovStechFormFactor:Outgoing 33 331
 newdef MelikhovStechFormFactor:Spin 33 0
 newdef MelikhovStechFormFactor:Spectator 33 -3
 newdef MelikhovStechFormFactor:InQuark 33 4
 newdef MelikhovStechFormFactor:OutQuark 33 3
 newdef MelikhovStechFormFactor:Incoming 34 431
 newdef MelikhovStechFormFactor:Outgoing 34 333
 newdef MelikhovStechFormFactor:Spin 34 1
 newdef MelikhovStechFormFactor:Spectator 34 -3
 newdef MelikhovStechFormFactor:InQuark 34 4
 newdef MelikhovStechFormFactor:OutQuark 34 3
 newdef MelikhovStechFormFactor:Incoming 35 -531
 newdef MelikhovStechFormFactor:Outgoing 35 311
 newdef MelikhovStechFormFactor:Spin 35 0
 newdef MelikhovStechFormFactor:Spectator 35 -3
 newdef MelikhovStechFormFactor:InQuark 35 5
 newdef MelikhovStechFormFactor:OutQuark 35 1
 newdef MelikhovStechFormFactor:Incoming 36 -531
 newdef MelikhovStechFormFactor:Outgoing 36 321
 newdef MelikhovStechFormFactor:Spin 36 0
 newdef MelikhovStechFormFactor:Spectator 36 -3
 newdef MelikhovStechFormFactor:InQuark 36 5
 newdef MelikhovStechFormFactor:OutQuark 36 2
 newdef MelikhovStechFormFactor:Incoming 37 -531
 newdef MelikhovStechFormFactor:Outgoing 37 313
 newdef MelikhovStechFormFactor:Spin 37 1
 newdef MelikhovStechFormFactor:Spectator 37 -3
 newdef MelikhovStechFormFactor:InQuark 37 5
 newdef MelikhovStechFormFactor:OutQuark 37 1
 newdef MelikhovStechFormFactor:Incoming 38 -531
 newdef MelikhovStechFormFactor:Outgoing 38 323
 newdef MelikhovStechFormFactor:Spin 38 1
 newdef MelikhovStechFormFactor:Spectator 38 -3
 newdef MelikhovStechFormFactor:InQuark 38 5
 newdef MelikhovStechFormFactor:OutQuark 38 2
 newdef MelikhovStechFormFactor:Incoming 39 -531
 newdef MelikhovStechFormFactor:Outgoing 39 221
 newdef MelikhovStechFormFactor:Spin 39 0
 newdef MelikhovStechFormFactor:Spectator 39 -3
 newdef MelikhovStechFormFactor:InQuark 39 5
 newdef MelikhovStechFormFactor:OutQuark 39 3
 newdef MelikhovStechFormFactor:Incoming 40 -531
 newdef MelikhovStechFormFactor:Outgoing 40 331
 newdef MelikhovStechFormFactor:Spin 40 0
 newdef MelikhovStechFormFactor:Spectator 40 -3
 newdef MelikhovStechFormFactor:InQuark 40 5
 newdef MelikhovStechFormFactor:OutQuark 40 3
 newdef MelikhovStechFormFactor:Incoming 41 -531
 newdef MelikhovStechFormFactor:Outgoing 41 333
 newdef MelikhovStechFormFactor:Spin 41 1
 newdef MelikhovStechFormFactor:Spectator 41 -3
 newdef MelikhovStechFormFactor:InQuark 41 5
 newdef MelikhovStechFormFactor:OutQuark 41 3
 newdef MelikhovStech:FormFactor MelikhovStechFormFactor
 #
 create Herwig::SemiLeptonicBaryonDecayer  BaryonLight2
 newdef BaryonLight2:Iteration 1
 newdef BaryonLight2:Ntry 500
 newdef BaryonLight2:Points 10000
 newdef BaryonLight2:GenerateIntermediates 0
 insert BaryonLight2:MaximumWeight 0 2.29013
 insert BaryonLight2:MaximumWeight 1 4.14333e-05
 insert BaryonLight2:MaximumWeight 2 0.00012764
 insert BaryonLight2:MaximumWeight 3 4.70199e-10
 insert BaryonLight2:MaximumWeight 4 3.04697e-20
 insert BaryonLight2:MaximumWeight 5 1.02959e-09
 insert BaryonLight2:MaximumWeight 6 0.0028835
 insert BaryonLight2:MaximumWeight 7 0.000392968
 insert BaryonLight2:MaximumWeight 8 9.43244e-13
 insert BaryonLight2:MaximumWeight 9 2.69324e-13
 insert BaryonLight2:MaximumWeight 10 0.00405493
 insert BaryonLight2:MaximumWeight 11 0.00117335
 insert BaryonLight2:MaximumWeight 12 0.00239207
 insert BaryonLight2:MaximumWeight 13 0.000443089
 insert BaryonLight2:MaximumWeight 14 0.000229395
 insert BaryonLight2:MaximumWeight 15 3.35965e-06
 insert BaryonLight2:MaximumWeight 16 0.000719781
 insert BaryonLight2:MaximumWeight 17 7.04736e-06
 create Herwig::LeptonNeutrinoCurrent BaryonLight2Current  HwWeakCurrents.so
 newdef BaryonLight2Current:Quark 0  11
 newdef BaryonLight2Current:AntiQuark 0  -12
 newdef BaryonLight2Current:Quark 1  13
 newdef BaryonLight2Current:AntiQuark 1  -15
 newdef BaryonLight2Current:Quark 2  15
 newdef BaryonLight2Current:AntiQuark 2  -16
 newdef BaryonLight2:Current BaryonLight2Current
 create Herwig::BaryonSimpleFormFactor BaryonLight2Form
 newdef BaryonLight2Form:g_A 1.25
 newdef BaryonLight2Form:alpha_D 0.6
 newdef BaryonLight2Form:eta_V 0.97
 newdef BaryonLight2Form:eta_A 1.08
 newdef BaryonLight2Form:rho_E 0.094
 newdef BaryonLight2Form:rho_M 0.86
 newdef BaryonLight2Form:Incoming 0 2112
 newdef BaryonLight2Form:Outgoing 0 2212
 newdef BaryonLight2Form:InSpin 0 2
 newdef BaryonLight2Form:OutSpin 0 2
 newdef BaryonLight2Form:Spectator1 0 2
 newdef BaryonLight2Form:Spectator2 0 1
 newdef BaryonLight2Form:InQuark 0 1
 newdef BaryonLight2Form:OutQuark 0 2
 newdef BaryonLight2Form:Incoming 1 3222
 newdef BaryonLight2Form:Outgoing 1 3122
 newdef BaryonLight2Form:InSpin 1 2
 newdef BaryonLight2Form:OutSpin 1 2
 newdef BaryonLight2Form:Spectator1 1 3
 newdef BaryonLight2Form:Spectator2 1 2
 newdef BaryonLight2Form:InQuark 1 1
 newdef BaryonLight2Form:OutQuark 1 2
 newdef BaryonLight2Form:Incoming 2 3112
 newdef BaryonLight2Form:Outgoing 2 3122
 newdef BaryonLight2Form:InSpin 2 2
 newdef BaryonLight2Form:OutSpin 2 2
 newdef BaryonLight2Form:Spectator1 2 3
 newdef BaryonLight2Form:Spectator2 2 1
 newdef BaryonLight2Form:InQuark 2 1
 newdef BaryonLight2Form:OutQuark 2 2
 newdef BaryonLight2Form:Incoming 3 3112
 newdef BaryonLight2Form:Outgoing 3 3212
 newdef BaryonLight2Form:InSpin 3 2
 newdef BaryonLight2Form:OutSpin 3 2
 newdef BaryonLight2Form:Spectator1 3 3
 newdef BaryonLight2Form:Spectator2 3 1
 newdef BaryonLight2Form:InQuark 3 1
 newdef BaryonLight2Form:OutQuark 3 2
 newdef BaryonLight2Form:Incoming 4 3212
 newdef BaryonLight2Form:Outgoing 4 3222
 newdef BaryonLight2Form:InSpin 4 2
 newdef BaryonLight2Form:OutSpin 4 2
 newdef BaryonLight2Form:Spectator1 4 3
 newdef BaryonLight2Form:Spectator2 4 2
 newdef BaryonLight2Form:InQuark 4 1
 newdef BaryonLight2Form:OutQuark 4 2
 newdef BaryonLight2Form:Incoming 5 3312
 newdef BaryonLight2Form:Outgoing 5 3322
 newdef BaryonLight2Form:InSpin 5 2
 newdef BaryonLight2Form:OutSpin 5 2
 newdef BaryonLight2Form:Spectator1 5 3
 newdef BaryonLight2Form:Spectator2 5 3
 newdef BaryonLight2Form:InQuark 5 1
 newdef BaryonLight2Form:OutQuark 5 2
 newdef BaryonLight2Form:Incoming 6 3122
 newdef BaryonLight2Form:Outgoing 6 2212
 newdef BaryonLight2Form:InSpin 6 2
 newdef BaryonLight2Form:OutSpin 6 2
 newdef BaryonLight2Form:Spectator1 6 2
 newdef BaryonLight2Form:Spectator2 6 1
 newdef BaryonLight2Form:InQuark 6 3
 newdef BaryonLight2Form:OutQuark 6 2
 newdef BaryonLight2Form:Incoming 7 3212
 newdef BaryonLight2Form:Outgoing 7 2212
 newdef BaryonLight2Form:InSpin 7 2
 newdef BaryonLight2Form:OutSpin 7 2
 newdef BaryonLight2Form:Spectator1 7 2
 newdef BaryonLight2Form:Spectator2 7 1
 newdef BaryonLight2Form:InQuark 7 3
 newdef BaryonLight2Form:OutQuark 7 2
 newdef BaryonLight2Form:Incoming 8 3112
 newdef BaryonLight2Form:Outgoing 8 2112
 newdef BaryonLight2Form:InSpin 8 2
 newdef BaryonLight2Form:OutSpin 8 2
 newdef BaryonLight2Form:Spectator1 8 1
 newdef BaryonLight2Form:Spectator2 8 1
 newdef BaryonLight2Form:InQuark 8 3
 newdef BaryonLight2Form:OutQuark 8 2
 newdef BaryonLight2Form:Incoming 9 3312
 newdef BaryonLight2Form:Outgoing 9 3122
 newdef BaryonLight2Form:InSpin 9 2
 newdef BaryonLight2Form:OutSpin 9 2
 newdef BaryonLight2Form:Spectator1 9 3
 newdef BaryonLight2Form:Spectator2 9 1
 newdef BaryonLight2Form:InQuark 9 3
 newdef BaryonLight2Form:OutQuark 9 2
 newdef BaryonLight2Form:Incoming 10 3312
 newdef BaryonLight2Form:Outgoing 10 3212
 newdef BaryonLight2Form:InSpin 10 2
 newdef BaryonLight2Form:OutSpin 10 2
 newdef BaryonLight2Form:Spectator1 10 3
 newdef BaryonLight2Form:Spectator2 10 1
 newdef BaryonLight2Form:InQuark 10 3
 newdef BaryonLight2Form:OutQuark 10 2
 newdef BaryonLight2Form:Incoming 11 3322
 newdef BaryonLight2Form:Outgoing 11 3222
 newdef BaryonLight2Form:InSpin 11 2
 newdef BaryonLight2Form:OutSpin 11 2
 newdef BaryonLight2Form:Spectator1 11 3
 newdef BaryonLight2Form:Spectator2 11 2
 newdef BaryonLight2Form:InQuark 11 3
 newdef BaryonLight2Form:OutQuark 11 2
 newdef BaryonLight2:FormFactor BaryonLight2Form
 #
 create Herwig::SemiLeptonicScalarDecayer  KiselevBc
 newdef KiselevBc:Iteration 1
 newdef KiselevBc:Ntry 500
 newdef KiselevBc:Points 10000
 newdef KiselevBc:GenerateIntermediates 0
 insert KiselevBc:MaximumWeight 0 0.175615
 insert KiselevBc:MaximumWeight 1 0.136474
 insert KiselevBc:MaximumWeight 2 0.137341
 insert KiselevBc:MaximumWeight 3 0.131993
 insert KiselevBc:MaximumWeight 4 0.0137226
 insert KiselevBc:MaximumWeight 5 0.0111086
 insert KiselevBc:MaximumWeight 6 0.0168782
 insert KiselevBc:MaximumWeight 7 0.0163124
 insert KiselevBc:MaximumWeight 8 0.000135914
 insert KiselevBc:MaximumWeight 9 0.000132475
 insert KiselevBc:MaximumWeight 10 6.16844e-05
 insert KiselevBc:MaximumWeight 11 0.00106059
 insert KiselevBc:MaximumWeight 12 0.00106038
 insert KiselevBc:MaximumWeight 13 0.000447588
 insert KiselevBc:MaximumWeight 14 0.027841
 insert KiselevBc:MaximumWeight 15 0.0259921
 insert KiselevBc:MaximumWeight 16 0.0101164
 insert KiselevBc:MaximumWeight 17 0.0397051
 insert KiselevBc:MaximumWeight 18 0.0395602
 insert KiselevBc:MaximumWeight 19 0.00990111
 insert KiselevBc:MaximumWeight 20 0.00068535
 insert KiselevBc:MaximumWeight 21 0.000682114
 insert KiselevBc:MaximumWeight 22 8.18378e-05
 insert KiselevBc:MaximumWeight 23 0.00136992
 insert KiselevBc:MaximumWeight 24 0.0013625
 insert KiselevBc:MaximumWeight 25 0.00014084
 create Herwig::LeptonNeutrinoCurrent KiselevBcCurrent  HwWeakCurrents.so
 newdef KiselevBcCurrent:Quark 0  11
 newdef KiselevBcCurrent:AntiQuark 0  -12
 newdef KiselevBcCurrent:Quark 1  13
 newdef KiselevBcCurrent:AntiQuark 1  -15
 newdef KiselevBcCurrent:Quark 2  15
 newdef KiselevBcCurrent:AntiQuark 2  -16
 newdef KiselevBc:Current KiselevBcCurrent
 create Herwig::KiselevBcFormFactor KiselevBcFormFactor
 newdef KiselevBcFormFactor:Fplus 0  1.3
 newdef KiselevBcFormFactor:Fminus 0  -5.8
 newdef KiselevBcFormFactor:FV 0  0
 newdef KiselevBcFormFactor:F0A 0  0
 newdef KiselevBcFormFactor:FplusA 0  0
 newdef KiselevBcFormFactor:FminusA 0  0
 newdef KiselevBcFormFactor:MpoleFplus 0  1.8
 newdef KiselevBcFormFactor:MpoleFminus 0  1.8
 newdef KiselevBcFormFactor:MpoleFV 0  0
 newdef KiselevBcFormFactor:MpoleF0A 0  0
 newdef KiselevBcFormFactor:MpoleFplusA 0  0
 newdef KiselevBcFormFactor:MpoleFminusA 0  0
 newdef KiselevBcFormFactor:Fplus 1  0
 newdef KiselevBcFormFactor:Fminus 1  0
 newdef KiselevBcFormFactor:FV 1  1.1
 newdef KiselevBcFormFactor:F0A 1  8.1
 newdef KiselevBcFormFactor:FplusA 1  0.2
 newdef KiselevBcFormFactor:FminusA 1  1.8
 newdef KiselevBcFormFactor:MpoleFplus 1  0
 newdef KiselevBcFormFactor:MpoleFminus 1  0
 newdef KiselevBcFormFactor:MpoleFV 1  1.8
 newdef KiselevBcFormFactor:MpoleF0A 1  1.8
 newdef KiselevBcFormFactor:MpoleFplusA 1  1.8
 newdef KiselevBcFormFactor:MpoleFminusA 1  1.8
 newdef KiselevBcFormFactor:Fplus 2  1.27
 newdef KiselevBcFormFactor:Fminus 2  -7.3
 newdef KiselevBcFormFactor:FV 2  0
 newdef KiselevBcFormFactor:F0A 2  0
 newdef KiselevBcFormFactor:FplusA 2  0
 newdef KiselevBcFormFactor:FminusA 2  0
 newdef KiselevBcFormFactor:MpoleFplus 2  1.7
 newdef KiselevBcFormFactor:MpoleFminus 2  1.7
 newdef KiselevBcFormFactor:MpoleFV 2  0
 newdef KiselevBcFormFactor:MpoleF0A 2  0
 newdef KiselevBcFormFactor:MpoleFplusA 2  0
 newdef KiselevBcFormFactor:MpoleFminusA 2  0
 newdef KiselevBcFormFactor:Fplus 3  1.27
 newdef KiselevBcFormFactor:Fminus 3  -7.3
 newdef KiselevBcFormFactor:FV 3  0
 newdef KiselevBcFormFactor:F0A 3  0
 newdef KiselevBcFormFactor:FplusA 3  0
 newdef KiselevBcFormFactor:FminusA 3  0
 newdef KiselevBcFormFactor:MpoleFplus 3  1.7
 newdef KiselevBcFormFactor:MpoleFminus 3  1.7
 newdef KiselevBcFormFactor:MpoleFV 3  0
 newdef KiselevBcFormFactor:MpoleF0A 3  0
 newdef KiselevBcFormFactor:MpoleFplusA 3  0
 newdef KiselevBcFormFactor:MpoleFminusA 3  0
 newdef KiselevBcFormFactor:Fplus 4  0
 newdef KiselevBcFormFactor:Fminus 4  0
 newdef KiselevBcFormFactor:FV 4  1.35
 newdef KiselevBcFormFactor:F0A 4  9.8
 newdef KiselevBcFormFactor:FplusA 4  0.35
 newdef KiselevBcFormFactor:FminusA 4  2.5
 newdef KiselevBcFormFactor:MpoleFplus 4  0
 newdef KiselevBcFormFactor:MpoleFminus 4  0
 newdef KiselevBcFormFactor:MpoleFV 4  2.2
 newdef KiselevBcFormFactor:MpoleF0A 4  3.2
 newdef KiselevBcFormFactor:MpoleFplusA 4  2.2
 newdef KiselevBcFormFactor:MpoleFminusA 4  3.2
 newdef KiselevBcFormFactor:Fplus 5  0
 newdef KiselevBcFormFactor:Fminus 5  0
 newdef KiselevBcFormFactor:FV 5  1.35
 newdef KiselevBcFormFactor:F0A 5  9.8
 newdef KiselevBcFormFactor:FplusA 5  0.35
 newdef KiselevBcFormFactor:FminusA 5  2.5
 newdef KiselevBcFormFactor:MpoleFplus 5  0
 newdef KiselevBcFormFactor:MpoleFminus 5  0
 newdef KiselevBcFormFactor:MpoleFV 5  2.2
 newdef KiselevBcFormFactor:MpoleF0A 5  3.2
 newdef KiselevBcFormFactor:MpoleFplusA 5  2.2
 newdef KiselevBcFormFactor:MpoleFminusA 5  3.2
 newdef KiselevBcFormFactor:Fplus 6  0.32
 newdef KiselevBcFormFactor:Fminus 6  -0.34
 newdef KiselevBcFormFactor:FV 6  0
 newdef KiselevBcFormFactor:F0A 6  0
 newdef KiselevBcFormFactor:FplusA 6  0
 newdef KiselevBcFormFactor:FminusA 6  0
 newdef KiselevBcFormFactor:MpoleFplus 6  5
 newdef KiselevBcFormFactor:MpoleFminus 6  5
 newdef KiselevBcFormFactor:MpoleFV 6  0
 newdef KiselevBcFormFactor:MpoleF0A 6  0
 newdef KiselevBcFormFactor:MpoleFplusA 6  0
 newdef KiselevBcFormFactor:MpoleFminusA 6  0
 newdef KiselevBcFormFactor:Fplus 7  0.32
 newdef KiselevBcFormFactor:Fminus 7  -0.34
 newdef KiselevBcFormFactor:FV 7  0
 newdef KiselevBcFormFactor:F0A 7  0
 newdef KiselevBcFormFactor:FplusA 7  0
 newdef KiselevBcFormFactor:FminusA 7  0
 newdef KiselevBcFormFactor:MpoleFplus 7  5
 newdef KiselevBcFormFactor:MpoleFminus 7  5
 newdef KiselevBcFormFactor:MpoleFV 7  0
 newdef KiselevBcFormFactor:MpoleF0A 7  0
 newdef KiselevBcFormFactor:MpoleFplusA 7  0
 newdef KiselevBcFormFactor:MpoleFminusA 7  0
 newdef KiselevBcFormFactor:Fplus 8  0
 newdef KiselevBcFormFactor:Fminus 8  0
 newdef KiselevBcFormFactor:FV 8  0.2
 newdef KiselevBcFormFactor:F0A 8  3.6
 newdef KiselevBcFormFactor:FplusA 8  -0.062
 newdef KiselevBcFormFactor:FminusA 8  0.1
 newdef KiselevBcFormFactor:MpoleFplus 8  0
 newdef KiselevBcFormFactor:MpoleFminus 8  0
 newdef KiselevBcFormFactor:MpoleFV 8  6.2
 newdef KiselevBcFormFactor:MpoleF0A 8  -1
 newdef KiselevBcFormFactor:MpoleFplusA 8  6.2
 newdef KiselevBcFormFactor:MpoleFminusA 8  6.2
 newdef KiselevBcFormFactor:Fplus 9  0
 newdef KiselevBcFormFactor:Fminus 9  0
 newdef KiselevBcFormFactor:FV 9  0.2
 newdef KiselevBcFormFactor:F0A 9  3.6
 newdef KiselevBcFormFactor:FplusA 9  -0.062
 newdef KiselevBcFormFactor:FminusA 9  0.1
 newdef KiselevBcFormFactor:MpoleFplus 9  0
 newdef KiselevBcFormFactor:MpoleFminus 9  0
 newdef KiselevBcFormFactor:MpoleFV 9  6.2
 newdef KiselevBcFormFactor:MpoleF0A 9  -1
 newdef KiselevBcFormFactor:MpoleFplusA 9  6.2
 newdef KiselevBcFormFactor:MpoleFminusA 9  6.2
 newdef KiselevBcFormFactor:Fplus 10  0.45
 newdef KiselevBcFormFactor:Fminus 10  -0.43
 newdef KiselevBcFormFactor:FV 10  0
 newdef KiselevBcFormFactor:F0A 10  0
 newdef KiselevBcFormFactor:FplusA 10  0
 newdef KiselevBcFormFactor:FminusA 10  0
 newdef KiselevBcFormFactor:MpoleFplus 10  5
 newdef KiselevBcFormFactor:MpoleFminus 10  5
 newdef KiselevBcFormFactor:MpoleFV 10  0
 newdef KiselevBcFormFactor:MpoleF0A 10  0
 newdef KiselevBcFormFactor:MpoleFplusA 10  0
 newdef KiselevBcFormFactor:MpoleFminusA 10  0
 newdef KiselevBcFormFactor:Fplus 11  0
 newdef KiselevBcFormFactor:Fminus 11  0
 newdef KiselevBcFormFactor:FV 11  0.24
 newdef KiselevBcFormFactor:F0A 11  4.7
 newdef KiselevBcFormFactor:FplusA 11  -0.077
 newdef KiselevBcFormFactor:FminusA 11  0.13
 newdef KiselevBcFormFactor:MpoleFplus 11  0
 newdef KiselevBcFormFactor:MpoleFminus 11  0
 newdef KiselevBcFormFactor:MpoleFV 11  6.2
 newdef KiselevBcFormFactor:MpoleF0A 11  -1
 newdef KiselevBcFormFactor:MpoleFplusA 11  6.2
 newdef KiselevBcFormFactor:MpoleFminusA 11  6.2
 newdef KiselevBcFormFactor:Fplus 12  0.66
 newdef KiselevBcFormFactor:Fminus 12  -0.36
 newdef KiselevBcFormFactor:FV 12  0
 newdef KiselevBcFormFactor:F0A 12  0
 newdef KiselevBcFormFactor:FplusA 12  0
 newdef KiselevBcFormFactor:FminusA 12  0
 newdef KiselevBcFormFactor:MpoleFplus 12  4.5
 newdef KiselevBcFormFactor:MpoleFminus 12  4.5
 newdef KiselevBcFormFactor:MpoleFV 12  0
 newdef KiselevBcFormFactor:MpoleF0A 12  0
 newdef KiselevBcFormFactor:MpoleFplusA 12  0
 newdef KiselevBcFormFactor:MpoleFminusA 12  0
 newdef KiselevBcFormFactor:Fplus 13  0
 newdef KiselevBcFormFactor:Fminus 13  0
 newdef KiselevBcFormFactor:FV 13  0.11
 newdef KiselevBcFormFactor:F0A 13  5.9
 newdef KiselevBcFormFactor:FplusA 13  -0.074
 newdef KiselevBcFormFactor:FminusA 13  0.12
 newdef KiselevBcFormFactor:MpoleFplus 13  0
 newdef KiselevBcFormFactor:MpoleFminus 13  0
 newdef KiselevBcFormFactor:MpoleFV 13  5.5
 newdef KiselevBcFormFactor:MpoleF0A 13  5.5
 newdef KiselevBcFormFactor:MpoleFplusA 13  5.5
 newdef KiselevBcFormFactor:MpoleFminusA 13  5.5
 newdef KiselevBcFormFactor:Fplus 14  0.17
 newdef KiselevBcFormFactor:Fminus 14  -0.16
 newdef KiselevBcFormFactor:FV 14  0
 newdef KiselevBcFormFactor:F0A 14  0
 newdef KiselevBcFormFactor:FplusA 14  0
 newdef KiselevBcFormFactor:FminusA 14  0
 newdef KiselevBcFormFactor:MpoleFplus 14  4.5
 newdef KiselevBcFormFactor:MpoleFminus 14  4.5
 newdef KiselevBcFormFactor:MpoleFV 14  0
 newdef KiselevBcFormFactor:MpoleF0A 14  0
 newdef KiselevBcFormFactor:MpoleFplusA 14  0
 newdef KiselevBcFormFactor:MpoleFminusA 14  0
 newdef KiselevBcFormFactor:Fplus 15  0
 newdef KiselevBcFormFactor:Fminus 15  0
 newdef KiselevBcFormFactor:FV 15  0.035
 newdef KiselevBcFormFactor:F0A 15  1.686
 newdef KiselevBcFormFactor:FplusA 15  -0.015
 newdef KiselevBcFormFactor:FminusA 15  0.052
 newdef KiselevBcFormFactor:MpoleFplus 15  0
 newdef KiselevBcFormFactor:MpoleFminus 15  0
 newdef KiselevBcFormFactor:MpoleFV 15  4.2
 newdef KiselevBcFormFactor:MpoleF0A 15  4.2
 newdef KiselevBcFormFactor:MpoleFplusA 15  4.2
 newdef KiselevBcFormFactor:MpoleFminusA 15  4.2
 newdef KiselevBcFormFactor:Incoming 0 541
 newdef KiselevBcFormFactor:Outgoing 0 531
 newdef KiselevBcFormFactor:Spin 0 0
 newdef KiselevBcFormFactor:Spectator 0 -5
 newdef KiselevBcFormFactor:InQuark 0 4
 newdef KiselevBcFormFactor:OutQuark 0 3
 newdef KiselevBcFormFactor:Incoming 1 541
 newdef KiselevBcFormFactor:Outgoing 1 533
 newdef KiselevBcFormFactor:Spin 1 1
 newdef KiselevBcFormFactor:Spectator 1 -5
 newdef KiselevBcFormFactor:InQuark 1 4
 newdef KiselevBcFormFactor:OutQuark 1 3
 newdef KiselevBcFormFactor:Incoming 2 541
 newdef KiselevBcFormFactor:Outgoing 2 511
 newdef KiselevBcFormFactor:Spin 2 0
 newdef KiselevBcFormFactor:Spectator 2 -5
 newdef KiselevBcFormFactor:InQuark 2 4
 newdef KiselevBcFormFactor:OutQuark 2 1
 newdef KiselevBcFormFactor:Incoming 3 541
 newdef KiselevBcFormFactor:Outgoing 3 521
 newdef KiselevBcFormFactor:Spin 3 0
 newdef KiselevBcFormFactor:Spectator 3 -5
 newdef KiselevBcFormFactor:InQuark 3 4
 newdef KiselevBcFormFactor:OutQuark 3 2
 newdef KiselevBcFormFactor:Incoming 4 541
 newdef KiselevBcFormFactor:Outgoing 4 513
 newdef KiselevBcFormFactor:Spin 4 1
 newdef KiselevBcFormFactor:Spectator 4 -5
 newdef KiselevBcFormFactor:InQuark 4 4
 newdef KiselevBcFormFactor:OutQuark 4 1
 newdef KiselevBcFormFactor:Incoming 5 541
 newdef KiselevBcFormFactor:Outgoing 5 523
 newdef KiselevBcFormFactor:Spin 5 1
 newdef KiselevBcFormFactor:Spectator 5 -5
 newdef KiselevBcFormFactor:InQuark 5 4
 newdef KiselevBcFormFactor:OutQuark 5 2
 newdef KiselevBcFormFactor:Incoming 6 -541
 newdef KiselevBcFormFactor:Outgoing 6 -411
 newdef KiselevBcFormFactor:Spin 6 0
 newdef KiselevBcFormFactor:Spectator 6 -4
 newdef KiselevBcFormFactor:InQuark 6 5
 newdef KiselevBcFormFactor:OutQuark 6 1
 newdef KiselevBcFormFactor:Incoming 7 -541
 newdef KiselevBcFormFactor:Outgoing 7 -421
 newdef KiselevBcFormFactor:Spin 7 0
 newdef KiselevBcFormFactor:Spectator 7 -4
 newdef KiselevBcFormFactor:InQuark 7 5
 newdef KiselevBcFormFactor:OutQuark 7 2
 newdef KiselevBcFormFactor:Incoming 8 -541
 newdef KiselevBcFormFactor:Outgoing 8 -413
 newdef KiselevBcFormFactor:Spin 8 1
 newdef KiselevBcFormFactor:Spectator 8 -4
 newdef KiselevBcFormFactor:InQuark 8 5
 newdef KiselevBcFormFactor:OutQuark 8 1
 newdef KiselevBcFormFactor:Incoming 9 -541
 newdef KiselevBcFormFactor:Outgoing 9 -423
 newdef KiselevBcFormFactor:Spin 9 1
 newdef KiselevBcFormFactor:Spectator 9 -4
 newdef KiselevBcFormFactor:InQuark 9 5
 newdef KiselevBcFormFactor:OutQuark 9 2
 newdef KiselevBcFormFactor:Incoming 10 -541
 newdef KiselevBcFormFactor:Outgoing 10 -431
 newdef KiselevBcFormFactor:Spin 10 0
 newdef KiselevBcFormFactor:Spectator 10 -4
 newdef KiselevBcFormFactor:InQuark 10 5
 newdef KiselevBcFormFactor:OutQuark 10 3
 newdef KiselevBcFormFactor:Incoming 11 -541
 newdef KiselevBcFormFactor:Outgoing 11 -433
 newdef KiselevBcFormFactor:Spin 11 1
 newdef KiselevBcFormFactor:Spectator 11 -4
 newdef KiselevBcFormFactor:InQuark 11 5
 newdef KiselevBcFormFactor:OutQuark 11 3
 newdef KiselevBcFormFactor:Incoming 12 -541
 newdef KiselevBcFormFactor:Outgoing 12 441
 newdef KiselevBcFormFactor:Spin 12 0
 newdef KiselevBcFormFactor:Spectator 12 -4
 newdef KiselevBcFormFactor:InQuark 12 5
 newdef KiselevBcFormFactor:OutQuark 12 4
 newdef KiselevBcFormFactor:Incoming 13 -541
 newdef KiselevBcFormFactor:Outgoing 13 443
 newdef KiselevBcFormFactor:Spin 13 1
 newdef KiselevBcFormFactor:Spectator 13 -4
 newdef KiselevBcFormFactor:InQuark 13 5
 newdef KiselevBcFormFactor:OutQuark 13 4
 newdef KiselevBcFormFactor:Incoming 14 -541
 newdef KiselevBcFormFactor:Outgoing 14 100441
 newdef KiselevBcFormFactor:Spin 14 0
 newdef KiselevBcFormFactor:Spectator 14 -4
 newdef KiselevBcFormFactor:InQuark 14 5
 newdef KiselevBcFormFactor:OutQuark 14 4
 newdef KiselevBcFormFactor:Incoming 15 -541
 newdef KiselevBcFormFactor:Outgoing 15 100443
 newdef KiselevBcFormFactor:Spin 15 1
 newdef KiselevBcFormFactor:Spectator 15 -4
 newdef KiselevBcFormFactor:InQuark 15 5
 newdef KiselevBcFormFactor:OutQuark 15 4
 newdef KiselevBc:FormFactor KiselevBcFormFactor
 #
 create Herwig::ScalarMesonFactorizedDecayer  BcHadronic
 newdef BcHadronic:Iteration 1
 newdef BcHadronic:Ntry 500
 newdef BcHadronic:Points 10000
 newdef BcHadronic:GenerateIntermediates 0
 newdef BcHadronic:a1Bottom 1.14
 newdef BcHadronic:a2Bottom -0.2
 newdef BcHadronic:a1Charm 1.2
 newdef BcHadronic:a2Charm -0.317
 create Herwig::ScalarMesonCurrent BcHadronicScalarCurrent HwWeakCurrents.so
 newdef BcHadronicScalarCurrent:ThetaEtaEtaPrime -0.194
 newdef BcHadronicScalarCurrent:ID 0 211
 newdef BcHadronicScalarCurrent:Decay_Constant 0 -132
 newdef BcHadronicScalarCurrent:ID 1 111
 newdef BcHadronicScalarCurrent:Decay_Constant 1 -132
 newdef BcHadronicScalarCurrent:ID 2 111
 newdef BcHadronicScalarCurrent:Decay_Constant 2 -132
 newdef BcHadronicScalarCurrent:ID 3 221
 newdef BcHadronicScalarCurrent:Decay_Constant 3 -132
 newdef BcHadronicScalarCurrent:ID 4 221
 newdef BcHadronicScalarCurrent:Decay_Constant 4 -132
 newdef BcHadronicScalarCurrent:ID 5 221
 newdef BcHadronicScalarCurrent:Decay_Constant 5 -132
 newdef BcHadronicScalarCurrent:ID 6 331
 newdef BcHadronicScalarCurrent:Decay_Constant 6 -132
 newdef BcHadronicScalarCurrent:ID 7 331
 newdef BcHadronicScalarCurrent:Decay_Constant 7 -132
 newdef BcHadronicScalarCurrent:ID 8 331
 newdef BcHadronicScalarCurrent:Decay_Constant 8 -132
 newdef BcHadronicScalarCurrent:ID 9 311
 newdef BcHadronicScalarCurrent:Decay_Constant 9 -162
 newdef BcHadronicScalarCurrent:ID 10 321
 newdef BcHadronicScalarCurrent:Decay_Constant 10 -162
 newdef BcHadronicScalarCurrent:ID 11 411
 newdef BcHadronicScalarCurrent:Decay_Constant 11 -214
 newdef BcHadronicScalarCurrent:ID 12 421
 newdef BcHadronicScalarCurrent:Decay_Constant 12 -214
 newdef BcHadronicScalarCurrent:ID 13 431
 newdef BcHadronicScalarCurrent:Decay_Constant 13 -237
 newdef BcHadronicScalarCurrent:ID 14 10431
 newdef BcHadronicScalarCurrent:Decay_Constant 14 -73.7
 insert BcHadronicScalarCurrent:ID 15 441
 insert BcHadronicScalarCurrent:Decay_Constant 15 -564
 newdef BcHadronicScalarCurrent:Quark 0  2
 newdef BcHadronicScalarCurrent:AntiQuark 0  -1
 newdef BcHadronicScalarCurrent:Quark 1  1
 newdef BcHadronicScalarCurrent:AntiQuark 1  -1
 newdef BcHadronicScalarCurrent:Quark 2  2
 newdef BcHadronicScalarCurrent:AntiQuark 2  -2
 newdef BcHadronicScalarCurrent:Quark 3  1
 newdef BcHadronicScalarCurrent:AntiQuark 3  -1
 newdef BcHadronicScalarCurrent:Quark 4  2
 newdef BcHadronicScalarCurrent:AntiQuark 4  -2
 newdef BcHadronicScalarCurrent:Quark 5  3
 newdef BcHadronicScalarCurrent:AntiQuark 5  -3
 newdef BcHadronicScalarCurrent:Quark 6  1
 newdef BcHadronicScalarCurrent:AntiQuark 6  -1
 newdef BcHadronicScalarCurrent:Quark 7  2
 newdef BcHadronicScalarCurrent:AntiQuark 7  -2
 newdef BcHadronicScalarCurrent:Quark 8  3
 newdef BcHadronicScalarCurrent:AntiQuark 8  -3
 newdef BcHadronicScalarCurrent:Quark 9  1
 newdef BcHadronicScalarCurrent:AntiQuark 9  -3
 newdef BcHadronicScalarCurrent:Quark 10  2
 newdef BcHadronicScalarCurrent:AntiQuark 10  -3
 newdef BcHadronicScalarCurrent:Quark 11  4
 newdef BcHadronicScalarCurrent:AntiQuark 11  -1
 newdef BcHadronicScalarCurrent:Quark 12  4
 newdef BcHadronicScalarCurrent:AntiQuark 12  -2
 newdef BcHadronicScalarCurrent:Quark 13  4
 newdef BcHadronicScalarCurrent:AntiQuark 13  -3
 newdef BcHadronicScalarCurrent:Quark 14  4
 newdef BcHadronicScalarCurrent:AntiQuark 14  -3
 insert BcHadronicScalarCurrent:Quark 15  4
 insert BcHadronicScalarCurrent:AntiQuark 15  -4
 insert BcHadronic:Currents 0 BcHadronicScalarCurrent
 create Herwig::VectorMesonCurrent BcHadronicVectorCurrent HwWeakCurrents.so
 newdef BcHadronicVectorCurrent:ID 0 213
 newdef BcHadronicVectorCurrent:Decay_Constant 0 0.16
 newdef BcHadronicVectorCurrent:ID 1 113
 newdef BcHadronicVectorCurrent:Decay_Constant 1 0.16
 newdef BcHadronicVectorCurrent:ID 2 113
 newdef BcHadronicVectorCurrent:Decay_Constant 2 0.16
 newdef BcHadronicVectorCurrent:ID 3 223
 newdef BcHadronicVectorCurrent:Decay_Constant 3 0.16
 newdef BcHadronicVectorCurrent:ID 4 223
 newdef BcHadronicVectorCurrent:Decay_Constant 4 0.16
 newdef BcHadronicVectorCurrent:ID 5 333
 newdef BcHadronicVectorCurrent:Decay_Constant 5 0.238
 newdef BcHadronicVectorCurrent:ID 6 313
 newdef BcHadronicVectorCurrent:Decay_Constant 6 0.197
 newdef BcHadronicVectorCurrent:ID 7 323
 newdef BcHadronicVectorCurrent:Decay_Constant 7 0.197
 newdef BcHadronicVectorCurrent:ID 8 20213
 newdef BcHadronicVectorCurrent:Decay_Constant 8 0.278
 newdef BcHadronicVectorCurrent:ID 9 20113
 newdef BcHadronicVectorCurrent:Decay_Constant 9 0.278
 newdef BcHadronicVectorCurrent:ID 10 20113
 newdef BcHadronicVectorCurrent:Decay_Constant 10 0.278
 newdef BcHadronicVectorCurrent:ID 11 413
 newdef BcHadronicVectorCurrent:Decay_Constant 11 0.457
 newdef BcHadronicVectorCurrent:ID 12 423
 newdef BcHadronicVectorCurrent:Decay_Constant 12 0.457
 newdef BcHadronicVectorCurrent:ID 13 433
 newdef BcHadronicVectorCurrent:Decay_Constant 13 0.55
 newdef BcHadronicVectorCurrent:ID 14 443
 newdef BcHadronicVectorCurrent:Decay_Constant 14 1.256
 newdef BcHadronicVectorCurrent:ID 15 100443
 newdef BcHadronicVectorCurrent:Decay_Constant 15 1.08
 newdef BcHadronicVectorCurrent:ID 16 20433
 newdef BcHadronicVectorCurrent:Decay_Constant 16 0.397
 newdef BcHadronicVectorCurrent:Quark 0  2
 newdef BcHadronicVectorCurrent:AntiQuark 0  -1
 newdef BcHadronicVectorCurrent:Quark 1  1
 newdef BcHadronicVectorCurrent:AntiQuark 1  -1
 newdef BcHadronicVectorCurrent:Quark 2  2
 newdef BcHadronicVectorCurrent:AntiQuark 2  -2
 newdef BcHadronicVectorCurrent:Quark 3  1
 newdef BcHadronicVectorCurrent:AntiQuark 3  -1
 newdef BcHadronicVectorCurrent:Quark 4  2
 newdef BcHadronicVectorCurrent:AntiQuark 4  -2
 newdef BcHadronicVectorCurrent:Quark 5  3
 newdef BcHadronicVectorCurrent:AntiQuark 5  -3
 newdef BcHadronicVectorCurrent:Quark 6  1
 newdef BcHadronicVectorCurrent:AntiQuark 6  -3
 newdef BcHadronicVectorCurrent:Quark 7  2
 newdef BcHadronicVectorCurrent:AntiQuark 7  -3
 newdef BcHadronicVectorCurrent:Quark 8  2
 newdef BcHadronicVectorCurrent:AntiQuark 8  -1
 newdef BcHadronicVectorCurrent:Quark 9  1
 newdef BcHadronicVectorCurrent:AntiQuark 9  -1
 newdef BcHadronicVectorCurrent:Quark 10  2
 newdef BcHadronicVectorCurrent:AntiQuark 10  -2
 newdef BcHadronicVectorCurrent:Quark 11  4
 newdef BcHadronicVectorCurrent:AntiQuark 11  -1
 newdef BcHadronicVectorCurrent:Quark 12  4
 newdef BcHadronicVectorCurrent:AntiQuark 12  -2
 newdef BcHadronicVectorCurrent:Quark 13  4
 newdef BcHadronicVectorCurrent:AntiQuark 13  -3
 newdef BcHadronicVectorCurrent:Quark 14  4
 newdef BcHadronicVectorCurrent:AntiQuark 14  -4
 newdef BcHadronicVectorCurrent:Quark 15  4
 newdef BcHadronicVectorCurrent:AntiQuark 15  -4
 newdef BcHadronicVectorCurrent:Quark 16  4
 newdef BcHadronicVectorCurrent:AntiQuark 16  -3
 insert BcHadronic:Currents 1 BcHadronicVectorCurrent
 create Herwig::KiselevBcFormFactor BcHadronicFormFactor
 newdef BcHadronicFormFactor:Fplus 0  1.3
 newdef BcHadronicFormFactor:Fminus 0  -5.8
 newdef BcHadronicFormFactor:FV 0  0
 newdef BcHadronicFormFactor:F0A 0  0
 newdef BcHadronicFormFactor:FplusA 0  0
 newdef BcHadronicFormFactor:FminusA 0  0
 newdef BcHadronicFormFactor:MpoleFplus 0  1.8
 newdef BcHadronicFormFactor:MpoleFminus 0  1.8
 newdef BcHadronicFormFactor:MpoleFV 0  0
 newdef BcHadronicFormFactor:MpoleF0A 0  0
 newdef BcHadronicFormFactor:MpoleFplusA 0  0
 newdef BcHadronicFormFactor:MpoleFminusA 0  0
 newdef BcHadronicFormFactor:Fplus 1  0
 newdef BcHadronicFormFactor:Fminus 1  0
 newdef BcHadronicFormFactor:FV 1  1.1
 newdef BcHadronicFormFactor:F0A 1  8.1
 newdef BcHadronicFormFactor:FplusA 1  0.2
 newdef BcHadronicFormFactor:FminusA 1  1.8
 newdef BcHadronicFormFactor:MpoleFplus 1  0
 newdef BcHadronicFormFactor:MpoleFminus 1  0
 newdef BcHadronicFormFactor:MpoleFV 1  1.8
 newdef BcHadronicFormFactor:MpoleF0A 1  1.8
 newdef BcHadronicFormFactor:MpoleFplusA 1  1.8
 newdef BcHadronicFormFactor:MpoleFminusA 1  1.8
 newdef BcHadronicFormFactor:Fplus 2  1.27
 newdef BcHadronicFormFactor:Fminus 2  -7.3
 newdef BcHadronicFormFactor:FV 2  0
 newdef BcHadronicFormFactor:F0A 2  0
 newdef BcHadronicFormFactor:FplusA 2  0
 newdef BcHadronicFormFactor:FminusA 2  0
 newdef BcHadronicFormFactor:MpoleFplus 2  1.7
 newdef BcHadronicFormFactor:MpoleFminus 2  1.7
 newdef BcHadronicFormFactor:MpoleFV 2  0
 newdef BcHadronicFormFactor:MpoleF0A 2  0
 newdef BcHadronicFormFactor:MpoleFplusA 2  0
 newdef BcHadronicFormFactor:MpoleFminusA 2  0
 newdef BcHadronicFormFactor:Fplus 3  1.27
 newdef BcHadronicFormFactor:Fminus 3  -7.3
 newdef BcHadronicFormFactor:FV 3  0
 newdef BcHadronicFormFactor:F0A 3  0
 newdef BcHadronicFormFactor:FplusA 3  0
 newdef BcHadronicFormFactor:FminusA 3  0
 newdef BcHadronicFormFactor:MpoleFplus 3  1.7
 newdef BcHadronicFormFactor:MpoleFminus 3  1.7
 newdef BcHadronicFormFactor:MpoleFV 3  0
 newdef BcHadronicFormFactor:MpoleF0A 3  0
 newdef BcHadronicFormFactor:MpoleFplusA 3  0
 newdef BcHadronicFormFactor:MpoleFminusA 3  0
 newdef BcHadronicFormFactor:Fplus 4  0
 newdef BcHadronicFormFactor:Fminus 4  0
 newdef BcHadronicFormFactor:FV 4  1.35
 newdef BcHadronicFormFactor:F0A 4  9.8
 newdef BcHadronicFormFactor:FplusA 4  0.35
 newdef BcHadronicFormFactor:FminusA 4  2.5
 newdef BcHadronicFormFactor:MpoleFplus 4  0
 newdef BcHadronicFormFactor:MpoleFminus 4  0
 newdef BcHadronicFormFactor:MpoleFV 4  2.2
 newdef BcHadronicFormFactor:MpoleF0A 4  3.2
 newdef BcHadronicFormFactor:MpoleFplusA 4  2.2
 newdef BcHadronicFormFactor:MpoleFminusA 4  3.2
 newdef BcHadronicFormFactor:Fplus 5  0
 newdef BcHadronicFormFactor:Fminus 5  0
 newdef BcHadronicFormFactor:FV 5  1.35
 newdef BcHadronicFormFactor:F0A 5  9.8
 newdef BcHadronicFormFactor:FplusA 5  0.35
 newdef BcHadronicFormFactor:FminusA 5  2.5
 newdef BcHadronicFormFactor:MpoleFplus 5  0
 newdef BcHadronicFormFactor:MpoleFminus 5  0
 newdef BcHadronicFormFactor:MpoleFV 5  2.2
 newdef BcHadronicFormFactor:MpoleF0A 5  3.2
 newdef BcHadronicFormFactor:MpoleFplusA 5  2.2
 newdef BcHadronicFormFactor:MpoleFminusA 5  3.2
 newdef BcHadronicFormFactor:Fplus 6  0.32
 newdef BcHadronicFormFactor:Fminus 6  -0.34
 newdef BcHadronicFormFactor:FV 6  0
 newdef BcHadronicFormFactor:F0A 6  0
 newdef BcHadronicFormFactor:FplusA 6  0
 newdef BcHadronicFormFactor:FminusA 6  0
 newdef BcHadronicFormFactor:MpoleFplus 6  5
 newdef BcHadronicFormFactor:MpoleFminus 6  5
 newdef BcHadronicFormFactor:MpoleFV 6  0
 newdef BcHadronicFormFactor:MpoleF0A 6  0
 newdef BcHadronicFormFactor:MpoleFplusA 6  0
 newdef BcHadronicFormFactor:MpoleFminusA 6  0
 newdef BcHadronicFormFactor:Fplus 7  0.32
 newdef BcHadronicFormFactor:Fminus 7  -0.34
 newdef BcHadronicFormFactor:FV 7  0
 newdef BcHadronicFormFactor:F0A 7  0
 newdef BcHadronicFormFactor:FplusA 7  0
 newdef BcHadronicFormFactor:FminusA 7  0
 newdef BcHadronicFormFactor:MpoleFplus 7  5
 newdef BcHadronicFormFactor:MpoleFminus 7  5
 newdef BcHadronicFormFactor:MpoleFV 7  0
 newdef BcHadronicFormFactor:MpoleF0A 7  0
 newdef BcHadronicFormFactor:MpoleFplusA 7  0
 newdef BcHadronicFormFactor:MpoleFminusA 7  0
 newdef BcHadronicFormFactor:Fplus 8  0
 newdef BcHadronicFormFactor:Fminus 8  0
 newdef BcHadronicFormFactor:FV 8  0.2
 newdef BcHadronicFormFactor:F0A 8  3.6
 newdef BcHadronicFormFactor:FplusA 8  -0.062
 newdef BcHadronicFormFactor:FminusA 8  0.1
 newdef BcHadronicFormFactor:MpoleFplus 8  0
 newdef BcHadronicFormFactor:MpoleFminus 8  0
 newdef BcHadronicFormFactor:MpoleFV 8  6.2
 newdef BcHadronicFormFactor:MpoleF0A 8  -1
 newdef BcHadronicFormFactor:MpoleFplusA 8  6.2
 newdef BcHadronicFormFactor:MpoleFminusA 8  6.2
 newdef BcHadronicFormFactor:Fplus 9  0
 newdef BcHadronicFormFactor:Fminus 9  0
 newdef BcHadronicFormFactor:FV 9  0.2
 newdef BcHadronicFormFactor:F0A 9  3.6
 newdef BcHadronicFormFactor:FplusA 9  -0.062
 newdef BcHadronicFormFactor:FminusA 9  0.1
 newdef BcHadronicFormFactor:MpoleFplus 9  0
 newdef BcHadronicFormFactor:MpoleFminus 9  0
 newdef BcHadronicFormFactor:MpoleFV 9  6.2
 newdef BcHadronicFormFactor:MpoleF0A 9  -1
 newdef BcHadronicFormFactor:MpoleFplusA 9  6.2
 newdef BcHadronicFormFactor:MpoleFminusA 9  6.2
 newdef BcHadronicFormFactor:Fplus 10  0.45
 newdef BcHadronicFormFactor:Fminus 10  -0.43
 newdef BcHadronicFormFactor:FV 10  0
 newdef BcHadronicFormFactor:F0A 10  0
 newdef BcHadronicFormFactor:FplusA 10  0
 newdef BcHadronicFormFactor:FminusA 10  0
 newdef BcHadronicFormFactor:MpoleFplus 10  5
 newdef BcHadronicFormFactor:MpoleFminus 10  5
 newdef BcHadronicFormFactor:MpoleFV 10  0
 newdef BcHadronicFormFactor:MpoleF0A 10  0
 newdef BcHadronicFormFactor:MpoleFplusA 10  0
 newdef BcHadronicFormFactor:MpoleFminusA 10  0
 newdef BcHadronicFormFactor:Fplus 11  0
 newdef BcHadronicFormFactor:Fminus 11  0
 newdef BcHadronicFormFactor:FV 11  0.24
 newdef BcHadronicFormFactor:F0A 11  4.7
 newdef BcHadronicFormFactor:FplusA 11  -0.077
 newdef BcHadronicFormFactor:FminusA 11  0.13
 newdef BcHadronicFormFactor:MpoleFplus 11  0
 newdef BcHadronicFormFactor:MpoleFminus 11  0
 newdef BcHadronicFormFactor:MpoleFV 11  6.2
 newdef BcHadronicFormFactor:MpoleF0A 11  -1
 newdef BcHadronicFormFactor:MpoleFplusA 11  6.2
 newdef BcHadronicFormFactor:MpoleFminusA 11  6.2
 newdef BcHadronicFormFactor:Fplus 12  0.66
 newdef BcHadronicFormFactor:Fminus 12  -0.36
 newdef BcHadronicFormFactor:FV 12  0
 newdef BcHadronicFormFactor:F0A 12  0
 newdef BcHadronicFormFactor:FplusA 12  0
 newdef BcHadronicFormFactor:FminusA 12  0
 newdef BcHadronicFormFactor:MpoleFplus 12  4.5
 newdef BcHadronicFormFactor:MpoleFminus 12  4.5
 newdef BcHadronicFormFactor:MpoleFV 12  0
 newdef BcHadronicFormFactor:MpoleF0A 12  0
 newdef BcHadronicFormFactor:MpoleFplusA 12  0
 newdef BcHadronicFormFactor:MpoleFminusA 12  0
 newdef BcHadronicFormFactor:Fplus 13  0
 newdef BcHadronicFormFactor:Fminus 13  0
 newdef BcHadronicFormFactor:FV 13  0.11
 newdef BcHadronicFormFactor:F0A 13  5.9
 newdef BcHadronicFormFactor:FplusA 13  -0.074
 newdef BcHadronicFormFactor:FminusA 13  0.12
 newdef BcHadronicFormFactor:MpoleFplus 13  0
 newdef BcHadronicFormFactor:MpoleFminus 13  0
 newdef BcHadronicFormFactor:MpoleFV 13  5.5
 newdef BcHadronicFormFactor:MpoleF0A 13  5.5
 newdef BcHadronicFormFactor:MpoleFplusA 13  5.5
 newdef BcHadronicFormFactor:MpoleFminusA 13  5.5
 newdef BcHadronicFormFactor:Fplus 14  0.17
 newdef BcHadronicFormFactor:Fminus 14  -0.16
 newdef BcHadronicFormFactor:FV 14  0
 newdef BcHadronicFormFactor:F0A 14  0
 newdef BcHadronicFormFactor:FplusA 14  0
 newdef BcHadronicFormFactor:FminusA 14  0
 newdef BcHadronicFormFactor:MpoleFplus 14  4.5
 newdef BcHadronicFormFactor:MpoleFminus 14  4.5
 newdef BcHadronicFormFactor:MpoleFV 14  0
 newdef BcHadronicFormFactor:MpoleF0A 14  0
 newdef BcHadronicFormFactor:MpoleFplusA 14  0
 newdef BcHadronicFormFactor:MpoleFminusA 14  0
 newdef BcHadronicFormFactor:Fplus 15  0
 newdef BcHadronicFormFactor:Fminus 15  0
 newdef BcHadronicFormFactor:FV 15  0.035
 newdef BcHadronicFormFactor:F0A 15  1.686
 newdef BcHadronicFormFactor:FplusA 15  -0.015
 newdef BcHadronicFormFactor:FminusA 15  0.052
 newdef BcHadronicFormFactor:MpoleFplus 15  0
 newdef BcHadronicFormFactor:MpoleFminus 15  0
 newdef BcHadronicFormFactor:MpoleFV 15  4.2
 newdef BcHadronicFormFactor:MpoleF0A 15  4.2
 newdef BcHadronicFormFactor:MpoleFplusA 15  4.2
 newdef BcHadronicFormFactor:MpoleFminusA 15  4.2
 newdef BcHadronicFormFactor:Incoming 0 541
 newdef BcHadronicFormFactor:Outgoing 0 531
 newdef BcHadronicFormFactor:Spin 0 0
 newdef BcHadronicFormFactor:Spectator 0 -5
 newdef BcHadronicFormFactor:InQuark 0 4
 newdef BcHadronicFormFactor:OutQuark 0 3
 newdef BcHadronicFormFactor:Incoming 1 541
 newdef BcHadronicFormFactor:Outgoing 1 533
 newdef BcHadronicFormFactor:Spin 1 1
 newdef BcHadronicFormFactor:Spectator 1 -5
 newdef BcHadronicFormFactor:InQuark 1 4
 newdef BcHadronicFormFactor:OutQuark 1 3
 newdef BcHadronicFormFactor:Incoming 2 541
 newdef BcHadronicFormFactor:Outgoing 2 511
 newdef BcHadronicFormFactor:Spin 2 0
 newdef BcHadronicFormFactor:Spectator 2 -5
 newdef BcHadronicFormFactor:InQuark 2 4
 newdef BcHadronicFormFactor:OutQuark 2 1
 newdef BcHadronicFormFactor:Incoming 3 541
 newdef BcHadronicFormFactor:Outgoing 3 521
 newdef BcHadronicFormFactor:Spin 3 0
 newdef BcHadronicFormFactor:Spectator 3 -5
 newdef BcHadronicFormFactor:InQuark 3 4
 newdef BcHadronicFormFactor:OutQuark 3 2
 newdef BcHadronicFormFactor:Incoming 4 541
 newdef BcHadronicFormFactor:Outgoing 4 513
 newdef BcHadronicFormFactor:Spin 4 1
 newdef BcHadronicFormFactor:Spectator 4 -5
 newdef BcHadronicFormFactor:InQuark 4 4
 newdef BcHadronicFormFactor:OutQuark 4 1
 newdef BcHadronicFormFactor:Incoming 5 541
 newdef BcHadronicFormFactor:Outgoing 5 523
 newdef BcHadronicFormFactor:Spin 5 1
 newdef BcHadronicFormFactor:Spectator 5 -5
 newdef BcHadronicFormFactor:InQuark 5 4
 newdef BcHadronicFormFactor:OutQuark 5 2
 newdef BcHadronicFormFactor:Incoming 6 -541
 newdef BcHadronicFormFactor:Outgoing 6 -411
 newdef BcHadronicFormFactor:Spin 6 0
 newdef BcHadronicFormFactor:Spectator 6 -4
 newdef BcHadronicFormFactor:InQuark 6 5
 newdef BcHadronicFormFactor:OutQuark 6 1
 newdef BcHadronicFormFactor:Incoming 7 -541
 newdef BcHadronicFormFactor:Outgoing 7 -421
 newdef BcHadronicFormFactor:Spin 7 0
 newdef BcHadronicFormFactor:Spectator 7 -4
 newdef BcHadronicFormFactor:InQuark 7 5
 newdef BcHadronicFormFactor:OutQuark 7 2
 newdef BcHadronicFormFactor:Incoming 8 -541
 newdef BcHadronicFormFactor:Outgoing 8 -413
 newdef BcHadronicFormFactor:Spin 8 1
 newdef BcHadronicFormFactor:Spectator 8 -4
 newdef BcHadronicFormFactor:InQuark 8 5
 newdef BcHadronicFormFactor:OutQuark 8 1
 newdef BcHadronicFormFactor:Incoming 9 -541
 newdef BcHadronicFormFactor:Outgoing 9 -423
 newdef BcHadronicFormFactor:Spin 9 1
 newdef BcHadronicFormFactor:Spectator 9 -4
 newdef BcHadronicFormFactor:InQuark 9 5
 newdef BcHadronicFormFactor:OutQuark 9 2
 newdef BcHadronicFormFactor:Incoming 10 -541
 newdef BcHadronicFormFactor:Outgoing 10 -431
 newdef BcHadronicFormFactor:Spin 10 0
 newdef BcHadronicFormFactor:Spectator 10 -4
 newdef BcHadronicFormFactor:InQuark 10 5
 newdef BcHadronicFormFactor:OutQuark 10 3
 newdef BcHadronicFormFactor:Incoming 11 -541
 newdef BcHadronicFormFactor:Outgoing 11 -433
 newdef BcHadronicFormFactor:Spin 11 1
 newdef BcHadronicFormFactor:Spectator 11 -4
 newdef BcHadronicFormFactor:InQuark 11 5
 newdef BcHadronicFormFactor:OutQuark 11 3
 newdef BcHadronicFormFactor:Incoming 12 -541
 newdef BcHadronicFormFactor:Outgoing 12 441
 newdef BcHadronicFormFactor:Spin 12 0
 newdef BcHadronicFormFactor:Spectator 12 -4
 newdef BcHadronicFormFactor:InQuark 12 5
 newdef BcHadronicFormFactor:OutQuark 12 4
 newdef BcHadronicFormFactor:Incoming 13 -541
 newdef BcHadronicFormFactor:Outgoing 13 443
 newdef BcHadronicFormFactor:Spin 13 1
 newdef BcHadronicFormFactor:Spectator 13 -4
 newdef BcHadronicFormFactor:InQuark 13 5
 newdef BcHadronicFormFactor:OutQuark 13 4
 newdef BcHadronicFormFactor:Incoming 14 -541
 newdef BcHadronicFormFactor:Outgoing 14 100441
 newdef BcHadronicFormFactor:Spin 14 0
 newdef BcHadronicFormFactor:Spectator 14 -4
 newdef BcHadronicFormFactor:InQuark 14 5
 newdef BcHadronicFormFactor:OutQuark 14 4
 newdef BcHadronicFormFactor:Incoming 15 -541
 newdef BcHadronicFormFactor:Outgoing 15 100443
 newdef BcHadronicFormFactor:Spin 15 1
 newdef BcHadronicFormFactor:Spectator 15 -4
 newdef BcHadronicFormFactor:InQuark 15 5
 newdef BcHadronicFormFactor:OutQuark 15 4
 insert BcHadronic:FormFactors 0 BcHadronicFormFactor
 insert BcHadronic:WeightLocation 0 0
 insert BcHadronic:WeightLocation 1 0
 insert BcHadronic:WeightLocation 2 0
 insert BcHadronic:WeightLocation 3 0
 insert BcHadronic:WeightLocation 4 0
 insert BcHadronic:WeightLocation 5 0
 insert BcHadronic:WeightLocation 6 0
 insert BcHadronic:WeightLocation 7 0
 insert BcHadronic:WeightLocation 8 0
 insert BcHadronic:WeightLocation 9 0
 insert BcHadronic:WeightLocation 10 0
 insert BcHadronic:WeightLocation 11 0
 insert BcHadronic:WeightLocation 12 0
 insert BcHadronic:WeightLocation 13 0
 insert BcHadronic:WeightLocation 14 0
 insert BcHadronic:WeightLocation 15 0
 insert BcHadronic:WeightLocation 16 0
 insert BcHadronic:WeightLocation 17 0
 insert BcHadronic:WeightLocation 18 0
 insert BcHadronic:WeightLocation 19 0
 insert BcHadronic:WeightLocation 20 0
 insert BcHadronic:WeightLocation 21 0
 insert BcHadronic:WeightLocation 22 0
 insert BcHadronic:WeightLocation 23 0
 insert BcHadronic:WeightLocation 24 0
 insert BcHadronic:WeightLocation 25 0
 insert BcHadronic:WeightLocation 26 0
 insert BcHadronic:WeightLocation 27 0
 insert BcHadronic:WeightLocation 28 0
 insert BcHadronic:WeightLocation 29 0
 insert BcHadronic:WeightLocation 30 0
 insert BcHadronic:WeightLocation 31 0
 insert BcHadronic:WeightLocation 32 0
 insert BcHadronic:WeightLocation 33 0
 insert BcHadronic:WeightLocation 34 0
 insert BcHadronic:WeightLocation 35 0
 insert BcHadronic:WeightLocation 36 0
 insert BcHadronic:WeightLocation 37 0
 insert BcHadronic:WeightLocation 38 0
 insert BcHadronic:WeightLocation 39 0
 insert BcHadronic:WeightLocation 40 0
 insert BcHadronic:WeightLocation 41 0
 insert BcHadronic:WeightLocation 42 0
 insert BcHadronic:WeightLocation 43 0
 insert BcHadronic:WeightLocation 44 0
 insert BcHadronic:WeightLocation 45 0
 insert BcHadronic:WeightLocation 46 0
 insert BcHadronic:WeightLocation 47 0
 insert BcHadronic:WeightLocation 48 0
 insert BcHadronic:WeightLocation 49 0
 insert BcHadronic:WeightLocation 50 0
 insert BcHadronic:WeightLocation 51 0
 insert BcHadronic:WeightLocation 52 0
 insert BcHadronic:WeightLocation 53 0
 insert BcHadronic:WeightLocation 54 0
 insert BcHadronic:WeightLocation 55 0
 insert BcHadronic:WeightLocation 56 0
 insert BcHadronic:WeightLocation 57 0
 insert BcHadronic:WeightLocation 58 0
 insert BcHadronic:WeightLocation 59 0
 insert BcHadronic:WeightLocation 60 0
 insert BcHadronic:WeightLocation 61 0
 insert BcHadronic:WeightLocation 62 0
 insert BcHadronic:WeightLocation 63 0
 insert BcHadronic:WeightLocation 64 0
 insert BcHadronic:WeightLocation 65 0
 insert BcHadronic:WeightLocation 66 0
 insert BcHadronic:WeightLocation 67 0
 insert BcHadronic:WeightLocation 68 0
 insert BcHadronic:WeightLocation 69 0
 insert BcHadronic:WeightLocation 70 0
 insert BcHadronic:WeightLocation 71 0
 insert BcHadronic:WeightLocation 72 0
 insert BcHadronic:WeightLocation 73 0
 insert BcHadronic:WeightLocation 74 0
 insert BcHadronic:WeightLocation 75 0
 insert BcHadronic:WeightLocation 76 0
 insert BcHadronic:WeightLocation 77 0
 insert BcHadronic:WeightLocation 78 0
 insert BcHadronic:WeightLocation 79 0
 insert BcHadronic:WeightLocation 80 0
 insert BcHadronic:WeightLocation 81 0
 insert BcHadronic:WeightLocation 82 0
 insert BcHadronic:WeightLocation 83 0
 insert BcHadronic:WeightLocation 84 0
 insert BcHadronic:WeightLocation 85 0
 insert BcHadronic:WeightLocation 86 0
 insert BcHadronic:WeightLocation 87 0
 insert BcHadronic:WeightLocation 88 0
 insert BcHadronic:WeightLocation 89 0
 insert BcHadronic:WeightLocation 90 0
 insert BcHadronic:WeightLocation 91 0
 insert BcHadronic:WeightLocation 92 0
 insert BcHadronic:WeightLocation 93 0
 insert BcHadronic:WeightLocation 94 0
 insert BcHadronic:WeightLocation 95 0
 insert BcHadronic:WeightLocation 96 0
 insert BcHadronic:WeightLocation 97 0
 insert BcHadronic:WeightLocation 98 0
 insert BcHadronic:WeightLocation 99 0
 insert BcHadronic:WeightLocation 100 0
 insert BcHadronic:WeightLocation 101 0
 insert BcHadronic:WeightLocation 102 0
 insert BcHadronic:WeightLocation 103 0
 insert BcHadronic:WeightLocation 104 0
 insert BcHadronic:WeightLocation 105 0
 insert BcHadronic:WeightLocation 106 0
 insert BcHadronic:WeightLocation 107 0
 insert BcHadronic:WeightLocation 108 0
 insert BcHadronic:WeightLocation 109 0
 insert BcHadronic:WeightLocation 110 0
 insert BcHadronic:WeightLocation 111 0
 insert BcHadronic:WeightLocation 112 0
 insert BcHadronic:WeightLocation 113 0
 insert BcHadronic:WeightLocation 114 0
 insert BcHadronic:WeightLocation 115 0
 insert BcHadronic:WeightLocation 116 0
 insert BcHadronic:WeightLocation 117 0
 insert BcHadronic:WeightLocation 118 0
 insert BcHadronic:WeightLocation 119 0
 insert BcHadronic:WeightLocation 120 0
 insert BcHadronic:WeightLocation 121 0
 insert BcHadronic:WeightLocation 122 0
 insert BcHadronic:WeightLocation 123 0
 insert BcHadronic:WeightLocation 124 0
 insert BcHadronic:WeightLocation 125 0
 insert BcHadronic:WeightLocation 126 0
 insert BcHadronic:WeightLocation 127 0
 insert BcHadronic:WeightLocation 128 0
 insert BcHadronic:WeightLocation 129 0
 insert BcHadronic:WeightLocation 130 0
 insert BcHadronic:WeightLocation 131 0
 insert BcHadronic:WeightLocation 132 0
 insert BcHadronic:WeightLocation 133 0
 insert BcHadronic:WeightLocation 134 0
 insert BcHadronic:WeightLocation 135 0
 insert BcHadronic:WeightLocation 136 0
 insert BcHadronic:WeightLocation 137 0
 insert BcHadronic:WeightLocation 138 0
 insert BcHadronic:MaximumWeight 0 0.193116
 insert BcHadronic:MaximumWeight 1 0.0124475
 insert BcHadronic:MaximumWeight 2 0.20794
 insert BcHadronic:MaximumWeight 3 0.0025397
 insert BcHadronic:MaximumWeight 4 0.00122669
 insert BcHadronic:MaximumWeight 5 0.084093
 insert BcHadronic:MaximumWeight 6 0.00487514
 insert BcHadronic:MaximumWeight 7 0.282946
 insert BcHadronic:MaximumWeight 8 0.00246642
 insert BcHadronic:MaximumWeight 9 0.00277351
 insert BcHadronic:MaximumWeight 10 0.0125732
 insert BcHadronic:MaximumWeight 11 0.000818638
 insert BcHadronic:MaximumWeight 12 0.0175067
 insert BcHadronic:MaximumWeight 13 0.000433506
 insert BcHadronic:MaximumWeight 14 0.000472281
 insert BcHadronic:MaximumWeight 15 0.000439635
 insert BcHadronic:MaximumWeight 16 0.000944917
 insert BcHadronic:MaximumWeight 17 9.54905e-06
 insert BcHadronic:MaximumWeight 18 5.69733e-05
 insert BcHadronic:MaximumWeight 19 0.020296
 insert BcHadronic:MaximumWeight 20 0.000609773
 insert BcHadronic:MaximumWeight 21 0.000755185
 insert BcHadronic:MaximumWeight 22 1.69391e-07
 insert BcHadronic:MaximumWeight 23 2.91996e-05
 insert BcHadronic:MaximumWeight 24 0.010402
 insert BcHadronic:MaximumWeight 25 1.69718e-05
 insert BcHadronic:MaximumWeight 26 0.0109577
 insert BcHadronic:MaximumWeight 27 0.00065288
 insert BcHadronic:MaximumWeight 28 0.0341826
 insert BcHadronic:MaximumWeight 29 0.00119113
 insert BcHadronic:MaximumWeight 30 0.00118643
 insert BcHadronic:MaximumWeight 31 0.000382964
 insert BcHadronic:MaximumWeight 32 0.000725851
 insert BcHadronic:MaximumWeight 33 7.9988e-08
 insert BcHadronic:MaximumWeight 34 4.52867e-05
 insert BcHadronic:MaximumWeight 35 0.0161328
 insert BcHadronic:MaximumWeight 36 0.00119259
 insert BcHadronic:MaximumWeight 37 0.00221337
 insert BcHadronic:MaximumWeight 38 7.96752e-05
 insert BcHadronic:MaximumWeight 39 0.0283814
 insert BcHadronic:MaximumWeight 40 4.22191e-05
 insert BcHadronic:MaximumWeight 41 9.08505e-08
 insert BcHadronic:MaximumWeight 42 4.59476e-08
 insert BcHadronic:MaximumWeight 43 4.25866e-08
 insert BcHadronic:MaximumWeight 44 5.70395e-05
 insert BcHadronic:MaximumWeight 45 5.36411e-07
 insert BcHadronic:MaximumWeight 46 0.000198872
 insert BcHadronic:MaximumWeight 47 2.3597e-07
 insert BcHadronic:MaximumWeight 48 6.31403e-07
 insert BcHadronic:MaximumWeight 49 2.76313e-07
 insert BcHadronic:MaximumWeight 50 6.53392e-05
 insert BcHadronic:MaximumWeight 51 1.16228e-06
 insert BcHadronic:MaximumWeight 52 0.000235939
 insert BcHadronic:MaximumWeight 53 2.05836e-05
 insert BcHadronic:MaximumWeight 54 5.9122e-06
 insert BcHadronic:MaximumWeight 55 4.70365e-07
 insert BcHadronic:MaximumWeight 56 1.10156e-05
 insert BcHadronic:MaximumWeight 57 1.67266e-06
 insert BcHadronic:MaximumWeight 58 1.53556e-05
 insert BcHadronic:MaximumWeight 59 1.82907e-06
 insert BcHadronic:MaximumWeight 60 1.79884e-05
 insert BcHadronic:MaximumWeight 61 1.40662e-06
 insert BcHadronic:MaximumWeight 62 2.91319e-05
 insert BcHadronic:MaximumWeight 63 7.40867e-06
 insert BcHadronic:MaximumWeight 64 1.24654e-07
 insert BcHadronic:MaximumWeight 65 6.23803e-08
 insert BcHadronic:MaximumWeight 66 5.52852e-08
 insert BcHadronic:MaximumWeight 67 6.86018e-05
 insert BcHadronic:MaximumWeight 68 0.000379401
 insert BcHadronic:MaximumWeight 69 5.19375e-07
 insert BcHadronic:MaximumWeight 70 1.2337e-06
 insert BcHadronic:MaximumWeight 71 7.15604e-07
 insert BcHadronic:MaximumWeight 72 0.000326321
 insert BcHadronic:MaximumWeight 73 3.0374e-06
 insert BcHadronic:MaximumWeight 74 0.00032888
 insert BcHadronic:MaximumWeight 75 1.19174e-05
 insert BcHadronic:MaximumWeight 76 7.10892e-06
 insert BcHadronic:MaximumWeight 77 5.61702e-07
 insert BcHadronic:MaximumWeight 78 2.84121e-05
 insert BcHadronic:MaximumWeight 79 1.59808e-06
 insert BcHadronic:MaximumWeight 80 3.1846e-05
 insert BcHadronic:MaximumWeight 81 4.98412e-06
 insert BcHadronic:MaximumWeight 82 4.0687e-05
 insert BcHadronic:MaximumWeight 83 6.63582e-05
 insert BcHadronic:MaximumWeight 84 4.36959e-05
 insert BcHadronic:MaximumWeight 85 9.2186e-09
 insert BcHadronic:MaximumWeight 86 4.66808e-09
 insert BcHadronic:MaximumWeight 87 4.33871e-09
 insert BcHadronic:MaximumWeight 88 5.88252e-06
 insert BcHadronic:MaximumWeight 89 0.00413246
 insert BcHadronic:MaximumWeight 90 2.39036e-08
 insert BcHadronic:MaximumWeight 91 6.43915e-08
 insert BcHadronic:MaximumWeight 92 2.79334e-08
 insert BcHadronic:MaximumWeight 93 6.52122e-06
 insert BcHadronic:MaximumWeight 94 0.00570196
 insert BcHadronic:MaximumWeight 95 0.000504975
 insert BcHadronic:MaximumWeight 96 9.5212e-09
 insert BcHadronic:MaximumWeight 97 4.76489e-09
 insert BcHadronic:MaximumWeight 98 4.31181e-09
 insert BcHadronic:MaximumWeight 99 5.13987e-06
 insert BcHadronic:MaximumWeight 100 0.00820037
 insert BcHadronic:MaximumWeight 101 4.05699e-08
 insert BcHadronic:MaximumWeight 102 9.73322e-08
 insert BcHadronic:MaximumWeight 103 4.94781e-08
 insert BcHadronic:MaximumWeight 104 2.19891e-05
 insert BcHadronic:MaximumWeight 105 0.00646066
 insert BcHadronic:MaximumWeight 106 0.00019162
 insert BcHadronic:MaximumWeight 107 0.00194861
 insert BcHadronic:MaximumWeight 108 0.000156104
 insert BcHadronic:MaximumWeight 109 0.000658833
 insert BcHadronic:MaximumWeight 110 0.00495538
 insert BcHadronic:MaximumWeight 111 0.000541734
 insert BcHadronic:MaximumWeight 112 0.00568466
 insert BcHadronic:MaximumWeight 113 0.00192927
 insert BcHadronic:MaximumWeight 114 0.00141085
 insert BcHadronic:MaximumWeight 115 0.000111666
 insert BcHadronic:MaximumWeight 116 0.000256352
 insert BcHadronic:MaximumWeight 117 0.00473289
 insert BcHadronic:MaximumWeight 118 0.000725369
 insert BcHadronic:MaximumWeight 119 0.00597086
 insert BcHadronic:MaximumWeight 120 0.00507513
 insert BcHadronic:MaximumWeight 121 8.38225e-05
 insert BcHadronic:MaximumWeight 122 6.62744e-06
 insert BcHadronic:MaximumWeight 123 9.59456e-06
 insert BcHadronic:MaximumWeight 124 0.000214975
 insert BcHadronic:MaximumWeight 125 1.67729e-05
 insert BcHadronic:MaximumWeight 126 0.000202917
 insert BcHadronic:MaximumWeight 127 2.00142e-05
 insert BcHadronic:MaximumWeight 128 0.00022541
 insert BcHadronic:MaximumWeight 129 7.04733e-06
 insert BcHadronic:MaximumWeight 130 0.000134124
 insert BcHadronic:MaximumWeight 131 2.3384e-05
 insert BcHadronic:MaximumWeight 132 8.24132e-05
 insert BcHadronic:MaximumWeight 133 6.50316e-06
 insert BcHadronic:MaximumWeight 134 6.40716e-06
 insert BcHadronic:MaximumWeight 135 0.000286851
 insert BcHadronic:MaximumWeight 136 4.44615e-05
 insert BcHadronic:MaximumWeight 137 0.000366705
 insert BcHadronic:MaximumWeight 138 0.000226844
 #
 create Herwig::SemiLeptonicBaryonDecayer  ExcitedLambda
 newdef ExcitedLambda:Iteration 1
 newdef ExcitedLambda:Ntry 500
 newdef ExcitedLambda:Points 10000
 insert ExcitedLambda:MaximumWeight 0 0.00284407
 insert ExcitedLambda:MaximumWeight 1 0.00277839
 insert ExcitedLambda:MaximumWeight 2 0.000412905
 insert ExcitedLambda:MaximumWeight 3 0.00244756
 insert ExcitedLambda:MaximumWeight 4 0.0024288
 insert ExcitedLambda:MaximumWeight 5 0.000347225
 create Herwig::LeptonNeutrinoCurrent ExcitedLambdaCurrent
 newdef ExcitedLambdaCurrent:Quark 0  11
 newdef ExcitedLambdaCurrent:AntiQuark 0  -12
 newdef ExcitedLambdaCurrent:Quark 1  13
 newdef ExcitedLambdaCurrent:AntiQuark 1  -15
 newdef ExcitedLambdaCurrent:Quark 2  15
 newdef ExcitedLambdaCurrent:AntiQuark 2  -16
 newdef ExcitedLambda:Current ExcitedLambdaCurrent
 create Herwig::LambdabExcitedLambdacSumRuleFormFactor ExcitedLambdaForm
 newdef ExcitedLambdaForm:Xi          0.29
 newdef ExcitedLambdaForm:Rho2        2.01
 newdef ExcitedLambdaForm:Incoming 0 5122
 newdef ExcitedLambdaForm:Outgoing 0 101242
 newdef ExcitedLambdaForm:InSpin 0 2
 newdef ExcitedLambdaForm:OutSpin 0 2
 newdef ExcitedLambdaForm:Spectator1 0 1
 newdef ExcitedLambdaForm:Spectator2 0 2
 newdef ExcitedLambdaForm:InQuark 0 5
 newdef ExcitedLambdaForm:OutQuark 0 4
 newdef ExcitedLambdaForm:Incoming 1 5122
 newdef ExcitedLambdaForm:Outgoing 1 101244
 newdef ExcitedLambdaForm:InSpin 1 2
 newdef ExcitedLambdaForm:OutSpin 1 4
 newdef ExcitedLambdaForm:Spectator1 1 1
 newdef ExcitedLambdaForm:Spectator2 1 2
 newdef ExcitedLambdaForm:InQuark 1 5
 newdef ExcitedLambdaForm:OutQuark 1 4
 newdef ExcitedLambda:FormFactor ExcitedLambdaForm
 #
 create Herwig::RadiativeHeavyBaryonDecayer  HeavyGamma
 newdef HeavyGamma:Iteration 1
 newdef HeavyGamma:Ntry 500
 newdef HeavyGamma:Points 10000
 newdef HeavyGamma:GenerateIntermediates 0
 newdef HeavyGamma:M1Coupling 0 1.1004e-05
 newdef HeavyGamma:E1Coupling 0 0
 newdef HeavyGamma:Incoming 0 4312
 newdef HeavyGamma:OutgoingB 0 4132
 newdef HeavyGamma:ModeType 0 1
 newdef HeavyGamma:MaxWeight 0 1.66921
 newdef HeavyGamma:M1Coupling 1 9.4102e-05
 newdef HeavyGamma:E1Coupling 1 0
 newdef HeavyGamma:Incoming 1 4322
 newdef HeavyGamma:OutgoingB 1 4232
 newdef HeavyGamma:ModeType 1 1
 newdef HeavyGamma:MaxWeight 1 1.67004
 newdef HeavyGamma:M1Coupling 2 1.1004e-05
 newdef HeavyGamma:E1Coupling 2 0
 newdef HeavyGamma:Incoming 2 5312
 newdef HeavyGamma:OutgoingB 2 5132
 newdef HeavyGamma:ModeType 2 1
 newdef HeavyGamma:MaxWeight 2 1.63358
 newdef HeavyGamma:M1Coupling 3 9.4102e-05
 newdef HeavyGamma:E1Coupling 3 0
 newdef HeavyGamma:Incoming 3 5322
 newdef HeavyGamma:OutgoingB 3 5232
 newdef HeavyGamma:ModeType 3 1
 newdef HeavyGamma:MaxWeight 3 1.60473
 newdef HeavyGamma:M1Coupling 4 0.000376
 newdef HeavyGamma:E1Coupling 4 0
 newdef HeavyGamma:Incoming 4 4214
 newdef HeavyGamma:OutgoingB 4 4122
 newdef HeavyGamma:ModeType 4 1
 newdef HeavyGamma:MaxWeight 4 0.035949
 newdef HeavyGamma:M1Coupling 5 0.000376
 newdef HeavyGamma:E1Coupling 5 0
 newdef HeavyGamma:Incoming 5 5214
 newdef HeavyGamma:OutgoingB 5 5122
 newdef HeavyGamma:ModeType 5 1
 newdef HeavyGamma:MaxWeight 5 0.03294
 newdef HeavyGamma:M1Coupling 6 3.74e-05
 newdef HeavyGamma:E1Coupling 6 0
 newdef HeavyGamma:Incoming 6 4314
 newdef HeavyGamma:OutgoingB 6 4132
 newdef HeavyGamma:ModeType 6 1
 newdef HeavyGamma:MaxWeight 6 0.000579519
 newdef HeavyGamma:M1Coupling 7 0.00032486
 newdef HeavyGamma:E1Coupling 7 0
 newdef HeavyGamma:Incoming 7 4324
 newdef HeavyGamma:OutgoingB 7 4232
 newdef HeavyGamma:ModeType 7 1
 newdef HeavyGamma:MaxWeight 7 0.0462769
 newdef HeavyGamma:M1Coupling 8 0.00010132
 newdef HeavyGamma:E1Coupling 8 0
 newdef HeavyGamma:Incoming 8 5314
 newdef HeavyGamma:OutgoingB 8 5132
 newdef HeavyGamma:ModeType 8 1
 newdef HeavyGamma:MaxWeight 8 0.00429418
 newdef HeavyGamma:M1Coupling 9 0.00032486
 newdef HeavyGamma:E1Coupling 9 0
 newdef HeavyGamma:Incoming 9 5324
 newdef HeavyGamma:OutgoingB 9 5232
 newdef HeavyGamma:ModeType 9 1
 newdef HeavyGamma:MaxWeight 9 0.0463449
 newdef HeavyGamma:M1Coupling 10 0.0001088
 newdef HeavyGamma:E1Coupling 10 0
 newdef HeavyGamma:Incoming 10 4212
 newdef HeavyGamma:OutgoingB 10 4122
 newdef HeavyGamma:ModeType 10 1
 newdef HeavyGamma:MaxWeight 10 0.064517
 newdef HeavyGamma:M1Coupling 11 0.0001088
 newdef HeavyGamma:E1Coupling 11 0
 newdef HeavyGamma:Incoming 11 5212
 newdef HeavyGamma:OutgoingB 11 5122
 newdef HeavyGamma:ModeType 11 1
 newdef HeavyGamma:MaxWeight 11 0.0325132
 newdef HeavyGamma:M1Coupling 12 0.0003337
 newdef HeavyGamma:E1Coupling 12 0
 newdef HeavyGamma:Incoming 12 4224
 newdef HeavyGamma:OutgoingB 12 4222
 newdef HeavyGamma:ModeType 12 1
 newdef HeavyGamma:MaxWeight 12 0.00297666
 newdef HeavyGamma:M1Coupling 13 8.34e-05
 newdef HeavyGamma:E1Coupling 13 0
 newdef HeavyGamma:Incoming 13 4214
 newdef HeavyGamma:OutgoingB 13 4212
 newdef HeavyGamma:ModeType 13 1
 newdef HeavyGamma:MaxWeight 13 0.000203503
 newdef HeavyGamma:M1Coupling 14 -0.0001688
 newdef HeavyGamma:E1Coupling 14 0
 newdef HeavyGamma:Incoming 14 4114
 newdef HeavyGamma:OutgoingB 14 4112
 newdef HeavyGamma:ModeType 14 1
 newdef HeavyGamma:MaxWeight 14 0.000903461
 newdef HeavyGamma:M1Coupling 15 -0.000611
 newdef HeavyGamma:E1Coupling 15 0
 newdef HeavyGamma:Incoming 15 4314
 newdef HeavyGamma:OutgoingB 15 4312
 newdef HeavyGamma:ModeType 15 1
 newdef HeavyGamma:MaxWeight 15 0.0178619
 newdef HeavyGamma:M1Coupling 16 -0.0003607
 newdef HeavyGamma:E1Coupling 16 0
 newdef HeavyGamma:Incoming 16 4324
 newdef HeavyGamma:OutgoingB 16 4322
 newdef HeavyGamma:ModeType 16 1
 newdef HeavyGamma:MaxWeight 16 0.00671238
 newdef HeavyGamma:M1Coupling 17 0.001055
 newdef HeavyGamma:E1Coupling 17 0
 newdef HeavyGamma:Incoming 17 4334
 newdef HeavyGamma:OutgoingB 17 4332
 newdef HeavyGamma:ModeType 17 1
 newdef HeavyGamma:MaxWeight 17 1.59261
 newdef HeavyGamma:M1Coupling 18 0.0009945
 newdef HeavyGamma:E1Coupling 18 0
 newdef HeavyGamma:Incoming 18 5224
 newdef HeavyGamma:OutgoingB 18 5222
 newdef HeavyGamma:ModeType 18 1
 newdef HeavyGamma:MaxWeight 18 0.00818774
 newdef HeavyGamma:M1Coupling 19 0.0002486
 newdef HeavyGamma:E1Coupling 19 0
 newdef HeavyGamma:Incoming 19 5214
 newdef HeavyGamma:OutgoingB 19 5212
 newdef HeavyGamma:ModeType 19 1
 newdef HeavyGamma:MaxWeight 19 0.000627892
 newdef HeavyGamma:M1Coupling 20 -0.0004973
 newdef HeavyGamma:E1Coupling 20 0
 newdef HeavyGamma:Incoming 20 5114
 newdef HeavyGamma:OutgoingB 20 5112
 newdef HeavyGamma:ModeType 20 1
 newdef HeavyGamma:MaxWeight 20 0.0025886
 newdef HeavyGamma:M1Coupling 21 -0.0004371
 newdef HeavyGamma:E1Coupling 21 0
 newdef HeavyGamma:Incoming 21 5314
 newdef HeavyGamma:OutgoingB 21 5312
 newdef HeavyGamma:ModeType 21 1
 newdef HeavyGamma:MaxWeight 21 0.00938573
 newdef HeavyGamma:M1Coupling 22 0.0003088
 newdef HeavyGamma:E1Coupling 22 0
 newdef HeavyGamma:Incoming 22 5324
 newdef HeavyGamma:OutgoingB 22 5322
 newdef HeavyGamma:ModeType 22 1
 newdef HeavyGamma:MaxWeight 22 0.00506067
 newdef HeavyGamma:M1Coupling 23 -0.0003769
 newdef HeavyGamma:E1Coupling 23 0
 newdef HeavyGamma:Incoming 23 5334
 newdef HeavyGamma:OutgoingB 23 5332
 newdef HeavyGamma:ModeType 23 1
 newdef HeavyGamma:MaxWeight 23 1.67242
 #
 create Herwig::ScalarVectorVectorDecayer  SVV
 newdef SVV:Iteration 1
 newdef SVV:Ntry 2000
 newdef SVV:Points 10000
 newdef SVV:GenerateIntermediates 0
 newdef SVV:Incoming   0 10221
 newdef SVV:FirstOutgoing  0 113
 newdef SVV:SecondOutgoing 0 113
 newdef SVV:Coupling   0 11.26
 newdef SVV:MaxWeight  0 17.5926
 newdef SVV:Incoming   1 10221
 newdef SVV:FirstOutgoing  1 213
 newdef SVV:SecondOutgoing 1 -213
 newdef SVV:Coupling   1 15.92
 newdef SVV:MaxWeight  1 19.1659
 newdef SVV:Incoming   2 9030221
 newdef SVV:FirstOutgoing  2 113
 newdef SVV:SecondOutgoing 2 113
 newdef SVV:Coupling   2 1.691
 newdef SVV:MaxWeight  2 16.8
 newdef SVV:Incoming   3 9030221
 newdef SVV:FirstOutgoing  3 213
 newdef SVV:SecondOutgoing 3 -213
 newdef SVV:Coupling   3 2.391
 newdef SVV:MaxWeight  3 17.
 newdef SVV:Incoming   4 10441
 newdef SVV:FirstOutgoing  4 443
 newdef SVV:SecondOutgoing 4 22
 newdef SVV:Coupling   4 0.251
 newdef SVV:MaxWeight  4 1.1081
 newdef SVV:Incoming   5 10441
 newdef SVV:FirstOutgoing  5 323
 newdef SVV:SecondOutgoing 5 -323
 newdef SVV:Coupling   5 0.0088
 newdef SVV:MaxWeight  5 12.5
 newdef SVV:Incoming   6 10441
 newdef SVV:FirstOutgoing  6 313
 newdef SVV:SecondOutgoing 6 -313
 newdef SVV:Coupling   6 0.0088
 newdef SVV:MaxWeight  6 12.5
 newdef SVV:Incoming   7 10441
 newdef SVV:FirstOutgoing  7 333
 newdef SVV:SecondOutgoing 7 333
 newdef SVV:Coupling   7 0.0067
 newdef SVV:MaxWeight  7 9.85019
 newdef SVV:Incoming   8 10441
 newdef SVV:FirstOutgoing  8 22
 newdef SVV:SecondOutgoing 8 22
 newdef SVV:Coupling   8 0.0027
 newdef SVV:MaxWeight  8 1.10652
 newdef SVV:Incoming   9 10111
 newdef SVV:FirstOutgoing  9 113
 newdef SVV:SecondOutgoing 9 223
 newdef SVV:Coupling   9 27.09
 newdef SVV:MaxWeight  9 8.
 newdef SVV:Incoming   10 10211
 newdef SVV:FirstOutgoing  10 213
 newdef SVV:SecondOutgoing 10 223
 newdef SVV:Coupling   10 27.09
 newdef SVV:MaxWeight  10 8.
 newdef SVV:Incoming   11 10441
 newdef SVV:FirstOutgoing  11 223
 newdef SVV:SecondOutgoing 11 223
 newdef SVV:Coupling   11 0.0093
 newdef SVV:MaxWeight  11 11.5
 #
 create Herwig::a1SimpleDecayer  a1Simple
 newdef a1Simple:Iteration 5
 newdef a1Simple:Ntry 500
 newdef a1Simple:Points 10000
 newdef a1Simple:GenerateIntermediates 1
 newdef a1Simple:LocalParameters 1
 newdef a1Simple:Coupling 47.95
 newdef a1Simple:OneMax   12.
 newdef a1Simple:TwoMax   12.
 newdef a1Simple:ThreeMax 12.
 newdef    a1Simple:RhoMasses 0 773
 newdef    a1Simple:RhoMasses 1 1370
 newdef    a1Simple:RhoMasses 2 1750
 newdef    a1Simple:RhoWidths 0 145
 newdef    a1Simple:RhoWidths 1 510
 newdef    a1Simple:RhoWidths 2 120
 newdef    a1Simple:RhoWeights 0 1
 newdef    a1Simple:RhoWeights 1 -0.145
 newdef    a1Simple:RhoWeights 2 0
 newdef a1Simple:OneChargedWeights 0 0.224559
 newdef a1Simple:OneChargedWeights 1 0.2198
 newdef a1Simple:OneChargedWeights 2 0.137131
 newdef a1Simple:OneChargedWeights 3 0.138579
 newdef a1Simple:OneChargedWeights 4 0.138346
 newdef a1Simple:OneChargedWeights 5 0.141585
 newdef a1Simple:TwoChargedWeights 0 0.224847
 newdef a1Simple:TwoChargedWeights 1 0.220554
 newdef a1Simple:TwoChargedWeights 2 0.135879
 newdef a1Simple:TwoChargedWeights 3 0.13917
 newdef a1Simple:TwoChargedWeights 4 0.138596
 newdef a1Simple:TwoChargedWeights 5 0.140955
 newdef a1Simple:ThreeChargedWeights 0 0.223434
 newdef a1Simple:ThreeChargedWeights 1 0.222521
 newdef a1Simple:ThreeChargedWeights 2 0.141309
 newdef a1Simple:ThreeChargedWeights 3 0.134317
 newdef a1Simple:ThreeChargedWeights 4 0.139732
 newdef a1Simple:ThreeChargedWeights 5 0.138687
 #
 create Herwig::MamboDecayer  Mambo
 
 #
 create Herwig::TauDecayer  Tau5Pion
 newdef Tau5Pion:Iteration 10
 newdef Tau5Pion:Ntry 4000
 newdef Tau5Pion:Points 10000
 newdef Tau5Pion:GenerateIntermediates 1
 insert Tau5Pion:WeightLocation 0 0
 insert Tau5Pion:WeightLocation 1 12
 insert Tau5Pion:WeightLocation 2 30
 insert Tau5Pion:MaximumWeight 0 0.12
 insert Tau5Pion:MaximumWeight 1 1.10
 insert Tau5Pion:MaximumWeight 2 0.19
 insert Tau5Pion:Weights 0 0.0829231
 insert Tau5Pion:Weights 1 0.0837284
 insert Tau5Pion:Weights 2 0.0832389
 insert Tau5Pion:Weights 3 0.0828526
 insert Tau5Pion:Weights 4 0.0841606
 insert Tau5Pion:Weights 5 0.0834426
 insert Tau5Pion:Weights 6 0.0834811
 insert Tau5Pion:Weights 7 0.0824631
 insert Tau5Pion:Weights 8 0.0836733
 insert Tau5Pion:Weights 9 0.0830621
 insert Tau5Pion:Weights 10 0.0832661
 insert Tau5Pion:Weights 11 0.083708
 insert Tau5Pion:Weights 12 0.0655493
 insert Tau5Pion:Weights 13 0.0669399
 insert Tau5Pion:Weights 14 0.06701
 insert Tau5Pion:Weights 15 0.065621
 insert Tau5Pion:Weights 16 0.066326
 insert Tau5Pion:Weights 17 0.069194
 insert Tau5Pion:Weights 18 0.0643572
 insert Tau5Pion:Weights 19 0.0671479
 insert Tau5Pion:Weights 20 0.0680149
 insert Tau5Pion:Weights 21 0.0660456
 insert Tau5Pion:Weights 22 0.0667967
 insert Tau5Pion:Weights 23 0.0674793
 insert Tau5Pion:Weights 24 0.0355917
 insert Tau5Pion:Weights 25 0.0340749
 insert Tau5Pion:Weights 26 0.03507
 insert Tau5Pion:Weights 27 0.0355398
 insert Tau5Pion:Weights 28 0.0292482
 insert Tau5Pion:Weights 29 0.0299938
 insert Tau5Pion:Weights 30 0.0832497
 insert Tau5Pion:Weights 31 0.083435
 insert Tau5Pion:Weights 32 0.0839012
 insert Tau5Pion:Weights 33 0.0831666
 insert Tau5Pion:Weights 34 0.0820835
 insert Tau5Pion:Weights 35 0.0843757
 insert Tau5Pion:Weights 36 0.0825918
 insert Tau5Pion:Weights 37 0.0838889
 insert Tau5Pion:Weights 38 0.0838214
 insert Tau5Pion:Weights 39 0.0830818
 insert Tau5Pion:Weights 40 0.0826944
 insert Tau5Pion:Weights 41 0.08371
 create Herwig::FivePionCurrent Tau5PionCurrent HwWeakCurrents.so
 newdef Tau5PionCurrent:RhoMass 776
 newdef Tau5PionCurrent:A1Mass  1260
 newdef Tau5PionCurrent:SigmaMass  800
 newdef Tau5PionCurrent:OmegaMass  782
 newdef Tau5PionCurrent:RhoWidth 150
 newdef Tau5PionCurrent:A1Width  400
 newdef Tau5PionCurrent:SigmaWidth  600
 newdef Tau5PionCurrent:OmegaWidth  8.5
 newdef Tau5PionCurrent:LocalParameters 1
 newdef Tau5PionCurrent:RhoOmega 0
 newdef Tau5PionCurrent:C 4
 newdef Tau5PionCurrent:C0 3
 newdef Tau5PionCurrent:fomegarhopi 0.07
 newdef Tau5PionCurrent:grhopipi 6
 newdef Tau5PionCurrent:garhopi 6
 newdef Tau5PionCurrent:faaf 4
 newdef Tau5PionCurrent:ffpipi 5
 newdef Tau5PionCurrent:Quark 0  2
 newdef Tau5PionCurrent:AntiQuark 0  -1
 newdef Tau5PionCurrent:Quark 1  2
 newdef Tau5PionCurrent:AntiQuark 1  -1
 newdef Tau5PionCurrent:Quark 2  2
 newdef Tau5PionCurrent:AntiQuark 2  -1
 newdef Tau5Pion:WeakCurrent Tau5PionCurrent
 #
 create Herwig::OniumToOniumPiPiDecayer  OniumPiPi
 newdef OniumPiPi:Iteration 1
 newdef OniumPiPi:Ntry 500
 newdef OniumPiPi:Points 10000
 newdef OniumPiPi:GenerateIntermediates 0
 newdef OniumPiPi:Incoming 0 200553
 newdef OniumPiPi:Outgoing 0 553
 newdef OniumPiPi:Coupling 0 3.92e-06
 newdef OniumPiPi:ReA 0 1
 newdef OniumPiPi:ImA 0 0
 newdef OniumPiPi:ReB 0 -2.523
 newdef OniumPiPi:ImB 0 1.189
 newdef OniumPiPi:ReC 0 0
 newdef OniumPiPi:ImC 0 0
 newdef OniumPiPi:Incoming 1 200553
 newdef OniumPiPi:Outgoing 1 100553
 newdef OniumPiPi:Coupling 1 0.000311
 newdef OniumPiPi:ReA 1 1
 newdef OniumPiPi:ImA 1 0
 newdef OniumPiPi:ReB 1 -0.395
 newdef OniumPiPi:ImB 1 0.001
 newdef OniumPiPi:ReC 1 0
 newdef OniumPiPi:ImC 1 0
 newdef OniumPiPi:Incoming 2 100553
 newdef OniumPiPi:Outgoing 2 553
 newdef OniumPiPi:Coupling 2 6.14e-05
 newdef OniumPiPi:ReA 2 1
 newdef OniumPiPi:ImA 2 0
 newdef OniumPiPi:ReB 2 -0.753
 newdef OniumPiPi:ImB 2 0
 newdef OniumPiPi:ReC 2 0
 newdef OniumPiPi:ImC 2 0
 newdef OniumPiPi:Incoming 3 300553
 newdef OniumPiPi:Outgoing 3 553
 newdef OniumPiPi:Coupling 3 1.77e-06
 newdef OniumPiPi:ReA 3 1
 newdef OniumPiPi:ImA 3 0
 newdef OniumPiPi:ReB 3 0
 newdef OniumPiPi:ImB 3 0
 newdef OniumPiPi:ReC 3 0
 newdef OniumPiPi:ImC 3 0
 newdef OniumPiPi:Incoming 4 300553
 newdef OniumPiPi:Outgoing 4 100553
 newdef OniumPiPi:Coupling 4 6.88e-05
 newdef OniumPiPi:ReA 4 1
 newdef OniumPiPi:ImA 4 0
 newdef OniumPiPi:ReB 4 -2.35
 newdef OniumPiPi:ImB 4 0.55
 newdef OniumPiPi:ReC 4 0
 newdef OniumPiPi:ImC 4 0
 newdef OniumPiPi:Incoming 5 100443
 newdef OniumPiPi:Outgoing 5 443
 newdef OniumPiPi:Coupling 5 6.62e-05
 newdef OniumPiPi:ReA 5 1
 newdef OniumPiPi:ImA 5 0
 newdef OniumPiPi:ReB 5 -0.336
 newdef OniumPiPi:ImB 5 0
 newdef OniumPiPi:ReC 5 0
 newdef OniumPiPi:ImC 5 0
 newdef OniumPiPi:Incoming 6 30443
 newdef OniumPiPi:Outgoing 6 443
 newdef OniumPiPi:Coupling 6 2.06e-05
 newdef OniumPiPi:ReA 6 1
 newdef OniumPiPi:ImA 6 0
 newdef OniumPiPi:ReB 6 0
 newdef OniumPiPi:ImB 6 0
 newdef OniumPiPi:ReC 6 0
 newdef OniumPiPi:ImC 6 0
 newdef OniumPiPi:Incoming 7 9000553
 newdef OniumPiPi:Outgoing 7 553
 newdef OniumPiPi:Coupling 7 6.88e-05
 newdef OniumPiPi:ReA 7 1
 newdef OniumPiPi:ImA 7 0
 newdef OniumPiPi:ReB 7 -2.35
 newdef OniumPiPi:ImB 7 0.55
 newdef OniumPiPi:ReC 7 0
 newdef OniumPiPi:ImC 7 0
 newdef OniumPiPi:Incoming 8 9000553
 newdef OniumPiPi:Outgoing 8 100553
 newdef OniumPiPi:Coupling 8 6.88e-05
 newdef OniumPiPi:ReA 8 1
 newdef OniumPiPi:ImA 8 0
 newdef OniumPiPi:ReB 8 -2.35
 newdef OniumPiPi:ImB 8 0.55
 newdef OniumPiPi:ReC 8 0
 newdef OniumPiPi:ImC 8 0
 newdef OniumPiPi:Incoming 9 9000553
 newdef OniumPiPi:Outgoing 9 200553
 newdef OniumPiPi:Coupling 9 6.88e-05
 newdef OniumPiPi:ReA 9 1
 newdef OniumPiPi:ImA 9 0
 newdef OniumPiPi:ReB 9 -2.35
 newdef OniumPiPi:ImB 9 0.55
 newdef OniumPiPi:ReC 9 0
 newdef OniumPiPi:ImC 9 0
 newdef OniumPiPi:Incoming 10 9000553
 newdef OniumPiPi:Outgoing 10 10553
 newdef OniumPiPi:Coupling 10 6.88e-05
 newdef OniumPiPi:ReA 10 1
 newdef OniumPiPi:ImA 10 0
 newdef OniumPiPi:ReB 10 -2.35
 newdef OniumPiPi:ImB 10 0.55
 newdef OniumPiPi:ReC 10 0
 newdef OniumPiPi:ImC 10 0
 newdef OniumPiPi:Incoming 11 9000553
 newdef OniumPiPi:Outgoing 11 110553
 newdef OniumPiPi:Coupling 11 6.88e-05
 newdef OniumPiPi:ReA 11 1
 newdef OniumPiPi:ImA 11 0
 newdef OniumPiPi:ReB 11 -2.35
 newdef OniumPiPi:ImB 11 0.55
 newdef OniumPiPi:ReC 11 0
 newdef OniumPiPi:ImC 11 0
 newdef OniumPiPi:MaxWeight 0 4.26075
 newdef OniumPiPi:MaxWeight 1 4.82302
 newdef OniumPiPi:MaxWeight 2 2.40535
 newdef OniumPiPi:MaxWeight 3 2.36975
 newdef OniumPiPi:MaxWeight 4 3.26611
 newdef OniumPiPi:MaxWeight 5 3.64848
 newdef OniumPiPi:MaxWeight 6 2.94445
 newdef OniumPiPi:MaxWeight 7 2.98196
 newdef OniumPiPi:MaxWeight 8 5.1262
 newdef OniumPiPi:MaxWeight 9 5.45035
 newdef OniumPiPi:MaxWeight 10 3.04451
 newdef OniumPiPi:MaxWeight 11 3.08418
 newdef OniumPiPi:MaxWeight 12 2.60132
 newdef OniumPiPi:MaxWeight 13 3.2421
 #
 create Herwig::TauDecayer  Tau2K1Pi
 newdef Tau2K1Pi:Iteration 10
 newdef Tau2K1Pi:Ntry 500
 newdef Tau2K1Pi:Points 1000000
 newdef Tau2K1Pi:GenerateIntermediates 1
 insert Tau2K1Pi:WeightLocation 0 0
 insert Tau2K1Pi:WeightLocation 1 15
 insert Tau2K1Pi:WeightLocation 2 30
 insert Tau2K1Pi:WeightLocation 3 57
 insert Tau2K1Pi:WeightLocation 4 81
 insert Tau2K1Pi:WeightLocation 5 105
 insert Tau2K1Pi:MaximumWeight 0 0.0432342
 insert Tau2K1Pi:MaximumWeight 1 0.0402371
 insert Tau2K1Pi:MaximumWeight 2 0.0377649
 insert Tau2K1Pi:MaximumWeight 3 0.00891024
 insert Tau2K1Pi:MaximumWeight 4 0.00892244
 insert Tau2K1Pi:MaximumWeight 5 0.0289829
 insert Tau2K1Pi:Weights 0 0.135963
 insert Tau2K1Pi:Weights 1 0.0544693
 insert Tau2K1Pi:Weights 2 0.103456
 insert Tau2K1Pi:Weights 3 0.0407584
 insert Tau2K1Pi:Weights 4 0.0406337
 insert Tau2K1Pi:Weights 5 0.055166
 insert Tau2K1Pi:Weights 6 0.0410856
 insert Tau2K1Pi:Weights 7 0.17814
 insert Tau2K1Pi:Weights 8 0.0714935
 insert Tau2K1Pi:Weights 9 0.0701645
 insert Tau2K1Pi:Weights 10 0.0533418
 insert Tau2K1Pi:Weights 11 0.038983
 insert Tau2K1Pi:Weights 12 0.0671185
 insert Tau2K1Pi:Weights 13 0.0251201
 insert Tau2K1Pi:Weights 14 0.0241059
 insert Tau2K1Pi:Weights 15 0.134816
 insert Tau2K1Pi:Weights 16 0.0533723
 insert Tau2K1Pi:Weights 17 0.104429
 insert Tau2K1Pi:Weights 18 0.0421405
 insert Tau2K1Pi:Weights 19 0.0408935
 insert Tau2K1Pi:Weights 20 0.0542975
 insert Tau2K1Pi:Weights 21 0.0412704
 insert Tau2K1Pi:Weights 22 0.177165
 insert Tau2K1Pi:Weights 23 0.0707521
 insert Tau2K1Pi:Weights 24 0.0697738
 insert Tau2K1Pi:Weights 25 0.0541069
 insert Tau2K1Pi:Weights 26 0.0395385
 insert Tau2K1Pi:Weights 27 0.0677817
 insert Tau2K1Pi:Weights 28 0.024839
 insert Tau2K1Pi:Weights 29 0.0248236
 insert Tau2K1Pi:Weights 30 0.060583
 insert Tau2K1Pi:Weights 31 0.0599504
 insert Tau2K1Pi:Weights 32 0.0321508
 insert Tau2K1Pi:Weights 33 0.0461654
 insert Tau2K1Pi:Weights 34 0.0453398
 insert Tau2K1Pi:Weights 35 0.0260173
 insert Tau2K1Pi:Weights 36 0.0267423
 insert Tau2K1Pi:Weights 37 0.0259576
 insert Tau2K1Pi:Weights 38 0.0259962
 insert Tau2K1Pi:Weights 39 0.0343573
 insert Tau2K1Pi:Weights 40 0.0344674
 insert Tau2K1Pi:Weights 41 0.0270866
 insert Tau2K1Pi:Weights 42 0.0805987
 insert Tau2K1Pi:Weights 43 0.0787342
 insert Tau2K1Pi:Weights 44 0.0453765
 insert Tau2K1Pi:Weights 45 0.0443932
 insert Tau2K1Pi:Weights 46 0.0443514
 insert Tau2K1Pi:Weights 47 0.043594
 insert Tau2K1Pi:Weights 48 0.0332234
 insert Tau2K1Pi:Weights 49 0.0332983
 insert Tau2K1Pi:Weights 50 0.0247822
 insert Tau2K1Pi:Weights 51 0.030008
 insert Tau2K1Pi:Weights 52 0.0303925
 insert Tau2K1Pi:Weights 53 0.0170077
 insert Tau2K1Pi:Weights 54 0.0162828
 insert Tau2K1Pi:Weights 55 0.0163017
 insert Tau2K1Pi:Weights 56 0.0168413
 insert Tau2K1Pi:Weights 57 0.0689969
 insert Tau2K1Pi:Weights 58 0.0688125
 insert Tau2K1Pi:Weights 59 0.0530756
 insert Tau2K1Pi:Weights 60 0.0532699
 insert Tau2K1Pi:Weights 61 0.0281161
 insert Tau2K1Pi:Weights 62 0.0283676
 insert Tau2K1Pi:Weights 63 0.0286176
 insert Tau2K1Pi:Weights 64 0.0286531
 insert Tau2K1Pi:Weights 65 0.0371487
 insert Tau2K1Pi:Weights 66 0.0369731
 insert Tau2K1Pi:Weights 67 0.089269
 insert Tau2K1Pi:Weights 68 0.0897125
 insert Tau2K1Pi:Weights 69 0.0478451
 insert Tau2K1Pi:Weights 70 0.0480762
 insert Tau2K1Pi:Weights 71 0.0481653
 insert Tau2K1Pi:Weights 72 0.0467581
 insert Tau2K1Pi:Weights 73 0.0360446
 insert Tau2K1Pi:Weights 74 0.0353376
 insert Tau2K1Pi:Weights 75 0.0316765
 insert Tau2K1Pi:Weights 76 0.0313933
 insert Tau2K1Pi:Weights 77 0.0154869
 insert Tau2K1Pi:Weights 78 0.0159134
 insert Tau2K1Pi:Weights 79 0.0160241
 insert Tau2K1Pi:Weights 80 0.0162663
 insert Tau2K1Pi:Weights 81 0.0691784
 insert Tau2K1Pi:Weights 82 0.06884
 insert Tau2K1Pi:Weights 83 0.0527187
 insert Tau2K1Pi:Weights 84 0.0533145
 insert Tau2K1Pi:Weights 85 0.0281019
 insert Tau2K1Pi:Weights 86 0.0287812
 insert Tau2K1Pi:Weights 87 0.0286907
 insert Tau2K1Pi:Weights 88 0.0283158
 insert Tau2K1Pi:Weights 89 0.0370588
 insert Tau2K1Pi:Weights 90 0.0371021
 insert Tau2K1Pi:Weights 91 0.0897679
 insert Tau2K1Pi:Weights 92 0.0899712
 insert Tau2K1Pi:Weights 93 0.0477173
 insert Tau2K1Pi:Weights 94 0.0483365
 insert Tau2K1Pi:Weights 95 0.0479435
 insert Tau2K1Pi:Weights 96 0.0459924
 insert Tau2K1Pi:Weights 97 0.0356369
 insert Tau2K1Pi:Weights 98 0.0363713
 insert Tau2K1Pi:Weights 99 0.0315165
 insert Tau2K1Pi:Weights 100 0.031417
 insert Tau2K1Pi:Weights 101 0.0157208
 insert Tau2K1Pi:Weights 102 0.0154267
 insert Tau2K1Pi:Weights 103 0.0160225
 insert Tau2K1Pi:Weights 104 0.0160575
 insert Tau2K1Pi:Weights 105 0.0662738
 insert Tau2K1Pi:Weights 106 0.0667806
 insert Tau2K1Pi:Weights 107 0.0329099
 insert Tau2K1Pi:Weights 108 0.051158
 insert Tau2K1Pi:Weights 109 0.0519009
 insert Tau2K1Pi:Weights 110 0.0518297
 insert Tau2K1Pi:Weights 111 0.0515922
 insert Tau2K1Pi:Weights 112 0.0518303
 insert Tau2K1Pi:Weights 113 0.051487
 insert Tau2K1Pi:Weights 114 0.0320661
 insert Tau2K1Pi:Weights 115 0.0320866
 insert Tau2K1Pi:Weights 116 0.0263489
 insert Tau2K1Pi:Weights 117 0.0421899
 insert Tau2K1Pi:Weights 118 0.0420786
 insert Tau2K1Pi:Weights 119 0.042311
 insert Tau2K1Pi:Weights 120 0.0404591
 insert Tau2K1Pi:Weights 121 0.0405805
 insert Tau2K1Pi:Weights 122 0.0409838
 insert Tau2K1Pi:Weights 123 0.0308081
 insert Tau2K1Pi:Weights 124 0.0313261
 insert Tau2K1Pi:Weights 125 0.0241062
 insert Tau2K1Pi:Weights 126 0.0163214
 insert Tau2K1Pi:Weights 127 0.0165679
 insert Tau2K1Pi:Weights 128 0.0159972
 insert Tau2K1Pi:Weights 129 0.0166933
 insert Tau2K1Pi:Weights 130 0.0167966
 insert Tau2K1Pi:Weights 131 0.0165165
 create Herwig::TwoKaonOnePionCurrent Tau2K1PiCurrent HwWeakCurrents.so
 newdef Tau2K1PiCurrent:AxialRhoWeight 0 1
 newdef Tau2K1PiCurrent:AxialRhoWeight 1 -0.145
 newdef Tau2K1PiCurrent:AxialRhoWeight 2 0
 newdef Tau2K1PiCurrent:AxialKStarWeight 0 1
 newdef Tau2K1PiCurrent:AxialKStarWeight 1 -0.135
 newdef Tau2K1PiCurrent:AxialKStarWeight 2 0
 newdef Tau2K1PiCurrent:VectorRhoWeight 0 1
 newdef Tau2K1PiCurrent:VectorRhoWeight 1 -0.25
 newdef Tau2K1PiCurrent:VectorRhoWeight 2 -0.038
 newdef Tau2K1PiCurrent:OmegaKStarWeight 0.707107
 newdef Tau2K1PiCurrent:EpsOmega 0.05
 newdef Tau2K1PiCurrent:Initializea1 0
 newdef Tau2K1PiCurrent:a1WidthOption 1
 newdef Tau2K1PiCurrent:a1RunningWidth 0 0
 newdef Tau2K1PiCurrent:a1RunningWidth 1 0
 newdef Tau2K1PiCurrent:a1RunningWidth 2 0
 newdef Tau2K1PiCurrent:a1RunningWidth 3 0
 newdef Tau2K1PiCurrent:a1RunningWidth 4 0
 newdef Tau2K1PiCurrent:a1RunningWidth 5 0
 newdef Tau2K1PiCurrent:a1RunningWidth 6 0
 newdef Tau2K1PiCurrent:a1RunningWidth 7 0
 newdef Tau2K1PiCurrent:a1RunningWidth 8 0
 newdef Tau2K1PiCurrent:a1RunningWidth 9 0
 newdef Tau2K1PiCurrent:a1RunningWidth 10 0
 newdef Tau2K1PiCurrent:a1RunningWidth 11 0
 newdef Tau2K1PiCurrent:a1RunningWidth 12 1.47729e-06
 newdef Tau2K1PiCurrent:a1RunningWidth 13 1.19209e-05
 newdef Tau2K1PiCurrent:a1RunningWidth 14 3.884e-05
 newdef Tau2K1PiCurrent:a1RunningWidth 15 8.83255e-05
 newdef Tau2K1PiCurrent:a1RunningWidth 16 0.00016561
 newdef Tau2K1PiCurrent:a1RunningWidth 17 0.000275439
 newdef Tau2K1PiCurrent:a1RunningWidth 18 0.000422332
 newdef Tau2K1PiCurrent:a1RunningWidth 19 0.000610773
 newdef Tau2K1PiCurrent:a1RunningWidth 20 0.000845357
 newdef Tau2K1PiCurrent:a1RunningWidth 21 0.00113092
 newdef Tau2K1PiCurrent:a1RunningWidth 22 0.00147264
 newdef Tau2K1PiCurrent:a1RunningWidth 23 0.00187616
 newdef Tau2K1PiCurrent:a1RunningWidth 24 0.0023477
 newdef Tau2K1PiCurrent:a1RunningWidth 25 0.00289413
 newdef Tau2K1PiCurrent:a1RunningWidth 26 0.00352315
 newdef Tau2K1PiCurrent:a1RunningWidth 27 0.00424342
 newdef Tau2K1PiCurrent:a1RunningWidth 28 0.0050647
 newdef Tau2K1PiCurrent:a1RunningWidth 29 0.00599808
 newdef Tau2K1PiCurrent:a1RunningWidth 30 0.00705616
 newdef Tau2K1PiCurrent:a1RunningWidth 31 0.00825335
 newdef Tau2K1PiCurrent:a1RunningWidth 32 0.0096062
 newdef Tau2K1PiCurrent:a1RunningWidth 33 0.0111337
 newdef Tau2K1PiCurrent:a1RunningWidth 34 0.0128579
 newdef Tau2K1PiCurrent:a1RunningWidth 35 0.0148041
 newdef Tau2K1PiCurrent:a1RunningWidth 36 0.017002
 newdef Tau2K1PiCurrent:a1RunningWidth 37 0.0194858
 newdef Tau2K1PiCurrent:a1RunningWidth 38 0.0222956
 newdef Tau2K1PiCurrent:a1RunningWidth 39 0.0254781
 newdef Tau2K1PiCurrent:a1RunningWidth 40 0.0290874
 newdef Tau2K1PiCurrent:a1RunningWidth 41 0.0331862
 newdef Tau2K1PiCurrent:a1RunningWidth 42 0.0378467
 newdef Tau2K1PiCurrent:a1RunningWidth 43 0.0431501
 newdef Tau2K1PiCurrent:a1RunningWidth 44 0.0491862
 newdef Tau2K1PiCurrent:a1RunningWidth 45 0.0560496
 newdef Tau2K1PiCurrent:a1RunningWidth 46 0.0638341
 newdef Tau2K1PiCurrent:a1RunningWidth 47 0.0726215
 newdef Tau2K1PiCurrent:a1RunningWidth 48 0.0824662
 newdef Tau2K1PiCurrent:a1RunningWidth 49 0.0933765
 newdef Tau2K1PiCurrent:a1RunningWidth 50 0.105297
 newdef Tau2K1PiCurrent:a1RunningWidth 51 0.118103
 newdef Tau2K1PiCurrent:a1RunningWidth 52 0.131602
 newdef Tau2K1PiCurrent:a1RunningWidth 53 0.145564
 newdef Tau2K1PiCurrent:a1RunningWidth 54 0.159749
 newdef Tau2K1PiCurrent:a1RunningWidth 55 0.173938
 newdef Tau2K1PiCurrent:a1RunningWidth 56 0.18795
 newdef Tau2K1PiCurrent:a1RunningWidth 57 0.201649
 newdef Tau2K1PiCurrent:a1RunningWidth 58 0.214943
 newdef Tau2K1PiCurrent:a1RunningWidth 59 0.227773
 newdef Tau2K1PiCurrent:a1RunningWidth 60 0.240109
 newdef Tau2K1PiCurrent:a1RunningWidth 61 0.25194
 newdef Tau2K1PiCurrent:a1RunningWidth 62 0.263268
 newdef Tau2K1PiCurrent:a1RunningWidth 63 0.274104
 newdef Tau2K1PiCurrent:a1RunningWidth 64 0.284466
 newdef Tau2K1PiCurrent:a1RunningWidth 65 0.294372
 newdef Tau2K1PiCurrent:a1RunningWidth 66 0.303845
 newdef Tau2K1PiCurrent:a1RunningWidth 67 0.312905
 newdef Tau2K1PiCurrent:a1RunningWidth 68 0.321576
 newdef Tau2K1PiCurrent:a1RunningWidth 69 0.329878
 newdef Tau2K1PiCurrent:a1RunningWidth 70 0.337832
 newdef Tau2K1PiCurrent:a1RunningWidth 71 0.345456
 newdef Tau2K1PiCurrent:a1RunningWidth 72 0.35277
 newdef Tau2K1PiCurrent:a1RunningWidth 73 0.35979
 newdef Tau2K1PiCurrent:a1RunningWidth 74 0.366532
 newdef Tau2K1PiCurrent:a1RunningWidth 75 0.373012
 newdef Tau2K1PiCurrent:a1RunningWidth 76 0.379243
 newdef Tau2K1PiCurrent:a1RunningWidth 77 0.38524
 newdef Tau2K1PiCurrent:a1RunningWidth 78 0.391014
 newdef Tau2K1PiCurrent:a1RunningWidth 79 0.396577
 newdef Tau2K1PiCurrent:a1RunningWidth 80 0.401939
 newdef Tau2K1PiCurrent:a1RunningWidth 81 0.407111
 newdef Tau2K1PiCurrent:a1RunningWidth 82 0.412102
 newdef Tau2K1PiCurrent:a1RunningWidth 83 0.416923
 newdef Tau2K1PiCurrent:a1RunningWidth 84 0.421577
 newdef Tau2K1PiCurrent:a1RunningWidth 85 0.426078
 newdef Tau2K1PiCurrent:a1RunningWidth 86 0.430427
 newdef Tau2K1PiCurrent:a1RunningWidth 87 0.434636
 newdef Tau2K1PiCurrent:a1RunningWidth 88 0.43871
 newdef Tau2K1PiCurrent:a1RunningWidth 89 0.442654
 newdef Tau2K1PiCurrent:a1RunningWidth 90 0.446475
 newdef Tau2K1PiCurrent:a1RunningWidth 91 0.450177
 newdef Tau2K1PiCurrent:a1RunningWidth 92 0.453765
 newdef Tau2K1PiCurrent:a1RunningWidth 93 0.457245
 newdef Tau2K1PiCurrent:a1RunningWidth 94 0.460621
 newdef Tau2K1PiCurrent:a1RunningWidth 95 0.463899
 newdef Tau2K1PiCurrent:a1RunningWidth 96 0.467077
 newdef Tau2K1PiCurrent:a1RunningWidth 97 0.470164
 newdef Tau2K1PiCurrent:a1RunningWidth 98 0.473162
 newdef Tau2K1PiCurrent:a1RunningWidth 99 0.476076
 newdef Tau2K1PiCurrent:a1RunningWidth 100 0.478909
 newdef Tau2K1PiCurrent:a1RunningWidth 101 0.481658
 newdef Tau2K1PiCurrent:a1RunningWidth 102 0.484333
 newdef Tau2K1PiCurrent:a1RunningWidth 103 0.486934
 newdef Tau2K1PiCurrent:a1RunningWidth 104 0.489465
 newdef Tau2K1PiCurrent:a1RunningWidth 105 0.491926
 newdef Tau2K1PiCurrent:a1RunningWidth 106 0.494321
 newdef Tau2K1PiCurrent:a1RunningWidth 107 0.496651
 newdef Tau2K1PiCurrent:a1RunningWidth 108 0.49892
 newdef Tau2K1PiCurrent:a1RunningWidth 109 0.501128
 newdef Tau2K1PiCurrent:a1RunningWidth 110 0.503277
 newdef Tau2K1PiCurrent:a1RunningWidth 111 0.505371
 newdef Tau2K1PiCurrent:a1RunningWidth 112 0.507409
 newdef Tau2K1PiCurrent:a1RunningWidth 113 0.509395
 newdef Tau2K1PiCurrent:a1RunningWidth 114 0.511328
 newdef Tau2K1PiCurrent:a1RunningWidth 115 0.513212
 newdef Tau2K1PiCurrent:a1RunningWidth 116 0.515047
 newdef Tau2K1PiCurrent:a1RunningWidth 117 0.516846
 newdef Tau2K1PiCurrent:a1RunningWidth 118 0.518624
 newdef Tau2K1PiCurrent:a1RunningWidth 119 0.520285
 newdef Tau2K1PiCurrent:a1RunningWidth 120 0.52194
 newdef Tau2K1PiCurrent:a1RunningWidth 121 0.523553
 newdef Tau2K1PiCurrent:a1RunningWidth 122 0.525124
 newdef Tau2K1PiCurrent:a1RunningWidth 123 0.526646
 newdef Tau2K1PiCurrent:a1RunningWidth 124 0.52814
 newdef Tau2K1PiCurrent:a1RunningWidth 125 0.529638
 newdef Tau2K1PiCurrent:a1RunningWidth 126 0.531016
 newdef Tau2K1PiCurrent:a1RunningWidth 127 0.532401
 newdef Tau2K1PiCurrent:a1RunningWidth 128 0.533751
 newdef Tau2K1PiCurrent:a1RunningWidth 129 0.535069
 newdef Tau2K1PiCurrent:a1RunningWidth 130 0.536354
 newdef Tau2K1PiCurrent:a1RunningWidth 131 0.537608
 newdef Tau2K1PiCurrent:a1RunningWidth 132 0.538831
 newdef Tau2K1PiCurrent:a1RunningWidth 133 0.540039
 newdef Tau2K1PiCurrent:a1RunningWidth 134 0.541194
 newdef Tau2K1PiCurrent:a1RunningWidth 135 0.542327
 newdef Tau2K1PiCurrent:a1RunningWidth 136 0.543438
 newdef Tau2K1PiCurrent:a1RunningWidth 137 0.544522
 newdef Tau2K1PiCurrent:a1RunningWidth 138 0.545582
 newdef Tau2K1PiCurrent:a1RunningWidth 139 0.546616
 newdef Tau2K1PiCurrent:a1RunningWidth 140 0.54764
 newdef Tau2K1PiCurrent:a1RunningWidth 141 0.548615
 newdef Tau2K1PiCurrent:a1RunningWidth 142 0.549581
 newdef Tau2K1PiCurrent:a1RunningWidth 143 0.550525
 newdef Tau2K1PiCurrent:a1RunningWidth 144 0.551449
 newdef Tau2K1PiCurrent:a1RunningWidth 145 0.552351
 newdef Tau2K1PiCurrent:a1RunningWidth 146 0.55324
 newdef Tau2K1PiCurrent:a1RunningWidth 147 0.554101
 newdef Tau2K1PiCurrent:a1RunningWidth 148 0.554944
 newdef Tau2K1PiCurrent:a1RunningWidth 149 0.555772
 newdef Tau2K1PiCurrent:a1RunningWidth 150 0.556583
 newdef Tau2K1PiCurrent:a1RunningWidth 151 0.557373
 newdef Tau2K1PiCurrent:a1RunningWidth 152 0.558155
 newdef Tau2K1PiCurrent:a1RunningWidth 153 0.558917
 newdef Tau2K1PiCurrent:a1RunningWidth 154 0.559664
 newdef Tau2K1PiCurrent:a1RunningWidth 155 0.560396
 newdef Tau2K1PiCurrent:a1RunningWidth 156 0.561114
 newdef Tau2K1PiCurrent:a1RunningWidth 157 0.561849
 newdef Tau2K1PiCurrent:a1RunningWidth 158 0.562508
 newdef Tau2K1PiCurrent:a1RunningWidth 159 0.563186
 newdef Tau2K1PiCurrent:a1RunningWidth 160 0.563851
 newdef Tau2K1PiCurrent:a1RunningWidth 161 0.564503
 newdef Tau2K1PiCurrent:a1RunningWidth 162 0.565145
 newdef Tau2K1PiCurrent:a1RunningWidth 163 0.565774
 newdef Tau2K1PiCurrent:a1RunningWidth 164 0.566394
 newdef Tau2K1PiCurrent:a1RunningWidth 165 0.567001
 newdef Tau2K1PiCurrent:a1RunningWidth 166 0.567595
 newdef Tau2K1PiCurrent:a1RunningWidth 167 0.568182
 newdef Tau2K1PiCurrent:a1RunningWidth 168 0.56876
 newdef Tau2K1PiCurrent:a1RunningWidth 169 0.56933
 newdef Tau2K1PiCurrent:a1RunningWidth 170 0.569886
 newdef Tau2K1PiCurrent:a1RunningWidth 171 0.570433
 newdef Tau2K1PiCurrent:a1RunningWidth 172 0.570976
 newdef Tau2K1PiCurrent:a1RunningWidth 173 0.571504
 newdef Tau2K1PiCurrent:a1RunningWidth 174 0.572027
 newdef Tau2K1PiCurrent:a1RunningWidth 175 0.572542
 newdef Tau2K1PiCurrent:a1RunningWidth 176 0.573114
 newdef Tau2K1PiCurrent:a1RunningWidth 177 0.573548
 newdef Tau2K1PiCurrent:a1RunningWidth 178 0.574108
 newdef Tau2K1PiCurrent:a1RunningWidth 179 0.574524
 newdef Tau2K1PiCurrent:a1RunningWidth 180 0.575002
 newdef Tau2K1PiCurrent:a1RunningWidth 181 0.575473
 newdef Tau2K1PiCurrent:a1RunningWidth 182 0.575937
 newdef Tau2K1PiCurrent:a1RunningWidth 183 0.576394
 newdef Tau2K1PiCurrent:a1RunningWidth 184 0.576845
 newdef Tau2K1PiCurrent:a1RunningWidth 185 0.57729
 newdef Tau2K1PiCurrent:a1RunningWidth 186 0.57773
 newdef Tau2K1PiCurrent:a1RunningWidth 187 0.578173
 newdef Tau2K1PiCurrent:a1RunningWidth 188 0.5786
 newdef Tau2K1PiCurrent:a1RunningWidth 189 0.579013
 newdef Tau2K1PiCurrent:a1RunningWidth 190 0.579431
 newdef Tau2K1PiCurrent:a1RunningWidth 191 0.579834
 newdef Tau2K1PiCurrent:a1RunningWidth 192 0.580246
 newdef Tau2K1PiCurrent:a1RunningWidth 193 0.580649
 newdef Tau2K1PiCurrent:a1RunningWidth 194 0.581045
 newdef Tau2K1PiCurrent:a1RunningWidth 195 0.581437
 newdef Tau2K1PiCurrent:a1RunningWidth 196 0.581827
 newdef Tau2K1PiCurrent:a1RunningWidth 197 0.582208
 newdef Tau2K1PiCurrent:a1RunningWidth 198 0.582586
 newdef Tau2K1PiCurrent:a1RunningWidth 199 0.582959
 newdef Tau2K1PiCurrent:a1RunningQ2 0 0
 newdef Tau2K1PiCurrent:a1RunningQ2 1 0.0158678
 newdef Tau2K1PiCurrent:a1RunningQ2 2 0.0317356
 newdef Tau2K1PiCurrent:a1RunningQ2 3 0.0476034
 newdef Tau2K1PiCurrent:a1RunningQ2 4 0.0634712
 newdef Tau2K1PiCurrent:a1RunningQ2 5 0.079339
 newdef Tau2K1PiCurrent:a1RunningQ2 6 0.0952068
 newdef Tau2K1PiCurrent:a1RunningQ2 7 0.111075
 newdef Tau2K1PiCurrent:a1RunningQ2 8 0.126942
 newdef Tau2K1PiCurrent:a1RunningQ2 9 0.14281
 newdef Tau2K1PiCurrent:a1RunningQ2 10 0.158678
 newdef Tau2K1PiCurrent:a1RunningQ2 11 0.174546
 newdef Tau2K1PiCurrent:a1RunningQ2 12 0.190414
 newdef Tau2K1PiCurrent:a1RunningQ2 13 0.206281
 newdef Tau2K1PiCurrent:a1RunningQ2 14 0.222149
 newdef Tau2K1PiCurrent:a1RunningQ2 15 0.238017
 newdef Tau2K1PiCurrent:a1RunningQ2 16 0.253885
 newdef Tau2K1PiCurrent:a1RunningQ2 17 0.269753
 newdef Tau2K1PiCurrent:a1RunningQ2 18 0.285621
 newdef Tau2K1PiCurrent:a1RunningQ2 19 0.301488
 newdef Tau2K1PiCurrent:a1RunningQ2 20 0.317356
 newdef Tau2K1PiCurrent:a1RunningQ2 21 0.333224
 newdef Tau2K1PiCurrent:a1RunningQ2 22 0.349092
 newdef Tau2K1PiCurrent:a1RunningQ2 23 0.36496
 newdef Tau2K1PiCurrent:a1RunningQ2 24 0.380827
 newdef Tau2K1PiCurrent:a1RunningQ2 25 0.396695
 newdef Tau2K1PiCurrent:a1RunningQ2 26 0.412563
 newdef Tau2K1PiCurrent:a1RunningQ2 27 0.428431
 newdef Tau2K1PiCurrent:a1RunningQ2 28 0.444299
 newdef Tau2K1PiCurrent:a1RunningQ2 29 0.460166
 newdef Tau2K1PiCurrent:a1RunningQ2 30 0.476034
 newdef Tau2K1PiCurrent:a1RunningQ2 31 0.491902
 newdef Tau2K1PiCurrent:a1RunningQ2 32 0.50777
 newdef Tau2K1PiCurrent:a1RunningQ2 33 0.523638
 newdef Tau2K1PiCurrent:a1RunningQ2 34 0.539505
 newdef Tau2K1PiCurrent:a1RunningQ2 35 0.555373
 newdef Tau2K1PiCurrent:a1RunningQ2 36 0.571241
 newdef Tau2K1PiCurrent:a1RunningQ2 37 0.587109
 newdef Tau2K1PiCurrent:a1RunningQ2 38 0.602977
 newdef Tau2K1PiCurrent:a1RunningQ2 39 0.618844
 newdef Tau2K1PiCurrent:a1RunningQ2 40 0.634712
 newdef Tau2K1PiCurrent:a1RunningQ2 41 0.65058
 newdef Tau2K1PiCurrent:a1RunningQ2 42 0.666448
 newdef Tau2K1PiCurrent:a1RunningQ2 43 0.682316
 newdef Tau2K1PiCurrent:a1RunningQ2 44 0.698183
 newdef Tau2K1PiCurrent:a1RunningQ2 45 0.714051
 newdef Tau2K1PiCurrent:a1RunningQ2 46 0.729919
 newdef Tau2K1PiCurrent:a1RunningQ2 47 0.745787
 newdef Tau2K1PiCurrent:a1RunningQ2 48 0.761655
 newdef Tau2K1PiCurrent:a1RunningQ2 49 0.777523
 newdef Tau2K1PiCurrent:a1RunningQ2 50 0.79339
 newdef Tau2K1PiCurrent:a1RunningQ2 51 0.809258
 newdef Tau2K1PiCurrent:a1RunningQ2 52 0.825126
 newdef Tau2K1PiCurrent:a1RunningQ2 53 0.840994
 newdef Tau2K1PiCurrent:a1RunningQ2 54 0.856862
 newdef Tau2K1PiCurrent:a1RunningQ2 55 0.872729
 newdef Tau2K1PiCurrent:a1RunningQ2 56 0.888597
 newdef Tau2K1PiCurrent:a1RunningQ2 57 0.904465
 newdef Tau2K1PiCurrent:a1RunningQ2 58 0.920333
 newdef Tau2K1PiCurrent:a1RunningQ2 59 0.936201
 newdef Tau2K1PiCurrent:a1RunningQ2 60 0.952068
 newdef Tau2K1PiCurrent:a1RunningQ2 61 0.967936
 newdef Tau2K1PiCurrent:a1RunningQ2 62 0.983804
 newdef Tau2K1PiCurrent:a1RunningQ2 63 0.999672
 newdef Tau2K1PiCurrent:a1RunningQ2 64 1.01554
 newdef Tau2K1PiCurrent:a1RunningQ2 65 1.03141
 newdef Tau2K1PiCurrent:a1RunningQ2 66 1.04728
 newdef Tau2K1PiCurrent:a1RunningQ2 67 1.06314
 newdef Tau2K1PiCurrent:a1RunningQ2 68 1.07901
 newdef Tau2K1PiCurrent:a1RunningQ2 69 1.09488
 newdef Tau2K1PiCurrent:a1RunningQ2 70 1.11075
 newdef Tau2K1PiCurrent:a1RunningQ2 71 1.12661
 newdef Tau2K1PiCurrent:a1RunningQ2 72 1.14248
 newdef Tau2K1PiCurrent:a1RunningQ2 73 1.15835
 newdef Tau2K1PiCurrent:a1RunningQ2 74 1.17422
 newdef Tau2K1PiCurrent:a1RunningQ2 75 1.19009
 newdef Tau2K1PiCurrent:a1RunningQ2 76 1.20595
 newdef Tau2K1PiCurrent:a1RunningQ2 77 1.22182
 newdef Tau2K1PiCurrent:a1RunningQ2 78 1.23769
 newdef Tau2K1PiCurrent:a1RunningQ2 79 1.25356
 newdef Tau2K1PiCurrent:a1RunningQ2 80 1.26942
 newdef Tau2K1PiCurrent:a1RunningQ2 81 1.28529
 newdef Tau2K1PiCurrent:a1RunningQ2 82 1.30116
 newdef Tau2K1PiCurrent:a1RunningQ2 83 1.31703
 newdef Tau2K1PiCurrent:a1RunningQ2 84 1.3329
 newdef Tau2K1PiCurrent:a1RunningQ2 85 1.34876
 newdef Tau2K1PiCurrent:a1RunningQ2 86 1.36463
 newdef Tau2K1PiCurrent:a1RunningQ2 87 1.3805
 newdef Tau2K1PiCurrent:a1RunningQ2 88 1.39637
 newdef Tau2K1PiCurrent:a1RunningQ2 89 1.41223
 newdef Tau2K1PiCurrent:a1RunningQ2 90 1.4281
 newdef Tau2K1PiCurrent:a1RunningQ2 91 1.44397
 newdef Tau2K1PiCurrent:a1RunningQ2 92 1.45984
 newdef Tau2K1PiCurrent:a1RunningQ2 93 1.47571
 newdef Tau2K1PiCurrent:a1RunningQ2 94 1.49157
 newdef Tau2K1PiCurrent:a1RunningQ2 95 1.50744
 newdef Tau2K1PiCurrent:a1RunningQ2 96 1.52331
 newdef Tau2K1PiCurrent:a1RunningQ2 97 1.53918
 newdef Tau2K1PiCurrent:a1RunningQ2 98 1.55505
 newdef Tau2K1PiCurrent:a1RunningQ2 99 1.57091
 newdef Tau2K1PiCurrent:a1RunningQ2 100 1.58678
 newdef Tau2K1PiCurrent:a1RunningQ2 101 1.60265
 newdef Tau2K1PiCurrent:a1RunningQ2 102 1.61852
 newdef Tau2K1PiCurrent:a1RunningQ2 103 1.63438
 newdef Tau2K1PiCurrent:a1RunningQ2 104 1.65025
 newdef Tau2K1PiCurrent:a1RunningQ2 105 1.66612
 newdef Tau2K1PiCurrent:a1RunningQ2 106 1.68199
 newdef Tau2K1PiCurrent:a1RunningQ2 107 1.69786
 newdef Tau2K1PiCurrent:a1RunningQ2 108 1.71372
 newdef Tau2K1PiCurrent:a1RunningQ2 109 1.72959
 newdef Tau2K1PiCurrent:a1RunningQ2 110 1.74546
 newdef Tau2K1PiCurrent:a1RunningQ2 111 1.76133
 newdef Tau2K1PiCurrent:a1RunningQ2 112 1.77719
 newdef Tau2K1PiCurrent:a1RunningQ2 113 1.79306
 newdef Tau2K1PiCurrent:a1RunningQ2 114 1.80893
 newdef Tau2K1PiCurrent:a1RunningQ2 115 1.8248
 newdef Tau2K1PiCurrent:a1RunningQ2 116 1.84067
 newdef Tau2K1PiCurrent:a1RunningQ2 117 1.85653
 newdef Tau2K1PiCurrent:a1RunningQ2 118 1.8724
 newdef Tau2K1PiCurrent:a1RunningQ2 119 1.88827
 newdef Tau2K1PiCurrent:a1RunningQ2 120 1.90414
 newdef Tau2K1PiCurrent:a1RunningQ2 121 1.92
 newdef Tau2K1PiCurrent:a1RunningQ2 122 1.93587
 newdef Tau2K1PiCurrent:a1RunningQ2 123 1.95174
 newdef Tau2K1PiCurrent:a1RunningQ2 124 1.96761
 newdef Tau2K1PiCurrent:a1RunningQ2 125 1.98348
 newdef Tau2K1PiCurrent:a1RunningQ2 126 1.99934
 newdef Tau2K1PiCurrent:a1RunningQ2 127 2.01521
 newdef Tau2K1PiCurrent:a1RunningQ2 128 2.03108
 newdef Tau2K1PiCurrent:a1RunningQ2 129 2.04695
 newdef Tau2K1PiCurrent:a1RunningQ2 130 2.06281
 newdef Tau2K1PiCurrent:a1RunningQ2 131 2.07868
 newdef Tau2K1PiCurrent:a1RunningQ2 132 2.09455
 newdef Tau2K1PiCurrent:a1RunningQ2 133 2.11042
 newdef Tau2K1PiCurrent:a1RunningQ2 134 2.12629
 newdef Tau2K1PiCurrent:a1RunningQ2 135 2.14215
 newdef Tau2K1PiCurrent:a1RunningQ2 136 2.15802
 newdef Tau2K1PiCurrent:a1RunningQ2 137 2.17389
 newdef Tau2K1PiCurrent:a1RunningQ2 138 2.18976
 newdef Tau2K1PiCurrent:a1RunningQ2 139 2.20563
 newdef Tau2K1PiCurrent:a1RunningQ2 140 2.22149
 newdef Tau2K1PiCurrent:a1RunningQ2 141 2.23736
 newdef Tau2K1PiCurrent:a1RunningQ2 142 2.25323
 newdef Tau2K1PiCurrent:a1RunningQ2 143 2.2691
 newdef Tau2K1PiCurrent:a1RunningQ2 144 2.28496
 newdef Tau2K1PiCurrent:a1RunningQ2 145 2.30083
 newdef Tau2K1PiCurrent:a1RunningQ2 146 2.3167
 newdef Tau2K1PiCurrent:a1RunningQ2 147 2.33257
 newdef Tau2K1PiCurrent:a1RunningQ2 148 2.34844
 newdef Tau2K1PiCurrent:a1RunningQ2 149 2.3643
 newdef Tau2K1PiCurrent:a1RunningQ2 150 2.38017
 newdef Tau2K1PiCurrent:a1RunningQ2 151 2.39604
 newdef Tau2K1PiCurrent:a1RunningQ2 152 2.41191
 newdef Tau2K1PiCurrent:a1RunningQ2 153 2.42777
 newdef Tau2K1PiCurrent:a1RunningQ2 154 2.44364
 newdef Tau2K1PiCurrent:a1RunningQ2 155 2.45951
 newdef Tau2K1PiCurrent:a1RunningQ2 156 2.47538
 newdef Tau2K1PiCurrent:a1RunningQ2 157 2.49125
 newdef Tau2K1PiCurrent:a1RunningQ2 158 2.50711
 newdef Tau2K1PiCurrent:a1RunningQ2 159 2.52298
 newdef Tau2K1PiCurrent:a1RunningQ2 160 2.53885
 newdef Tau2K1PiCurrent:a1RunningQ2 161 2.55472
 newdef Tau2K1PiCurrent:a1RunningQ2 162 2.57058
 newdef Tau2K1PiCurrent:a1RunningQ2 163 2.58645
 newdef Tau2K1PiCurrent:a1RunningQ2 164 2.60232
 newdef Tau2K1PiCurrent:a1RunningQ2 165 2.61819
 newdef Tau2K1PiCurrent:a1RunningQ2 166 2.63406
 newdef Tau2K1PiCurrent:a1RunningQ2 167 2.64992
 newdef Tau2K1PiCurrent:a1RunningQ2 168 2.66579
 newdef Tau2K1PiCurrent:a1RunningQ2 169 2.68166
 newdef Tau2K1PiCurrent:a1RunningQ2 170 2.69753
 newdef Tau2K1PiCurrent:a1RunningQ2 171 2.71339
 newdef Tau2K1PiCurrent:a1RunningQ2 172 2.72926
 newdef Tau2K1PiCurrent:a1RunningQ2 173 2.74513
 newdef Tau2K1PiCurrent:a1RunningQ2 174 2.761
 newdef Tau2K1PiCurrent:a1RunningQ2 175 2.77687
 newdef Tau2K1PiCurrent:a1RunningQ2 176 2.79273
 newdef Tau2K1PiCurrent:a1RunningQ2 177 2.8086
 newdef Tau2K1PiCurrent:a1RunningQ2 178 2.82447
 newdef Tau2K1PiCurrent:a1RunningQ2 179 2.84034
 newdef Tau2K1PiCurrent:a1RunningQ2 180 2.85621
 newdef Tau2K1PiCurrent:a1RunningQ2 181 2.87207
 newdef Tau2K1PiCurrent:a1RunningQ2 182 2.88794
 newdef Tau2K1PiCurrent:a1RunningQ2 183 2.90381
 newdef Tau2K1PiCurrent:a1RunningQ2 184 2.91968
 newdef Tau2K1PiCurrent:a1RunningQ2 185 2.93554
 newdef Tau2K1PiCurrent:a1RunningQ2 186 2.95141
 newdef Tau2K1PiCurrent:a1RunningQ2 187 2.96728
 newdef Tau2K1PiCurrent:a1RunningQ2 188 2.98315
 newdef Tau2K1PiCurrent:a1RunningQ2 189 2.99902
 newdef Tau2K1PiCurrent:a1RunningQ2 190 3.01488
 newdef Tau2K1PiCurrent:a1RunningQ2 191 3.03075
 newdef Tau2K1PiCurrent:a1RunningQ2 192 3.04662
 newdef Tau2K1PiCurrent:a1RunningQ2 193 3.06249
 newdef Tau2K1PiCurrent:a1RunningQ2 194 3.07835
 newdef Tau2K1PiCurrent:a1RunningQ2 195 3.09422
 newdef Tau2K1PiCurrent:a1RunningQ2 196 3.11009
 newdef Tau2K1PiCurrent:a1RunningQ2 197 3.12596
 newdef Tau2K1PiCurrent:a1RunningQ2 198 3.14183
 newdef Tau2K1PiCurrent:a1RunningQ2 199 3.15769
 newdef Tau2K1PiCurrent:A1Width 0.475
 newdef Tau2K1PiCurrent:A1Mass 1.251
 newdef Tau2K1PiCurrent:OmegaWidth 0.00843
 newdef Tau2K1PiCurrent:OmegaMass 0.782
 newdef Tau2K1PiCurrent:PhiWidth 0.00443
 newdef Tau2K1PiCurrent:PhiMass 1.02
 newdef Tau2K1PiCurrent:FPi 92.4189
 newdef Tau2K1PiCurrent:RhoAxialMasses 0 0.773
 newdef Tau2K1PiCurrent:RhoAxialMasses 1 1.37
 newdef Tau2K1PiCurrent:RhoAxialMasses 2 1.75
 newdef Tau2K1PiCurrent:RhoAxialWidths 0 0.145
 newdef Tau2K1PiCurrent:RhoAxialWidths 1 0.51
 newdef Tau2K1PiCurrent:RhoAxialWidths 2 0.12
 newdef Tau2K1PiCurrent:RhoVectorMasses 0 0.773
 newdef Tau2K1PiCurrent:RhoVectorMasses 1 1.5
 newdef Tau2K1PiCurrent:RhoVectorMasses 2 1.75
 newdef Tau2K1PiCurrent:RhoVectorWidths 0 0.145
 newdef Tau2K1PiCurrent:RhoVectorWidths 1 0.22
 newdef Tau2K1PiCurrent:RhoVectorWidths 2 0.12
 newdef Tau2K1PiCurrent:KstarAxialMasses 0 0.892
 newdef Tau2K1PiCurrent:KstarAxialMasses 1 1.412
 newdef Tau2K1PiCurrent:KstarAxialMasses 2 1.714
 newdef Tau2K1PiCurrent:KstarAxialWidths 0 0.05
 newdef Tau2K1PiCurrent:KstarAxialWidths 1 0.227
 newdef Tau2K1PiCurrent:KstarAxialWidths 2 0.323
 newdef Tau2K1PiCurrent:Quark 0  2
 newdef Tau2K1PiCurrent:AntiQuark 0  -1
 newdef Tau2K1PiCurrent:Quark 1  2
 newdef Tau2K1PiCurrent:AntiQuark 1  -1
 newdef Tau2K1PiCurrent:Quark 2  2
 newdef Tau2K1PiCurrent:AntiQuark 2  -1
 newdef Tau2K1PiCurrent:Quark 3  2
 newdef Tau2K1PiCurrent:AntiQuark 3  -1
 newdef Tau2K1PiCurrent:Quark 4  2
 newdef Tau2K1PiCurrent:AntiQuark 4  -1
 newdef Tau2K1PiCurrent:Quark 5  2
 newdef Tau2K1PiCurrent:AntiQuark 5  -1
 newdef Tau2K1Pi:WeakCurrent Tau2K1PiCurrent
 #
 create Herwig::TauDecayer  TauKPi
 newdef TauKPi:Iteration 5
 newdef TauKPi:Ntry 500
 newdef TauKPi:Points 10000
 newdef TauKPi:GenerateIntermediates 1
 insert TauKPi:WeightLocation 0 0
 insert TauKPi:WeightLocation 1 5
 insert TauKPi:MaximumWeight 0 0.07
 insert TauKPi:MaximumWeight 1 0.14
 insert TauKPi:Weights 0 0.667015
 insert TauKPi:Weights 1 0.0215203
 insert TauKPi:Weights 2 0.0176676
 insert TauKPi:Weights 3 0.253612
 insert TauKPi:Weights 4 0.040185
 insert TauKPi:Weights 5 0.652889
 insert TauKPi:Weights 6 0.0361892
 insert TauKPi:Weights 7 0.0173992
 insert TauKPi:Weights 8 0.261652
 insert TauKPi:Weights 9 0.0318708
 create Herwig::KPiCurrent TauKPiCurrent HeWeakCurrents.so
 newdef TauKPiCurrent:LocalParameters 1
 newdef TauKPiCurrent:Transverse 1
 newdef TauKPiCurrent:cV 1
 newdef TauKPiCurrent:cS 0.465
 newdef TauKPiCurrent:VectorMagnitude 0 1
 newdef TauKPiCurrent:VectorPhase 0 0
 newdef TauKPiCurrent:VectorMagnitude 1 0.075
 newdef TauKPiCurrent:VectorPhase 1 82.5
 newdef TauKPiCurrent:ScalarMagnitude 0 1
 newdef TauKPiCurrent:ScalarPhase 0 0
 newdef TauKPiCurrent:ScalarMagnitude 1 0
 newdef TauKPiCurrent:ScalarPhase 1 0
 newdef TauKPiCurrent:VectorMass 0 895.47
 newdef TauKPiCurrent:VectorWidth 0 46.19
 newdef TauKPiCurrent:VectorMass 1 1414
 newdef TauKPiCurrent:VectorWidth 1 232
 insert TauKPiCurrent:VectorMass 2 1717
 insert TauKPiCurrent:VectorWidth 2 322
 newdef TauKPiCurrent:ScalarMass 0 878
 newdef TauKPiCurrent:ScalarWidth 0 499
 newdef TauKPiCurrent:ScalarMass 1 1429
 newdef TauKPiCurrent:ScalarWidth 1 287
 newdef TauKPiCurrent:Quark 0  2
 newdef TauKPiCurrent:AntiQuark 0  -3
 newdef TauKPiCurrent:Quark 1  2
 newdef TauKPiCurrent:AntiQuark 1  -3
 newdef TauKPi:WeakCurrent TauKPiCurrent 
 #
 create Herwig::BtoSGammaDecayer  BtosgammaKagan
 newdef  BtosgammaKagan:PartonSplitter /Herwig/Hadronization/PartonSplitter 
 newdef  BtosgammaKagan:ClusterFinder /Herwig/Hadronization/ClusterFinder 
 newdef  BtosgammaKagan:ClusterFissioner /Herwig/Hadronization/ClusterFissioner 
 newdef  BtosgammaKagan:LightClusterDecayer /Herwig/Hadronization/LightClusterDecayer 
 newdef  BtosgammaKagan:ClusterDecayer /Herwig/Hadronization/ClusterDecayer 
 newdef  BtosgammaKagan:Exclusive 1 
 newdef  BtosgammaKagan:Intermediates 0 
 newdef  BtosgammaKagan:Partonic_Tries 100 
 create Herwig::BtoSGammaKagan BtosgammaMass 
 newdef BtosgammaMass:TopMass 175 
 newdef BtosgammaMass:BottomMass 4.8 
 newdef BtosgammaMass:CharmMass 1.392 
 newdef BtosgammaMass:StrangeMassRatio 0.02 
 newdef BtosgammaMass:WMass 80.425 
 newdef BtosgammaMass:ZMass 91.1876 
 newdef BtosgammaMass:Lambda2 0.12 
 newdef BtosgammaMass:BMesonMass 5.2794 
 newdef BtosgammaMass:Mu 4.8 
 newdef BtosgammaMass:Delta 0.9 
 newdef BtosgammaMass:Lambda1 -0.3 
 newdef BtosgammaMass:alpha 0.00729735 
 newdef BtosgammaMass:CKM 0.976 
 newdef BtosgammaMass:FermiNormalisation 1.21691 
 newdef BtosgammaMass:MaximumTries 100 
 newdef BtosgammaMass:ycut 1 
 newdef BtosgammaMass:NSpectrum 100 
 newdef BtosgammaMass:mHValues 0 0.825 
 newdef BtosgammaMass:mHValues 1 0.867257 
 newdef BtosgammaMass:mHValues 2 0.909515 
 newdef BtosgammaMass:mHValues 3 0.951772 
 newdef BtosgammaMass:mHValues 4 0.994029 
 newdef BtosgammaMass:mHValues 5 1.03629 
 newdef BtosgammaMass:mHValues 6 1.07854 
 newdef BtosgammaMass:mHValues 7 1.1208 
 newdef BtosgammaMass:mHValues 8 1.16306 
 newdef BtosgammaMass:mHValues 9 1.20532 
 newdef BtosgammaMass:mHValues 10 1.24757 
 newdef BtosgammaMass:mHValues 11 1.28983 
 newdef BtosgammaMass:mHValues 12 1.33209 
 newdef BtosgammaMass:mHValues 13 1.37435 
 newdef BtosgammaMass:mHValues 14 1.4166 
 newdef BtosgammaMass:mHValues 15 1.45886 
 newdef BtosgammaMass:mHValues 16 1.50112 
 newdef BtosgammaMass:mHValues 17 1.54338 
 newdef BtosgammaMass:mHValues 18 1.58563 
 newdef BtosgammaMass:mHValues 19 1.62789 
 newdef BtosgammaMass:mHValues 20 1.67015 
 newdef BtosgammaMass:mHValues 21 1.7124 
 newdef BtosgammaMass:mHValues 22 1.75466 
 newdef BtosgammaMass:mHValues 23 1.79692 
 newdef BtosgammaMass:mHValues 24 1.83918 
 newdef BtosgammaMass:mHValues 25 1.88143 
 newdef BtosgammaMass:mHValues 26 1.92369 
 newdef BtosgammaMass:mHValues 27 1.96595 
 newdef BtosgammaMass:mHValues 28 2.00821 
 newdef BtosgammaMass:mHValues 29 2.05046 
 newdef BtosgammaMass:mHValues 30 2.09272 
 newdef BtosgammaMass:mHValues 31 2.13498 
 newdef BtosgammaMass:mHValues 32 2.17724 
 newdef BtosgammaMass:mHValues 33 2.21949 
 newdef BtosgammaMass:mHValues 34 2.26175 
 newdef BtosgammaMass:mHValues 35 2.30401 
 newdef BtosgammaMass:mHValues 36 2.34626 
 newdef BtosgammaMass:mHValues 37 2.38852 
 newdef BtosgammaMass:mHValues 38 2.43078 
 newdef BtosgammaMass:mHValues 39 2.47304 
 newdef BtosgammaMass:mHValues 40 2.51529 
 newdef BtosgammaMass:mHValues 41 2.55755 
 newdef BtosgammaMass:mHValues 42 2.59981 
 newdef BtosgammaMass:mHValues 43 2.64207 
 newdef BtosgammaMass:mHValues 44 2.68432 
 newdef BtosgammaMass:mHValues 45 2.72658 
 newdef BtosgammaMass:mHValues 46 2.76884 
 newdef BtosgammaMass:mHValues 47 2.8111 
 newdef BtosgammaMass:mHValues 48 2.85335 
 newdef BtosgammaMass:mHValues 49 2.89561 
 newdef BtosgammaMass:mHValues 50 2.93787 
 newdef BtosgammaMass:mHValues 51 2.98013 
 newdef BtosgammaMass:mHValues 52 3.02238 
 newdef BtosgammaMass:mHValues 53 3.06464 
 newdef BtosgammaMass:mHValues 54 3.1069 
 newdef BtosgammaMass:mHValues 55 3.14915 
 newdef BtosgammaMass:mHValues 56 3.19141 
 newdef BtosgammaMass:mHValues 57 3.23367 
 newdef BtosgammaMass:mHValues 58 3.27593 
 newdef BtosgammaMass:mHValues 59 3.31818 
 newdef BtosgammaMass:mHValues 60 3.36044 
 newdef BtosgammaMass:mHValues 61 3.4027 
 newdef BtosgammaMass:mHValues 62 3.44496 
 newdef BtosgammaMass:mHValues 63 3.48721 
 newdef BtosgammaMass:mHValues 64 3.52947 
 newdef BtosgammaMass:mHValues 65 3.57173 
 newdef BtosgammaMass:mHValues 66 3.61399 
 newdef BtosgammaMass:mHValues 67 3.65624 
 newdef BtosgammaMass:mHValues 68 3.6985 
 newdef BtosgammaMass:mHValues 69 3.74076 
 newdef BtosgammaMass:mHValues 70 3.78302 
 newdef BtosgammaMass:mHValues 71 3.82527 
 newdef BtosgammaMass:mHValues 72 3.86753 
 newdef BtosgammaMass:mHValues 73 3.90979 
 newdef BtosgammaMass:mHValues 74 3.95204 
 newdef BtosgammaMass:mHValues 75 3.9943 
 newdef BtosgammaMass:mHValues 76 4.03656 
 newdef BtosgammaMass:mHValues 77 4.07882 
 newdef BtosgammaMass:mHValues 78 4.12107 
 newdef BtosgammaMass:mHValues 79 4.16333 
 newdef BtosgammaMass:mHValues 80 4.20559 
 newdef BtosgammaMass:mHValues 81 4.24785 
 newdef BtosgammaMass:mHValues 82 4.2901 
 newdef BtosgammaMass:mHValues 83 4.33236 
 newdef BtosgammaMass:mHValues 84 4.37462 
 newdef BtosgammaMass:mHValues 85 4.41688 
 newdef BtosgammaMass:mHValues 86 4.45913 
 newdef BtosgammaMass:mHValues 87 4.50139 
 newdef BtosgammaMass:mHValues 88 4.54365 
 newdef BtosgammaMass:mHValues 89 4.58591 
 newdef BtosgammaMass:mHValues 90 4.62816 
 newdef BtosgammaMass:mHValues 91 4.67042 
 newdef BtosgammaMass:mHValues 92 4.71268 
 newdef BtosgammaMass:mHValues 93 4.75493 
 newdef BtosgammaMass:mHValues 94 4.79719 
 newdef BtosgammaMass:mHValues 95 4.83945 
 newdef BtosgammaMass:mHValues 96 4.88171 
 newdef BtosgammaMass:mHValues 97 4.92396 
 newdef BtosgammaMass:mHValues 98 4.96622 
 newdef BtosgammaMass:mHValues 99 5.00848 
 newdef BtosgammaMass:Spectrum 0 7.66578e-05 
 newdef BtosgammaMass:Spectrum 1 8.88774e-05 
 newdef BtosgammaMass:Spectrum 2 0.000101655 
 newdef BtosgammaMass:Spectrum 3 0.000114816 
 newdef BtosgammaMass:Spectrum 4 0.000128169 
 newdef BtosgammaMass:Spectrum 5 0.000141542 
 newdef BtosgammaMass:Spectrum 6 0.000154679 
 newdef BtosgammaMass:Spectrum 7 0.000167399 
 newdef BtosgammaMass:Spectrum 8 0.000179472 
 newdef BtosgammaMass:Spectrum 9 0.00019078 
 newdef BtosgammaMass:Spectrum 10 0.000201121 
 newdef BtosgammaMass:Spectrum 11 0.000210346 
 newdef BtosgammaMass:Spectrum 12 0.00021833 
 newdef BtosgammaMass:Spectrum 13 0.00022497 
 newdef BtosgammaMass:Spectrum 14 0.000230231 
 newdef BtosgammaMass:Spectrum 15 0.000233996 
 newdef BtosgammaMass:Spectrum 16 0.000236281 
 newdef BtosgammaMass:Spectrum 17 0.000237093 
 newdef BtosgammaMass:Spectrum 18 0.000236431 
 newdef BtosgammaMass:Spectrum 19 0.000234426 
 newdef BtosgammaMass:Spectrum 20 0.000231119 
 newdef BtosgammaMass:Spectrum 21 0.000226602 
 newdef BtosgammaMass:Spectrum 22 0.000220987 
 newdef BtosgammaMass:Spectrum 23 0.000214393 
 newdef BtosgammaMass:Spectrum 24 0.000206948 
 newdef BtosgammaMass:Spectrum 25 0.000198784 
 newdef BtosgammaMass:Spectrum 26 0.000190058 
 newdef BtosgammaMass:Spectrum 27 0.000180856 
 newdef BtosgammaMass:Spectrum 28 0.00017133 
 newdef BtosgammaMass:Spectrum 29 0.000161602 
 newdef BtosgammaMass:Spectrum 30 0.000151786 
 newdef BtosgammaMass:Spectrum 31 0.000141971 
 newdef BtosgammaMass:Spectrum 32 0.000132288 
 newdef BtosgammaMass:Spectrum 33 0.0001228 
 newdef BtosgammaMass:Spectrum 34 0.000113581 
 newdef BtosgammaMass:Spectrum 35 0.00010469 
 newdef BtosgammaMass:Spectrum 36 9.61778e-05 
 newdef BtosgammaMass:Spectrum 37 8.80815e-05 
 newdef BtosgammaMass:Spectrum 38 8.04295e-05 
 newdef BtosgammaMass:Spectrum 39 7.32403e-05 
 newdef BtosgammaMass:Spectrum 40 6.65241e-05 
 newdef BtosgammaMass:Spectrum 41 6.02879e-05 
 newdef BtosgammaMass:Spectrum 42 5.45173e-05 
 newdef BtosgammaMass:Spectrum 43 4.92076e-05 
 newdef BtosgammaMass:Spectrum 44 4.43443e-05 
 newdef BtosgammaMass:Spectrum 45 3.9909e-05 
 newdef BtosgammaMass:Spectrum 46 3.58802e-05 
 newdef BtosgammaMass:Spectrum 47 3.22326e-05 
 newdef BtosgammaMass:Spectrum 48 2.8946e-05 
 newdef BtosgammaMass:Spectrum 49 2.59925e-05 
 newdef BtosgammaMass:Spectrum 50 2.33464e-05 
 newdef BtosgammaMass:Spectrum 51 2.09823e-05 
 newdef BtosgammaMass:Spectrum 52 1.88754e-05 
 newdef BtosgammaMass:Spectrum 53 1.70019e-05 
 newdef BtosgammaMass:Spectrum 54 1.5339e-05 
 newdef BtosgammaMass:Spectrum 55 1.38655e-05 
 newdef BtosgammaMass:Spectrum 56 1.25614e-05 
 newdef BtosgammaMass:Spectrum 57 1.14085e-05 
 newdef BtosgammaMass:Spectrum 58 1.03894e-05 
 newdef BtosgammaMass:Spectrum 59 9.48883e-06 
 newdef BtosgammaMass:Spectrum 60 8.69297e-06 
 newdef BtosgammaMass:Spectrum 61 7.9892e-06 
 newdef BtosgammaMass:Spectrum 62 7.36625e-06 
 newdef BtosgammaMass:Spectrum 63 6.81403e-06 
 newdef BtosgammaMass:Spectrum 64 6.32388e-06 
 newdef BtosgammaMass:Spectrum 65 5.88784e-06 
 newdef BtosgammaMass:Spectrum 66 5.49905e-06 
 newdef BtosgammaMass:Spectrum 67 5.1515e-06 
 newdef BtosgammaMass:Spectrum 68 4.83997e-06 
 newdef BtosgammaMass:Spectrum 69 4.55992e-06 
 newdef BtosgammaMass:Spectrum 70 4.30743e-06 
 newdef BtosgammaMass:Spectrum 71 4.07914e-06 
 newdef BtosgammaMass:Spectrum 72 3.87217e-06 
 newdef BtosgammaMass:Spectrum 73 3.68409e-06 
 newdef BtosgammaMass:Spectrum 74 3.51284e-06 
 newdef BtosgammaMass:Spectrum 75 3.35671e-06 
 newdef BtosgammaMass:Spectrum 76 3.2143e-06 
 newdef BtosgammaMass:Spectrum 77 3.08444e-06 
 newdef BtosgammaMass:Spectrum 78 2.9662e-06 
 newdef BtosgammaMass:Spectrum 79 2.85934e-06 
 newdef BtosgammaMass:Spectrum 80 2.76345e-06 
 newdef BtosgammaMass:Spectrum 81 2.67832e-06 
 newdef BtosgammaMass:Spectrum 82 2.60408e-06 
 newdef BtosgammaMass:Spectrum 83 2.54259e-06 
 newdef BtosgammaMass:Spectrum 84 2.51139e-06 
 newdef BtosgammaMass:Spectrum 85 2.5295e-06 
 newdef BtosgammaMass:Spectrum 86 2.60152e-06 
 newdef BtosgammaMass:Spectrum 87 2.72469e-06 
 newdef BtosgammaMass:Spectrum 88 2.89586e-06 
 newdef BtosgammaMass:Spectrum 89 3.11368e-06 
 newdef BtosgammaMass:Spectrum 90 3.37949e-06 
 newdef BtosgammaMass:Spectrum 91 3.69773e-06 
 newdef BtosgammaMass:Spectrum 92 4.07611e-06 
 newdef BtosgammaMass:Spectrum 93 4.52598e-06 
 newdef BtosgammaMass:Spectrum 94 5.06366e-06 
 newdef BtosgammaMass:Spectrum 95 5.71246e-06 
 newdef BtosgammaMass:Spectrum 96 6.50607e-06 
 newdef BtosgammaMass:Spectrum 97 7.49463e-06 
 newdef BtosgammaMass:Spectrum 98 8.75571e-06 
 newdef BtosgammaMass:Spectrum 99 1.04156e-05 
 newdef BtosgammaKagan:HadronicMass BtosgammaMass 
 #
 create Herwig::SMTopDecayer  Top
 newdef Top:AlphaS  /Herwig/Shower/AlphaQCD
 newdef Top:AlphaEM /Herwig/Shower/AlphaQED
 newdef Top:QuarkWeights 0 5.
 newdef Top:QuarkWeights 1 5.
 newdef Top:QuarkWeights 2 5.
 newdef Top:QuarkWeights 3 5.
 newdef Top:QuarkWeights 4 1.5e-05
 newdef Top:QuarkWeights 5 5.
 newdef Top:LeptonWeights 0 5.
 newdef Top:LeptonWeights 1 5.
 newdef Top:LeptonWeights 2 5.
 newdef Top:Iteration 1
 newdef Top:Ntry 500
 newdef Top:Points 10000
 newdef Top:GenerateIntermediates 1
 newdef Top:PhotonGenerator /Herwig/QEDRadiation/SOPHTY
 #
 create Herwig::SMHiggsFermionsDecayer  Hff
 newdef Hff:NLO Yes
 newdef Hff:MaxWeights 0 2.116e-06
 newdef Hff:MaxWeights 1 4.47418e-07
 newdef Hff:MaxWeights 2 0.000763237
 newdef Hff:MaxWeights 3 0.0276405
 newdef Hff:MaxWeights 4 0.571455
 newdef Hff:MaxWeights 5 0
 newdef Hff:MaxWeights 6 5.76739e-09
 newdef Hff:MaxWeights 7 0.000246492
 newdef Hff:MaxWeights 8 0.0696381
 newdef Hff:Iteration 1
 newdef Hff:Ntry 500
 newdef Hff:Points 10000
 newdef Hff:GenerateIntermediates 0
 newdef Hff:AlphaS  /Herwig/Shower/AlphaQCD
 newdef Hff:AlphaEM /Herwig/Shower/AlphaQED
 newdef Hff:PhotonGenerator /Herwig/QEDRadiation/SOPHTY
 #
 create Herwig::SMHiggsWWDecayer  HWW
 newdef HWW:WMaximum 0 19.5935
 newdef HWW:ZMaximum 0 1.84109
 newdef HWW:WMaximum 1 183.963
 newdef HWW:ZMaximum 1 39.4542
 newdef HWW:Iteration 1
 newdef HWW:Ntry 2000
 newdef HWW:Points 10000
 newdef HWW:GenerateIntermediates 0
 newdef HWW:PhotonGenerator /Herwig/QEDRadiation/SOPHTY
 #
 create Herwig::SemiLeptonicScalarDecayer  HQET
 newdef HQET:Iteration 1
 newdef HQET:Ntry 500
 newdef HQET:Points 10000
 newdef HQET:GenerateIntermediates 0
 insert HQET:MaximumWeight 0 0.0762401
 insert HQET:MaximumWeight 1 0.0723751
 insert HQET:MaximumWeight 2 0.0189018
 insert HQET:MaximumWeight 3 0.105976
 insert HQET:MaximumWeight 4 0.105066
 insert HQET:MaximumWeight 5 0.0261202
 insert HQET:MaximumWeight 6 0.0700031
 insert HQET:MaximumWeight 7 0.066446
 insert HQET:MaximumWeight 8 0.0172756
 insert HQET:MaximumWeight 9 0.10208
 insert HQET:MaximumWeight 10 0.106631
 insert HQET:MaximumWeight 11 0.0278126
 create Herwig::LeptonNeutrinoCurrent HQETCurrent  HwWeakCurrents.so
 newdef HQETCurrent:Quark 0  11
 newdef HQETCurrent:AntiQuark 0  -12
 newdef HQETCurrent:Quark 1  13
 newdef HQETCurrent:AntiQuark 1  -15
 newdef HQETCurrent:Quark 2  15
 newdef HQETCurrent:AntiQuark 2  -16
 newdef HQET:Current HQETCurrent
 create Herwig::HQETFormFactor HQETFormFactor
 newdef HQETFormFactor:Incoming 0 -521
 newdef HQETFormFactor:Outgoing 0 421
 newdef HQETFormFactor:Spin 0 0
 newdef HQETFormFactor:Spectator 0 -2
 newdef HQETFormFactor:InQuark 0 5
 newdef HQETFormFactor:OutQuark 0 4
 newdef HQETFormFactor:Incoming 1 -521
 newdef HQETFormFactor:Outgoing 1 423
 newdef HQETFormFactor:Spin 1 1
 newdef HQETFormFactor:Spectator 1 -2
 newdef HQETFormFactor:InQuark 1 5
 newdef HQETFormFactor:OutQuark 1 4
 newdef HQETFormFactor:Incoming 2 -511
 newdef HQETFormFactor:Outgoing 2 411
 newdef HQETFormFactor:Spin 2 0
 newdef HQETFormFactor:Spectator 2 1
 newdef HQETFormFactor:InQuark 2 5
 newdef HQETFormFactor:OutQuark 2 4
 newdef HQETFormFactor:Incoming 3 -511
 newdef HQETFormFactor:Outgoing 3 413
 newdef HQETFormFactor:Spin 3 1
 newdef HQETFormFactor:Spectator 3 1
 newdef HQETFormFactor:InQuark 3 5
 newdef HQETFormFactor:OutQuark 3 4
 newdef HQETFormFactor:F1Scalar   1.02693
 newdef HQETFormFactor:F1Vector   0.84
 newdef HQETFormFactor:Rho2Scalar 1.17
 newdef HQETFormFactor:Rho2Vector 1.179
 newdef HQETFormFactor:R1         1.417
 newdef HQETFormFactor:R2         0.836
 newdef HQET:FormFactor HQETFormFactor 
 #
 create Herwig::CLEOD0toK0PipPim D0K0PipPimCLEO
 newdef D0K0PipPimCLEO:Iteration 10
 newdef D0K0PipPimCLEO:Ntry 500
 newdef D0K0PipPimCLEO:Points 100000
 newdef D0K0PipPimCLEO:GenerateIntermediates 1 
 newdef D0K0PipPimCLEO:DRadius 5
 newdef D0K0PipPimCLEO:ResonanceRadius 1.5
 newdef D0K0PipPimCLEO:MaximumWeight 4.0e+10
 insert D0K0PipPimCLEO:Weights 0 0.0315344
 insert D0K0PipPimCLEO:Weights 1 0.143317
 insert D0K0PipPimCLEO:Weights 2 0.0614656
 insert D0K0PipPimCLEO:Weights 3 0.316689
 insert D0K0PipPimCLEO:Weights 4 0.0334101
 insert D0K0PipPimCLEO:Weights 5 0.108971
 insert D0K0PipPimCLEO:Weights 6 0.112036
 insert D0K0PipPimCLEO:Weights 7 0.070267
 insert D0K0PipPimCLEO:Weights 8 0.0527859
 insert D0K0PipPimCLEO:Weights 9 0.0695232
 newdef D0K0PipPimCLEO:RhoMass 769.3
 newdef D0K0PipPimCLEO:RhoWidth 150.2
 newdef D0K0PipPimCLEO:OmegaMass 782.57
 newdef D0K0PipPimCLEO:OmegaWidth 8.44
 newdef D0K0PipPimCLEO:f980Mass 977
 newdef D0K0PipPimCLEO:f980Width 50
 newdef D0K0PipPimCLEO:gPi 0.09
 newdef D0K0PipPimCLEO:gK 0.02
 newdef D0K0PipPimCLEO:f0Option 1
 newdef D0K0PipPimCLEO:f_2Mass 1275.4
 newdef D0K0PipPimCLEO:f_2Width 185.1
 newdef D0K0PipPimCLEO:f1370Mass 1310
 newdef D0K0PipPimCLEO:f1370Width 272
 newdef D0K0PipPimCLEO:KstarMass 891.66
 newdef D0K0PipPimCLEO:KstarWidth 50.8
 newdef D0K0PipPimCLEO:K_01430Mass 1412
 newdef D0K0PipPimCLEO:K_01430Width 294
 newdef D0K0PipPimCLEO:K_21430Mass 1425.6
 newdef D0K0PipPimCLEO:K_21430Width 98.5
 newdef D0K0PipPimCLEO:Kstar1680Mass 1717
 newdef D0K0PipPimCLEO:Kstar1680Width 322
 newdef D0K0PipPimCLEO:KStarPlusAmplitude 0.11
 newdef D0K0PipPimCLEO:KStarPlusPhase 321
 newdef D0K0PipPimCLEO:RhoAmplitude 1
 newdef D0K0PipPimCLEO:RhoPhase 0
 newdef D0K0PipPimCLEO:OmegaAmplitude 0.037
 newdef D0K0PipPimCLEO:OmegaPhase 114
 newdef D0K0PipPimCLEO:KStarMinusAmplitude 1.56
 newdef D0K0PipPimCLEO:KStarMinusPhase 150
 newdef D0K0PipPimCLEO:f980Amplitude 0.34
 newdef D0K0PipPimCLEO:f980Phase 188
 newdef D0K0PipPimCLEO:f2Amplitude 0.7
 newdef D0K0PipPimCLEO:f2Phase 308
 newdef D0K0PipPimCLEO:f1370Amplitude 1.8
 newdef D0K0PipPimCLEO:f1370Phase 85
 newdef D0K0PipPimCLEO:KK_0MinusAmplitude 2
 newdef D0K0PipPimCLEO:KK_0MinusPhase 3
 newdef D0K0PipPimCLEO:KK_2MinusAmplitude 1
 newdef D0K0PipPimCLEO:KK_2MinusPhase 335
 newdef D0K0PipPimCLEO:K1680MinusAmplitude 5.6
 newdef D0K0PipPimCLEO:K1680MinusPhase 174
 newdef D0K0PipPimCLEO:NonResonantAmplitude 1.1
 newdef D0K0PipPimCLEO:NonResonantPhase 340
 #
 create Herwig::DtoKPiPiE691  DKPiPiE691
 newdef DKPiPiE691:Iteration 10
 newdef DKPiPiE691:Ntry 500
 newdef DKPiPiE691:Points 10000
 newdef DKPiPiE691:GenerateIntermediates 1
 newdef DKPiPiE691:KmPipPipNonResonantMagnitude 1
 newdef DKPiPiE691:KmPipPipNonResonantPhase     0
 newdef DKPiPiE691:KmPipPipK892Magnitude        0.78
 newdef DKPiPiE691:KmPipPipK892Phase            -60
 newdef DKPiPiE691:KmPipPipK1430Magnitude       0.53
 newdef DKPiPiE691:KmPipPipK1430Phase           132
 newdef DKPiPiE691:KmPipPipK1680Magnitude       0.47
 newdef DKPiPiE691:KmPipPipK1680Phase           -51
 newdef DKPiPiE691:KmPipPi0NonResonantMagnitude 1
 newdef DKPiPiE691:KmPipPi0NonResonantPhase     0
 newdef DKPiPiE691:KmPipPi0K8920Magnitude       3.19
 newdef DKPiPiE691:KmPipPi0K8920Phase           167
 newdef DKPiPiE691:KmPipPi0K892mMagnitude       2.96
 newdef DKPiPiE691:KmPipPi0K892mPhase           -112
 newdef DKPiPiE691:KmPipPi0RhoMagnitude         8.56
 newdef DKPiPiE691:KmPipPi0RhoPhase             40
 newdef DKPiPiE691:K0PipPimNonResonantMagnitude 1
 newdef DKPiPiE691:K0PipPimNonResonantPhase     0
 newdef DKPiPiE691:K0PipPimK892Magnitude        2.31
 newdef DKPiPiE691:K0PipPimK892Phase            109
 newdef DKPiPiE691:K0PipPimRhoMagnitude         1.59
 newdef DKPiPiE691:K0PipPimRhoPhase             -123
 newdef DKPiPiE691:LocalParameters 1
 newdef DKPiPiE691:K8920Mass      0.8961
 newdef DKPiPiE691:K8920Width     0.0505
 newdef DKPiPiE691:K892MinusMass  0.89159
 newdef DKPiPiE691:K892MinusWidth 0.0498
 newdef DKPiPiE691:K1680Mass      1.714
 newdef DKPiPiE691:K1680Width     0.323
 newdef DKPiPiE691:K1430Mass      1.429
 newdef DKPiPiE691:K1430Width     0.287
 newdef DKPiPiE691:Rho0Mass       0.7681
 newdef DKPiPiE691:Rho0Width      0.1515
 newdef DKPiPiE691:RhoPlusMass    0.7681
 newdef DKPiPiE691:RhoPlusWidth   0.1515
 insert DKPiPiE691:MaximumWeights 0 1.76526e+09
 insert DKPiPiE691:MaximumWeights 1 6.09945e+09
 insert DKPiPiE691:MaximumWeights 2 1.02351e+09
 insert DKPiPiE691:Weights 0 0.192843
 insert DKPiPiE691:Weights 1 0.198588
 insert DKPiPiE691:Weights 2 0.108339
 insert DKPiPiE691:Weights 3 0.114322
 insert DKPiPiE691:Weights 4 0.192924
 insert DKPiPiE691:Weights 5 0.192984
 insert DKPiPiE691:Weights 6 0.226201
 insert DKPiPiE691:Weights 7 0.217755
 insert DKPiPiE691:Weights 8 0.556044
 insert DKPiPiE691:Weights 9 0.453208
 insert DKPiPiE691:Weights 10 0.546792
 #
 create Herwig::DtoKPiPiMarkIII  DtoKPiPiMarkIII
 newdef DtoKPiPiMarkIII:Iteration 10
 newdef DtoKPiPiMarkIII:Ntry 500
 newdef DtoKPiPiMarkIII:Points 10000
 newdef DtoKPiPiMarkIII:GenerateIntermediates 1
 newdef DtoKPiPiMarkIII:KmPipPi0RhoMagnitude 1
 newdef DtoKPiPiMarkIII:KmPipPi0RhoPhase 0
 newdef DtoKPiPiMarkIII:KmPipPi0KstarmMagnitude 0.4018
 newdef DtoKPiPiMarkIII:KmPipPi0KstarmPhase 154
 newdef DtoKPiPiMarkIII:KmPipPi0Kstar0Magnitude 0.4244
 newdef DtoKPiPiMarkIII:KmPipPi0Kstar0Phase 7
 newdef DtoKPiPiMarkIII:KmPipPi0NonResonantMagnitude 2.0693
 newdef DtoKPiPiMarkIII:KmPipPi0NonResonantPhase 52
 newdef DtoKPiPiMarkIII:K0PipPimRhoMagnitude 0.0975
 newdef DtoKPiPiMarkIII:K0PipPimRhoPhase 93
 newdef DtoKPiPiMarkIII:K0PipPimKstarMagnitude 0.2225
 newdef DtoKPiPiMarkIII:K0PipPimKstarPhase 0
 newdef DtoKPiPiMarkIII:K0PipPimNonResonantMagnitude 1
 newdef DtoKPiPiMarkIII:K0PipPimNonResonantPhase 0
 newdef DtoKPiPiMarkIII:K0PipPi0RhoMagnitude 1
 newdef DtoKPiPiMarkIII:K0PipPi0RhoPhase 0
 newdef DtoKPiPiMarkIII:K0PipPi0KstarMagnitude 0.5617
 newdef DtoKPiPiMarkIII:K0PipPi0KstarPhase 43
 newdef DtoKPiPiMarkIII:K0PipPi0NonResonantMagnitude 2.725
 newdef DtoKPiPiMarkIII:K0PipPi0NonResonantPhase 250
 newdef DtoKPiPiMarkIII:KmPipPipNonResonantMagnitude 1
 newdef DtoKPiPiMarkIII:KmPipPipNonResonantPhase 0
 newdef DtoKPiPiMarkIII:KmPipPipKstarMagnitude 0.04749
 newdef DtoKPiPiMarkIII:KmPipPipKstarPhase 105
 newdef DtoKPiPiMarkIII:LocalParameters 1
 newdef DtoKPiPiMarkIII:Kstar0Mass 0.8695
 newdef DtoKPiPiMarkIII:Kstar0Width 0.0502
 newdef DtoKPiPiMarkIII:KstarMinusMass 0.8921
 newdef DtoKPiPiMarkIII:KstarMinusWidth 0.0511
 newdef DtoKPiPiMarkIII:Rho0Mass 0.77
 newdef DtoKPiPiMarkIII:Rho0Width 0.1533
 newdef DtoKPiPiMarkIII:RhoPlusMass 0.77
 newdef DtoKPiPiMarkIII:RhoPlusWidth 0.1533
 newdef DtoKPiPiMarkIII:RhoRadius 5
 newdef DtoKPiPiMarkIII:KstarRadius 2
 insert DtoKPiPiMarkIII:MaximumWeights 0 3.40137e+10
 insert DtoKPiPiMarkIII:MaximumWeights 1 1.26052e+09
 insert DtoKPiPiMarkIII:MaximumWeights 2 7.78925e+10
 insert DtoKPiPiMarkIII:MaximumWeights 3 3.50351e+09
 insert DtoKPiPiMarkIII:Weights 0 0.508183
 insert DtoKPiPiMarkIII:Weights 1 0.186959
 insert DtoKPiPiMarkIII:Weights 2 0.304858
 insert DtoKPiPiMarkIII:Weights 3 0.442997
 insert DtoKPiPiMarkIII:Weights 4 0.557003
 insert DtoKPiPiMarkIII:Weights 5 0.576273
 insert DtoKPiPiMarkIII:Weights 6 0.423727
 insert DtoKPiPiMarkIII:Weights 7 0.497905
 insert DtoKPiPiMarkIII:Weights 8 0.502095
 #
 create Herwig::RadiativeHyperonDecayer  RadiativeHyperon
 newdef RadiativeHyperon:Iteration 1
 newdef RadiativeHyperon:Ntry 500
 newdef RadiativeHyperon:Points 10000
 newdef RadiativeHyperon:GenerateIntermediates 0 
 do RadiativeHyperon:SetUpDecayMode 3222 2212 -1.81e-07 4.7e-08 0.0245809
 do RadiativeHyperon:SetUpDecayMode 3312 3112 8e-09 1.5e-08 6.02591e-05
 do RadiativeHyperon:SetUpDecayMode 3212 2112 -2e-09 -4.5e-08 1.34599e-12
 do RadiativeHyperon:SetUpDecayMode 3122 2112 -5.2e-08 -5e-09 0.00237221
 do RadiativeHyperon:SetUpDecayMode 3322 3212 5e-09 7e-08 0.00175107
 do RadiativeHyperon:SetUpDecayMode 3322 3122 -3.4e-08 -8e-09 0.00171032
 #
 create Herwig::SMWDecayer  WDecayer
 newdef WDecayer:AlphaS  /Herwig/Shower/AlphaQCD
 newdef WDecayer:AlphaEM /Herwig/Shower/AlphaQED
 newdef WDecayer:QuarkMax 0 3.
 newdef WDecayer:QuarkMax 1 3.
 newdef WDecayer:QuarkMax 2 3.
 newdef WDecayer:QuarkMax 3 3.
 newdef WDecayer:QuarkMax 4 3.
 newdef WDecayer:QuarkMax 5 3.
 newdef WDecayer:LeptonMax 0 3.
 newdef WDecayer:LeptonMax 1 3.
 newdef WDecayer:LeptonMax 2 3.
 newdef WDecayer:Iteration 1
 newdef WDecayer:Ntry 500
 newdef WDecayer:Points 10000
 newdef WDecayer:GenerateIntermediates 0 
 newdef WDecayer:PhotonGenerator /Herwig/QEDRadiation/SOPHTY
 #
 create Herwig::SMHiggsGGHiggsPPDecayer  HPP
 newdef HPP:MaxWeights 0 0.624291
 newdef HPP:MaxWeights 1 1.17718
 newdef HPP:MaxWeights 2 1.15963
 newdef HPP:SMHGGVertex /Herwig/Vertices/HGGVertex
 newdef HPP:SMHPPVertex /Herwig/Vertices/HPPVertex
 newdef HPP:SMHZPVertex /Herwig/Vertices/HZPVertex
 newdef HPP:Iteration 10
 newdef HPP:Ntry 500
 newdef HPP:Points 10000
 newdef HPP:AlphaS  /Herwig/Shower/AlphaQCD
 newdef HPP:GenerateIntermediates 0
 #
 create Herwig::TauDecayer  Tau2Kaon
 newdef Tau2Kaon:Ntry 500
 newdef Tau2Kaon:Points 10000
 newdef Tau2Kaon:GenerateIntermediates 1 
 insert Tau2Kaon:WeightLocation 0 0
 insert Tau2Kaon:MaximumWeight 0 0.014
 insert Tau2Kaon:Weights 0 0.505259
 insert Tau2Kaon:Weights 1 0.43015
 insert Tau2Kaon:Weights 2 0.064591
 newdef Tau2Kaon:WeakCurrent TwoKaonCzyzCurrent
 #
 create Herwig::Spin3Meson2PScalarDecayer  Spin3PP
 newdef Spin3PP:Iteration 1
 newdef Spin3PP:Ntry 500
 newdef Spin3PP:Points 10000
 newdef Spin3PP:GenerateIntermediates 0 
 set Spin3PP:DatabaseOutput 1
 do Spin3PP:SetUpDecayMode 447 411 -411 6.01096 1.59891
 do Spin3PP:SetUpDecayMode 447 421 -421 6.01096 1.6008
 #
 create Herwig::TauDecayer  Tau1K2Pi
 newdef Tau1K2Pi:Iteration 10
 newdef Tau1K2Pi:Ntry 500
 newdef Tau1K2Pi:Points 1000000
 newdef Tau1K2Pi:GenerateIntermediates 1 
 insert Tau1K2Pi:WeightLocation 0 0
 insert Tau1K2Pi:WeightLocation 1 30
 insert Tau1K2Pi:WeightLocation 2 60
 insert Tau1K2Pi:MaximumWeight 0 0.0273874
 insert Tau1K2Pi:MaximumWeight 1 0.0811559
 insert Tau1K2Pi:MaximumWeight 2 0.0860745
 insert Tau1K2Pi:Weights 0 0.0982712
 insert Tau1K2Pi:Weights 1 0.0985845
 insert Tau1K2Pi:Weights 2 0.0754198
 insert Tau1K2Pi:Weights 3 0.0751768
 insert Tau1K2Pi:Weights 4 0.00576148
 insert Tau1K2Pi:Weights 5 0.0054422
 insert Tau1K2Pi:Weights 6 0.0030416
 insert Tau1K2Pi:Weights 7 0.00282067
 insert Tau1K2Pi:Weights 8 0.00292896
 insert Tau1K2Pi:Weights 9 0.00333228
 insert Tau1K2Pi:Weights 10 0.0354826
 insert Tau1K2Pi:Weights 11 0.0362049
 insert Tau1K2Pi:Weights 12 0.0288883
 insert Tau1K2Pi:Weights 13 0.0290415
 insert Tau1K2Pi:Weights 14 0.0706914
 insert Tau1K2Pi:Weights 15 0.070505
 insert Tau1K2Pi:Weights 16 0.0273647
 insert Tau1K2Pi:Weights 17 0.0276436
 insert Tau1K2Pi:Weights 18 0.0318761
 insert Tau1K2Pi:Weights 19 0.0313382
 insert Tau1K2Pi:Weights 20 0.0386597
 insert Tau1K2Pi:Weights 21 0.0385886
 insert Tau1K2Pi:Weights 22 0.0334508
 insert Tau1K2Pi:Weights 23 0.0337579
 insert Tau1K2Pi:Weights 24 0.0256563
 insert Tau1K2Pi:Weights 25 0.0256098
 insert Tau1K2Pi:Weights 26 0.0105038
 insert Tau1K2Pi:Weights 27 0.0103908
 insert Tau1K2Pi:Weights 28 0.0116108
 insert Tau1K2Pi:Weights 29 0.0119557
 insert Tau1K2Pi:Weights 30 0.0643114
 insert Tau1K2Pi:Weights 31 0.135241
 insert Tau1K2Pi:Weights 32 0.0462792
 insert Tau1K2Pi:Weights 33 0.132393
 insert Tau1K2Pi:Weights 34 0.00228711
 insert Tau1K2Pi:Weights 35 0.00712326
 insert Tau1K2Pi:Weights 36 0.00250683
 insert Tau1K2Pi:Weights 37 0.00711817
 insert Tau1K2Pi:Weights 38 0.00214168
 insert Tau1K2Pi:Weights 39 0.00734524
 insert Tau1K2Pi:Weights 40 0.056539
 insert Tau1K2Pi:Weights 41 0.0371129
 insert Tau1K2Pi:Weights 42 0.0419097
 insert Tau1K2Pi:Weights 43 0.024564
 insert Tau1K2Pi:Weights 44 0.0387979
 insert Tau1K2Pi:Weights 45 0.0235521
 insert Tau1K2Pi:Weights 46 0.0389098
 insert Tau1K2Pi:Weights 47 0.023459
 insert Tau1K2Pi:Weights 48 0.0389241
 insert Tau1K2Pi:Weights 49 0.0234025
 insert Tau1K2Pi:Weights 50 0.0564586
 insert Tau1K2Pi:Weights 51 0.0414258
 insert Tau1K2Pi:Weights 52 0.0424572
 insert Tau1K2Pi:Weights 53 0.0306962
 insert Tau1K2Pi:Weights 54 0.014456
 insert Tau1K2Pi:Weights 55 0.0105052
 insert Tau1K2Pi:Weights 56 0.0143489
 insert Tau1K2Pi:Weights 57 0.0105307
 insert Tau1K2Pi:Weights 58 0.0143897
 insert Tau1K2Pi:Weights 59 0.0108141
 insert Tau1K2Pi:Weights 60 0.0689819
 insert Tau1K2Pi:Weights 61 0.061703
 insert Tau1K2Pi:Weights 62 0.0616514
 insert Tau1K2Pi:Weights 63 0.0386958
 insert Tau1K2Pi:Weights 64 0.0453983
 insert Tau1K2Pi:Weights 65 0.045033
 insert Tau1K2Pi:Weights 66 0.00234914
 insert Tau1K2Pi:Weights 67 0.0017299
 insert Tau1K2Pi:Weights 68 0.00225587
 insert Tau1K2Pi:Weights 69 0.00149289
 insert Tau1K2Pi:Weights 70 0.00146865
 insert Tau1K2Pi:Weights 71 0.00133644
 insert Tau1K2Pi:Weights 72 0.00127344
 insert Tau1K2Pi:Weights 73 0.00154511
 insert Tau1K2Pi:Weights 74 0.0013302
 insert Tau1K2Pi:Weights 75 0.0491598
 insert Tau1K2Pi:Weights 76 0.0264942
 insert Tau1K2Pi:Weights 77 0.0264046
 insert Tau1K2Pi:Weights 78 0.0288977
 insert Tau1K2Pi:Weights 79 0.0179427
 insert Tau1K2Pi:Weights 80 0.017631
 insert Tau1K2Pi:Weights 81 0.0417104
 insert Tau1K2Pi:Weights 82 0.0358827
 insert Tau1K2Pi:Weights 83 0.0414594
 insert Tau1K2Pi:Weights 84 0.0165004
 insert Tau1K2Pi:Weights 85 0.0267491
 insert Tau1K2Pi:Weights 86 0.0163126
 insert Tau1K2Pi:Weights 87 0.0191507
 insert Tau1K2Pi:Weights 88 0.026621
 insert Tau1K2Pi:Weights 89 0.0189324
 insert Tau1K2Pi:Weights 90 0.0464448
 insert Tau1K2Pi:Weights 91 0.0292149
 insert Tau1K2Pi:Weights 92 0.0286853
 insert Tau1K2Pi:Weights 93 0.0277957
 insert Tau1K2Pi:Weights 94 0.0201043
 insert Tau1K2Pi:Weights 95 0.0201356
 insert Tau1K2Pi:Weights 96 0.0138683
 insert Tau1K2Pi:Weights 97 0.0116343
 insert Tau1K2Pi:Weights 98 0.0140018
 insert Tau1K2Pi:Weights 99 0.00576547
 insert Tau1K2Pi:Weights 100 0.00879157
 insert Tau1K2Pi:Weights 101 0.00565538
 insert Tau1K2Pi:Weights 102 0.00658881
 insert Tau1K2Pi:Weights 103 0.00871664
 insert Tau1K2Pi:Weights 104 0.00650336
 create Herwig::OneKaonTwoPionCurrent Tau1K2PiCurrent HwWeakCurrents.so
 newdef Tau1K2PiCurrent:AxialRhoWeight 0 1
 newdef Tau1K2PiCurrent:AxialRhoWeight 1 -0.145
 newdef Tau1K2PiCurrent:AxialRhoWeight 2 0
 newdef Tau1K2PiCurrent:AxialKStarWeight 0 1
 newdef Tau1K2PiCurrent:AxialKStarWeight 1 -0.135
 newdef Tau1K2PiCurrent:AxialKStarWeight 2 0
 newdef Tau1K2PiCurrent:VectorKStarWeight 0 1
 newdef Tau1K2PiCurrent:VectorKStarWeight 1 -0.25
 newdef Tau1K2PiCurrent:VectorKStarWeight 2 -0.038
 newdef Tau1K2PiCurrent:FPi 92.4189
 newdef Tau1K2PiCurrent:K1Masses 0 1.27
 newdef Tau1K2PiCurrent:K1Masses 1 1.402
 newdef Tau1K2PiCurrent:K1Widths 0 0.09
 newdef Tau1K2PiCurrent:K1Widths 1 0.174
 newdef Tau1K2PiCurrent:RhoAxialMasses 0 0.773
 newdef Tau1K2PiCurrent:RhoAxialMasses 1 1.37
 newdef Tau1K2PiCurrent:RhoAxialMasses 2 1.75
 newdef Tau1K2PiCurrent:RhoAxialWidths 0 0.145
 newdef Tau1K2PiCurrent:RhoAxialWidths 1 0.51
 newdef Tau1K2PiCurrent:RhoAxialWidths 2 0.12
 newdef Tau1K2PiCurrent:KstarAxialMasses 0 0.892
 newdef Tau1K2PiCurrent:KstarAxialMasses 1 1.412
 newdef Tau1K2PiCurrent:KstarAxialMasses 2 1.714
 newdef Tau1K2PiCurrent:KstarAxialWidths 0 0.05
 newdef Tau1K2PiCurrent:KstarAxialWidths 1 0.227
 newdef Tau1K2PiCurrent:KstarAxialWidths 2 0.323
 newdef Tau1K2PiCurrent:KstarVectorMasses 0 0.892
 newdef Tau1K2PiCurrent:KstarVectorMasses 1 1.412
 newdef Tau1K2PiCurrent:KstarVectorMasses 2 1.714
 newdef Tau1K2PiCurrent:KstarVectorWidths 0 0.05
 newdef Tau1K2PiCurrent:KstarVectorWidths 1 0.227
 newdef Tau1K2PiCurrent:KstarVectorWidths 2 0.323
 newdef Tau1K2PiCurrent:K1WeightKStarPi 0 0.33
 newdef Tau1K2PiCurrent:K1WeightKStarPi 1 1
 newdef Tau1K2PiCurrent:K1WeightRhoK 0 1
 newdef Tau1K2PiCurrent:K1WeightRhoK 1 0
 newdef Tau1K2PiCurrent:Quark 0  2
 newdef Tau1K2PiCurrent:AntiQuark 0  -3
 newdef Tau1K2PiCurrent:Quark 1  2
 newdef Tau1K2PiCurrent:AntiQuark 1  -3
 newdef Tau1K2PiCurrent:Quark 2  2
 newdef Tau1K2PiCurrent:AntiQuark 2  -3
 newdef Tau1K2Pi:WeakCurrent Tau1K2PiCurrent
 #
 create Herwig::VectorMeson2SpinHalfBaryonsDecayer  Vector2BaryonsHalf
 newdef Vector2BaryonsHalf:Iteration 1
 newdef Vector2BaryonsHalf:Ntry 500
 newdef Vector2BaryonsHalf:Points 10000
 newdef Vector2BaryonsHalf:GenerateIntermediates 0 
 do Vector2BaryonsHalf:SetUpDecayMode 443 2212 -2212 0.00135736265293 0.00163222616377 0. 1.6
 do Vector2BaryonsHalf:SetUpDecayMode 443 2112 -2112 0.0015117595557 0.00158881446341 0. 1.6 
 do Vector2BaryonsHalf:SetUpDecayMode 443 3122 -3122 0.00137881900413 0.00163561699791 0.740 2.1
 do Vector2BaryonsHalf:SetUpDecayMode 443 3212 -3212 0.001988067505 0.000944247071286 0. 1.5  
 do Vector2BaryonsHalf:SetUpDecayMode 443 3222 -3222 0.00233118573611 0.00102277134344 -0.270 2.0
 do Vector2BaryonsHalf:SetUpDecayMode 443 3312 -3312 0.000852659560453 0.00141162244048 0. 2.
 do Vector2BaryonsHalf:SetUpDecayMode 443 3322 -3322 0.000801719253474 0.00150424724997 0. 2.1   
 do Vector2BaryonsHalf:SetUpDecayMode 100443 2212 -2212 0. 0.00103222902272 0. 1.7 
 do Vector2BaryonsHalf:SetUpDecayMode 100443 2112 -2112 0.00084599445285 0.00098818310509 0. 1.7
 do Vector2BaryonsHalf:SetUpDecayMode 100443 3122 -3122 0.000621041230885 0.00119542938517 0. 2.5  
 do Vector2BaryonsHalf:SetUpDecayMode 100443 3212 -3212 0.000599393812308 0.000941856299908 0. 1.6
 do Vector2BaryonsHalf:SetUpDecayMode 100443 3222 -3222 0.00194199600339 0.00288222568159 0.379 15.
 do Vector2BaryonsHalf:SetUpDecayMode 100443 3312 -3312 0.000327664954147 0.00108249234586 0. 2.   
 do Vector2BaryonsHalf:SetUpDecayMode 100443 3322 -3322 0.000664382626732 0.00102912698738 0. 2. 
 #
 create Herwig::CLEOD0toKmPipPi0  D0KmPipPi0CLEO
 newdef D0KmPipPi0CLEO:Iteration 10
 newdef D0KmPipPi0CLEO:Ntry 500
 newdef D0KmPipPi0CLEO:Points 100000
 newdef D0KmPipPi0CLEO:GenerateIntermediates 1 
 newdef D0KmPipPi0CLEO:DRadius 5
 newdef D0KmPipPi0CLEO:ResonanceRadius 1.5
 newdef D0KmPipPi0CLEO:MaximumWeight 1.52393e+10
 insert D0KmPipPi0CLEO:Weights 0 0.279469
 insert D0KmPipPi0CLEO:Weights 1 0.14109
 insert D0KmPipPi0CLEO:Weights 2 0.0801408
 insert D0KmPipPi0CLEO:Weights 3 0.093447
 insert D0KmPipPi0CLEO:Weights 4 0.166967
 insert D0KmPipPi0CLEO:Weights 5 0.0844772
 insert D0KmPipPi0CLEO:Weights 6 0.154409
 newdef D0KmPipPi0CLEO:K_01430Mass 1412
 newdef D0KmPipPi0CLEO:K_01430Width 294
 newdef D0KmPipPi0CLEO:Kstar1680Mass 1717
 newdef D0KmPipPi0CLEO:Kstar1680Width 322
 newdef D0KmPipPi0CLEO:rho1700Mass 1700
 newdef D0KmPipPi0CLEO:rho1700Width 240
 newdef D0KmPipPi0CLEO:Kstar0892Mass 896.1
 newdef D0KmPipPi0CLEO:Kstar0892Width 50.5
 newdef D0KmPipPi0CLEO:KstarPlus892Mass 891.5
 newdef D0KmPipPi0CLEO:KstarPlus892Width 50
 newdef D0KmPipPi0CLEO:RhoMass 770
 newdef D0KmPipPi0CLEO:RhoWidth 150.7
 newdef D0KmPipPi0CLEO:NonResonantAmplitude 1.75
 newdef D0KmPipPi0CLEO:NonResonantPhase 31.2
 newdef D0KmPipPi0CLEO:RhoAmplitude 1
 newdef D0KmPipPi0CLEO:RhoPhase 0
 newdef D0KmPipPi0CLEO:KStarMinusAmplitude 0.44
 newdef D0KmPipPi0CLEO:KStarMinusPhase 163
 newdef D0KmPipPi0CLEO:KStar0Amplitude 0.39
 newdef D0KmPipPi0CLEO:KStar0Phase -0.2
 newdef D0KmPipPi0CLEO:K_0MinusAmplitude 0.77
 newdef D0KmPipPi0CLEO:K_0MinusPhase 55.5
 newdef D0KmPipPi0CLEO:K_00Amplitude 0.85
 newdef D0KmPipPi0CLEO:K_00Phase 166
 newdef D0KmPipPi0CLEO:Rho1700Amplitude 2.5
 newdef D0KmPipPi0CLEO:Rho1700Phase 171
 newdef D0KmPipPi0CLEO:K1680MinusAmplitude 2.5
 newdef D0KmPipPi0CLEO:K1680MinusPhase 103
 #
 @LOAD_EVTGEN_DECAYER@
 
diff --git a/src/defaults/meson_decays.in b/src/defaults/meson_decays.in
--- a/src/defaults/meson_decays.in
+++ b/src/defaults/meson_decays.in
@@ -1,2123 +1,2153 @@
 # -*- ThePEG-repository -*-
 
 #
 # file containing the decays for the mesons
 #
 #
 # the 1^1S_0 multiplet
 #
 #
 decaymode pi+->mu+,nu_mu; 0.999877 1 /Herwig/Decays/PScalarlnu
 decaymode pi+->e+,nu_e; 0.000123 1 /Herwig/Decays/PScalarlnu
 #
 decaymode pi0->gamma,gamma; 0.988227 1 /Herwig/Decays/DecayME0
 decaymode pi0->gamma,e-,e+; 0.01174 1 /Herwig/Decays/PVff
 decaymode pi0->e-,e+,e-,e+; 3.3E-5 1 /Herwig/Decays/PScalar4f
 #
 decaymode pi-->mu-,nu_mubar; 0.999877 1 /Herwig/Decays/PScalarlnu
 decaymode pi-->e-,nu_ebar; 0.000123 1 /Herwig/Decays/PScalarlnu
 #
 decaymode eta->gamma,gamma; 0.394082 1 /Herwig/Decays/PVV
 decaymode eta->pi0,pi0,pi0; 0.326779 1 /Herwig/Decays/Etapipipi
 decaymode eta->pi+,pi-,pi0; 0.229175 1 /Herwig/Decays/Etapipipi
 decaymode eta->pi+,pi-,gamma; 0.0422 1 /Herwig/Decays/Etapipigamma
 decaymode eta->e-,e+,gamma; 0.0069 1 /Herwig/Decays/PVff
 decaymode eta->mu-,mu+,gamma; 0.00031 1 /Herwig/Decays/PVff
 decaymode eta->pi+,pi-,e-,e+; 0.000268 1 /Herwig/Decays/Mambo
 decaymode eta->pi0,gamma,gamma; 0.000256 1 /Herwig/Decays/Etapigammagamma
 decaymode eta->e-,e+,e-,e+; 2.4E-5 1 /Herwig/Decays/PScalar4f
 decaymode eta->mu-,mu+; 6.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode eta'->pi+,pi-,eta; 0.444682 1 /Herwig/Decays/Etapipipi
 decaymode eta'->pi+,pi-,gamma; 0.29379 1 /Herwig/Decays/Etapipigamma
 decaymode eta'->pi0,pi0,eta; 0.207852 1 /Herwig/Decays/Etapipipi
 decaymode eta'->omega,gamma; 0.0303 1 /Herwig/Decays/PVV
 decaymode eta'->gamma,gamma; 0.0212 1 /Herwig/Decays/PVV
 decaymode eta'->pi0,pi0,pi0; 0.00155 1 /Herwig/Decays/Etapipipi
 decaymode eta'->e-,e+,gamma; 0.000522 1 /Herwig/Decays/PVff
 decaymode eta'->mu-,mu+,gamma; 0.000104 1 /Herwig/Decays/PVff
 #
 decaymode eta_c->g,g; 0.720947 1 /Herwig/Decays/QDecayME0
 decaymode eta_c->eta,pi+,pi-; 0.032667 1 /Herwig/Decays/DecayME0
 decaymode eta_c->eta',pi+,pi-; 0.027333 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K-,K0,pi+; 0.023333 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K+,Kbar0,pi-; 0.023333 1 /Herwig/Decays/DecayME0
 decaymode eta_c->eta,pi0,pi0; 0.016333 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*0,K*bar0,pi+,pi-; 0.015 1 /Herwig/Decays/Mambo
 decaymode eta_c->eta',pi0,pi0; 0.013667 1 /Herwig/Decays/DecayME0
 decaymode eta_c->rho+,rho-; 0.013333 1 /Herwig/Decays/PVV
 decaymode eta_c->K0,Kbar0,pi0; 0.011667 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K+,K-,pi0; 0.011667 1 /Herwig/Decays/DecayME0
 decaymode eta_c->f_2,f_2; 0.01 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*-,K0,pi+; 0.00847 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*bar0,K+,pi-; 0.00847 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*0,K-,pi+; 0.00847 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*+,Kbar0,pi-; 0.00847 1 /Herwig/Decays/DecayME0
 decaymode eta_c->rho0,rho0; 0.006667 1 /Herwig/Decays/PVV
 decaymode eta_c->pi+,pi-,pi+,pi-; 0.005333 1 /Herwig/Decays/Mambo
 decaymode eta_c->K*0,K*bar0; 0.0046 1 /Herwig/Decays/PVV
 decaymode eta_c->K*+,K*-; 0.0046 1 /Herwig/Decays/PVV
 decaymode eta_c->K*-,K+,pi0; 0.00423 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*bar0,K0,pi0; 0.00423 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*0,Kbar0,pi0; 0.00423 1 /Herwig/Decays/DecayME0
 decaymode eta_c->K*+,K-,pi0; 0.00423 1 /Herwig/Decays/DecayME0
 decaymode eta_c->phi,phi; 0.0027 1 /Herwig/Decays/PVV
 decaymode eta_c->phi,K0,Kbar0; 0.00157 1 /Herwig/Decays/DecayME0
 decaymode eta_c->phi,K+,K-; 0.00157 1 /Herwig/Decays/DecayME0
 decaymode eta_c->n0,nbar0; 0.0013 1 /Herwig/Decays/DecayME0
 decaymode eta_c->p+,pbar-; 0.0013 1 /Herwig/Decays/DecayME0
 decaymode eta_c->gamma,gamma; 0.00028 1 /Herwig/Decays/PVV
 #
 decaymode eta_b->g,g; 1 1 /Herwig/Decays/QDecayME0
 #
 decaymode K+->mu+,nu_mu; 0.634277 1 /Herwig/Decays/PScalarlnu
 decaymode K+->pi+,pi0; 0.209159 1 /Herwig/Decays/DecayME0
 decaymode K+->pi+,pi+,pi-; 0.0559 1 /Herwig/Decays/DecayME0
 decaymode K+->pi0,e+,nu_e; 0.0498 1 /Herwig/Decays/DecayME101
 decaymode K+->pi0,mu+,nu_mu; 0.0332 1 /Herwig/Decays/DecayME101
 decaymode K+->pi+,pi0,pi0; 0.01757 1 /Herwig/Decays/DecayME0
 decaymode K+->pi+,pi-,e+,nu_e; 4.1E-5 1 /Herwig/Decays/Mambo
 decaymode K+->pi0,pi0,e+,nu_e; 2.2E-5 1 /Herwig/Decays/Mambo
 decaymode K+->e+,nu_e; 1.6E-5 1 /Herwig/Decays/PScalarlnu
 decaymode K+->pi+,pi-,mu+,nu_mu; 1.4E-5 1 /Herwig/Decays/Mambo
 decaymode K+->pi+,gamma,gamma; 1.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode K0->K_L0; 0.5 1 /Herwig/Decays/DecayME0
 decaymode K0->K_S0; 0.5 1 /Herwig/Decays/DecayME0
 #
 decaymode K-->mu-,nu_mubar; 0.634277 1 /Herwig/Decays/PScalarlnu
 decaymode K-->pi-,pi0; 0.209159 1 /Herwig/Decays/DecayME0
 decaymode K-->pi-,pi-,pi+; 0.0559 1 /Herwig/Decays/DecayME0
 decaymode K-->pi0,e-,nu_ebar; 0.0498 1 /Herwig/Decays/DecayME101
 decaymode K-->pi0,mu-,nu_mubar; 0.0332 1 /Herwig/Decays/DecayME101
 decaymode K-->pi-,pi0,pi0; 0.01757 1 /Herwig/Decays/DecayME0
 decaymode K-->pi-,pi+,e-,nu_ebar; 4.1E-5 1 /Herwig/Decays/Mambo
 decaymode K-->pi0,pi0,e-,nu_ebar; 2.2E-5 1 /Herwig/Decays/Mambo
 decaymode K-->e-,nu_ebar; 1.6E-5 1 /Herwig/Decays/PScalarlnu
 decaymode K-->pi-,pi+,mu-,nu_mubar; 1.4E-5 1 /Herwig/Decays/Mambo
 decaymode K-->pi-,gamma,gamma; 1.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode Kbar0->K_L0; 0.5 1 /Herwig/Decays/DecayME0
 decaymode Kbar0->K_S0; 0.5 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c+->B_s*0,rho+; 0.202 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s0,pi+; 0.164 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s0,rho+; 0.072 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s*0,pi+; 0.065 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s*0,mu+,nu_mu; 0.0506 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B_s*0,e+,nu_e; 0.0506 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->c,sbar; 0.049 1 /Herwig/Decays/QDecayME0
 decaymode B_c+->B_s0,mu+,nu_mu; 0.0403 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B_s0,e+,nu_e; 0.0403 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B*0,rho+; 0.0257 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B+,Kbar0; 0.0198 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,mu+,nu_mu; 0.019 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->Jpsi,e+,nu_e; 0.019 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B*+,K*bar0; 0.0167 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->tau+,nu_tau; 0.016 1 /Herwig/Decays/PScalarlnu
 decaymode B_c+->B*+,Kbar0; 0.016 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->dbar=u,cbar=c; 0.011134 1 /Herwig/Decays/WeakPartonic100
 decaymode B_c+->B0,pi+; 0.0106 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s0,K+; 0.0106 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B0,rho+; 0.0096 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B*0,pi+; 0.0095 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,mu+,nu_mu; 0.0075 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c,e+,nu_e; 0.0075 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->Jpsi,D_s*+; 0.0067 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B*0,mu+,nu_mu; 0.0058 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B*0,e+,nu_e; 0.0058 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->Jpsi,tau+,nu_tau; 0.0048 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B+,K*bar0; 0.0043 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,rho+; 0.0042 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,rho+; 0.004 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B_s*0,K+; 0.0037 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B0,mu+,nu_mu; 0.0034 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B0,e+,nu_e; 0.0034 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c,D_s+; 0.0028 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,D_s*+; 0.0027 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,tau+,nu_tau; 0.0023 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c,pi+; 0.002 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,D_s+; 0.0017 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,pi+; 0.0013 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->psi(2S),mu+,nu_mu; 0.00094 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->psi(2S),e+,nu_e; 0.00094 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->B*+,rho0; 0.0009 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B0,K+; 0.0007 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B*0,K*+; 0.00058 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B*0,K+; 0.00055 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B+,pi0; 0.00037 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B+,rho0; 0.00034 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D*+,D*bar0; 0.00033 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B*+,pi0; 0.00033 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,D*+; 0.00028 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,K*+; 0.00022 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,K*+; 0.0002 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c(2S),mu+,nu_mu; 0.0002 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c(2S),e+,nu_e; 0.0002 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D*0,mu+,nu_mu; 0.00018 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D*0,e+,nu_e; 0.00018 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c,D+; 0.00015 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->B0,K*+; 0.00015 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,K+; 0.00013 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,K+; 0.00011 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->eta_c,D*+; 0.0001 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->Jpsi,D+; 9.0E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D*0,tau+,nu_tau; 8.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->psi(2S),tau+,nu_tau; 8.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D+,D*bar0; 7.5E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D+,Dbar0; 5.3E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D*+,Dbar0; 4.9E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D0,mu+,nu_mu; 4.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D0,e+,nu_e; 4.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D_s*+,D*bar0; 2.6E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D0,tau+,nu_tau; 2.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->eta_c(2S),tau+,nu_tau; 1.6E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c+->D_s+,D*bar0; 7.0E-6 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D_s+,Dbar0; 5.0E-6 1 /Herwig/Decays/BcHadronic
 decaymode B_c+->D_s*+,Dbar0; 5.0E-6 1 /Herwig/Decays/BcHadronic
 #
 decaymode B_c-->B_s*bar0,rho-; 0.202 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B_sbar0,pi-; 0.164 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B_sbar0,rho-; 0.072 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B_s*bar0,pi-; 0.065 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B_s*bar0,e-,nu_ebar; 0.0506 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B_s*bar0,mu-,nu_mubar; 0.0506 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->cbar,s; 0.049 1 /Herwig/Decays/QDecayME0
 decaymode B_c-->B_sbar0,e-,nu_ebar; 0.0403 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B_sbar0,mu-,nu_mubar; 0.0403 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B*bar0,rho-; 0.0257 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B-,K0; 0.0198 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,e-,nu_ebar; 0.019 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Jpsi,mu-,nu_mubar; 0.019 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B*-,K*0; 0.0167 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*-,K0; 0.016 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->tau-,nu_taubar; 0.016 1 /Herwig/Decays/PScalarlnu
 decaymode B_c-->d=ubar,c=cbar; 0.011134 1 /Herwig/Decays/WeakPartonic100
 decaymode B_c-->B_sbar0,K-; 0.0106 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Bbar0,pi-; 0.0106 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Bbar0,rho-; 0.0096 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*bar0,pi-; 0.0095 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,e-,nu_ebar; 0.0075 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->eta_c,mu-,nu_mubar; 0.0075 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Jpsi,D_s*-; 0.0067 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*bar0,e-,nu_ebar; 0.0058 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B*bar0,mu-,nu_mubar; 0.0058 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Jpsi,tau-,nu_taubar; 0.0048 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B-,K*0; 0.0043 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,rho-; 0.0042 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,rho-; 0.004 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B_s*bar0,K-; 0.0037 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Bbar0,e-,nu_ebar; 0.0034 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Bbar0,mu-,nu_mubar; 0.0034 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->eta_c,D_s-; 0.0028 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,D_s*-; 0.0027 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,tau-,nu_taubar; 0.0023 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->eta_c,pi-; 0.002 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,D_s-; 0.0017 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,pi-; 0.0013 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->psi(2S),e-,nu_ebar; 0.00094 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->psi(2S),mu-,nu_mubar; 0.00094 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->B*-,rho0; 0.0009 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Bbar0,K-; 0.0007 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*bar0,K*-; 0.00058 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*bar0,K-; 0.00055 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B-,pi0; 0.00037 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B-,rho0; 0.00034 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->B*-,pi0; 0.00033 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D*-,D*0; 0.00033 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,D*-; 0.00028 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,K*-; 0.00022 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,K*-; 0.0002 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c(2S),e-,nu_ebar; 0.0002 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->eta_c(2S),mu-,nu_mubar; 0.0002 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->D*bar0,e-,nu_ebar; 0.00018 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->D*bar0,mu-,nu_mubar; 0.00018 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Bbar0,K*-; 0.00015 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,D-; 0.00015 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,K-; 0.00013 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,K-; 0.00011 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->eta_c,D*-; 0.0001 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Jpsi,D-; 9.0E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D*bar0,tau-,nu_taubar; 8.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->psi(2S),tau-,nu_taubar; 8.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->D-,D*0; 7.5E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D-,D0; 5.3E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D*-,D0; 4.9E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Dbar0,e-,nu_ebar; 4.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->Dbar0,mu-,nu_mubar; 4.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->D_s*-,D*0; 2.6E-5 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->Dbar0,tau-,nu_taubar; 2.0E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->eta_c(2S),tau-,nu_taubar; 1.6E-5 1 /Herwig/Decays/KiselevBc
 decaymode B_c-->D_s-,D*0; 7.0E-6 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D_s*-,D0; 5.0E-6 1 /Herwig/Decays/BcHadronic
 decaymode B_c-->D_s-,D0; 5.0E-6 1 /Herwig/Decays/BcHadronic
 #
 # the 1^3S_1 multiplet
 #
 #
 decaymode rho+->pi+,pi0; 0.99955 1 /Herwig/Decays/Vector2Meson
 decaymode rho+->pi+,gamma; 0.00045 1 /Herwig/Decays/VectorVP
 #
 decaymode rho0->pi+,pi-; 0.998956 1 /Herwig/Decays/Vector2Meson
 decaymode rho0->pi0,gamma; 0.00047 1 /Herwig/Decays/VectorVP
 decaymode rho0->eta,gamma; 0.0003 1 /Herwig/Decays/VectorVP
 decaymode rho0->pi+,pi-,pi0; 0.000101 1 /Herwig/Decays/DecayME0
 decaymode rho0->e-,e+; 4.7E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode rho0->mu-,mu+; 4.7E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode rho0->pi0,pi0,gamma; 4.5E-5 1 /Herwig/Decays/DecayME0
 decaymode rho0->pi+,pi-,pi+,pi-; 1.8E-5 1 /Herwig/Decays/Mambo
 decaymode rho0->pi+,pi-,pi0,pi0; 1.6E-5 1 /Herwig/Decays/Mambo
 #
 decaymode rho-->pi-,pi0; 0.99955 1 /Herwig/Decays/Vector2Meson
 decaymode rho-->pi-,gamma; 0.00045 1 /Herwig/Decays/VectorVP
 #
 decaymode omega->pi+,pi-,pi0; 0.897637 1 /Herwig/Decays/Vector3Pion
 decaymode omega->pi0,gamma; 0.085494 1 /Herwig/Decays/VectorVP
 decaymode omega->pi+,pi-; 0.0153 1 /Herwig/Decays/Vector2Meson
 decaymode omega->pi0,e-,e+; 0.00077 1 /Herwig/Decays/VectorVPff
 decaymode omega->eta,gamma; 0.00045 1 /Herwig/Decays/VectorVP
 decaymode omega->pi0,mu-,mu+; 0.000134 1 /Herwig/Decays/VectorVPff
 decaymode omega->e-,e+; 7.4E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode omega->mu-,mu+; 7.4E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode omega->pi0,pi0,gamma; 6.7E-5 1 /Herwig/Decays/DecayME0
 #
 decaymode phi->K+,K-; 0.492008 1 /Herwig/Decays/Vector2Meson
 decaymode phi->K_L0,K_S0; 0.340007 1 /Herwig/Decays/Vector2Meson
 decaymode phi->pi+,pi-,pi0; 0.1524 1 /Herwig/Decays/Vector3Pion
 decaymode phi->eta,gamma; 0.01303 1 /Herwig/Decays/VectorVP
 decaymode phi->pi0,gamma; 0.00132 1 /Herwig/Decays/VectorVP
 decaymode phi->f_0,gamma; 0.000322 1 /Herwig/Decays/VVSDecayer
 decaymode phi->e-,e+; 0.000297 1 /Herwig/Decays/Vector2Leptons
 decaymode phi->mu-,mu+; 0.000297 1 /Herwig/Decays/Vector2Leptons
 decaymode phi->eta,e-,e+; 0.000108 1 /Herwig/Decays/VectorVPff
 decaymode phi->a_00,gamma; 7.6E-5 1 /Herwig/Decays/VVSDecayer
 decaymode phi->eta',gamma; 6.2E-5 1 /Herwig/Decays/VectorVP
 decaymode phi->omega,pi0; 4.7E-5 1 /Herwig/Decays/VectorVP
 decaymode phi->pi0,e-,e+; 1.3E-5 1 /Herwig/Decays/VectorVPff
 decaymode phi->eta,mu-,mu+; 6.0E-6 1 /Herwig/Decays/VectorVPff
 decaymode phi->pi+,pi-,pi+,pi-; 4.0E-6 1 /Herwig/Decays/Mambo
 decaymode phi->pi0,mu-,mu+; 3.0E-6 1 /Herwig/Decays/VectorVPff
 #
 decaymode Jpsi->g,g,g; 0.486225 1 /Herwig/Decays/QDecayME130
 decaymode Jpsi->u,ubar; 0.0791 1 /Herwig/Decays/QDecayME0
 decaymode Jpsi->e-,e+; 0.05935 1 /Herwig/Decays/Vector2Leptons
 decaymode Jpsi->mu-,mu+; 0.05935 1 /Herwig/Decays/Vector2Leptons
 decaymode Jpsi->g,g,gamma; 0.05 1 /Herwig/Decays/QDecayME130
 decaymode Jpsi->d,dbar; 0.0198 1 /Herwig/Decays/QDecayME0
 decaymode Jpsi->s,sbar; 0.0198 1 /Herwig/Decays/QDecayME0
 decaymode Jpsi->gamma,eta_c; 0.013 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->omega,pi+,pi-,pi+,pi-; 0.0085 1 /Herwig/Decays/Mambo
 decaymode Jpsi->rho-,pi+; 0.00563 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->rho0,pi0; 0.00563 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->rho+,pi-; 0.00563 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->gamma,pi+,pi-,pi0,pi0; 0.005 1 /Herwig/Decays/Mambo
 decaymode Jpsi->omega,pi+,pi-; 0.00475 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,eta'; 0.00471 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->n0,nbar0,pi+,pi-; 0.0045 1 /Herwig/Decays/Mambo
 decaymode Jpsi->p+,pbar-,pi+,pi-; 0.0045 1 /Herwig/Decays/Mambo
 decaymode Jpsi->f_2,omega; 0.0043 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->a_20,rho0; 0.003634 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->a_2-,rho+; 0.003633 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->a_2+,rho-; 0.003633 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,pi+,pi-,pi0; 0.0036 1 /Herwig/Decays/Mambo
 decaymode Jpsi->K*-,K*_2+; 0.00335 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K*bar0,K*_20; 0.00335 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K*0,K*_2bar0; 0.00335 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K*+,K*_2-; 0.00335 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pi+,pi-,pi0; 0.0033 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,eta,pi+,pi-; 0.0031 1 /Herwig/Decays/Mambo
 decaymode Jpsi->gamma,rho+,rho-; 0.003 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,eta(1475); 0.0028 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K-,K*+; 0.0023 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->Kbar0,K*0; 0.0023 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->K0,K*bar0; 0.0023 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->K+,K*-; 0.0023 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->p+,pbar-,pi+,pi-,pi0; 0.0023 1 /Herwig/Decays/Mambo
 decaymode Jpsi->omega,pi0,pi0; 0.00217 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,nbar0; 0.00217 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->p+,pbar-; 0.00217 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->gamma,K+,K-,pi+,pi-; 0.0021 1 /Herwig/Decays/Mambo
 decaymode Jpsi->n0,nbar0,eta; 0.00209 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,pbar-,eta; 0.00209 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pbar-,n0,pi+; 0.00204 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,nbar0,pi-; 0.00204 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,K*0,K*bar0; 0.002 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,K*+,K*-; 0.002 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K'_1-,K+; 0.0019 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->K'_1bar0,K0; 0.0019 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->K'_10,Kbar0; 0.0019 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->K'_1+,K-; 0.0019 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->omega,eta; 0.00174 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->phi,pi+,pi-,pi+,pi-; 0.00166 1 /Herwig/Decays/Mambo
 decaymode Jpsi->b_1-,pi+; 0.00162 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->b_10,pi0; 0.00162 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->b_1+,pi-; 0.00162 1 /Herwig/Decays/VAPDecayer
 decaymode Jpsi->gamma,eta,pi0,pi0; 0.0016 1 /Herwig/Decays/Mambo
 decaymode Jpsi->gamma,omega,omega; 0.00159 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Lambda0,Lambdabar0; 0.00154 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->gamma,rho0,rho0; 0.0015 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pi+,pi-; 0.00147 1 /Herwig/Decays/Vector2Meson
 decaymode Jpsi->gamma,f_2; 0.00138 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,f_0(1710); 0.00134 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->omega,K*-,K+; 0.001325 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,K*bar0,K0; 0.001325 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,K*0,Kbar0; 0.001325 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,K*+,K-; 0.001325 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma-,Sigmabar+; 0.00131 1 /Herwig/Decays/Vector2Leptons
 decaymode Jpsi->Sigma0,Sigmabar0; 0.00131 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->Sigma+,Sigmabar-; 0.00131 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->n0,nbar0,omega; 0.0013 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,pbar-,omega; 0.0013 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Delta-,Deltabar+; 0.0011 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Delta0,Deltabar0; 0.0011 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Delta+,Deltabar-; 0.0011 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Delta++,Deltabar--; 0.0011 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pbar-,K0,Sigma*+; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pbar-,p+,pi0; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->nbar0,K+,Sigma*-; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,nbar0,pi0; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,K-,Sigma*bar+; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,Kbar0,Sigma*bar-; 0.00102 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,pi+,pi-,pi+,pi-; 0.001 1 /Herwig/Decays/Mambo
 decaymode Jpsi->gamma,eta; 0.000966 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->gamma,f_2,f_2; 0.00095 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->eta',n0,nbar0; 0.0009 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->eta',p+,pbar-; 0.0009 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Xi-,Xibar+; 0.0009 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->Xi0,Xibar0; 0.0009 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode Jpsi->pbar-,K+,Lambda0; 0.00089 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->nbar0,K0,Lambda0; 0.00089 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,Kbar0,Lambdabar0; 0.00089 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,K-,Lambdabar0; 0.00089 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,f'_2; 0.0008 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,f'_1; 0.00079 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,pi+,pi-; 0.00078 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->f_0(1710),omega; 0.00076 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->phi,eta; 0.00074 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->phi,K0,Kbar0; 0.00074 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,K+,K-; 0.00074 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,K0,Kbar0; 0.00071 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,K+,K-; 0.00071 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,f'_1; 0.00068 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,f_1; 0.00061 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->pbar-,K0,Sigma+; 0.00058 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->nbar0,K+,Sigma-; 0.00058 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,K-,Sigmabar+; 0.00058 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,Kbar0,Sigmabar-; 0.00058 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,f_0(1500); 0.00057 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->f_0(1710),phi; 0.00057 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->Sigmabar-,pi+,Lambda0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigmabar0,pi0,Lambda0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigmabar+,pi-,Lambda0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma-,pi+,Lambdabar0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma0,pi0,Lambdabar0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma+,pi-,Lambdabar0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*-,Sigma*bar+; 0.000515 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode Jpsi->Sigma*0,Sigma*bar0; 0.000515 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode Jpsi->Sigma*+,Sigma*bar-; 0.000515 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode Jpsi->pbar-,K+,Sigma*0; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->nbar0,K0,Sigma*0; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K-,K*+,phi; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Kbar0,K*0,phi; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K0,K*bar0,phi; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K+,K*-,phi; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,Kbar0,Sigma*bar0; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,K-,Sigma*bar0; 0.00051 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,f'_2; 0.00045 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,eta(1405); 0.00045 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->omega,pi0; 0.00045 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->Xi*bar0,Xi0; 0.000446 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Xi*bar+,Xi-; 0.000446 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Xi*-,Xibar+; 0.000446 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Xi*0,Xibar0; 0.000446 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,phi,phi; 0.0004 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,eta'; 0.0004 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->gamma,n0,nbar0; 0.00038 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,p+,pbar-; 0.00038 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,f_0; 0.00032 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->pbar-,K+,Sigma0; 0.00029 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->nbar0,K0,Sigma0; 0.00029 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->n0,Kbar0,Sigmabar0; 0.00029 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->p+,K-,Sigmabar0; 0.00029 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,f_1; 0.00026 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K-,K+; 0.000237 1 /Herwig/Decays/Vector2Meson
 decaymode Jpsi->Lambda0,Lambdabar0,pi0; 0.00022 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->rho0,eta; 0.000193 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->omega,eta'; 0.000182 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->Sigma*bar-,Sigma+; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*bar0,Sigma0; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*bar+,Sigma-; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*-,Sigmabar+; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*0,Sigmabar0; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->Sigma*+,Sigmabar-; 0.000155 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->K_L0,K_S0; 0.000146 1 /Herwig/Decays/Vector2Meson
 decaymode Jpsi->omega,f_0; 0.00014 1 /Herwig/Decays/VVSDecayer
 decaymode Jpsi->rho0,eta'; 0.000105 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->phi,n0,nbar0; 4.5E-5 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->phi,p+,pbar-; 4.5E-5 1 /Herwig/Decays/DecayME0
 decaymode Jpsi->gamma,pi0; 3.3E-5 1 /Herwig/Decays/VectorVP
 decaymode Jpsi->eta,e-,e+; 1.4E-5 1 /Herwig/Decays/VectorVPff
 #
 decaymode Upsilon->g,g,g; 0.820252 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon->u,ubar; 0.033195 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon->c,cbar; 0.033195 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon->e-,e+; 0.024896 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon->mu-,mu+; 0.024896 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon->tau-,tau+; 0.0247 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon->g,g,gamma; 0.022 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon->d,dbar; 0.008299 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon->s,sbar; 0.008299 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon->gamma,f_2; 0.000101 1 /Herwig/Decays/DecayME0
 decaymode Upsilon->gamma,pi+,pi-; 6.3E-5 1 /Herwig/Decays/DecayME0
 decaymode Upsilon->gamma,chi_c1; 4.7E-5 1 /Herwig/Decays/DecayME0
 decaymode Upsilon->gamma,f'_2; 2.9E-5 1 /Herwig/Decays/DecayME0
 decaymode Upsilon->gamma,pi0,pi0; 1.7E-5 1 /Herwig/Decays/DecayME0
 decaymode Upsilon->gamma,K+,K-; 1.1E-5 1 /Herwig/Decays/DecayME0
 #
 decaymode K*+->K0,pi+; 0.666013 1 /Herwig/Decays/Vector2Meson
 decaymode K*+->K+,pi0; 0.333007 1 /Herwig/Decays/Vector2Meson
 decaymode K*+->K+,gamma; 0.00098 1 /Herwig/Decays/VectorVP
 #
 decaymode K*0->K+,pi-; 0.665027 1 /Herwig/Decays/Vector2Meson
 decaymode K*0->K0,pi0; 0.332513 1 /Herwig/Decays/Vector2Meson
 decaymode K*0->K0,gamma; 0.00246 1 /Herwig/Decays/VectorVP
 #
 decaymode K*-->Kbar0,pi-; 0.666013 1 /Herwig/Decays/Vector2Meson
 decaymode K*-->K-,pi0; 0.333007 1 /Herwig/Decays/Vector2Meson
 decaymode K*-->K-,gamma; 0.00098 1 /Herwig/Decays/VectorVP
 #
 decaymode K*bar0->K-,pi+; 0.665027 1 /Herwig/Decays/Vector2Meson
 decaymode K*bar0->Kbar0,pi0; 0.332513 1 /Herwig/Decays/Vector2Meson
 decaymode K*bar0->Kbar0,gamma; 0.00246 1 /Herwig/Decays/VectorVP
 #
 decaymode D*0->D0,pi0; 0.647 1 /Herwig/Decays/HQETMeson
 decaymode D*0->D0,gamma; 0.353 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode D*+->D0,pi+; 0.677 1 /Herwig/Decays/HQETMeson
 decaymode D*+->D+,pi0; 0.307 1 /Herwig/Decays/HQETMeson
 decaymode D*+->D+,gamma; 0.016 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode D*bar0->Dbar0,pi0; 0.647 1 /Herwig/Decays/HQETMeson
 decaymode D*bar0->Dbar0,gamma; 0.353 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode D*-->Dbar0,pi-; 0.677 1 /Herwig/Decays/HQETMeson
 decaymode D*-->D-,pi0; 0.307 1 /Herwig/Decays/HQETMeson
 decaymode D*-->D-,gamma; 0.016 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode D_s*+->D_s+,pi0; 0.942 1 /Herwig/Decays/HQETMeson
 decaymode D_s*+->D_s+,gamma; 0.058 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode D_s*-->D_s-,gamma; 0.942 1 /Herwig/Decays/HQETMesonEM
 decaymode D_s*-->D_s-,pi0; 0.058 1 /Herwig/Decays/HQETMeson
 #
 decaymode B*0->B0,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B*+->B+,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B*bar0->Bbar0,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B*-->B-,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B_s*0->B_s0,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B_s*bar0->B_sbar0,gamma; 1 1 /Herwig/Decays/HQETMesonEM
 #
 decaymode B_c*+->B_c+,gamma; 1 1 /Herwig/Decays/VectorVP
 #
 decaymode B_c*-->B_c-,gamma; 1 1 /Herwig/Decays/VectorVP
 #
 # the 1^1P_1 multiplet
 #
 #
 decaymode b_1+->omega,pi+; 0.9984 1 /Herwig/Decays/PVectorVP
 decaymode b_1+->pi+,gamma; 0.0016 1 /Herwig/Decays/PVectorVP
 #
 decaymode b_10->omega,pi0; 1 1 /Herwig/Decays/PVectorVP
 #
 decaymode b_1-->omega,pi-; 0.9984 1 /Herwig/Decays/PVectorVP
 decaymode b_1-->pi-,gamma; 0.0016 1 /Herwig/Decays/PVectorVP
 #
 decaymode h_1->rho0,pi0; 0.333334 1 /Herwig/Decays/PVectorVP
 decaymode h_1->rho-,pi+; 0.333333 1 /Herwig/Decays/PVectorVP
 decaymode h_1->rho+,pi-; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode h'_1->K*-,K+; 0.25 1 /Herwig/Decays/PVectorVP
 decaymode h'_1->K*bar0,K0; 0.25 1 /Herwig/Decays/PVectorVP
 decaymode h'_1->K*0,Kbar0; 0.25 1 /Herwig/Decays/PVectorVP
 decaymode h'_1->K*+,K-; 0.25 1 /Herwig/Decays/PVectorVP
 #
 decaymode h_c->g,g,g; 0.6 1 /Herwig/Decays/QDecayME130
 decaymode h_c->eta_c,gamma; 0.4 1 /Herwig/Decays/PVectorVP
 #
 decaymode h_b->eta_b,gamma; 0.52 1 /Herwig/Decays/PVectorVP
 decaymode h_b->g,g,g; 0.462 1 /Herwig/Decays/QDecayME130
 decaymode h_b->g,g,gamma; 0.018 1 /Herwig/Decays/QDecayME130
 #
 decaymode K_1+->rho+,K0; 0.298667 1 /Herwig/Decays/PVectorVP
 decaymode K_1+->K*_00,pi+; 0.199111 1 /Herwig/Decays/Vector2Meson
 decaymode K_1+->rho0,K+; 0.149333 1 /Herwig/Decays/PVectorVP
 decaymode K_1+->K*0,pi+; 0.122222 1 /Herwig/Decays/PVectorVP
 decaymode K_1+->K*_0+,pi0; 0.099556 1 /Herwig/Decays/Vector2Meson
 decaymode K_1+->K+,omega; 0.07 1 /Herwig/Decays/PVectorVP
 decaymode K_1+->K*+,pi0; 0.061111 1 /Herwig/Decays/PVectorVP
 #
 decaymode K_10->rho-,K+; 0.298412 1 /Herwig/Decays/PVectorVP
 decaymode K_10->K*_0+,pi-; 0.198941 1 /Herwig/Decays/Vector2Meson
 decaymode K_10->rho0,K0; 0.149206 1 /Herwig/Decays/PVectorVP
 decaymode K_10->K*+,pi-; 0.122009 1 /Herwig/Decays/PVectorVP
 decaymode K_10->K*_00,pi0; 0.09947 1 /Herwig/Decays/Vector2Meson
 decaymode K_10->K0,omega; 0.07 1 /Herwig/Decays/PVectorVP
 decaymode K_10->K*0,pi0; 0.061005 1 /Herwig/Decays/PVectorVP
 decaymode K_10->K0,gamma; 0.000957 1 /Herwig/Decays/PVectorVP
 #
 decaymode K_1-->rho-,Kbar0; 0.298667 1 /Herwig/Decays/PVectorVP
 decaymode K_1-->K*_0bar0,pi-; 0.199111 1 /Herwig/Decays/Vector2Meson
 decaymode K_1-->rho0,K-; 0.149333 1 /Herwig/Decays/PVectorVP
 decaymode K_1-->K*bar0,pi-; 0.122222 1 /Herwig/Decays/PVectorVP
 decaymode K_1-->K*_0-,pi0; 0.099556 1 /Herwig/Decays/Vector2Meson
 decaymode K_1-->K-,omega; 0.07 1 /Herwig/Decays/PVectorVP
 decaymode K_1-->K*-,pi0; 0.061111 1 /Herwig/Decays/PVectorVP
 #
 decaymode K_1bar0->rho+,K-; 0.298412 1 /Herwig/Decays/PVectorVP
 decaymode K_1bar0->K*_0-,pi+; 0.198941 1 /Herwig/Decays/Vector2Meson
 decaymode K_1bar0->rho0,Kbar0; 0.149206 1 /Herwig/Decays/PVectorVP
 decaymode K_1bar0->K*-,pi+; 0.122009 1 /Herwig/Decays/PVectorVP
 decaymode K_1bar0->K*_0bar0,pi0; 0.09947 1 /Herwig/Decays/Vector2Meson
 decaymode K_1bar0->Kbar0,omega; 0.07 1 /Herwig/Decays/PVectorVP
 decaymode K_1bar0->K*bar0,pi0; 0.061005 1 /Herwig/Decays/PVectorVP
 decaymode K_1bar0->Kbar0,gamma; 0.000957 1 /Herwig/Decays/PVectorVP
 #
 decaymode D_10->D*+,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_10->D*0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_1+->D*0,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_1+->D*+,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_1bar0->D*-,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_1bar0->D*bar0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_1-->D*bar0,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_1-->D*-,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s1+->D*0,K+; 0.540541 1 /Herwig/Decays/HQETMeson
 decaymode D_s1+->D*+,K0; 0.459459 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s1-->D*bar0,K-; 0.540541 1 /Herwig/Decays/HQETMeson
 decaymode D_s1-->D*-,Kbar0; 0.459459 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_10->B*+,pi-; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B_10->B*0,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_1+->B*0,pi+; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B_1+->B*+,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_1bar0->B*-,pi+; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B_1bar0->B*bar0,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_1-->B*bar0,pi-; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B_1-->B*-,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_s10->B*0,Kbar0; 0.5 1 /Herwig/Decays/PVectorVP
 decaymode B_s10->B*+,K-; 0.5 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_s1bar0->B*-,K+; 0.5 1 /Herwig/Decays/PVectorVP
 decaymode B_s1bar0->B*bar0,K0; 0.5 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_c1+->B_c*+,gamma; 0.82 1 /Herwig/Decays/DecayME0
 decaymode B_c1+->B_c+,gamma; 0.18 1 /Herwig/Decays/PVectorVP
 #
 decaymode B_c1-->B_c*-,gamma; 0.82 1 /Herwig/Decays/DecayME0
 decaymode B_c1-->B_c-,gamma; 0.18 1 /Herwig/Decays/PVectorVP
 #
 # the 1^3P_0 multiplet
 #
 #
 decaymode a'_0+->omega,rho+; 0.827532 1 /Herwig/Decays/SVV
 decaymode a'_0+->pi+,eta; 0.07734 1 /Herwig/Decays/ScalarSS
 decaymode a'_0+->K+,Kbar0; 0.068059 1 /Herwig/Decays/ScalarSS
 decaymode a'_0+->pi+,eta'; 0.027069 1 /Herwig/Decays/ScalarSS
 #
 decaymode a'_00->omega,rho0; 0.827533 1 /Herwig/Decays/SVV
 decaymode a'_00->pi0,eta; 0.07734 1 /Herwig/Decays/ScalarSS
 decaymode a'_00->K-,K+; 0.034029 1 /Herwig/Decays/ScalarSS
 decaymode a'_00->Kbar0,K0; 0.034029 1 /Herwig/Decays/ScalarSS
 decaymode a'_00->pi0,eta'; 0.027069 1 /Herwig/Decays/ScalarSS
 #
 decaymode a'_0-->omega,rho-; 0.827532 1 /Herwig/Decays/SVV
 decaymode a'_0-->pi-,eta; 0.07734 1 /Herwig/Decays/ScalarSS
 decaymode a'_0-->K-,K0; 0.068059 1 /Herwig/Decays/ScalarSS
 decaymode a'_0-->pi-,eta'; 0.027069 1 /Herwig/Decays/ScalarSS
 #
 decaymode f'_0->sigma,sigma; 0.438181 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->rho+,rho-; 0.150788 1 /Herwig/Decays/SVV
 decaymode f'_0->rho0,rho0; 0.075394 1 /Herwig/Decays/SVV
 decaymode f'_0->pi+,pi-; 0.052606 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->pi'-,pi+; 0.050424 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->pi'0,pi0; 0.050424 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->pi'+,pi-; 0.050424 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->K0,Kbar0; 0.026364 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->K+,K-; 0.026364 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->pi0,pi0; 0.026303 1 /Herwig/Decays/ScalarSS
 decaymode f'_0->a_1-,pi+; 0.017091 1 /Herwig/Decays/PPVDecayer
 decaymode f'_0->a_10,pi0; 0.017091 1 /Herwig/Decays/PPVDecayer
 decaymode f'_0->a_1+,pi-; 0.017091 1 /Herwig/Decays/PPVDecayer
 decaymode f'_0->eta,eta; 0.001455 1 /Herwig/Decays/ScalarSS
 #
 decaymode f_0(1710)->K0,Kbar0; 0.316456 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1710)->K+,K-; 0.316456 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1710)->eta,eta; 0.303797 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1710)->pi+,pi-; 0.042194 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1710)->pi0,pi0; 0.021097 1 /Herwig/Decays/ScalarSS
 #
 decaymode chi_c0->g,g; 0.788568 1 /Herwig/Decays/QDecayME0
 decaymode chi_c0->f'_0,f_0(1710); 0.026 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->rho-,pi+,pi0; 0.016 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->rho0,pi+,pi-; 0.016 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->rho+,pi-,pi0; 0.016 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->Jpsi,gamma; 0.013 1 /Herwig/Decays/SVV
 decaymode chi_c0->K_1-,K+; 0.01 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K_1bar0,K0; 0.01 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K_10,Kbar0; 0.01 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K_1+,K-; 0.01 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->pi-,pi+,pi-,pi+; 0.00739 1 /Herwig/Decays/Mambo
 decaymode chi_c0->K0,Kbar0; 0.0054 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K+,K-; 0.0054 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->pi+,pi-; 0.0048 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K-,K*0,pi+; 0.0044 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->Kbar0,K*+,pi-; 0.0044 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K0,K*-,pi+; 0.0044 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K+,K*bar0,pi-; 0.0044 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->pi+,pi-,K+,K-; 0.00277 1 /Herwig/Decays/Mambo
 decaymode chi_c0->pi0,pi0; 0.0024 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K*_00,K*_0bar0; 0.002363 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K*_0+,K*_0-; 0.002363 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->omega,omega; 0.0023 1 /Herwig/Decays/SVV
 decaymode chi_c0->K*-,K+,pi0; 0.0022 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K*bar0,K0,pi0; 0.0022 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K*0,Kbar0,pi0; 0.0022 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->K*+,K-,pi0; 0.0022 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->f_0,f_0; 0.00215 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K+,K-,K+,K-; 0.0021 1 /Herwig/Decays/Mambo
 decaymode chi_c0->K*_0-,K*_2+; 0.001912 1 /Herwig/Decays/STSDecayer
 decaymode chi_c0->K*_0bar0,K*_20; 0.001912 1 /Herwig/Decays/STSDecayer
 decaymode chi_c0->K*_00,K*_2bar0; 0.001912 1 /Herwig/Decays/STSDecayer
 decaymode chi_c0->K*_0+,K*_2-; 0.001912 1 /Herwig/Decays/STSDecayer
 decaymode chi_c0->pi+,pi-,p+,pbar-; 0.0019 1 /Herwig/Decays/Mambo
 decaymode chi_c0->eta,eta; 0.0019 1 /Herwig/Decays/ScalarSS
 decaymode chi_c0->K*0,K*bar0; 0.0018 1 /Herwig/Decays/SVV
 decaymode chi_c0->K*+,K*-; 0.0018 1 /Herwig/Decays/SVV
 decaymode chi_c0->K+,K-,K_S0,K_S0; 0.0015 1 /Herwig/Decays/Mambo
 decaymode chi_c0->phi,phi; 0.0009 1 /Herwig/Decays/SVV
 decaymode chi_c0->Lambda0,Lambdabar0; 0.00044 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->gamma,gamma; 0.000276 1 /Herwig/Decays/SVV
 decaymode chi_c0->n0,nbar0; 0.000216 1 /Herwig/Decays/DecayME0
 decaymode chi_c0->p+,pbar-; 0.000216 1 /Herwig/Decays/DecayME0
 #
 decaymode chi_b0->g,g; 0.9806 1 /Herwig/Decays/QDecayME0
 decaymode chi_b0->Upsilon,gamma; 0.0194 1 /Herwig/Decays/DecayME0
 #
 decaymode K*_0+->K0,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode K*_0+->K+,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode K*_00->K+,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode K*_00->K0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode K*_0-->Kbar0,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode K*_0-->K-,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode K*_0bar0->K-,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode K*_0bar0->Kbar0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode D_0*+->D0,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_0*+->D+,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_0*0->D+,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_0*0->D0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_0*-->Dbar0,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_0*-->D-,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_0*bar0->D-,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D_0*bar0->Dbar0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s0+->D_s+,pi0; 1 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s0-->D_s-,pi0; 1 1 /Herwig/Decays/HQETMeson
 #
 decaymode B*_00->B+,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode B*_00->B0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_0+->B0,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode B*_0+->B+,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_0bar0->B-,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode B*_0bar0->Bbar0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_0-->Bbar0,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode B*_0-->B-,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_s00->B0,Kbar0; 0.5 1 /Herwig/Decays/ScalarSS
 decaymode B*_s00->B+,K-; 0.5 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_s0bar0->B-,K+; 0.5 1 /Herwig/Decays/ScalarSS
 decaymode B*_s0bar0->Bbar0,K0; 0.5 1 /Herwig/Decays/ScalarSS
 #
 decaymode B*_c0+->B_c+,gamma; 1 1 /Herwig/Decays/DecayME0
 #
 decaymode B*_c0-->B_c-,gamma; 1 1 /Herwig/Decays/DecayME0
 #
 # the 1^3P_1 multiplet
 #
 #
 decaymode a_1+->pi+,pi0,pi0; 0.499099 1 /Herwig/Decays/a1Simple
 decaymode a_1+->pi+,pi+,pi-; 0.4881 1 /Herwig/Decays/a1Simple
 decaymode a_1+->K+,K*bar0; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_1+->K*+,Kbar0; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_1+->pi+,gamma; 1.0E-6 1 /Herwig/Decays/PVectorVP
 #
 decaymode a_10->pi+,pi-,pi0; 0.987199 1 /Herwig/Decays/a1Simple
 decaymode a_10->K*0,Kbar0; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_10->K*+,K-; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_10->pi0,gamma; 1.0E-6 1 /Herwig/Decays/PVectorVP
 #
 decaymode a_1-->pi-,pi0,pi0; 0.499099 1 /Herwig/Decays/a1Simple
 decaymode a_1-->pi-,pi-,pi+; 0.4881 1 /Herwig/Decays/a1Simple
 decaymode a_1-->K*-,K0; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_1-->K-,K*0; 0.0064 1 /Herwig/Decays/PVectorVP
 decaymode a_1-->pi-,gamma; 1.0E-6 1 /Herwig/Decays/PVectorVP
 #
 decaymode f_1->a_0-,pi+; 0.14257 1 /Herwig/Decays/Vector2Meson
 decaymode f_1->a_00,pi0; 0.14257 1 /Herwig/Decays/Vector2Meson
 decaymode f_1->a_0+,pi-; 0.14257 1 /Herwig/Decays/Vector2Meson
 decaymode f_1->rho-,pi+,pi0; 0.110471 1 /Herwig/Decays/DecayME0
 decaymode f_1->rho0,pi+,pi-; 0.110471 1 /Herwig/Decays/DecayME0
 decaymode f_1->rho+,pi-,pi0; 0.110471 1 /Herwig/Decays/DecayME0
 decaymode f_1->eta,pi+,pi-; 0.107123 1 /Herwig/Decays/DecayME0
 decaymode f_1->rho0,gamma; 0.055235 1 /Herwig/Decays/DecayME0
 decaymode f_1->eta,pi0,pi0; 0.053562 1 /Herwig/Decays/DecayME0
 decaymode f_1->K-,K0,pi+; 0.008071 1 /Herwig/Decays/DecayME0
 decaymode f_1->K+,Kbar0,pi-; 0.008071 1 /Herwig/Decays/DecayME0
 decaymode f_1->K0,Kbar0,pi0; 0.004036 1 /Herwig/Decays/DecayME0
 decaymode f_1->K+,K-,pi0; 0.004036 1 /Herwig/Decays/DecayME0
 decaymode f_1->phi,gamma; 0.000743 1 /Herwig/Decays/DecayME0
 #
 decaymode f'_1->K*-,K+; 0.1886 1 /Herwig/Decays/PVectorVP
 decaymode f'_1->K*bar0,K0; 0.1886 1 /Herwig/Decays/PVectorVP
 decaymode f'_1->K*0,Kbar0; 0.1886 1 /Herwig/Decays/PVectorVP
 decaymode f'_1->K*+,K-; 0.1886 1 /Herwig/Decays/PVectorVP
 decaymode f'_1->K-,K0,pi+; 0.0709 1 /Herwig/Decays/DecayME0
 decaymode f'_1->K+,Kbar0,pi-; 0.0709 1 /Herwig/Decays/DecayME0
 decaymode f'_1->K0,Kbar0,pi0; 0.0355 1 /Herwig/Decays/DecayME0
 decaymode f'_1->K+,K-,pi0; 0.0355 1 /Herwig/Decays/DecayME0
 decaymode f'_1->a_0-,pi+; 0.01 1 /Herwig/Decays/Vector2Meson
 decaymode f'_1->a_00,pi0; 0.01 1 /Herwig/Decays/Vector2Meson
 decaymode f'_1->a_0+,pi-; 0.01 1 /Herwig/Decays/Vector2Meson
 decaymode f'_1->phi,gamma; 0.0028 1 /Herwig/Decays/DecayME0
 #
 decaymode chi_c1->g,g; 0.608569 1 /Herwig/Decays/QDecayME0
 decaymode chi_c1->Jpsi,gamma; 0.356 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->rho-,pi+,pi0; 0.0039 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->rho0,pi+,pi-; 0.0039 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->rho+,pi-,pi0; 0.0039 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->pi+,pi-,pi+,pi-; 0.0037 1 /Herwig/Decays/Mambo
 decaymode chi_c1->pi+,pi-,K+,K-; 0.00237 1 /Herwig/Decays/Mambo
 decaymode chi_c1->K-,K0,pi+; 0.0023 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K+,Kbar0,pi-; 0.0023 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*0,K*bar0; 0.0016 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*+,K*-; 0.0016 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K0,Kbar0,pi0; 0.00115 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K+,K-,pi0; 0.00115 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*-,K0,pi+; 0.00107 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*bar0,K+,pi-; 0.00107 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*0,K-,pi+; 0.00107 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*+,Kbar0,pi-; 0.00107 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*0,Kbar0,pi0; 0.000537 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*-,K+,pi0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*bar0,K0,pi0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->K*+,K-,pi0; 0.00053 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->pi+,pi-,p+,pbar-; 0.00039 1 /Herwig/Decays/Mambo
 decaymode chi_c1->K+,K-,K+,K-; 0.00039 1 /Herwig/Decays/Mambo
 decaymode chi_c1->Lambda0,Lambdabar0; 0.00024 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->n0,nbar0; 6.7E-5 1 /Herwig/Decays/DecayME0
 decaymode chi_c1->p+,pbar-; 6.7E-5 1 /Herwig/Decays/DecayME0
 #
 decaymode chi_b1->g,g; 0.648 1 /Herwig/Decays/QDecayME0
 decaymode chi_b1->Upsilon,gamma; 0.352 1 /Herwig/Decays/DecayME0
 #
 decaymode K'_1+->K*0,pi+; 0.634667 1 /Herwig/Decays/PVectorVP
 decaymode K'_1+->K*+,pi0; 0.317333 1 /Herwig/Decays/PVectorVP
 decaymode K'_1+->K0,rho+; 0.024 1 /Herwig/Decays/PVectorVP
 decaymode K'_1+->K+,rho0; 0.012 1 /Herwig/Decays/PVectorVP
 decaymode K'_1+->K+,omega; 0.012 1 /Herwig/Decays/PVectorVP
 #
 decaymode K'_10->K*+,pi-; 0.634005 1 /Herwig/Decays/PVectorVP
 decaymode K'_10->K*0,pi0; 0.317002 1 /Herwig/Decays/PVectorVP
 decaymode K'_10->K+,rho-; 0.023669 1 /Herwig/Decays/PVectorVP
 decaymode K'_10->K0,rho0; 0.011834 1 /Herwig/Decays/PVectorVP
 decaymode K'_10->K0,omega; 0.011834 1 /Herwig/Decays/PVectorVP
 decaymode K'_10->K0,gamma; 0.001656 1 /Herwig/Decays/PVectorVP
 #
 decaymode K'_1-->K*bar0,pi-; 0.634667 1 /Herwig/Decays/PVectorVP
 decaymode K'_1-->K*-,pi0; 0.317333 1 /Herwig/Decays/PVectorVP
 decaymode K'_1-->Kbar0,rho-; 0.024 1 /Herwig/Decays/PVectorVP
 decaymode K'_1-->K-,rho0; 0.012 1 /Herwig/Decays/PVectorVP
 decaymode K'_1-->K-,omega; 0.012 1 /Herwig/Decays/PVectorVP
 #
 decaymode K'_1bar0->K*-,pi+; 0.634005 1 /Herwig/Decays/PVectorVP
 decaymode K'_1bar0->K*bar0,pi0; 0.317002 1 /Herwig/Decays/PVectorVP
 decaymode K'_1bar0->K-,rho+; 0.023669 1 /Herwig/Decays/PVectorVP
 decaymode K'_1bar0->Kbar0,rho0; 0.011834 1 /Herwig/Decays/PVectorVP
 decaymode K'_1bar0->Kbar0,omega; 0.011834 1 /Herwig/Decays/PVectorVP
 decaymode K'_1bar0->Kbar0,gamma; 0.001656 1 /Herwig/Decays/PVectorVP
 #
 decaymode D'_10->D*+,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D'_10->D*0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D'_1+->D*0,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D'_1+->D*+,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D'_1bar0->D*-,pi+; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D'_1bar0->D*bar0,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D'_1-->D*bar0,pi-; 0.666667 1 /Herwig/Decays/HQETMeson
 decaymode D'_1-->D*-,pi0; 0.333333 1 /Herwig/Decays/HQETMeson
 #
 decaymode D'_s1+->D_s*+,pi0; 0.656068 1 /Herwig/Decays/HQETMeson
 decaymode D'_s1+->D_s+,gamma; 0.206139 1 /Herwig/Decays/PVectorVP
 decaymode D'_s1+->D_s+,pi+,pi-; 0.091862 1 /Herwig/Decays/DecayME0
 decaymode D'_s1+->D_s+,pi0,pi0; 0.045931 1 /Herwig/Decays/DecayME0
 #
 decaymode D'_s1-->D_s*-,pi0; 0.656068 1 /Herwig/Decays/HQETMeson
 decaymode D'_s1-->D_s-,gamma; 0.206139 1 /Herwig/Decays/PVectorVP
 decaymode D'_s1-->D_s-,pi-,pi+; 0.091862 1 /Herwig/Decays/DecayME0
 decaymode D'_s1-->D_s-,pi0,pi0; 0.045931 1 /Herwig/Decays/DecayME0
 #
 decaymode B'_10->B*+,pi-; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B'_10->B*0,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_1+->B*0,pi+; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B'_1+->B*+,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_1bar0->B*-,pi+; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B'_1bar0->B*bar0,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_1-->B*bar0,pi-; 0.666667 1 /Herwig/Decays/PVectorVP
 decaymode B'_1-->B*-,pi0; 0.333333 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_s10->B*0,Kbar0; 0.5 1 /Herwig/Decays/PVectorVP
 decaymode B'_s10->B*+,K-; 0.5 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_s1bar0->B*-,K+; 0.5 1 /Herwig/Decays/PVectorVP
 decaymode B'_s1bar0->B*bar0,K0; 0.5 1 /Herwig/Decays/PVectorVP
 #
 decaymode B'_c1+->B_c+,gamma; 0.88 1 /Herwig/Decays/PVectorVP
 decaymode B'_c1+->B_c*+,gamma; 0.12 1 /Herwig/Decays/DecayME0
 #
 decaymode B'_c1-->B_c-,gamma; 0.88 1 /Herwig/Decays/PVectorVP
 decaymode B'_c1-->B_c*-,gamma; 0.12 1 /Herwig/Decays/DecayME0
 #
 # the 1^3P_2 multiplet
 #
 #
 decaymode a_2+->pi+,rho0; 0.348989 1 /Herwig/Decays/TensorVP
 decaymode a_2+->rho+,pi0; 0.348989 1 /Herwig/Decays/TensorVP
 decaymode a_2+->pi+,eta; 0.143657 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2+->omega,rho+; 0.102417 1 /Herwig/Decays/TVV
 decaymode a_2+->K+,Kbar0; 0.048104 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2+->eta',pi+; 0.005199 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2+->pi+,gamma; 0.002645 1 /Herwig/Decays/TensorVP
 #
 decaymode a_20->rho-,pi+; 0.349434 1 /Herwig/Decays/TensorVP
 decaymode a_20->rho+,pi-; 0.349434 1 /Herwig/Decays/TensorVP
 decaymode a_20->pi0,eta; 0.144053 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_20->omega,rho0; 0.103473 1 /Herwig/Decays/TVV
 decaymode a_20->K0,Kbar0; 0.024184 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_20->K+,K-; 0.024184 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_20->eta',pi0; 0.005229 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_20->gamma,gamma; 9.0E-6 1 /Herwig/Decays/TVV
 #
 decaymode a_2-->rho-,pi0; 0.348989 1 /Herwig/Decays/TensorVP
 decaymode a_2-->pi-,rho0; 0.348989 1 /Herwig/Decays/TensorVP
 decaymode a_2-->pi-,eta; 0.143657 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2-->omega,rho-; 0.102417 1 /Herwig/Decays/TVV
 decaymode a_2-->K-,K0; 0.048104 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2-->eta',pi-; 0.005199 1 /Herwig/Decays/Tensor2PScalar
 decaymode a_2-->pi-,gamma; 0.002645 1 /Herwig/Decays/TensorVP
 #
 decaymode f_2->pi+,pi-; 0.570829 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->pi0,pi0; 0.285414 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->rho+,rho-; 0.046681 1 /Herwig/Decays/TVV
 decaymode f_2->K0,Kbar0; 0.023516 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->K+,K-; 0.023516 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->rho0,rho0; 0.02334 1 /Herwig/Decays/TVV
 decaymode f_2->sigma,sigma; 0.022649 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->eta,eta; 0.004041 1 /Herwig/Decays/Tensor2PScalar
 decaymode f_2->gamma,gamma; 1.4E-5 1 /Herwig/Decays/TVV
 #
 decaymode f'_2->K0,Kbar0; 0.444355 1 /Herwig/Decays/Tensor2PScalar
 decaymode f'_2->K+,K-; 0.444355 1 /Herwig/Decays/Tensor2PScalar
 decaymode f'_2->eta,eta; 0.103083 1 /Herwig/Decays/Tensor2PScalar
 decaymode f'_2->pi+,pi-; 0.00547 1 /Herwig/Decays/Tensor2PScalar
 decaymode f'_2->pi0,pi0; 0.002736 1 /Herwig/Decays/Tensor2PScalar
 decaymode f'_2->gamma,gamma; 1.0E-6 1 /Herwig/Decays/TVV
 #
 decaymode chi_c2->g,g; 0.700639 1 /Herwig/Decays/QDecayME0
 decaymode chi_c2->Jpsi,gamma; 0.202 1 /Herwig/Decays/TVV
 decaymode chi_c2->K0,Kbar0; 0.0093 1 /Herwig/Decays/Tensor2PScalar
 decaymode chi_c2->K+,K-; 0.0093 1 /Herwig/Decays/Tensor2PScalar
 decaymode chi_c2->K0,K-,pi0,pi+; 0.008 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K0,Kbar0,pi+,pi-; 0.008 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K+,K-,pi+,pi-; 0.008 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K+,Kbar0,pi0,pi-; 0.008 1 /Herwig/Decays/Mambo
 decaymode chi_c2->rho-,pi+,pi0; 0.007 1 /Herwig/Decays/DecayME0
 decaymode chi_c2->rho0,pi+,pi-; 0.007 1 /Herwig/Decays/DecayME0
 decaymode chi_c2->rho+,pi-,pi0; 0.007 1 /Herwig/Decays/DecayME0
 decaymode chi_c2->pi+,pi-,pi+,pi-; 0.0053 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K*0,K*bar0; 0.0038 1 /Herwig/Decays/TVV
 decaymode chi_c2->K*+,K*-; 0.0038 1 /Herwig/Decays/TVV
 decaymode chi_c2->omega,omega; 0.002 1 /Herwig/Decays/TVV
 decaymode chi_c2->K0,Kbar0,pi0,pi0; 0.002 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K+,K-,pi0,pi0; 0.002 1 /Herwig/Decays/Mambo
 decaymode chi_c2->phi,phi; 0.0019 1 /Herwig/Decays/TVV
 decaymode chi_c2->pi+,pi-; 0.001427 1 /Herwig/Decays/Tensor2PScalar
 decaymode chi_c2->pi+,pi-,p+,pbar-; 0.00121 1 /Herwig/Decays/Mambo
 decaymode chi_c2->K+,K-,K+,K-; 0.00095 1 /Herwig/Decays/Mambo
 decaymode chi_c2->pi0,pi0; 0.000713 1 /Herwig/Decays/Tensor2PScalar
 decaymode chi_c2->Lambda0,Lambdabar0; 0.00027 1 /Herwig/Decays/DecayME0
 decaymode chi_c2->gamma,gamma; 0.000259 1 /Herwig/Decays/TVV
 decaymode chi_c2->n0,nbar0; 6.6E-5 1 /Herwig/Decays/DecayME0
 decaymode chi_c2->p+,pbar-; 6.6E-5 1 /Herwig/Decays/DecayME0
 #
 decaymode chi_b2->g,g; 0.82 1 /Herwig/Decays/QDecayME0
 decaymode chi_b2->Upsilon,gamma; 0.18 1 /Herwig/Decays/TVV
 #
 decaymode K*_2+->K0,pi+; 0.3327 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2+->K+,pi0; 0.16635 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2+->K*0,pi+; 0.164683 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K*0,rho+; 0.089342 1 /Herwig/Decays/TVV
 decaymode K*_2+->K*+,pi0; 0.082342 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K0,rho+; 0.058006 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K*+,rho0; 0.044671 1 /Herwig/Decays/TVV
 decaymode K*_2+->K+,rho0; 0.029003 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K+,omega; 0.029003 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K+,gamma; 0.0024 1 /Herwig/Decays/TensorVP
 decaymode K*_2+->K+,eta; 0.0015 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode K*_20->K+,pi-; 0.3335 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_20->K0,pi0; 0.16675 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_20->K*+,pi-; 0.165079 1 /Herwig/Decays/TensorVP
 decaymode K*_20->K*+,rho-; 0.089557 1 /Herwig/Decays/TVV
 decaymode K*_20->K*0,pi0; 0.08254 1 /Herwig/Decays/TensorVP
 decaymode K*_20->K+,rho-; 0.058145 1 /Herwig/Decays/TensorVP
 decaymode K*_20->K*0,rho0; 0.044779 1 /Herwig/Decays/TVV
 decaymode K*_20->K0,rho0; 0.029073 1 /Herwig/Decays/TensorVP
 decaymode K*_20->K0,omega; 0.029073 1 /Herwig/Decays/TensorVP
 decaymode K*_20->K0,eta; 0.001504 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode K*_2-->Kbar0,pi-; 0.3327 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2-->K-,pi0; 0.16635 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2-->K*bar0,pi-; 0.164683 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->K*bar0,rho-; 0.089342 1 /Herwig/Decays/TVV
 decaymode K*_2-->K*-,pi0; 0.082342 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->Kbar0,rho-; 0.058006 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->K*-,rho0; 0.044671 1 /Herwig/Decays/TVV
 decaymode K*_2-->K-,rho0; 0.029003 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->K-,omega; 0.029003 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->K-,gamma; 0.0024 1 /Herwig/Decays/TensorVP
 decaymode K*_2-->K-,eta; 0.0015 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode K*_2bar0->K-,pi+; 0.3335 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2bar0->Kbar0,pi0; 0.16675 1 /Herwig/Decays/Tensor2PScalar
 decaymode K*_2bar0->K*-,pi+; 0.165079 1 /Herwig/Decays/TensorVP
 decaymode K*_2bar0->K*-,rho+; 0.089557 1 /Herwig/Decays/TVV
 decaymode K*_2bar0->K*bar0,pi0; 0.08254 1 /Herwig/Decays/TensorVP
 decaymode K*_2bar0->K-,rho+; 0.058145 1 /Herwig/Decays/TensorVP
 decaymode K*_2bar0->K*bar0,rho0; 0.044779 1 /Herwig/Decays/TVV
 decaymode K*_2bar0->Kbar0,rho0; 0.029073 1 /Herwig/Decays/TensorVP
 decaymode K*_2bar0->Kbar0,omega; 0.029073 1 /Herwig/Decays/TensorVP
 decaymode K*_2bar0->Kbar0,eta; 0.001504 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode D*_20->D+,pi-; 0.448087 1 /Herwig/Decays/HQETMeson
 decaymode D*_20->D0,pi0; 0.224044 1 /Herwig/Decays/HQETMeson
 decaymode D*_20->D*+,pi-; 0.218579 1 /Herwig/Decays/HQETMeson
 decaymode D*_20->D*0,pi0; 0.10929 1 /Herwig/Decays/HQETMeson
 #
 decaymode D*_2+->D0,pi+; 0.448087 1 /Herwig/Decays/HQETMeson
 decaymode D*_2+->D+,pi0; 0.224044 1 /Herwig/Decays/HQETMeson
 decaymode D*_2+->D*0,pi+; 0.218579 1 /Herwig/Decays/HQETMeson
 decaymode D*_2+->D*+,pi0; 0.10929 1 /Herwig/Decays/HQETMeson
 #
 decaymode D*_2bar0->D-,pi+; 0.448087 1 /Herwig/Decays/HQETMeson
 decaymode D*_2bar0->Dbar0,pi0; 0.224044 1 /Herwig/Decays/HQETMeson
 decaymode D*_2bar0->D*-,pi+; 0.218579 1 /Herwig/Decays/HQETMeson
 decaymode D*_2bar0->D*bar0,pi0; 0.10929 1 /Herwig/Decays/HQETMeson
 #
 decaymode D*_2-->Dbar0,pi-; 0.448087 1 /Herwig/Decays/HQETMeson
 decaymode D*_2-->D-,pi0; 0.224044 1 /Herwig/Decays/HQETMeson
 decaymode D*_2-->D*bar0,pi-; 0.218579 1 /Herwig/Decays/HQETMeson
 decaymode D*_2-->D*-,pi0; 0.10929 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s2+->D0,K+; 0.453903 1 /Herwig/Decays/HQETMeson
 decaymode D_s2+->D+,K0; 0.410175 1 /Herwig/Decays/HQETMeson
 decaymode D_s2+->D*0,K+; 0.077088 1 /Herwig/Decays/HQETMeson
 decaymode D_s2+->D*+,K0; 0.058834 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s2-->Dbar0,K-; 0.453903 1 /Herwig/Decays/HQETMeson
 decaymode D_s2-->D-,Kbar0; 0.410175 1 /Herwig/Decays/HQETMeson
 decaymode D_s2-->D*bar0,K-; 0.077088 1 /Herwig/Decays/HQETMeson
 decaymode D_s2-->D*-,Kbar0; 0.058834 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_20->B+,pi-; 0.345404 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_20->B*+,pi-; 0.321262 1 /Herwig/Decays/TensorVP
 decaymode B_20->B0,pi0; 0.172703 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_20->B*0,pi0; 0.160631 1 /Herwig/Decays/TensorVP
 #
 decaymode B_2+->B0,pi+; 0.345404 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2+->B*0,pi+; 0.321262 1 /Herwig/Decays/TensorVP
 decaymode B_2+->B+,pi0; 0.172703 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2+->B*+,pi0; 0.160631 1 /Herwig/Decays/TensorVP
 #
 decaymode B_2bar0->B-,pi+; 0.345404 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2bar0->B*-,pi+; 0.321262 1 /Herwig/Decays/TensorVP
 decaymode B_2bar0->Bbar0,pi0; 0.172703 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2bar0->B*bar0,pi0; 0.160631 1 /Herwig/Decays/TensorVP
 #
 decaymode B_2-->Bbar0,pi-; 0.345404 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2-->B*bar0,pi-; 0.321262 1 /Herwig/Decays/TensorVP
 decaymode B_2-->B-,pi0; 0.172703 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_2-->B*-,pi0; 0.160631 1 /Herwig/Decays/TensorVP
 #
 decaymode B_s20->B0,Kbar0; 0.47 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_s20->B+,K-; 0.47 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_s20->B*0,Kbar0; 0.03 1 /Herwig/Decays/TensorVP
 decaymode B_s20->B*+,K-; 0.03 1 /Herwig/Decays/TensorVP
 #
 decaymode B_s2bar0->B-,K+; 0.47 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_s2bar0->Bbar0,K0; 0.47 1 /Herwig/Decays/Tensor2PScalar
 decaymode B_s2bar0->B*-,K+; 0.03 1 /Herwig/Decays/TensorVP
 decaymode B_s2bar0->B*bar0,K0; 0.03 1 /Herwig/Decays/TensorVP
 #
 decaymode B_c2+->B_c+,gamma; 1 1 /Herwig/Decays/TensorVP
 #
 decaymode B_c2-->B_c-,gamma; 1 1 /Herwig/Decays/TensorVP
 #
 # the 1^1D_2 multiplet
 #
 #
 decaymode pi_2+->pi+,f_2; 0.546654 1 /Herwig/Decays/DecayME0
 decaymode pi_2+->rho0,pi+; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_2+->rho+,pi0; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_2+->pi+,sigma; 0.084624 1 /Herwig/Decays/Tensor2PScalar
 decaymode pi_2+->rho+,omega; 0.02629 1 /Herwig/Decays/DecayME0
 decaymode pi_2+->K*bar0,K+; 0.020448 1 /Herwig/Decays/DecayME0
 decaymode pi_2+->K*+,Kbar0; 0.020448 1 /Herwig/Decays/DecayME0
 #
 decaymode pi_20->pi0,f_2; 0.546654 1 /Herwig/Decays/DecayME0
 decaymode pi_20->rho-,pi+; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_20->rho+,pi-; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_20->pi0,sigma; 0.084624 1 /Herwig/Decays/Tensor2PScalar
 decaymode pi_20->rho0,omega; 0.02629 1 /Herwig/Decays/DecayME0
 decaymode pi_20->K*-,K+; 0.010224 1 /Herwig/Decays/DecayME0
 decaymode pi_20->K*bar0,K0; 0.010224 1 /Herwig/Decays/DecayME0
 decaymode pi_20->K*0,Kbar0; 0.010224 1 /Herwig/Decays/DecayME0
 decaymode pi_20->K*+,K-; 0.010224 1 /Herwig/Decays/DecayME0
 #
 decaymode pi_2-->pi-,f_2; 0.546654 1 /Herwig/Decays/DecayME0
 decaymode pi_2-->rho-,pi0; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_2-->rho0,pi-; 0.150768 1 /Herwig/Decays/DecayME0
 decaymode pi_2-->pi-,sigma; 0.084624 1 /Herwig/Decays/Tensor2PScalar
 decaymode pi_2-->rho-,omega; 0.02629 1 /Herwig/Decays/DecayME0
 decaymode pi_2-->K*-,K0; 0.020448 1 /Herwig/Decays/DecayME0
 decaymode pi_2-->K*0,K-; 0.020448 1 /Herwig/Decays/DecayME0
 #
 decaymode eta_2->a_20,pi0; 0.290634 1 /Herwig/Decays/DecayME0
 decaymode eta_2->a_2-,pi+; 0.290633 1 /Herwig/Decays/DecayME0
 decaymode eta_2->a_2+,pi-; 0.290633 1 /Herwig/Decays/DecayME0
 decaymode eta_2->a_0-,pi+; 0.022356 1 /Herwig/Decays/Tensor2PScalar
 decaymode eta_2->a_00,pi0; 0.022356 1 /Herwig/Decays/Tensor2PScalar
 decaymode eta_2->a_0+,pi-; 0.022356 1 /Herwig/Decays/Tensor2PScalar
 decaymode eta_2->K*-,K+; 0.015258 1 /Herwig/Decays/DecayME0
 decaymode eta_2->K*bar0,K0; 0.015258 1 /Herwig/Decays/DecayME0
 decaymode eta_2->K*0,Kbar0; 0.015258 1 /Herwig/Decays/DecayME0
 decaymode eta_2->K*+,K-; 0.015258 1 /Herwig/Decays/DecayME0
 #
 decaymode eta'_2->a_2-,pi+; 0.278395 1 /Herwig/Decays/DecayME0
 decaymode eta'_2->a_20,pi0; 0.278395 1 /Herwig/Decays/DecayME0
 decaymode eta'_2->a_2+,pi-; 0.278395 1 /Herwig/Decays/DecayME0
 decaymode eta'_2->f_2,eta; 0.139195 1 /Herwig/Decays/DecayME0
 decaymode eta'_2->a_0-,pi+; 0.00854 1 /Herwig/Decays/Tensor2PScalar
 decaymode eta'_2->a_00,pi0; 0.00854 1 /Herwig/Decays/Tensor2PScalar
 decaymode eta'_2->a_0+,pi-; 0.00854 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode eta_b2->h_b,gamma; 0.9 1 /Herwig/Decays/DecayME0
 decaymode eta_b2->g,g; 0.1 1 /Herwig/Decays/QDecayME0
 #
 decaymode K_2(1770)+->K+,f_2; 0.74 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)+->K*0,pi+; 0.153333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)+->K*+,pi0; 0.076667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)+->K*_20,pi+; 0.02 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)+->K*_2+,pi0; 0.01 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1770)0->K0,f_2; 0.74 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)0->K*+,pi-; 0.153333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)0->K*0,pi0; 0.076667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)0->K*_2+,pi-; 0.02 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)0->K*_20,pi0; 0.01 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1770)-->K-,f_2; 0.74 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)-->K*bar0,pi-; 0.153333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)-->K*-,pi0; 0.076667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)-->K*_2bar0,pi-; 0.02 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)-->K*_2-,pi0; 0.01 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1770)bar0->Kbar0,f_2; 0.74 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)bar0->K*-,pi+; 0.153333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)bar0->K*bar0,pi0; 0.076667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)bar0->K*_2-,pi+; 0.02 1 /Herwig/Decays/DecayME0
 decaymode K_2(1770)bar0->K*_2bar0,pi0; 0.01 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c2(L)+->B_c1+,gamma; 0.758 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B_c2+,gamma; 0.106 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B'_c1+,gamma; 0.084 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B_c+,pi+,pi-; 0.017 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B_c*+,pi+,pi-; 0.017 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B_c+,pi0,pi0; 0.009 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)+->B_c*+,pi0,pi0; 0.009 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c2(L)-->B_c1-,gamma; 0.758 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B_c2-,gamma; 0.106 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B'_c1-,gamma; 0.084 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B_c*-,pi+,pi-; 0.017 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B_c-,pi+,pi-; 0.017 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B_c*-,pi0,pi0; 0.009 1 /Herwig/Decays/DecayME0
 decaymode B_c2(L)-->B_c-,pi0,pi0; 0.009 1 /Herwig/Decays/DecayME0
 #
 # the 1^3D_1 multiplet
 #
 #
 decaymode rho''+->rho+,sigma; 0.209974 1 /Herwig/Decays/DecayME0
 decaymode rho''+->h_1,pi+; 0.127484 1 /Herwig/Decays/VAPDecayer
 decaymode rho''+->pi+,pi0; 0.119985 1 /Herwig/Decays/Vector2Meson
 decaymode rho''+->pi'0,pi+; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''+->pi'+,pi0; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''+->rho+,eta; 0.092239 1 /Herwig/Decays/VectorVP
 decaymode rho''+->rho+,rho0; 0.067492 1 /Herwig/Decays/VectorVV
 decaymode rho''+->a_10,pi+; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''+->a_1+,pi0; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''+->K*bar0,K+; 0.017998 1 /Herwig/Decays/VectorVP
 decaymode rho''+->K*+,Kbar0; 0.017998 1 /Herwig/Decays/VectorVP
 decaymode rho''+->K+,Kbar0; 0.001872 1 /Herwig/Decays/Vector2Meson
 #
 decaymode rho''0->rho0,sigma; 0.209974 1 /Herwig/Decays/DecayME0
 decaymode rho''0->h_1,pi0; 0.127484 1 /Herwig/Decays/VAPDecayer
 decaymode rho''0->pi+,pi-; 0.119985 1 /Herwig/Decays/Vector2Meson
 decaymode rho''0->pi'-,pi+; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''0->pi'+,pi-; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''0->rho0,eta; 0.092239 1 /Herwig/Decays/VectorVP
 decaymode rho''0->rho+,rho-; 0.067492 1 /Herwig/Decays/VectorVV
 decaymode rho''0->a_1-,pi+; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''0->a_1+,pi-; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''0->K*-,K+; 0.008999 1 /Herwig/Decays/VectorVP
 decaymode rho''0->K*bar0,K0; 0.008999 1 /Herwig/Decays/VectorVP
 decaymode rho''0->K*0,Kbar0; 0.008999 1 /Herwig/Decays/VectorVP
 decaymode rho''0->K*+,K-; 0.008999 1 /Herwig/Decays/VectorVP
 decaymode rho''0->K-,K+; 0.000936 1 /Herwig/Decays/Vector2Meson
 decaymode rho''0->Kbar0,K0; 0.000936 1 /Herwig/Decays/Vector2Meson
 #
 decaymode rho''-->rho-,sigma; 0.209974 1 /Herwig/Decays/DecayME0
 decaymode rho''-->h_1,pi-; 0.127484 1 /Herwig/Decays/VAPDecayer
 decaymode rho''-->pi-,pi0; 0.119985 1 /Herwig/Decays/Vector2Meson
 decaymode rho''-->pi'-,pi0; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''-->pi'0,pi-; 0.112486 1 /Herwig/Decays/Vector2Meson
 decaymode rho''-->rho-,eta; 0.092239 1 /Herwig/Decays/VectorVP
 decaymode rho''-->rho-,rho0; 0.067492 1 /Herwig/Decays/VectorVV
 decaymode rho''-->a_1-,pi0; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''-->a_10,pi-; 0.059993 1 /Herwig/Decays/VAPDecayer
 decaymode rho''-->K*-,K0; 0.017998 1 /Herwig/Decays/VectorVP
 decaymode rho''-->K*0,K-; 0.017998 1 /Herwig/Decays/VectorVP
 decaymode rho''-->K-,K0; 0.001872 1 /Herwig/Decays/Vector2Meson
 #
 decaymode omega''->omega,pi+,pi-; 0.333333 1 /Herwig/Decays/DecayME0
 decaymode omega''->rho-,pi+; 0.166667 1 /Herwig/Decays/VectorVP
 decaymode omega''->rho+,pi-; 0.166667 1 /Herwig/Decays/VectorVP
 decaymode omega''->omega,pi0,pi0; 0.166667 1 /Herwig/Decays/DecayME0
 decaymode omega''->rho0,pi0; 0.166666 1 /Herwig/Decays/VectorVP
 #
 decaymode psi(3770)->D0,Dbar0; 0.595969 1 /Herwig/Decays/Vector2Meson
 decaymode psi(3770)->D+,D-; 0.400064 1 /Herwig/Decays/Vector2Meson
 decaymode psi(3770)->Jpsi,pi+,pi-; 0.00193 1 /Herwig/Decays/OniumPiPi
 decaymode psi(3770)->Jpsi,eta; 0.0009 1 /Herwig/Decays/VectorVP
 decaymode psi(3770)->Jpsi,pi0,pi0; 0.0008 1 /Herwig/Decays/OniumPiPi
 decaymode psi(3770)->phi,eta; 0.00031 1 /Herwig/Decays/VectorVP
 decaymode psi(3770)->e-,e+; 1.1E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(3770)->mu-,mu+; 1.1E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(3770)->tau-,tau+; 5.0E-6 1 /Herwig/Decays/Vector2Leptons
 #
 decaymode Upsilon_1(1D)->chi_b0,gamma; 0.602 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(1D)->chi_b1,gamma; 0.318 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(1D)->g,g,g; 0.062 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon_1(1D)->chi_b2,gamma; 0.016 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(1D)->Upsilon,pi+,pi-; 0.001333 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(1D)->Upsilon,pi0,pi0; 0.000667 1 /Herwig/Decays/DecayME0
 #
 decaymode K''*+->K0,pi+; 0.258 1 /Herwig/Decays/Vector2Meson
 decaymode K''*+->K0,rho+; 0.209333 1 /Herwig/Decays/VectorVP
 decaymode K''*+->K*0,pi+; 0.199333 1 /Herwig/Decays/VectorVP
 decaymode K''*+->K+,pi0; 0.129 1 /Herwig/Decays/Vector2Meson
 decaymode K''*+->K+,rho0; 0.104667 1 /Herwig/Decays/VectorVP
 decaymode K''*+->K*+,pi0; 0.099667 1 /Herwig/Decays/VectorVP
 #
 decaymode K''*0->K+,pi-; 0.258 1 /Herwig/Decays/Vector2Meson
 decaymode K''*0->K+,rho-; 0.209333 1 /Herwig/Decays/VectorVP
 decaymode K''*0->K*+,pi-; 0.199333 1 /Herwig/Decays/VectorVP
 decaymode K''*0->K0,pi0; 0.129 1 /Herwig/Decays/Vector2Meson
 decaymode K''*0->K0,rho0; 0.104667 1 /Herwig/Decays/VectorVP
 decaymode K''*0->K*0,pi0; 0.099667 1 /Herwig/Decays/VectorVP
 #
 decaymode K''*-->Kbar0,pi-; 0.258 1 /Herwig/Decays/Vector2Meson
 decaymode K''*-->Kbar0,rho-; 0.209333 1 /Herwig/Decays/VectorVP
 decaymode K''*-->K*bar0,pi-; 0.199333 1 /Herwig/Decays/VectorVP
 decaymode K''*-->K-,pi0; 0.129 1 /Herwig/Decays/Vector2Meson
 decaymode K''*-->K-,rho0; 0.104667 1 /Herwig/Decays/VectorVP
 decaymode K''*-->K*-,pi0; 0.099667 1 /Herwig/Decays/VectorVP
 #
 decaymode K''*bar0->K-,pi+; 0.258 1 /Herwig/Decays/Vector2Meson
 decaymode K''*bar0->K-,rho+; 0.209333 1 /Herwig/Decays/VectorVP
 decaymode K''*bar0->K*-,pi+; 0.199333 1 /Herwig/Decays/VectorVP
 decaymode K''*bar0->Kbar0,pi0; 0.129 1 /Herwig/Decays/Vector2Meson
 decaymode K''*bar0->Kbar0,rho0; 0.104667 1 /Herwig/Decays/VectorVP
 decaymode K''*bar0->K*bar0,pi0; 0.099667 1 /Herwig/Decays/VectorVP
 #
+decaymode D_1*(2760)0->D+,pi-; 0.52278 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)0->D0,pi0; 0.26687 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)0->D*+,pi-; 0.139301 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)0->D*0,pi0; 0.071049 1 /Herwig/Decays/HQETMeson
+#
+decaymode D_1*(2760)+->D0,pi+; 0.529493 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)+->D+,pi0; 0.260253 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)+->D*0,pi+; 0.140847 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)+->D*+,pi0; 0.069407 1 /Herwig/Decays/HQETMeson
+#
+decaymode Dbar_1*(2760)0->D-,pi+; 0.52278 1 /Herwig/Decays/HQETMeson
+decaymode Dbar_1*(2760)0->Dbar0,pi0; 0.26687 1 /Herwig/Decays/HQETMeson
+decaymode Dbar_1*(2760)0->D*-,pi+; 0.139301 1 /Herwig/Decays/HQETMeson
+decaymode Dbar_1*(2760)0->D*bar0,pi0; 0.071049 1 /Herwig/Decays/HQETMeson
+#
+decaymode D_1*(2760)-->Dbar0,pi-; 0.529493 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)-->D-,pi0; 0.260253 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)-->D*bar0,pi-; 0.140847 1 /Herwig/Decays/HQETMeson
+decaymode D_1*(2760)-->D*-,pi0; 0.069407 1 /Herwig/Decays/HQETMeson
+#
+decaymode D_s1*(2860)+->D*0,K+; 0.265999 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)+->D*+,K0; 0.25781 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)+->D0,K+; 0.241382 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)+->D+,K0; 0.234809 1 /Herwig/Decays/HQETMeson
+#
+decaymode D_s1*(2860)-->D*bar0,K-; 0.265999 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)-->D*-,Kbar0; 0.25781 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)-->Dbar0,K-; 0.241382 1 /Herwig/Decays/HQETMeson
+decaymode D_s1*(2860)-->D-,Kbar0; 0.234809 1 /Herwig/Decays/HQETMeson
+#
 decaymode B_c(1D)*+->B*_c0+,gamma;  0.588 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*+->B'_c1+,gamma;  0.299 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*+->B_c1+,gamma;   0.047 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*+->B_c*+,pi+,pi-; 0.031 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*+->B_c2+,gamma;   0.019 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*+->B_c*+,pi0,pi0; 0.016 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c(1D)*-->B*_c0-,gamma;  0.588 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*-->B'_c1-,gamma;  0.299 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*-->B_c1-,gamma;   0.047 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*-->B_c*-,pi+,pi-; 0.031 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*-->B_c2-,gamma;   0.019 1 /Herwig/Decays/DecayME0
 decaymode B_c(1D)*-->B_c*-,pi0,pi0; 0.016 1 /Herwig/Decays/DecayME0
 #
 # the 1^3D_2 multiplet
 #
 #
 decaymode psi_2(1D)->chi_c1,gamma; 0.486 1 /Herwig/Decays/DecayME0
 decaymode psi_2(1D)->Jpsi,pi+,pi-; 0.1893 1 /Herwig/Decays/DecayME0
 decaymode psi_2(1D)->chi_b2,gamma; 0.122 1 /Herwig/Decays/DecayME0
 decaymode psi_2(1D)->g,g,g; 0.108 1 /Herwig/Decays/QDecayME130
 decaymode psi_2(1D)->Jpsi,pi0,pi0; 0.0947 1 /Herwig/Decays/DecayME0
 #
 decaymode Upsilon_2(1D)->chi_b0,gamma; 0.7781 1 /Herwig/Decays/TensorVP
 decaymode Upsilon_2(1D)->chi_b2,gamma; 0.203 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_2(1D)->g,g,g; 0.009 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon_2(1D)->Upsilon,pi+,pi-; 0.0066 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_2(1D)->Upsilon,pi0,pi0; 0.0033 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1820)+->K*_20,pi+; 0.513333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)+->K*_2+,pi0; 0.256667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)+->K+,f_2; 0.18 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)+->K*0,pi+; 0.033333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)+->K*+,pi0; 0.016667 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1820)0->K*_2+,pi-; 0.513333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)0->K*_20,pi0; 0.256667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)0->K0,f_2; 0.18 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)0->K*+,pi-; 0.033333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)0->K*0,pi0; 0.016667 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1820)-->K*_2bar0,pi-; 0.513333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)-->K*_2-,pi0; 0.256667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)-->K-,f_2; 0.18 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)-->K*bar0,pi-; 0.033333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)-->K*-,pi0; 0.016667 1 /Herwig/Decays/DecayME0
 #
 decaymode K_2(1820)bar0->K*_2-,pi+; 0.513333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)bar0->K*_2bar0,pi0; 0.256667 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)bar0->Kbar0,f_2; 0.18 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)bar0->K*-,pi+; 0.033333 1 /Herwig/Decays/DecayME0
 decaymode K_2(1820)bar0->K*bar0,pi0; 0.016667 1 /Herwig/Decays/DecayME0
 #
 decaymode D_2(2740)0->D*+,pi-; 0.657996 1 /Herwig/Decays/HQETMeson
 decaymode D_2(2740)0->D*0,pi0; 0.342004 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_2(2740)+->D*0,pi+; 0.671485 1 /Herwig/Decays/HQETMeson
 decaymode D_2(2740)+->D*+,pi0; 0.328515 1 /Herwig/Decays/HQETMeson
 #
 decaymode Dbar_2(2740)0->D*-,pi+; 0.657996 1 /Herwig/Decays/HQETMeson
 decaymode Dbar_2(2740)0->D*bar0,pi0; 0.342004 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_2(2740)-->D*bar0,pi-; 0.671485 1 /Herwig/Decays/HQETMeson
 decaymode D_2(2740)-->D*-,pi0; 0.328515 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s2(2850)+->D*0,K+; 0.517484 1 /Herwig/Decays/HQETMeson
 decaymode D_s2(2850)+->D*+,K0; 0.482516 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s2(2850)-->D*bar0,K-; 0.517484 1 /Herwig/Decays/HQETMeson
 decaymode D_s2(2850)-->D*-,Kbar0; 0.482516 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_c2(H)+->B'_c1+,gamma;  0.689 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c1+,gamma;   0.161 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c2+,gamma;   0.103 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c+,pi+,pi-;  0.016 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c*+,pi+,pi-; 0.015 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c+,pi0,pi0;  0.008 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)+->B_c*+,pi0,pi0; 0.008 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c2(H)-->B'_c1-,gamma;  0.689 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c1-,gamma;   0.161 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c2-,gamma;   0.103 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c-,pi+,pi-;  0.016 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c*-,pi+,pi-; 0.015 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c*-,pi0,pi0; 0.008 1 /Herwig/Decays/DecayME0
 decaymode B_c2(H)-->B_c-,pi0,pi0;  0.008 1 /Herwig/Decays/DecayME0
 #
 # the 1^3D_3 multiplet
 #
 #
 decaymode rho_3+->pi+,pi0; 0.23581 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->a_20,pi+; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->a_2+,pi0; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->pi+,omega; 0.16 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->rho+,rho0; 0.081547 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->K*bar0,K+; 0.018985 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->K*+,Kbar0; 0.018985 1 /Herwig/Decays/DecayME0
 decaymode rho_3+->K+,Kbar0; 0.015787 1 /Herwig/Decays/DecayME0
 #
 decaymode rho_30->pi+,pi-; 0.235811 1 /Herwig/Decays/DecayME0
 decaymode rho_30->a_2-,pi+; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_30->a_2+,pi-; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_30->pi0,omega; 0.16 1 /Herwig/Decays/DecayME0
 decaymode rho_30->rho+,rho-; 0.081547 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K*-,K+; 0.009492 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K*bar0,K0; 0.009492 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K*0,Kbar0; 0.009492 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K*+,K-; 0.009492 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K0,Kbar0; 0.007894 1 /Herwig/Decays/DecayME0
 decaymode rho_30->K+,K-; 0.007894 1 /Herwig/Decays/DecayME0
 #
 decaymode rho_3-->pi-,pi0; 0.23581 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->a_2-,pi0; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->a_20,pi-; 0.234443 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->pi-,omega; 0.16 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->rho-,rho0; 0.081547 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->K*-,K0; 0.018985 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->K*0,K-; 0.018985 1 /Herwig/Decays/DecayME0
 decaymode rho_3-->K-,K0; 0.015787 1 /Herwig/Decays/DecayME0
 #
 decaymode omega_3->rho0,pi0; 0.194933 1 /Herwig/Decays/DecayME0
 decaymode omega_3->rho-,pi+; 0.194932 1 /Herwig/Decays/DecayME0
 decaymode omega_3->rho+,pi-; 0.194932 1 /Herwig/Decays/DecayME0
 decaymode omega_3->b_1-,pi+; 0.138401 1 /Herwig/Decays/DecayME0
 decaymode omega_3->b_10,pi0; 0.138401 1 /Herwig/Decays/DecayME0
 decaymode omega_3->b_1+,pi-; 0.138401 1 /Herwig/Decays/DecayME0
 #
 decaymode phi_3->K0,Kbar0; 0.322582 1 /Herwig/Decays/DecayME0
 decaymode phi_3->K+,K-; 0.322582 1 /Herwig/Decays/DecayME0
 decaymode phi_3->K*-,K+; 0.088709 1 /Herwig/Decays/DecayME0
 decaymode phi_3->K*bar0,K0; 0.088709 1 /Herwig/Decays/DecayME0
 decaymode phi_3->K*0,Kbar0; 0.088709 1 /Herwig/Decays/DecayME0
 decaymode phi_3->K*+,K-; 0.088709 1 /Herwig/Decays/DecayME0
 #
 decaymode psi_3(1D)->D0,Dbar0; 0.576 1 /Herwig/Decays/Spin3PP
 decaymode psi_3(1D)->D+,D-; 0.424 1 /Herwig/Decays/Spin3PP
 #
 decaymode Upsilon_3(1D)->chi_b2,gamma; 0.954 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_3(1D)->g,g,g; 0.043 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon_3(1D)->Upsilon,pi+,pi-; 0.002 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_3(1D)->Upsilon,pi0,pi0; 0.001 1 /Herwig/Decays/DecayME0
 #
 decaymode K_3*+->K+,eta; 0.300601 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K0,rho+; 0.207081 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K*0,pi+; 0.133601 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K0,pi+; 0.125585 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K+,rho0; 0.10354 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K*+,pi0; 0.0668 1 /Herwig/Decays/DecayME0
 decaymode K_3*+->K+,pi0; 0.062792 1 /Herwig/Decays/DecayME0
 #
 decaymode K_3*0->K0,eta; 0.300601 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K+,rho-; 0.207081 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K*+,pi-; 0.133601 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K+,pi-; 0.125585 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K0,rho0; 0.10354 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K*0,pi0; 0.0668 1 /Herwig/Decays/DecayME0
 decaymode K_3*0->K0,pi0; 0.062792 1 /Herwig/Decays/DecayME0
 #
 decaymode K_3*-->K-,eta; 0.300601 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->Kbar0,rho-; 0.207081 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->K*bar0,pi-; 0.133601 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->Kbar0,pi-; 0.125585 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->K-,rho0; 0.10354 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->K*-,pi0; 0.0668 1 /Herwig/Decays/DecayME0
 decaymode K_3*-->K-,pi0; 0.062792 1 /Herwig/Decays/DecayME0
 #
 decaymode K_3*bar0->Kbar0,eta; 0.300601 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->K-,rho+; 0.207081 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->K*-,pi+; 0.133601 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->K-,pi+; 0.125585 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->Kbar0,rho0; 0.10354 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->K*bar0,pi0; 0.0668 1 /Herwig/Decays/DecayME0
 decaymode K_3*bar0->Kbar0,pi0; 0.062792 1 /Herwig/Decays/DecayME0
 #
 decaymode D_3*(2750)0->D*+,pi-; 0.464082 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)0->D*0,pi0; 0.240121 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)0->D+,pi-; 0.194915 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)0->D0,pi0; 0.100882 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_3*(2750)+->D*0,pi+; 0.47212 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)+->D*+,pi0; 0.231895 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)+->D0,pi+; 0.198821 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)+->D+,pi0; 0.097164 1 /Herwig/Decays/HQETMeson
 #
 decaymode Dbar_3*(2750)0->D*-,pi+; 0.464082 1 /Herwig/Decays/HQETMeson
 decaymode Dbar_3*(2750)0->D*bar0,pi0; 0.240121 1 /Herwig/Decays/HQETMeson
 decaymode Dbar_3*(2750)0->D-,pi+; 0.194915 1 /Herwig/Decays/HQETMeson
 decaymode Dbar_3*(2750)0->Dbar0,pi0; 0.100882 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_3*(2750)-->D*bar0,pi-; 0.47212 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)-->D*-,pi0; 0.231895 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)-->Dbar0,pi-; 0.198821 1 /Herwig/Decays/HQETMeson
 decaymode D_3*(2750)-->D-,pi0; 0.097164 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s3*(2860)+->D0,K+; 0.37044 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)+->D+,K0; 0.350777 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)+->D*0,K+; 0.143907 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)+->D*+,K0; 0.134876 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s3*(2860)-->Dbar0,K-; 0.37044 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)-->D-,Kbar0; 0.350777 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)-->D*bar0,K-; 0.143907 1 /Herwig/Decays/HQETMeson
 decaymode D_s3*(2860)-->D*-,Kbar0; 0.134876 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_c3(1D)*+->B_c2+,gamma;   0.948 1 /Herwig/Decays/DecayME0
 decaymode B_c3(1D)*+->B_c*+,pi+,pi-; 0.035 1 /Herwig/Decays/DecayME0
 decaymode B_c3(1D)*+->B_c*+,pi0,pi0; 0.017 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c3(1D)*-->B_c2-,gamma;   0.948 1 /Herwig/Decays/DecayME0
 decaymode B_c3(1D)*-->B_c*-,pi+,pi-; 0.035 1 /Herwig/Decays/DecayME0
 decaymode B_c3(1D)*-->B_c*-,pi0,pi0; 0.017 1 /Herwig/Decays/DecayME0
 #
 # the 1^3F_4 multiplet
 #
 #
 # the 2^1S_0 multiplet
 #
 #
 decaymode pi'+->rho0,pi+; 0.5 1 /Herwig/Decays/PPVDecayer
 decaymode pi'+->rho+,pi0; 0.5 1 /Herwig/Decays/PPVDecayer
 #
 decaymode pi'0->rho-,pi+; 0.5 1 /Herwig/Decays/PPVDecayer
 decaymode pi'0->rho+,pi-; 0.5 1 /Herwig/Decays/PPVDecayer
 #
 decaymode pi'-->rho-,pi0; 0.5 1 /Herwig/Decays/PPVDecayer
 decaymode pi'-->rho0,pi-; 0.5 1 /Herwig/Decays/PPVDecayer
 #
 decaymode eta(1295)->sigma,eta; 0.349999 1 /Herwig/Decays/ScalarSS
 decaymode eta(1295)->a_0-,pi+; 0.216667 1 /Herwig/Decays/ScalarSS
 decaymode eta(1295)->a_00,pi0; 0.216667 1 /Herwig/Decays/ScalarSS
 decaymode eta(1295)->a_0+,pi-; 0.216667 1 /Herwig/Decays/ScalarSS
 #
 decaymode eta(1475)->K*-,K+; 0.25 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1475)->K*bar0,K0; 0.25 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1475)->K*0,Kbar0; 0.25 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1475)->K*+,K-; 0.25 1 /Herwig/Decays/PPVDecayer
 #
 decaymode eta_c(2S)->g,g; 0.9752 1 /Herwig/Decays/QDecayME0
 decaymode eta_c(2S)->eta_c,pi+,pi-; 0.0125 1 /Herwig/Decays/DecayME0
 decaymode eta_c(2S)->eta_c,pi0,pi0; 0.0063 1 /Herwig/Decays/DecayME0
 decaymode eta_c(2S)->h_c,gamma; 0.006 1 /Herwig/Decays/DecayME0
 #
 decaymode eta_b(2S)->g,g; 0.9943 1 /Herwig/Decays/QDecayME0
 decaymode eta_b(2S)->h_b,gamma; 0.0057 1 /Herwig/Decays/DecayME0
 #
 decaymode K'+->K*_00,pi+; 0.3 1 /Herwig/Decays/ScalarSS
 decaymode K'+->K*0,pi+; 0.279487 1 /Herwig/Decays/PPVDecayer
 decaymode K'+->K*_0+,pi0; 0.15 1 /Herwig/Decays/ScalarSS
 decaymode K'+->K*+,pi0; 0.139744 1 /Herwig/Decays/PPVDecayer
 decaymode K'+->K0,rho+; 0.087179 1 /Herwig/Decays/PPVDecayer
 decaymode K'+->K+,rho0; 0.04359 1 /Herwig/Decays/PPVDecayer
 #
 decaymode K'0->K*_0+,pi-; 0.3 1 /Herwig/Decays/ScalarSS
 decaymode K'0->K*+,pi-; 0.279487 1 /Herwig/Decays/PPVDecayer
 decaymode K'0->K*_00,pi0; 0.15 1 /Herwig/Decays/ScalarSS
 decaymode K'0->K*0,pi0; 0.139744 1 /Herwig/Decays/PPVDecayer
 decaymode K'0->K+,rho-; 0.087179 1 /Herwig/Decays/PPVDecayer
 decaymode K'0->K0,rho0; 0.04359 1 /Herwig/Decays/PPVDecayer
 #
 decaymode K'-->K*_0bar0,pi-; 0.3 1 /Herwig/Decays/ScalarSS
 decaymode K'-->K*bar0,pi-; 0.279487 1 /Herwig/Decays/PPVDecayer
 decaymode K'-->K*_0-,pi0; 0.15 1 /Herwig/Decays/ScalarSS
 decaymode K'-->K*-,pi0; 0.139744 1 /Herwig/Decays/PPVDecayer
 decaymode K'-->Kbar0,rho-; 0.087179 1 /Herwig/Decays/PPVDecayer
 decaymode K'-->K-,rho0; 0.04359 1 /Herwig/Decays/PPVDecayer
 #
 decaymode K'bar0->K*_0-,pi+; 0.3 1 /Herwig/Decays/ScalarSS
 decaymode K'bar0->K*-,pi+; 0.279487 1 /Herwig/Decays/PPVDecayer
 decaymode K'bar0->K*_0bar0,pi0; 0.15 1 /Herwig/Decays/ScalarSS
 decaymode K'bar0->K*bar0,pi0; 0.139744 1 /Herwig/Decays/PPVDecayer
 decaymode K'bar0->K-,rho+; 0.087179 1 /Herwig/Decays/PPVDecayer
 decaymode K'bar0->Kbar0,rho0; 0.04359 1 /Herwig/Decays/PPVDecayer
 #
 decaymode D_0(2550)0->D*+,pi-; 0.660707 1 /Herwig/Decays/HQETMeson
 decaymode D_0(2550)0->D*0,pi0; 0.339293 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_0(2550)+->D*0,pi+; 0.669476 1 /Herwig/Decays/HQETMeson
 decaymode D_0(2550)+->D*+,pi0; 0.330524 1 /Herwig/Decays/HQETMeson
 #
 decaymode Dbar_0(2550)0->D*-,pi+; 0.660707 1 /Herwig/Decays/HQETMeson
 decaymode Dbar_0(2550)0->D*bar0,pi0; 0.339293 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_0(2550)-->D*bar0,pi-; 0.669476 1 /Herwig/Decays/HQETMeson
 decaymode D_0(2550)-->D*-,pi0; 0.330524 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s0(2590)+->D*0,K+; 0.531455 1 /Herwig/Decays/HQETMeson
 decaymode D_s0(2590)+->D*+,K0; 0.468545 1 /Herwig/Decays/HQETMeson
 #
 decaymode D_s0(2590)-->D*bar0,K-; 0.531455 1 /Herwig/Decays/HQETMeson
 decaymode D_s0(2590)-->D*-,Kbar0; 0.468545 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_c(2S)+->B_c+,pi+,pi-; 0.587 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)+->B_c+,pi0,pi0; 0.294 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)+->B_c1+,gamma;  0.094 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)+->B'_c1+,gamma; 0.02 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)+->B_c*+,gamma;  0.005 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c(2S)-->B_c-,pi+,pi-; 0.587 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)-->B_c-,pi0,pi0; 0.294 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)-->B_c1-,gamma;  0.094 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)-->B'_c1-,gamma; 0.02 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)-->B_c*-,gamma;  0.005 1 /Herwig/Decays/DecayME0
 #
 # the 2^3S_1 multiplet
 #
 #
 decaymode rho'+->pi+,pi0; 0.270072 1 /Herwig/Decays/Vector2Meson
 decaymode rho'+->pi'0,pi+; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'+->pi'+,pi0; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'+->rho+,sigma; 0.124088 1 /Herwig/Decays/VVSDecayer
 decaymode rho'+->a_10,pi+; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'+->a_1+,pi0; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'+->rho+,rho0; 0.080292 1 /Herwig/Decays/VectorVV
 decaymode rho'+->h_1,pi+; 0.058394 1 /Herwig/Decays/VAPDecayer
 #
 decaymode rho'0->pi+,pi-; 0.270072 1 /Herwig/Decays/Vector2Meson
 decaymode rho'0->pi'-,pi+; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'0->pi'+,pi-; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'0->rho0,sigma; 0.124088 1 /Herwig/Decays/VVSDecayer
 decaymode rho'0->a_1-,pi+; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'0->a_1+,pi-; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'0->rho+,rho-; 0.080292 1 /Herwig/Decays/VectorVV
 decaymode rho'0->h_1,pi0; 0.058394 1 /Herwig/Decays/VAPDecayer
 #
 decaymode rho'-->pi-,pi0; 0.270072 1 /Herwig/Decays/Vector2Meson
 decaymode rho'-->pi'-,pi0; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'-->pi'0,pi-; 0.135037 1 /Herwig/Decays/Vector2Meson
 decaymode rho'-->rho-,sigma; 0.124088 1 /Herwig/Decays/VVSDecayer
 decaymode rho'-->a_1-,pi0; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'-->a_10,pi-; 0.09854 1 /Herwig/Decays/VAPDecayer
 decaymode rho'-->rho-,rho0; 0.080292 1 /Herwig/Decays/VectorVV
 decaymode rho'-->h_1,pi-; 0.058394 1 /Herwig/Decays/VAPDecayer
 #
 decaymode omega'->rho-,pi+; 0.233 1 /Herwig/Decays/VectorVP
 decaymode omega'->rho0,pi0; 0.233 1 /Herwig/Decays/VectorVP
 decaymode omega'->rho+,pi-; 0.233 1 /Herwig/Decays/VectorVP
 decaymode omega'->omega,sigma; 0.112876 1 /Herwig/Decays/DecayME0
 decaymode omega'->b_1-,pi+; 0.062708 1 /Herwig/Decays/VAPDecayer
 decaymode omega'->b_10,pi0; 0.062708 1 /Herwig/Decays/VAPDecayer
 decaymode omega'->b_1+,pi-; 0.062708 1 /Herwig/Decays/VAPDecayer
 #
 decaymode phi'->K*-,K+; 0.233645 1 /Herwig/Decays/VectorVP
 decaymode phi'->K*bar0,K0; 0.233645 1 /Herwig/Decays/VectorVP
 decaymode phi'->K*0,Kbar0; 0.233645 1 /Herwig/Decays/VectorVP
 decaymode phi'->K*+,K-; 0.233645 1 /Herwig/Decays/VectorVP
 decaymode phi'->K_L0,K_S0; 0.03271 1 /Herwig/Decays/Vector2Meson
 decaymode phi'->K+,K-; 0.03271 1 /Herwig/Decays/Vector2Meson
 #
 decaymode psi(2S)->Jpsi,pi+,pi-; 0.318 1 /Herwig/Decays/OniumPiPi
 decaymode psi(2S)->g,g,g; 0.183093 1 /Herwig/Decays/QDecayME130
 decaymode psi(2S)->Jpsi,pi0,pi0; 0.1646 1 /Herwig/Decays/OniumPiPi
 decaymode psi(2S)->chi_c0,gamma; 0.092 1 /Herwig/Decays/VVSDecayer
 decaymode psi(2S)->chi_c1,gamma; 0.087 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->chi_c2,gamma; 0.081 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Jpsi,eta; 0.0309 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->e-,e+; 0.00735 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(2S)->mu-,mu+; 0.00734 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(2S)->tau-,tau+; 0.00285 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(2S)->eta_c,gamma; 0.0026 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->Jpsi,pi0; 0.00126 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->K_1-,K+; 0.001 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->K_1bar0,K0; 0.001 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->K_10,Kbar0; 0.001 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->K_1+,K-; 0.001 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->h_c,pi0; 0.001 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->eta,pi+,pi-,pi0; 0.00095 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->p+,pbar-,pi+,pi-,pi0; 0.00073 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->eta',pi+,pi-,pi0; 0.00045 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->pi+,pi-,p+,pbar-; 0.0004 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->K*-,K0,rho+; 0.00035 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*bar0,K+,rho-; 0.00035 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*0,K-,rho+; 0.00035 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*+,Kbar0,rho-; 0.00035 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*-,K0,pi+; 0.000335 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*bar0,K+,pi-; 0.000335 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*0,K-,pi+; 0.000335 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*+,Kbar0,pi-; 0.000335 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->b_1-,pi+; 0.0003 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->b_10,pi0; 0.0003 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->b_1+,pi-; 0.0003 1 /Herwig/Decays/VAPDecayer
 decaymode psi(2S)->Lambda0,Lambdabar0,pi+,pi-; 0.00028 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->n0,pbar-,pi+; 0.000266 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,nbar0,pi-; 0.000266 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->n0,nbar0; 0.000265 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->p+,pbar-; 0.000265 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->Lambda0,Lambdabar0; 0.00025 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->Sigma-,Sigmabar+; 0.00023 1 /Herwig/Decays/Vector2Leptons
 decaymode psi(2S)->Sigma0,Sigmabar0; 0.00023 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->Sigma+,Sigmabar-; 0.00023 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->rho-,pi+,pi0; 0.00022 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->rho0,pi+,pi-; 0.00022 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->rho+,pi-,pi0; 0.00022 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->f_2,gamma; 0.00021 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,f_2; 0.0002 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Xi-,Xibar+; 0.0002 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->Xi0,Xibar0; 0.0002 1 /Herwig/Decays/Vector2BaryonsHalf
 decaymode psi(2S)->K*-,K*_2+; 0.00019 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*bar0,K*_20; 0.00019 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,f_0(1710); 0.00019 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*0,K*_2bar0; 0.00019 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*+,K*_2-; 0.00019 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,K0,Kbar0; 0.000185 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,K+,K-; 0.000185 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Lambdabar0,p+,K-,pi+,pi-; 0.00018 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->Lambda0,pbar-,K+,pi+,pi-; 0.00018 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->K*-,K+,rho0; 0.000175 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*bar0,K0,rho0; 0.000175 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*0,Kbar0,rho0; 0.000175 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*+,K-,rho0; 0.000175 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*-,K+,pi0; 0.000168 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*bar0,K0,pi0; 0.000168 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*0,Kbar0,pi0; 0.000168 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K*+,K-,pi0; 0.000168 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->eta',gamma; 0.00015 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->pi+,pi-,pi0; 0.000136 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->n0,nbar0,pi0; 0.000133 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,pbar-,pi0; 0.000133 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Delta-,Deltabar+; 0.000128 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Delta0,Deltabar0; 0.000128 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Delta+,Deltabar-; 0.000128 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Delta++,Deltabar--; 0.000128 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Xi*-,Xi*bar+; 0.000115 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode psi(2S)->K+,K-,K+,K-,pi0; 0.00011 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->Sigma*-,Sigma*bar+; 0.00011 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode psi(2S)->Sigma*0,Sigma*bar0; 0.00011 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode psi(2S)->Sigma*+,Sigma*bar-; 0.00011 1 /Herwig/Decays/Vector2Baryons3Half
 decaymode psi(2S)->Kbar0,K*0; 0.000109 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->K0,K*bar0; 0.000109 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->Lambdabar0,n0,Kbar0; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Lambdabar0,p+,K-; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->phi,f_0; 0.0001 1 /Herwig/Decays/VVSDecayer
 decaymode psi(2S)->n0,pbar-,rho+; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,nbar0,rho-; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Lambda0,pbar-,K+; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->Lambda0,nbar0,K0; 0.0001 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->f_0(1710),gamma; 0.0001 1 /Herwig/Decays/VVSDecayer
 decaymode psi(2S)->rho-,a_2+; 8.7E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->rho0,a_20; 8.7E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->rho+,a_2-; 8.7E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->pi+,pi-; 8.0E-5 1 /Herwig/Decays/Vector2Meson
 decaymode psi(2S)->phi,K0,Kbar0; 7.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->phi,K+,K-; 7.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,n0,nbar0; 6.9E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,p+,pbar-; 6.9E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K+,K-,K+,K-; 6.0E-5 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->n0,nbar0,eta; 6.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,pbar-,eta; 6.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->K_L0,K_S0; 5.3E-5 1 /Herwig/Decays/Vector2Meson
 decaymode psi(2S)->K+,K-; 5.3E-5 1 /Herwig/Decays/Vector2Meson
 decaymode psi(2S)->phi,pi+,pi-; 5.3E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->n0,nbar0,rho0; 5.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,pbar-,rho0; 5.0E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->phi,f'_2; 4.4E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->omega,eta'; 3.2E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->phi,eta'; 3.1E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->phi,eta; 2.8E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->phi,pi0,pi0; 2.7E-5 1 /Herwig/Decays/DecayME0
 decaymode psi(2S)->p+,pbar-,K+,K-; 2.7E-5 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->rho0,eta; 2.2E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->omega,pi0; 2.1E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->pi+,pi-,pi+,pi-; 2.0E-5 1 /Herwig/Decays/Mambo
 decaymode psi(2S)->rho0,eta'; 1.9E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->K-,K*+; 1.7E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->K+,K*-; 1.7E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->rho-,pi+; 1.1E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->rho0,pi0; 1.1E-5 1 /Herwig/Decays/VectorVP
 decaymode psi(2S)->rho+,pi-; 1.1E-5 1 /Herwig/Decays/VectorVP
 #
 decaymode Upsilon(2S)->g,g,g; 0.414645 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon(2S)->Upsilon,pi+,pi-; 0.1785 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(2S)->Upsilon,pi0,pi0; 0.086 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(2S)->chi_b2,gamma; 0.0715 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(2S)->chi_b1,gamma; 0.069 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(2S)->chi_b0,gamma; 0.038 1 /Herwig/Decays/VVSDecayer
 decaymode Upsilon(2S)->u,ubar; 0.025881 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(2S)->c,cbar; 0.025881 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(2S)->e-,e+; 0.019411 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(2S)->mu-,mu+; 0.019411 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(2S)->tau-,tau+; 0.019291 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(2S)->g,g,gamma; 0.0187 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon(2S)->d,dbar; 0.00647 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(2S)->s,sbar; 0.00647 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(2S)->eta_b,gamma; 0.00055 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(2S)->Upsilon,eta; 0.00029 1 /Herwig/Decays/DecayME0
 #
 decaymode K'*+->K*0,pi+; 0.622667 1 /Herwig/Decays/VectorVP
 decaymode K'*+->K*+,pi0; 0.311333 1 /Herwig/Decays/VectorVP
 decaymode K'*+->K0,pi+; 0.044 1 /Herwig/Decays/Vector2Meson
 decaymode K'*+->K+,pi0; 0.022 1 /Herwig/Decays/Vector2Meson
 #
 decaymode K'*0->K*+,pi-; 0.622667 1 /Herwig/Decays/VectorVP
 decaymode K'*0->K*0,pi0; 0.311333 1 /Herwig/Decays/VectorVP
 decaymode K'*0->K+,pi-; 0.044 1 /Herwig/Decays/Vector2Meson
 decaymode K'*0->K0,pi0; 0.022 1 /Herwig/Decays/Vector2Meson
 #
 decaymode K'*-->K*bar0,pi-; 0.622667 1 /Herwig/Decays/VectorVP
 decaymode K'*-->K*-,pi0; 0.311333 1 /Herwig/Decays/VectorVP
 decaymode K'*-->Kbar0,pi-; 0.044 1 /Herwig/Decays/Vector2Meson
 decaymode K'*-->K-,pi0; 0.022 1 /Herwig/Decays/Vector2Meson
 #
 decaymode K'*bar0->K*-,pi+; 0.622667 1 /Herwig/Decays/VectorVP
 decaymode K'*bar0->K*bar0,pi0; 0.311333 1 /Herwig/Decays/VectorVP
 decaymode K'*bar0->K-,pi+; 0.044 1 /Herwig/Decays/Vector2Meson
 decaymode K'*bar0->Kbar0,pi0; 0.022 1 /Herwig/Decays/Vector2Meson
 #
 decaymode D*1(2600)0->D*+,pi-; 0.501937 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)0->D*0,pi0; 0.255727 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)0->D+,pi-; 0.16062 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)0->D0,pi0; 0.081716 1 /Herwig/Decays/HQETMeson
 #
 decaymode D*1(2600)+->D*0,pi+; 0.506472 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)+->D*+,pi0; 0.251168 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)+->D0,pi+; 0.162132 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)+->D+,pi0; 0.080228 1 /Herwig/Decays/HQETMeson
 #
 decaymode Dbar*1(2600)0->D*-,pi+; 0.501937 1 /Herwig/Decays/HQETMeson
 decaymode Dbar*1(2600)0->D*bar0,pi0; 0.255727 1 /Herwig/Decays/HQETMeson
 decaymode Dbar*1(2600)0->D-,pi+; 0.16062 1 /Herwig/Decays/HQETMeson
 decaymode Dbar*1(2600)0->Dbar0,pi0; 0.081716 1 /Herwig/Decays/HQETMeson
 #
 decaymode D*1(2600)-->D*bar0,pi-; 0.506472 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)-->D*-,pi0; 0.251168 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)-->Dbar0,pi-; 0.162132 1 /Herwig/Decays/HQETMeson
 decaymode D*1(2600)-->D-,pi0; 0.080228 1 /Herwig/Decays/HQETMeson
 #
 decaymode Ds*1(2700)+->D0,K+; 0.264387 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)+->D+,K0; 0.25583 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)+->D*0,K+; 0.245676 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)+->D*+,K0; 0.234107 1 /Herwig/Decays/HQETMeson
 #
 decaymode Ds*1(2700)-->Dbar0,K-; 0.264387 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)-->D-,Kbar0; 0.25583 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)-->D*bar0,K-; 0.245676 1 /Herwig/Decays/HQETMeson
 decaymode Ds*1(2700)-->D*-,Kbar0; 0.234107 1 /Herwig/Decays/HQETMeson
 #
 decaymode B_c(2S)*+->B_c*+,pi+,pi-; 0.531 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B_c*+,pi0,pi0; 0.265 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B_c2+,gamma;   0.08 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B'_c1+,gamma;  0.066 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B*_c0+,gamma;  0.04 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B_c1+,gamma;   0.01 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*+->B_c+,gamma;    0.008 1 /Herwig/Decays/DecayME0
 #
 decaymode B_c(2S)*-->B_c*-,pi+,pi-; 0.531 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B_c*-,pi0,pi0; 0.265 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B_c2-,gamma;   0.08 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B'_c1-,gamma;  0.066 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B*_c0-,gamma;  0.04 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B_c1-,gamma;   0.01 1 /Herwig/Decays/DecayME0
 decaymode B_c(2S)*-->B_c-,gamma;    0.008 1 /Herwig/Decays/DecayME0
 #
 # the 2^1P_1 multiplet
 #
 #
 decaymode h_b(2P)->eta_b(2S),gamma; 0.48 1 /Herwig/Decays/DecayME0
 decaymode h_b(2P)->g,g,g; 0.246 1 /Herwig/Decays/QDecayME130
 decaymode h_b(2P)->eta_b,gamma; 0.22 1 /Herwig/Decays/DecayME0
 decaymode h_b(2P)->eta_b2,gamma; 0.034 1 /Herwig/Decays/DecayME0
 decaymode h_b(2P)->g,g,gamma; 0.02 1 /Herwig/Decays/QDecayME130
 #
 # the 2^3P_0 multiplet
 #
 #
 decaymode chi_b0(2P)->g,g; 0.9809 1 /Herwig/Decays/QDecayME0
 decaymode chi_b0(2P)->Upsilon(2S),gamma; 0.0138 1 /Herwig/Decays/DecayME0
 decaymode chi_b0(2P)->Upsilon,gamma; 0.0038 1 /Herwig/Decays/DecayME0
 decaymode chi_b0(2P)->Upsilon_1(1D),gamma; 0.0015 1 /Herwig/Decays/DecayME0
 #
 # the 2^3P_1 multiplet
 #
 #
 decaymode chi_b1(2P)->g,g; 0.6613 1 /Herwig/Decays/QDecayME0
 decaymode chi_b1(2P)->Upsilon(2S),gamma; 0.181 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->Upsilon,gamma; 0.099 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->Upsilon_2(1D),gamma; 0.0236 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->omega,Upsilon; 0.0163 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->Upsilon_1(1D),gamma; 0.0097 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->chi_b1,pi+,pi-; 0.00607 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(2P)->chi_b1,pi0,pi0; 0.00303 1 /Herwig/Decays/DecayME0
 #
 # the 2^3P_2 multiplet
 #
 #
 decaymode chi_c2(2P)->D0,Dbar0; 0.5291 1 /Herwig/Decays/Tensor2PScalar
 decaymode chi_c2(2P)->D+,D-; 0.4709 1 /Herwig/Decays/Tensor2PScalar
 #
 decaymode chi_b2(2P)->g,g; 0.81157 1 /Herwig/Decays/QDecayME0
 decaymode chi_b2(2P)->Upsilon(2S),gamma; 0.089 1 /Herwig/Decays/TVV
 decaymode chi_b2(2P)->Upsilon,gamma; 0.066 1 /Herwig/Decays/TVV
 decaymode chi_b2(2P)->Upsilon_3(1D),gamma; 0.0142 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(2P)->omega,Upsilon; 0.011 1 /Herwig/Decays/TVV
 decaymode chi_b2(2P)->chi_b2,pi+,pi-; 0.0034 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(2P)->Upsilon_2(1D),gamma; 0.0029 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(2P)->chi_b2,pi0,pi0; 0.0017 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(2P)->Upsilon_1(1D),gamma; 0.00023 1 /Herwig/Decays/DecayME0
 #
 # the 2^1D_2 multiplet
 #
 #
 # the 2^3D_1 multiplet
 #
 #
 decaymode Upsilon_1(2D)->chi_b0(2P),gamma; 0.5381 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(2D)->chi_b1(2P),gamma; 0.2728 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(2D)->chi_b0,gamma; 0.1046 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(2D)->chi_b1,gamma; 0.0663 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(2D)->chi_b2(2P),gamma; 0.0144 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_1(2D)->chi_b2,gamma; 0.0038 1 /Herwig/Decays/DecayME0
 #
 # the 2^3D_2 multiplet
 #
 #
 decaymode Upsilon_2(2D)->chi_b1(2P),gamma; 0.6382 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_2(2D)->chi_b2(2P),gamma; 0.1721 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_2(2D)->chi_b1,gamma; 0.1461 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_2(2D)->chi_b2,gamma; 0.0436 1 /Herwig/Decays/DecayME0
 #
 # the 2^3D_3 multiplet
 #
 #
 decaymode Upsilon_3(2D)->chi_b2(2P),gamma; 0.8053 1 /Herwig/Decays/DecayME0
 decaymode Upsilon_3(2D)->chi_b2,gamma; 0.1947 1 /Herwig/Decays/DecayME0
 #
 # the 3^1S_0 multiplet
 #
 #
 decaymode eta_b(3S)->g,g; 0.9983 1 /Herwig/Decays/QDecayME0
 decaymode eta_b(3S)->h_b(2P),gamma; 0.0012 1 /Herwig/Decays/DecayME0
 decaymode eta_b(3S)->h_b,gamma; 0.0005 1 /Herwig/Decays/DecayME0
 #
 # the 3^3S_1 multiplet
 #
 #
 decaymode Upsilon(3S)->g,g,g; 0.357563 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon(3S)->chi_b2(2P),gamma; 0.131 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->chi_b1(2P),gamma; 0.126 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->chi_b0(2P),gamma; 0.059 1 /Herwig/Decays/VVSDecayer
 decaymode Upsilon(3S)->Upsilon(2S),gamma,gamma; 0.05 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->Upsilon,pi+,pi-; 0.0437 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(3S)->u,ubar; 0.029373 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(3S)->c,cbar; 0.029373 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(3S)->Upsilon(2S),pi+,pi-; 0.0282 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(3S)->e-,e+; 0.022029 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(3S)->mu-,mu+; 0.022029 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(3S)->Upsilon,pi0,pi0; 0.022 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(3S)->tau-,tau+; 0.02191 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(3S)->Upsilon(2S),pi0,pi0; 0.0185 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(3S)->chi_b2,gamma; 0.01 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->g,g,gamma; 0.0097 1 /Herwig/Decays/QDecayME130
 decaymode Upsilon(3S)->d,dbar; 0.007343 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(3S)->s,sbar; 0.007343 1 /Herwig/Decays/QDecayME0
 decaymode Upsilon(3S)->chi_b0,gamma; 0.0027 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->chi_b1,gamma; 0.0009 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->h_b,pi0; 0.000827 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(3S)->eta_b,gamma; 0.00051 1 /Herwig/Decays/DecayME0
 #
 # the 3^1P_1 multiplet
 #
 #
 # the 3^3P_0 multiplet
 #
 #
 decaymode chi_b0(3P)->g,g; 0.9773 1 /Herwig/Decays/QDecayME0
 decaymode chi_b0(3P)->Upsilon(3S),gamma; 0.0105 1 /Herwig/Decays/DecayME0
 decaymode chi_b0(3P)->Upsilon,gamma; 0.005 1 /Herwig/Decays/DecayME0
 decaymode chi_b0(3P)->Upsilon(2S),gamma; 0.0046 1 /Herwig/Decays/DecayME0
 decaymode chi_b0(3P)->Upsilon_1(2D),gamma; 0.0026 1 /Herwig/Decays/DecayME0
 #
 # the 3^3P_1 multiplet
 #
 #
 decaymode chi_b1(3P)->g,g; 0.6925 1 /Herwig/Decays/QDecayME0
 decaymode chi_b1(3P)->Upsilon(3S),gamma; 0.1531 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(3P)->Upsilon,gamma; 0.0559 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(3P)->Upsilon(2S),gamma; 0.054 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(3P)->Upsilon_2(2D),gamma; 0.0315 1 /Herwig/Decays/DecayME0
 decaymode chi_b1(3P)->Upsilon_1(2D),gamma; 0.013 1 /Herwig/Decays/DecayME0
 #
 # the 3^3P_2 multiplet
 #
 #
 decaymode chi_b2(3P)->g,g; 0.8404 1 /Herwig/Decays/QDecayME0
 decaymode chi_b2(3P)->Upsilon(3S),gamma; 0.0827 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(3P)->Upsilon,gamma; 0.026 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(3P)->Upsilon(2S),gamma; 0.0258 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(3P)->Upsilon_3(2D),gamma; 0.0206 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(3P)->Upsilon_2(2D),gamma; 0.0042 1 /Herwig/Decays/DecayME0
 decaymode chi_b2(3P)->Upsilon_1(2D),gamma; 0.0003 1 /Herwig/Decays/DecayME0
 #
 # the 4^3S_1 multiplet
 #
 #
 decaymode Upsilon(4S)->B+,B-; 0.510004 1 /Herwig/Decays/Vector2Meson
 decaymode Upsilon(4S)->B0,Bbar0; 0.487307 1 /Herwig/Decays/Vector2Meson
 decaymode Upsilon(4S)->h_b,eta; 0.00218 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(4S)->Upsilon,eta; 0.000181 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(4S)->Upsilon,pi+,pi-; 8.2E-5 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(4S)->Upsilon(2S),pi+,pi-; 8.2E-5 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(4S)->Upsilon,pi0,pi0; 4.1E-5 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(4S)->Upsilon(2S),pi0,pi0; 4.1E-5 1 /Herwig/Decays/OniumPiPi
 decaymode Upsilon(4S)->Upsilon,eta'; 3.4E-5 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(4S)->e-,e+; 1.6E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(4S)->mu-,mu+; 1.6E-5 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(4S)->tau-,tau+; 1.6E-5 1 /Herwig/Decays/Vector2Leptons
 #
 # the 5^3S_1 multiplet
 #
 #
 decaymode Upsilon(5S)->B*0,B*bar0; 0.184007 1 /Herwig/Decays/VectorVV
 decaymode Upsilon(5S)->B*+,B*-; 0.184007 1 /Herwig/Decays/VectorVV
 decaymode Upsilon(5S)->B_s*0,B_s*bar0; 0.179726 1 /Herwig/Decays/VectorVV
 decaymode Upsilon(5S)->B-,B*+; 0.050276 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->Bbar0,B*0; 0.050276 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->B0,B*bar0; 0.050276 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->B+,B*-; 0.050276 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->B0,Bbar0; 0.04927 1 /Herwig/Decays/Vector2Meson
 decaymode Upsilon(5S)->B+,B-; 0.04927 1 /Herwig/Decays/Vector2Meson
 decaymode Upsilon(5S)->B*-,B0,pi+; 0.012234 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B-,B*0,pi+; 0.012234 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B+,B*bar0,pi-; 0.012234 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*+,Bbar0,pi-; 0.012234 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon(2S),pi+,pi-; 0.0078 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B_sbar0,B_s*0; 0.006893 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->B_s0,B_s*bar0; 0.006893 1 /Herwig/Decays/VectorVP
 decaymode Upsilon(5S)->B0,B*bar0,pi0; 0.006117 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*0,Bbar0,pi0; 0.006117 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B+,B*-,pi0; 0.006117 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*+,B-,pi0; 0.006117 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->h_b(2P),pi+,pi-; 0.0057 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon,pi+,pi-; 0.0053 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B_s0,B_sbar0; 0.005106 1 /Herwig/Decays/Vector2Meson
 decaymode Upsilon(5S)->Upsilon_2(1D),eta; 0.0048 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon(3S),pi+,pi-; 0.0048 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon(2S),pi0,pi0; 0.0039 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->h_b,pi+,pi-; 0.0035 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*-,B*0,pi+; 0.003352 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*+,B*bar0,pi-; 0.003352 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->h_b(2P),pi0,pi0; 0.00285 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon,pi0,pi0; 0.00265 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon(3S),pi0,pi0; 0.0024 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->chi_b1,omega; 0.00185 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->h_b,pi0,pi0; 0.00175 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*0,B*bar0,pi0; 0.001676 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->B*+,B*-,pi0; 0.001676 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon,K0,Kbar0; 0.00061 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->Upsilon,K+,K-; 0.00061 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->chi_b2,pi+,pi-,pi0; 0.0006 1 /Herwig/Decays/Mambo
 decaymode Upsilon(5S)->chi_b2,omega; 0.0006 1 /Herwig/Decays/DecayME0
 decaymode Upsilon(5S)->chi_b1,pi+,pi-,pi0; 0.00052 1 /Herwig/Decays/Mambo
 decaymode Upsilon(5S)->e-,e+; 8.0E-6 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(5S)->mu-,mu+; 8.0E-6 1 /Herwig/Decays/Vector2Leptons
 decaymode Upsilon(5S)->tau-,tau+; 8.0E-6 1 /Herwig/Decays/Vector2Leptons
 #
 # The meson which are not part of a multiplet
 #
 #
 decaymode f_0(1500)->pi+,pi-; 0.232667 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->sigma,sigma; 0.127426 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->pi0,pi0; 0.116333 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->pi'-,pi+; 0.081683 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->pi'0,pi0; 0.081683 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->pi'+,pi-; 0.081683 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->eta,eta; 0.051 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->K0,Kbar0; 0.043 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->K+,K-; 0.043 1 /Herwig/Decays/ScalarSS
 decaymode f_0(1500)->rho+,rho-; 0.042475 1 /Herwig/Decays/SVV
 decaymode f_0(1500)->rho0,rho0; 0.021238 1 /Herwig/Decays/SVV
 decaymode f_0(1500)->a_1-,pi+; 0.019604 1 /Herwig/Decays/PPVDecayer
 decaymode f_0(1500)->a_10,pi0; 0.019604 1 /Herwig/Decays/PPVDecayer
 decaymode f_0(1500)->a_1+,pi-; 0.019604 1 /Herwig/Decays/PPVDecayer
 decaymode f_0(1500)->eta,eta'; 0.019 1 /Herwig/Decays/ScalarSS
 #
 decaymode sigma->pi+,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode sigma->pi0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode f_0->pi+,pi-; 0.493994 1 /Herwig/Decays/ScalarSS
 decaymode f_0->pi0,pi0; 0.247 1 /Herwig/Decays/ScalarSS
 decaymode f_0->K+,K-; 0.139 1 /Herwig/Decays/ScalarSS
 decaymode f_0->K0,Kbar0; 0.12 1 /Herwig/Decays/ScalarSS
 decaymode f_0->gamma,gamma; 6.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode a_00->eta,pi0; 0.906997 1 /Herwig/Decays/ScalarSS
 decaymode a_00->K+,K-; 0.049 1 /Herwig/Decays/ScalarSS
 decaymode a_00->K0,Kbar0; 0.044 1 /Herwig/Decays/ScalarSS
 decaymode a_00->gamma,gamma; 3.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode a_0+->eta,pi+; 0.907 1 /Herwig/Decays/ScalarSS
 decaymode a_0+->K+,Kbar0; 0.093 1 /Herwig/Decays/ScalarSS
 #
 decaymode a_0-->eta,pi-; 0.907 1 /Herwig/Decays/ScalarSS
 decaymode a_0-->K-,K0; 0.093 1 /Herwig/Decays/ScalarSS
 #
 decaymode eta(1405)->eta,sigma; 0.479845 1 /Herwig/Decays/ScalarSS
 decaymode eta(1405)->a_0-,pi+; 0.159949 1 /Herwig/Decays/ScalarSS
 decaymode eta(1405)->a_00,pi0; 0.159949 1 /Herwig/Decays/ScalarSS
 decaymode eta(1405)->a_0+,pi-; 0.159949 1 /Herwig/Decays/ScalarSS
 decaymode eta(1405)->K*-,K+; 0.010077 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1405)->K*bar0,K0; 0.010077 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1405)->K*0,Kbar0; 0.010077 1 /Herwig/Decays/PPVDecayer
 decaymode eta(1405)->K*+,K-; 0.010077 1 /Herwig/Decays/PPVDecayer
 #
 decaymode K_S0->pi+,pi-; 0.69224 1 /Herwig/Decays/DecayME0
 decaymode K_S0->pi0,pi0; 0.307006 1 /Herwig/Decays/DecayME0
 decaymode K_S0->pi-,e+,nu_e; 0.000352 1 /Herwig/Decays/DecayME101
 decaymode K_S0->pi+,e-,nu_ebar; 0.000352 1 /Herwig/Decays/DecayME101
 decaymode K_S0->pi+,pi-,e-,e+; 4.7E-5 1 /Herwig/Decays/Mambo
 decaymode K_S0->gamma,gamma; 3.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode K_L0->pi-,e+,nu_e; 0.202618 1 /Herwig/Decays/DecayME101
 decaymode K_L0->pi+,e-,nu_ebar; 0.202618 1 /Herwig/Decays/DecayME101
 decaymode K_L0->pi0,pi0,pi0; 0.195569 1 /Herwig/Decays/DecayME0
 decaymode K_L0->pi-,mu+,nu_mu; 0.135079 1 /Herwig/Decays/DecayME101
 decaymode K_L0->pi+,mu-,nu_mubar; 0.135079 1 /Herwig/Decays/DecayME101
 decaymode K_L0->pi+,pi-,pi0; 0.125581 1 /Herwig/Decays/DecayME0
 decaymode K_L0->pi+,pi-; 0.001976 1 /Herwig/Decays/DecayME0
 decaymode K_L0->pi0,pi0; 0.000869 1 /Herwig/Decays/DecayME0
 decaymode K_L0->gamma,gamma; 0.000548 1 /Herwig/Decays/DecayME0
 decaymode K_L0->pi0,pi-,e+,nu_e; 2.6E-5 1 /Herwig/Decays/Mambo
 decaymode K_L0->pi0,pi+,e-,nu_ebar; 2.6E-5 1 /Herwig/Decays/Mambo
 decaymode K_L0->e-,e+,gamma; 1.0E-5 1 /Herwig/Decays/DecayME0
 decaymode K_L0->pi0,gamma,gamma; 1.0E-6 1 /Herwig/Decays/DecayME0
 #
 decaymode kappa0->K+,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode kappa0->K0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode kappabar0->K-,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode kappabar0->Kbar0,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode kappa-->Kbar0,pi-; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode kappa-->K-,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
 #
 decaymode kappa+->K0,pi+; 0.666667 1 /Herwig/Decays/ScalarSS
 decaymode kappa+->K+,pi0; 0.333333 1 /Herwig/Decays/ScalarSS
diff --git a/src/defaults/mesons.in b/src/defaults/mesons.in
--- a/src/defaults/mesons.in
+++ b/src/defaults/mesons.in
@@ -1,880 +1,895 @@
 # -*- ThePEG-repository -*-
 
 #
 # file containing the particle data for the mesons
 #
 #
 # the 1^1S_0 multiplet
 #
 create ThePEG::ParticleData pi+
 setup pi+ 211 pi+ 0.13957039 2.5283740149914E-17 0 7804.5 3 0 1 1 
 create ThePEG::ParticleData pi0
 setup pi0 111 pi0 0.1349768 7.7994841897233E-9 0 2.53E-5 0 0 1 0 
 create ThePEG::ParticleData pi-
 setup pi- -211 pi- 0.13957039 2.5283740149914E-17 0 7804.5 -3 0 1 1 
 makeanti pi- pi+
 create ThePEG::ParticleData eta
 setup eta 221 eta 0.547862 1.31E-6 1.31E-5 0 0 0 1 0 
 create ThePEG::ParticleData eta'
 setup eta' 331 eta' 0.95778 0.000203 0.00203 0 0 0 1 0 
 create ThePEG::ParticleData eta_c
 setup eta_c 441 eta_c 2.9804 0.0255 0.255 0 0 0 1 0 
 create ThePEG::ParticleData eta_b
 setup eta_b 551 eta_b 9.3987 0.01 0.1 0 0 0 1 0 
 create ThePEG::ParticleData K+
 setup K+ 321 K+ 0.493677 5.3173524656427E-17 0 3711 3 0 1 1 
 create ThePEG::ParticleData K0
 setup K0 311 K0 0.497611 1.9732793663968E+24 0 9.99995E-38 0 0 1 0
 create ThePEG::ParticleData K-
 setup K- -321 K- 0.493677 5.3173524656427E-17 0 3711 -3 0 1 1 
 makeanti K- K+
 create ThePEG::ParticleData Kbar0
 setup Kbar0 -311 Kbar0 0.497611 1.9732793663968E+24 0 9.99995E-38 0 0 1 0
 makeanti Kbar0 K0
 create ThePEG::ParticleData D0
 setup D0 421 D0 1.86484 1.6042841463415E-12 0 0.123 0 0 1 0
 create ThePEG::ParticleData D+
 setup D+ 411 D+ 1.86966 6.3286385503528E-13 0 0.3118 3 0 1 0
 create ThePEG::ParticleData Dbar0
 setup Dbar0 -421 Dbar0 1.86484 1.6042841463415E-12 0 0.123 0 0 1 0
 makeanti Dbar0 D0
 create ThePEG::ParticleData D-
 setup D- -411 D- 1.86966 6.3286385503528E-13 0 0.3118 -3 0 1 0
 makeanti D- D+
 create ThePEG::ParticleData D_s+
 setup D_s+ 431 D_s+ 1.9682 1.315513E-12 0 0.15 3 0 1 0 
 create ThePEG::ParticleData D_s-
 setup D_s- -431 D_s- 1.9682 1.315513E-12 0 0.15 -3 0 1 0 
 makeanti D_s- D_s+
 create ThePEG::MixedParticleData B0
 setup B0 511 B0 5.27965 4.2897163043478E-13 0 0.46 0 0 1 0
 newdef B0:DeltaM 3.337134e-13*GeV
 newdef B0:DeltaGamma 0.*GeV
 newdef B0:PQMagnitude 1.
 newdef B0:PQPhase 1.
 newdef B0:ZMagnitude 0.
 newdef B0:ZPhase 0.
 create ThePEG::ParticleData B+
 setup B+ 521 B+ 5.27934 3.9386616766467E-13 0 0.501 3 0 1 0 
 create ThePEG::MixedParticleData Bbar0
 setup Bbar0 -511 Bbar0 5.27965 4.2897163043478E-13 0 0.46 0 0 1 0 
 makeanti Bbar0 B0
 newdef Bbar0:Synchronized 0
 newdef Bbar0:DeltaM 3.337134e-13*GeV
 newdef Bbar0:DeltaGamma 0.*GeV
 newdef Bbar0:PQMagnitude 1.
 newdef Bbar0:PQPhase 1.
 newdef Bbar0:ZMagnitude 0.
 newdef Bbar0:ZPhase 0.
 create ThePEG::ParticleData B-
 setup B- -521 B- 5.27934 3.9386616766467E-13 0 0.501 -3 0 1 0 
 makeanti B- B+
 newdef B-:Synchronized 0
 create ThePEG::MixedParticleData B_s0
 setup B_s0 531 B_s0 5.36688 4.5051815068493E-13 0 0.438 0 0 1 0 
 newdef B_s0:DeltaM 1.169642e-11*GeV
 newdef B_s0:DeltaGamma 6.676243e-14*GeV
 newdef B_s0:PQMagnitude 1.
 newdef B_s0:PQPhase 1.
 newdef B_s0:ZMagnitude 0.
 newdef B_s0:ZPhase 0.
 create ThePEG::MixedParticleData B_sbar0
 setup B_sbar0 -531 B_sbar0 5.36688 4.5051815068493E-13 0 0.438 0 0 1 0 
 makeanti B_sbar0 B_s0
 newdef B_sbar0:Synchronized 0
 newdef B_sbar0:DeltaM 1.169642e-11*GeV
 newdef B_sbar0:DeltaGamma 6.676243e-14*GeV
 newdef B_sbar0:PQMagnitude 1.
 newdef B_sbar0:PQPhase 1.
 newdef B_sbar0:ZMagnitude 0.
 newdef B_sbar0:ZPhase 0.
 create ThePEG::ParticleData B_c+
 setup B_c+ 541 B_c+ 6.286 1.4299054347826E-12 0 0.138 3 0 1 0 
 create ThePEG::ParticleData B_c-
 setup B_c- -541 B_c- 6.286 1.4299054347826E-12 0 0.138 -3 0 1 0 
 makeanti B_c- B_c+
 #
 # the 1^3S_1 multiplet
 #
 create ThePEG::ParticleData rho+
 setup rho+ 213 rho+ 0.77526 0.1491 0.45 0 3 0 3 0 
 newdef rho+:WidthLoCut 0.4
 newdef rho+:WidthUpCut 0.5
 create ThePEG::ParticleData rho0
 setup rho0 113 rho0 0.77526 0.1491 0.45 0 0 0 3 0 
 newdef rho0:WidthLoCut 0.4
 newdef rho0:WidthUpCut 0.5
 create ThePEG::ParticleData rho-
 setup rho- -213 rho- 0.77526 0.1491 0.45 0 -3 0 3 0 
 makeanti rho- rho+
 newdef rho-:WidthLoCut 0.4
 newdef rho-:WidthUpCut 0.5
 create ThePEG::ParticleData omega
 setup omega 223 omega 0.78266 0.00868 0.0868 0 0 0 3 0 
 create ThePEG::ParticleData phi
 setup phi 333 phi 1.019461 0.004249 0.036245 0 0 0 3 0 
 newdef phi:WidthLoCut 0.03
 newdef phi:WidthUpCut 0.04249
 create ThePEG::ParticleData Jpsi
 setup Jpsi 443 Jpsi 3.096916 9.34E-5 0.000934 0 0 0 3 0 
 create ThePEG::ParticleData Upsilon
 setup Upsilon 553 Upsilon 9.4603 5.4E-5 0.00054 0 0 0 3 0 
 create ThePEG::ParticleData K*+
 setup K*+ 323 K*+ 0.89167 0.0514 0.382 0 3 0 3 0 
 newdef K*+:WidthLoCut 0.25
 newdef K*+:WidthUpCut 0.514
 create ThePEG::ParticleData K*0
 setup K*0 313 K*0 0.89555 0.0473 0.3615 0 0 0 3 0 
 newdef K*0:WidthLoCut 0.25
 newdef K*0:WidthUpCut 0.473
 create ThePEG::ParticleData K*-
 setup K*- -323 K*- 0.89167 0.0514 0.382 0 -3 0 3 0 
 makeanti K*- K*+
 newdef K*-:WidthLoCut 0.25
 newdef K*-:WidthUpCut 0.514
 create ThePEG::ParticleData K*bar0
 setup K*bar0 -313 K*bar0 0.89555 0.0473 0.3615 0 0 0 3 0 
 makeanti K*bar0 K*0
 newdef K*bar0:WidthLoCut 0.25
 newdef K*bar0:WidthUpCut 0.473
 create ThePEG::ParticleData D*0
 setup D*0 423 D*0 2.00685 6.8E-5 0.00068 0 0 0 3 0 
 create ThePEG::ParticleData D*+
 setup D*+ 413 D*+ 2.01026 8.34E-5 0.000834 0 3 0 3 0 
 create ThePEG::ParticleData D*bar0
 setup D*bar0 -423 D*bar0 2.00685 6.8E-5 0.00068 0 0 0 3 0 
 makeanti D*bar0 D*0
 create ThePEG::ParticleData D*-
 setup D*- -413 D*- 2.01026 8.34E-5 0.000834 0 -3 0 3 0 
 makeanti D*- D*+
 create ThePEG::ParticleData D_s*+
 setup D_s*+ 433 D_s*+ 2.1122 4.4E-5 0.00044 0 3 0 3 0 
 create ThePEG::ParticleData D_s*-
 setup D_s*- -433 D_s*- 2.1122 4.4E-5 0.00044 0 -3 0 3 0 
 makeanti D_s*- D_s*+
 create ThePEG::ParticleData B*0
 setup B*0 513 B*0 5.3247 2.4E-7 2.4E-6 0 0 0 3 0 
 create ThePEG::ParticleData B*+
 setup B*+ 523 B*+ 5.3247 7.8E-7 7.8E-6 0 3 0 3 0 
 create ThePEG::ParticleData B*bar0
 setup B*bar0 -513 B*bar0 5.3247 2.4E-7 2.4E-6 0 0 0 3 0 
 makeanti B*bar0 B*0
 create ThePEG::ParticleData B*-
 setup B*- -523 B*- 5.3247 7.8E-7 7.8E-6 0 -3 0 3 0 
 makeanti B*- B*+
 create ThePEG::ParticleData B_s*0
 setup B_s*0 533 B_s*0 5.4154 1.5E-7 1.5E-6 0 0 0 3 0 
 create ThePEG::ParticleData B_s*bar0
 setup B_s*bar0 -533 B_s*bar0 5.4154 1.5E-7 1.5E-6 0 0 0 3 0 
 makeanti B_s*bar0 B_s*0
 create ThePEG::ParticleData B_c*+
 setup B_c*+ 543 B_c*+ 6.321 8.0E-8 8.0E-7 0 3 0 3 0 
 create ThePEG::ParticleData B_c*-
 setup B_c*- -543 B_c*- 6.321 8.0E-8 8.0E-7 0 -3 0 3 0 
 makeanti B_c*- B_c*+
 #
 # the 1^1P_1 multiplet
 #
 create ThePEG::ParticleData b_1+
 setup b_1+ 10213 b_1+ 1.2295 0.142 0.505 0 3 0 3 0 
 newdef b_1+:WidthLoCut 0.3
 newdef b_1+:WidthUpCut 0.71
 create ThePEG::ParticleData b_10
 setup b_10 10113 b_10 1.2295 0.142 0.505 0 0 0 3 0 
 newdef b_10:WidthLoCut 0.3
 newdef b_10:WidthUpCut 0.71
 create ThePEG::ParticleData b_1-
 setup b_1- -10213 b_1- 1.2295 0.142 0.505 0 -3 0 3 0 
 makeanti b_1- b_1+
 newdef b_1-:WidthLoCut 0.3
 newdef b_1-:WidthUpCut 0.71
 create ThePEG::ParticleData h_1
 setup h_1 10223 h_1 1.166 0.375 0.375 0 0 0 3 0 
 create ThePEG::ParticleData h'_1
 setup h'_1 10333 h'_1 1.416 0.09 0.18 0 0 0 3 0 
 create ThePEG::ParticleData h_c
 setup h_c 10443 h_c 3.52593 0.0009 0.009 0 0 0 3 0 
 create ThePEG::ParticleData h_b
 setup h_b 10553 h_b 9.8993 8.94E-5 0.000894 0 0 0 3 0 
 create ThePEG::ParticleData K_1+
 setup K_1+ 10323 K_1+ 1.272 0.09 0.18 0 3 0 3 0 
 newdef K_1+:VariableRatio 1
 create ThePEG::ParticleData K_10
 setup K_10 10313 K_10 1.272 0.09 0.18 0 0 0 3 0 
 newdef K_10:VariableRatio 1
 create ThePEG::ParticleData K_1-
 setup K_1- -10323 K_1- 1.272 0.09 0.18 0 -3 0 3 0 
 makeanti K_1- K_1+
 newdef K_1-:VariableRatio 1
 create ThePEG::ParticleData K_1bar0
 setup K_1bar0 -10313 K_1bar0 1.272 0.09 0.18 0 0 0 3 0 
 makeanti K_1bar0 K_10
 newdef K_1bar0:VariableRatio 1
 create ThePEG::ParticleData D_10
 setup D_10 10423 D_10 2.4221 0.0313 0.0939 0 0 0 3 0 
 create ThePEG::ParticleData D_1+
 setup D_1+ 10413 D_1+ 2.4221 0.0313 0.0939 0 3 0 3 0 
 create ThePEG::ParticleData D_1bar0
 setup D_1bar0 -10423 D_1bar0 2.4221 0.0313 0.0939 0 0 0 3 0 
 makeanti D_1bar0 D_10
 create ThePEG::ParticleData D_1-
 setup D_1- -10413 D_1- 2.4221 0.0313 0.0939 0 -3 0 3 0 
 makeanti D_1- D_1+
 create ThePEG::ParticleData D_s1+
 setup D_s1+ 10433 D_s1+ 2.53511 0.00092 0.0092 0 3 0 3 0 
 create ThePEG::ParticleData D_s1-
 setup D_s1- -10433 D_s1- 2.53511 0.00092 0.0092 0 -3 0 3 0 
 makeanti D_s1- D_s1+
 create ThePEG::ParticleData B_10
 setup B_10 10513 B_10 5.7261 0.0275 0.0825 0 0 0 3 0 
 create ThePEG::ParticleData B_1+
 setup B_1+ 10523 B_1+ 5.7259 0.031 0.093 0 3 0 3 0 
 create ThePEG::ParticleData B_1bar0
 setup B_1bar0 -10513 B_1bar0 5.7261 0.0275 0.0825 0 0 0 3 0 
 makeanti B_1bar0 B_10
 create ThePEG::ParticleData B_1-
 setup B_1- -10523 B_1- 5.7259 0.031 0.093 0 -3 0 3 0 
 makeanti B_1- B_1+
 create ThePEG::ParticleData B_s10
 setup B_s10 10533 B_s10 5.8287 0.0005 0.005 0 0 0 3 0 
 create ThePEG::ParticleData B_s1bar0
 setup B_s1bar0 -10533 B_s1bar0 5.8287 0.0005 0.005 0 0 0 3 0 
 makeanti B_s1bar0 B_s10
 create ThePEG::ParticleData B_c1+
 setup B_c1+ 10543 B_c1+ 6.743 7.3E-5 0.00073 0 3 0 3 0 
 create ThePEG::ParticleData B_c1-
 setup B_c1- -10543 B_c1- 6.743 7.3E-5 0.00073 0 -3 0 3 0 
 makeanti B_c1- B_c1+
 #
 # the 1^3P_0 multiplet
 #
 create ThePEG::ParticleData a'_0+
 setup a'_0+ 10211 a'_0+ 1.474 0.265 0.265 0 3 0 1 0 
 create ThePEG::ParticleData a'_00
 setup a'_00 10111 a'_00 1.474 0.265 0.265 0 0 0 1 0 
 create ThePEG::ParticleData a'_0-
 setup a'_0- -10211 a'_0- 1.474 0.265 0.265 0 -3 0 1 0 
 makeanti a'_0- a'_0+
 create ThePEG::ParticleData f'_0
 setup f'_0 10221 f'_0 1.395 0.275 0.275 0 0 0 1 0 
 create ThePEG::ParticleData f_0(1710)
 setup f_0(1710) 10331 f_0(1710) 1.718 0.137 0.411 0 0 0 1 0 
 create ThePEG::ParticleData chi_c0
 setup chi_c0 10441 chi_c0 3.41476 0.0104 0.104 0 0 0 1 0 
 create ThePEG::ParticleData chi_b0
 setup chi_b0 10551 chi_b0 9.85944 0.000817 0.00817 0 0 0 1 0 
 create ThePEG::ParticleData K*_0+
 setup K*_0+ 10321 K*_0+ 1.414 0.29 0.82 0 3 0 1 0 
 newdef K*_0+:WidthLoCut 0.77
 newdef K*_0+:WidthUpCut 0.87
 create ThePEG::ParticleData K*_00
 setup K*_00 10311 K*_00 1.414 0.29 0.82 0 0 0 1 0 
 newdef K*_00:WidthLoCut 0.77
 newdef K*_00:WidthUpCut 0.87
 create ThePEG::ParticleData K*_0-
 setup K*_0- -10321 K*_0- 1.414 0.29 0.82 0 -3 0 1 0 
 makeanti K*_0- K*_0+
 newdef K*_0-:WidthLoCut 0.77
 newdef K*_0-:WidthUpCut 0.87
 create ThePEG::ParticleData K*_0bar0
 setup K*_0bar0 -10311 K*_0bar0 1.414 0.29 0.82 0 0 0 1 0 
 makeanti K*_0bar0 K*_00
 newdef K*_0bar0:WidthLoCut 0.77
 newdef K*_0bar0:WidthUpCut 0.87
 create ThePEG::ParticleData D_0*+
 setup D_0*+ 10411 D_0*+ 2.343 0.229 0.458 0 3 0 1 0 
 newdef D_0*+:WidthLoCut 0.229
 newdef D_0*+:WidthUpCut 0.687
 create ThePEG::ParticleData D_0*0
 setup D_0*0 10421 D_0*0 2.343 0.229 0.458 0 0 0 1 0 
 newdef D_0*0:WidthLoCut 0.229
 newdef D_0*0:WidthUpCut 0.687
 create ThePEG::ParticleData D_0*-
 setup D_0*- -10411 D_0*- 2.343 0.229 0.458 0 -3 0 1 0 
 makeanti D_0*- D_0*+
 newdef D_0*-:WidthLoCut 0.229
 newdef D_0*-:WidthUpCut 0.687
 create ThePEG::ParticleData D_0*bar0
 setup D_0*bar0 -10421 D_0*bar0 2.343 0.229 0.458 0 0 0 1 0 
 makeanti D_0*bar0 D_0*0
 newdef D_0*bar0:WidthLoCut 0.229
 newdef D_0*bar0:WidthUpCut 0.687
 create ThePEG::ParticleData D_s0+
 setup D_s0+ 10431 D_s0+ 2.3173 2.32E-5 0.000232 0 3 0 1 0 
 create ThePEG::ParticleData D_s0-
 setup D_s0- -10431 D_s0- 2.3173 2.32E-5 0.000232 0 -3 0 1 0 
 makeanti D_s0- D_s0+
 create ThePEG::ParticleData B*_00
 setup B*_00 10511 B*_00 5.726 0.14 0.28 0 0 0 1 0 
 create ThePEG::ParticleData B*_0+
 setup B*_0+ 10521 B*_0+ 5.726 0.14 0.28 0 3 0 1 0 
 create ThePEG::ParticleData B*_0bar0
 setup B*_0bar0 -10511 B*_0bar0 5.726 0.14 0.28 0 0 0 1 0 
 makeanti B*_0bar0 B*_00
 create ThePEG::ParticleData B*_0-
 setup B*_0- -10521 B*_0- 5.726 0.14 0.28 0 -3 0 1 0 
 makeanti B*_0- B*_0+
 create ThePEG::ParticleData B*_s00
 setup B*_s00 10531 B*_s00 5.818 0.07 0.0875 0 0 0 1 0 
 newdef B*_s00:WidthLoCut 0.035
 newdef B*_s00:WidthUpCut 0.14
 create ThePEG::ParticleData B*_s0bar0
 setup B*_s0bar0 -10531 B*_s0bar0 5.818 0.07 0.0875 0 0 0 1 0 
 makeanti B*_s0bar0 B*_s00
 newdef B*_s0bar0:WidthLoCut 0.035
 newdef B*_s0bar0:WidthUpCut 0.14
 create ThePEG::ParticleData B*_c0+
 setup B*_c0+ 10541 B*_c0+ 6.727 5.5E-5 0.00055 0 3 0 1 0 
 create ThePEG::ParticleData B*_c0-
 setup B*_c0- -10541 B*_c0- 6.727 5.5E-5 0.00055 0 -3 0 1 0 
 makeanti B*_c0- B*_c0+
 #
 # the 1^3P_1 multiplet
 #
 create ThePEG::ParticleData a_1+
 setup a_1+ 20213 a_1+ 1.24 0.56 0.56 0 3 0 3 0 
 newdef a_1+:VariableRatio 1
 create ThePEG::ParticleData a_10
 setup a_10 20113 a_10 1.24 0.56 0.56 0 0 0 3 0 
 newdef a_10:VariableRatio 1
 create ThePEG::ParticleData a_1-
 setup a_1- -20213 a_1- 1.24 0.56 0.56 0 -3 0 3 0 
 makeanti a_1- a_1+
 newdef a_1-:VariableRatio 1
 create ThePEG::ParticleData f_1
 setup f_1 20223 f_1 1.2818 0.0242 0.242 0 0 0 3 0 
 create ThePEG::ParticleData f'_1
 setup f'_1 20333 f'_1 1.4263 0.0549 0.41175 0 0 0 3 0 
 newdef f'_1:WidthLoCut 0.2745
 newdef f'_1:WidthUpCut 0.549
 create ThePEG::ParticleData chi_c1
 setup chi_c1 20443 chi_c1 3.51066 0.00089 0.0089 0 0 0 3 0 
 create ThePEG::ParticleData chi_b1
 setup chi_b1 20553 chi_b1 9.89278 7.1E-5 0.00071 0 0 0 3 0 
 create ThePEG::ParticleData K'_1+
 setup K'_1+ 20323 K'_1+ 1.402 0.174 0.348 0 3 0 3 0 
 newdef K'_1+:VariableRatio 1
 create ThePEG::ParticleData K'_10
 setup K'_10 20313 K'_10 1.402 0.174 0.348 0 0 0 3 0 
 newdef K'_10:VariableRatio 1
 create ThePEG::ParticleData K'_1-
 setup K'_1- -20323 K'_1- 1.402 0.174 0.348 0 -3 0 3 0 
 makeanti K'_1- K'_1+
 newdef K'_1-:VariableRatio 1
 create ThePEG::ParticleData K'_1bar0
 setup K'_1bar0 -20313 K'_1bar0 1.402 0.174 0.348 0 0 0 3 0 
 makeanti K'_1bar0 K'_10
 newdef K'_1bar0:VariableRatio 1
 create ThePEG::ParticleData D'_10
 setup D'_10 20423 D'_10 2.438 0.329 0.454 0 0 0 3 0 
 newdef D'_10:WidthLoCut 0.25
 newdef D'_10:WidthUpCut 0.658
 create ThePEG::ParticleData D'_1+
 setup D'_1+ 20413 D'_1+ 2.438 0.329 0.454 0 3 0 3 0 
 newdef D'_1+:WidthLoCut 0.25
 newdef D'_1+:WidthUpCut 0.658
 create ThePEG::ParticleData D'_1bar0
 setup D'_1bar0 -20423 D'_1bar0 2.438 0.329 0.454 0 0 0 3 0 
 makeanti D'_1bar0 D'_10
 newdef D'_1bar0:WidthLoCut 0.25
 newdef D'_1bar0:WidthUpCut 0.658
 create ThePEG::ParticleData D'_1-
 setup D'_1- -20413 D'_1- 2.438 0.329 0.454 0 -3 0 3 0 
 makeanti D'_1- D'_1+
 newdef D'_1-:WidthLoCut 0.25
 newdef D'_1-:WidthUpCut 0.658
 create ThePEG::ParticleData D'_s1+
 setup D'_s1+ 20433 D'_s1+ 2.4595 3.82E-5 0.000382 0 3 0 3 0 
 create ThePEG::ParticleData D'_s1-
 setup D'_s1- -20433 D'_s1- 2.4595 3.82E-5 0.000382 0 -3 0 3 0 
 makeanti D'_s1- D'_s1+
 create ThePEG::ParticleData B'_10
 setup B'_10 20513 B'_10 5.762 0.13 0.26 0 0 0 3 0 
 create ThePEG::ParticleData B'_1+
 setup B'_1+ 20523 B'_1+ 5.762 0.13 0.26 0 3 0 3 0 
 create ThePEG::ParticleData B'_1bar0
 setup B'_1bar0 -20513 B'_1bar0 5.762 0.13 0.26 0 0 0 3 0 
 makeanti B'_1bar0 B'_10
 create ThePEG::ParticleData B'_1-
 setup B'_1- -20523 B'_1- 5.762 0.13 0.26 0 -3 0 3 0 
 makeanti B'_1- B'_1+
 create ThePEG::ParticleData B'_s10
 setup B'_s10 20533 B'_s10 5.856 0.06 0.075 0 0 0 3 0 
 newdef B'_s10:WidthLoCut 0.03
 newdef B'_s10:WidthUpCut 0.12
 create ThePEG::ParticleData B'_s1bar0
 setup B'_s1bar0 -20533 B'_s1bar0 5.856 0.06 0.075 0 0 0 3 0 
 makeanti B'_s1bar0 B'_s10
 newdef B'_s1bar0:WidthLoCut 0.03
 newdef B'_s1bar0:WidthUpCut 0.12
 create ThePEG::ParticleData B'_c1+
 setup B'_c1+ 20543 B'_c1+ 6.765 9.1E-5 0.00091 0 3 0 3 0 
 create ThePEG::ParticleData B'_c1-
 setup B'_c1- -20543 B'_c1- 6.765 9.1E-5 0.00091 0 -3 0 3 0 
 makeanti B'_c1- B'_c1+
 #
 # the 1^3P_2 multiplet
 #
 create ThePEG::ParticleData a_2+
 setup a_2+ 215 a_2+ 1.3183 0.107 0.214 0 3 0 5 0 
 create ThePEG::ParticleData a_20
 setup a_20 115 a_20 1.3183 0.107 0.214 0 0 0 5 0 
 create ThePEG::ParticleData a_2-
 setup a_2- -215 a_2- 1.3183 0.107 0.214 0 -3 0 5 0 
 makeanti a_2- a_2+
 create ThePEG::ParticleData f_2
 setup f_2 225 f_2 1.2754 0.1852 0.1801 0 0 0 5 0 
 newdef f_2:WidthLoCut 0.175
 newdef f_2:WidthUpCut 0.1852
 create ThePEG::ParticleData f'_2
 setup f'_2 335 f'_2 1.525 0.073 0.365 0 0 0 5 0 
 create ThePEG::ParticleData chi_c2
 setup chi_c2 445 chi_c2 3.5562 0.00206 0.0206 0 0 0 5 0 
 create ThePEG::ParticleData chi_b2
 setup chi_b2 555 chi_b2 9.91221 0.00017 0.0017 0 0 0 5 0 
 create ThePEG::ParticleData K*_2+
 setup K*_2+ 325 K*_2+ 1.4256 0.0985 0.197 0 3 0 5 0 
 create ThePEG::ParticleData K*_20
 setup K*_20 315 K*_20 1.4324 0.109 0.218 0 0 0 5 0 
 create ThePEG::ParticleData K*_2-
 setup K*_2- -325 K*_2- 1.4256 0.0985 0.197 0 -3 0 5 0 
 makeanti K*_2- K*_2+
 create ThePEG::ParticleData K*_2bar0
 setup K*_2bar0 -315 K*_2bar0 1.4324 0.109 0.218 0 0 0 5 0 
 makeanti K*_2bar0 K*_20
 create ThePEG::ParticleData D*_20
 setup D*_20 425 D*_20 2.4599 0.0473 0.2365 0 0 0 5 0 
 create ThePEG::ParticleData D*_2+
 setup D*_2+ 415 D*_2+ 2.4623 0.0473 0.2365 0 3 0 5 0 
 create ThePEG::ParticleData D*_2bar0
 setup D*_2bar0 -425 D*_2bar0 2.4599 0.0473 0.2365 0 0 0 5 0 
 makeanti D*_2bar0 D*_20
 create ThePEG::ParticleData D*_2-
 setup D*_2- -415 D*_2- 2.4623 0.0473 0.2365 0 -3 0 5 0 
 makeanti D*_2- D*_2+
 create ThePEG::ParticleData D_s2+
 setup D_s2+ 435 D_s2+ 2.5735 0.015 0.105 0 3 0 5 0 
 newdef D_s2+:WidthLoCut 0.06
 newdef D_s2+:WidthUpCut 0.15
 create ThePEG::ParticleData D_s2-
 setup D_s2- -435 D_s2- 2.5735 0.015 0.105 0 -3 0 5 0 
 makeanti D_s2- D_s2+
 newdef D_s2-:WidthLoCut 0.06
 newdef D_s2-:WidthUpCut 0.15
 create ThePEG::ParticleData B_20
 setup B_20 515 B_20 5.7468 0.01 0.1 0 0 0 5 0 
 create ThePEG::ParticleData B_2+
 setup B_2+ 525 B_2+ 5.7468 0.01 0.1 0 3 0 5 0 
 create ThePEG::ParticleData B_2bar0
 setup B_2bar0 -515 B_2bar0 5.7468 0.01 0.1 0 0 0 5 0 
 makeanti B_2bar0 B_20
 create ThePEG::ParticleData B_2-
 setup B_2- -525 B_2- 5.7468 0.01 0.1 0 -3 0 5 0 
 makeanti B_2- B_2+
 create ThePEG::ParticleData B_s20
 setup B_s20 535 B_s20 5.8396 0.0007 0.007 0 0 0 5 0 
 create ThePEG::ParticleData B_s2bar0
 setup B_s2bar0 -535 B_s2bar0 5.8396 0.0007 0.007 0 0 0 5 0 
 makeanti B_s2bar0 B_s20
 create ThePEG::ParticleData B_c2+
 setup B_c2+ 545 B_c2+ 6.783 8.3E-5 0.00083 0 3 0 5 0 
 create ThePEG::ParticleData B_c2-
 setup B_c2- -545 B_c2- 6.783 8.3E-5 0.00083 0 -3 0 5 0 
 makeanti B_c2- B_c2+
 #
 # the 1^1D_2 multiplet
 #
 create ThePEG::ParticleData pi_2+
 setup pi_2+ 10215 pi_2+ 1.6724 0.259 0.259 0 3 0 5 0 
 create ThePEG::ParticleData pi_20
 setup pi_20 10115 pi_20 1.6724 0.259 0.259 0 0 0 5 0 
 create ThePEG::ParticleData pi_2-
 setup pi_2- -10215 pi_2- 1.6724 0.259 0.259 0 -3 0 5 0 
 makeanti pi_2- pi_2+
 create ThePEG::ParticleData eta_2
 setup eta_2 10225 eta_2 1.617 0.181 0.362 0 0 0 5 0 
 create ThePEG::ParticleData eta'_2
 setup eta'_2 10335 eta'_2 1.842 0.225 0.225 0 0 0 5 0 
 create ThePEG::ParticleData eta_b2
 setup eta_b2 10555 eta_b2 10.158 3.2E-5 0.00032 0 0 0 5 0 
 create ThePEG::ParticleData K_2(1770)+
 setup K_2(1770)+ 10325 K_2(1770)+ 1.773 0.186 0.558 0 3 0 5 0 
 create ThePEG::ParticleData K_2(1770)0
 setup K_2(1770)0 10315 K_2(1770)0 1.773 0.186 0.558 0 0 0 5 0 
 create ThePEG::ParticleData K_2(1770)-
 setup K_2(1770)- -10325 K_2(1770)- 1.773 0.186 0.558 0 -3 0 5 0 
 makeanti K_2(1770)- K_2(1770)+
 create ThePEG::ParticleData K_2(1770)bar0
 setup K_2(1770)bar0 -10315 K_2(1770)bar0 1.773 0.186 0.558 0 0 0 5 0 
 makeanti K_2(1770)bar0 K_2(1770)0
 create ThePEG::ParticleData B_c2(L)+
 setup B_c2(L)+ 10545 B_c2(L)+ 7.036 8.3E-5 0.00083 0  3 0 5 0
 create ThePEG::ParticleData B_c2(L)-
 setup B_c2(L)- -10545 B_c2(L)- 7.036 8.3E-5 0.00083 0 -3 0 5 0
 makeanti B_c2(L)- B_c2(L)+
 #
 # the 1^3D_1 multiplet
 #
 create ThePEG::ParticleData rho''+
 setup rho''+ 30213 rho''+ 1.72 0.25 0.5 0 3 0 3 0 
 create ThePEG::ParticleData rho''0
 setup rho''0 30113 rho''0 1.72 0.25 0.5 0 0 0 3 0 
 create ThePEG::ParticleData rho''-
 setup rho''- -30213 rho''- 1.72 0.25 0.5 0 -3 0 3 0 
 makeanti rho''- rho''+
 create ThePEG::ParticleData omega''
 setup omega'' 30223 omega'' 1.67 0.315 0.63 0 0 0 3 0 
 create ThePEG::ParticleData psi(3770)
 setup psi(3770) 30443 psi(3770) 3.7711 0.023 0.1305 0 0 0 3 0 
 newdef psi(3770):WidthLoCut 0.031
 newdef psi(3770):WidthUpCut 0.23
 create ThePEG::ParticleData Upsilon_1(1D)
 setup Upsilon_1(1D) 30553 Upsilon_1(1D) 10.1551 3.56E-5 0.000356 0 0 0 3 0 
 create ThePEG::ParticleData K''*+
 setup K''*+ 30323 K''*+ 1.717 0.322 0.322 0 3 0 3 0 
 create ThePEG::ParticleData K''*0
 setup K''*0 30313 K''*0 1.717 0.322 0.322 0 0 0 3 0 
 create ThePEG::ParticleData K''*-
 setup K''*- -30323 K''*- 1.717 0.322 0.322 0 -3 0 3 0 
 makeanti K''*- K''*+
 create ThePEG::ParticleData K''*bar0
 setup K''*bar0 -30313 K''*bar0 1.717 0.322 0.322 0 0 0 3 0 
 makeanti K''*bar0 K''*0
+create ThePEG::ParticleData D_1*(2760)0
+setup D_1*(2760)0 30423 D_1*(2760)0 2.781 0.177 0.354 0 0 0 3 0 
+create ThePEG::ParticleData D_1*(2760)+
+setup D_1*(2760)+ 30413 D_1*(2760)+ 2.781 0.177 0.354 0 3 0 3 0 
+create ThePEG::ParticleData Dbar_1*(2760)0
+setup Dbar_1*(2760)0 -30423 Dbar_1*(2760)0 2.781 0.177 0.354 0 0 0 3 0 
+makeanti Dbar_1*(2760)0 D_1*(2760)0
+create ThePEG::ParticleData D_1*(2760)-
+setup D_1*(2760)- -30413 D_1*(2760)- 2.781 0.177 0.354 0 -3 0 3 0 
+makeanti D_1*(2760)- D_1*(2760)+
+create ThePEG::ParticleData D_s1*(2860)+
+setup D_s1*(2860)+ 30433 D_s1*(2860)+ 2.86 0.159 0.318 0 3 0 3 0 
+create ThePEG::ParticleData D_s1*(2860)-
+setup D_s1*(2860)- -30433 D_s1*(2860)- 2.86 0.159 0.318 0 -3 0 3 0 
+makeanti D_s1*(2860)- D_s1*(2860)+
 create ThePEG::ParticleData B_c(1D)*+
 setup B_c(1D)*+  30543 B_c(1D)*+ 7.028 0.0001 0.001 0  3 0 3 0
 create ThePEG::ParticleData B_c(1D)*-
 setup B_c(1D)*- -30543 B_c(1D)*- 7.028 0.0001 0.001 0 -3 0 3 0
 makeanti B_c(1D)*- B_c(1D)*+
 #
 # the 1^3D_2 multiplet
 #
 create ThePEG::ParticleData psi_2(1D)
 setup psi_2(1D) 20445 psi_2(1D) 3.8237 0.00074 0.0074 0 0 0 5 0
 create ThePEG::ParticleData Upsilon_2(1D)
 setup Upsilon_2(1D) 20555 Upsilon_2(1D) 10.1637 2.8E-5 0.00028 0 0 0 5 0 
 create ThePEG::ParticleData K_2(1820)+
 setup K_2(1820)+ 20325 K_2(1820)+ 1.816 0.276 0.552 0 3 0 5 0 
 create ThePEG::ParticleData K_2(1820)0
 setup K_2(1820)0 20315 K_2(1820)0 1.816 0.276 0.552 0 0 0 5 0 
 create ThePEG::ParticleData K_2(1820)-
 setup K_2(1820)- -20325 K_2(1820)- 1.816 0.276 0.552 0 -3 0 5 0 
 makeanti K_2(1820)- K_2(1820)+
 create ThePEG::ParticleData K_2(1820)bar0
 setup K_2(1820)bar0 -20315 K_2(1820)bar0 1.816 0.276 0.552 0 0 0 5 0 
 makeanti K_2(1820)bar0 K_2(1820)0
 create ThePEG::ParticleData D_2(2740)0
 setup D_2(2740)0 20425 D_2(2740)0 2.747 0.088 0.264 0 0 0 5 0 
 create ThePEG::ParticleData D_2(2740)+
 setup D_2(2740)+ 20415 D_2(2740)+ 2.747 0.088 0.264 0 3 0 5 0 
 create ThePEG::ParticleData Dbar_2(2740)0
 setup Dbar_2(2740)0 -20425 Dbar_2(2740)0 2.747 0.088 0.264 0 0 0 5 0 
 makeanti Dbar_2(2740)0 D_2(2740)0
 create ThePEG::ParticleData D_2(2740)-
 setup D_2(2740)- -20415 D_2(2740)- 2.747 0.088 0.264 0 -3 0 5 0 
 makeanti D_2(2740)- D_2(2740)+
 create ThePEG::ParticleData D_s2(2850)+
 setup D_s2(2850)+ 20435 D_s2(2850)+ 2.851 0.052 0.156 0 3 0 5 0 
 create ThePEG::ParticleData D_s2(2850)-
 setup D_s2(2850)- -20435 D_s2(2850)- 2.851 0.052 0.156 0 -3 0 5 0 
 makeanti D_s2(2850)- D_s2(2850)+
 create ThePEG::ParticleData B_c2(H)+
 setup B_c2(H)+ 20545 B_c2(H)+ 7.041 9.3E-5 0.00093 0  3 0 5 0
 create ThePEG::ParticleData B_c2(H)-
 setup B_c2(H)- -20545 B_c2(H)- 7.041 9.3E-5 0.00093 0 -3 0 5 0
 makeanti B_c2(H)- B_c2(H)+
 #
 # the 1^3D_3 multiplet
 #
 create ThePEG::ParticleData rho_3+
 setup rho_3+ 217 rho_3+ 1.6888 0.161 0.592 0 3 0 7 0 
 newdef rho_3+:WidthLoCut 0.54
 newdef rho_3+:WidthUpCut 0.644
 create ThePEG::ParticleData rho_30
 setup rho_30 117 rho_30 1.6888 0.161 0.592 0 0 0 7 0 
 newdef rho_30:WidthLoCut 0.54
 newdef rho_30:WidthUpCut 0.644
 create ThePEG::ParticleData rho_3-
 setup rho_3- -217 rho_3- 1.6888 0.161 0.592 0 -3 0 7 0 
 makeanti rho_3- rho_3+
 newdef rho_3-:WidthLoCut 0.54
 newdef rho_3-:WidthUpCut 0.644
 create ThePEG::ParticleData omega_3
 setup omega_3 227 omega_3 1.667 0.168 0.336 0 0 0 7 0 
 create ThePEG::ParticleData phi_3
 setup phi_3 337 phi_3 1.854 0.087 0.435 0 0 0 7 0 
 create ThePEG::ParticleData psi_3(1D)
 setup psi_3(1D) 447 psi_3(1D) 3.84271 0.0028 0.014 0 0 0 7 0
 create ThePEG::ParticleData Upsilon_3(1D)
 setup Upsilon_3(1D) 557 Upsilon_3(1D) 10.1651 2.55E-5 0.000255 0 0 0 7 0 
 create ThePEG::ParticleData K_3*+
 setup K_3*+ 327 K_3*+ 1.776 0.159 0.477 0 3 0 7 0 
 create ThePEG::ParticleData K_3*0
 setup K_3*0 317 K_3*0 1.776 0.159 0.477 0 0 0 7 0 
 create ThePEG::ParticleData K_3*-
 setup K_3*- -327 K_3*- 1.776 0.159 0.477 0 -3 0 7 0 
 makeanti K_3*- K_3*+
 create ThePEG::ParticleData K_3*bar0
 setup K_3*bar0 -317 K_3*bar0 1.776 0.159 0.477 0 0 0 7 0 
 makeanti K_3*bar0 K_3*0
 create ThePEG::ParticleData D_3*(2750)0
 setup D_3*(2750)0 427 D_3*(2750)0 2.7631 0.066 0.192 0 0 0 7 0 
 create ThePEG::ParticleData D_3*(2750)+
 setup D_3*(2750)+ 417 D_3*(2750)+ 2.7631 0.066 0.192 0 3 0 7 0 
 create ThePEG::ParticleData Dbar_3*(2750)0
 setup Dbar_3*(2750)0 -427 Dbar_3*(2750)0 2.7631 0.066 0.192 0 0 0 7 0 
 makeanti Dbar_3*(2750)0 D_3*(2750)0
 create ThePEG::ParticleData D_3*(2750)-
 setup D_3*(2750)- -417 D_3*(2750)- 2.7631 0.066 0.192 0 -3 0 7 0 
 makeanti D_3*(2750)- D_3*(2750)+
 create ThePEG::ParticleData D_s3*(2860)+
 setup D_s3*(2860)+ 437 D_s3*(2860)+ 2.8605 0.053 0.159 0 3 0 7 0 
 create ThePEG::ParticleData D_s3*(2860)-
 setup D_s3*(2860)- -437 D_s3*(2860)- 2.8605 0.053 0.159 0 -3 0 7 0 
 makeanti D_s3*(2860)- D_s3*(2860)+
 create ThePEG::ParticleData B_c3(1D)*+
 setup B_c3(1D)*+  547 B_c3(1D)*+ 7.045 0.0001 0.001 0  3 0 7 0
 create ThePEG::ParticleData B_c3(1D)*-
 setup B_c3(1D)*- -547 B_c3(1D)*- 7.045 0.0001 0.001 0 -3 0 7 0
 makeanti B_c3(1D)*- B_c3(1D)*+
 #
 # the 1^3F_4 multiplet
 #
 #
 # the 2^1S_0 multiplet
 #
 create ThePEG::ParticleData pi'+
 setup pi'+ 100211 pi'+ 1.3 0.4 0.4 0 3 0 1 0 
 create ThePEG::ParticleData pi'0
 setup pi'0 100111 pi'0 1.3 0.4 0.4 0 0 0 1 0 
 create ThePEG::ParticleData pi'-
 setup pi'- -100211 pi'- 1.3 0.4 0.4 0 -3 0 1 0 
 makeanti pi'- pi'+
 create ThePEG::ParticleData eta(1295)
 setup eta(1295) 100221 eta(1295) 1.294 0.055 0.395 0 0 0 1 0 
 newdef eta(1295):WidthLoCut 0.24
 newdef eta(1295):WidthUpCut 0.55
 create ThePEG::ParticleData eta(1475)
 setup eta(1475) 100331 eta(1475) 1.476 0.087 0.174 0 0 0 1 0 
 create ThePEG::ParticleData eta_c(2S)
 setup eta_c(2S) 100441 eta_c(2S) 3.6375 0.0113 0.113 0 0 0 1 0 
 create ThePEG::ParticleData eta_b(2S)
 setup eta_b(2S) 100551 eta_b(2S) 9.999 0.0041 0.041 0 0 0 1 0 
 create ThePEG::ParticleData K'+
 setup K'+ 100321 K'+ 1.46 0.26 0.26 0 3 0 1 0 
 create ThePEG::ParticleData K'0
 setup K'0 100311 K'0 1.46 0.26 0.26 0 0 0 1 0 
 create ThePEG::ParticleData K'-
 setup K'- -100321 K'- 1.46 0.26 0.26 0 -3 0 1 0 
 makeanti K'- K'+
 create ThePEG::ParticleData K'bar0
 setup K'bar0 -100311 K'bar0 1.46 0.26 0.26 0 0 0 1 0 
 makeanti K'bar0 K'0
 create ThePEG::ParticleData D_0(2550)0
 setup D_0(2550)0 100421 D_0(2550)0 2.549 0.165 0.33 0 0 0 1 0 
 create ThePEG::ParticleData D_0(2550)+
 setup D_0(2550)+ 100411 D_0(2550)+ 2.549 0.165 0.33 0 3 0 1 0 
 create ThePEG::ParticleData Dbar_0(2550)0
 setup Dbar_0(2550)0 -100421 Dbar_0(2550)0 2.549 0.165 0.33 0 0 0 1 0 
 makeanti Dbar_0(2550)0 D_0(2550)0
 create ThePEG::ParticleData D_0(2550)-
 setup D_0(2550)- -100411 D_0(2550)- 2.549 0.165 0.33 0 -3 0 1 0 
 makeanti D_0(2550)- D_0(2550)+
 create ThePEG::ParticleData D_s0(2590)+
 setup D_s0(2590)+ 100431 D_s0(2590)+ 2.591 0.089 0.267 0 3 0 1 0 
 create ThePEG::ParticleData D_s0(2590)-
 setup D_s0(2590)- -100431 D_s0(2590)- 2.591 0.089 0.267 0 -3 0 1 0 
 makeanti D_s0(2590)- D_s0(2590)+
 create ThePEG::ParticleData B_c(2S)+
 setup B_c(2S)+ 100541 B_c(2S)+ 6.8712 6.5E-5 0.00065 0  3 0 1 0
 create ThePEG::ParticleData B_c(2S)-
 setup B_c(2S)- -100541 B_c(2S)- 6.8712 6.5E-5 0.00065 0 -3 0 1 0
 makeanti B_c(2S)- B_c(2S)+
 #
 # the 2^3S_1 multiplet
 #
 create ThePEG::ParticleData rho'+
 setup rho'+ 100213 rho'+ 1.459 0.147 0.294 0 3 0 3 0 
 create ThePEG::ParticleData rho'0
 setup rho'0 100113 rho'0 1.459 0.147 0.294 0 0 0 3 0 
 create ThePEG::ParticleData rho'-
 setup rho'- -100213 rho'- 1.459 0.147 0.294 0 -3 0 3 0 
 makeanti rho'- rho'+
 create ThePEG::ParticleData omega'
 setup omega' 100223 omega' 1.425 0.215 0.3225 0 0 0 3 0 
 newdef omega':WidthLoCut 0.215
 newdef omega':WidthUpCut 0.43
 create ThePEG::ParticleData phi'
 setup phi' 100333 phi' 1.68 0.15 0.3 0 0 0 3 0 
 create ThePEG::ParticleData psi(2S)
 setup psi(2S) 100443 psi(2S) 3.686093 0.000337 0.00337 0 0 0 3 0 
 create ThePEG::ParticleData Upsilon(2S)
 setup Upsilon(2S) 100553 Upsilon(2S) 10.02326 3.198E-5 0.0003198 0 0 0 3 0 
 create ThePEG::ParticleData K'*+
 setup K'*+ 100323 K'*+ 1.414 0.232 0.464 0 3 0 3 0 
 create ThePEG::ParticleData K'*0
 setup K'*0 100313 K'*0 1.414 0.232 0.464 0 0 0 3 0 
 create ThePEG::ParticleData K'*-
 setup K'*- -100323 K'*- 1.414 0.232 0.464 0 -3 0 3 0 
 makeanti K'*- K'*+
 create ThePEG::ParticleData K'*bar0
 setup K'*bar0 -100313 K'*bar0 1.414 0.232 0.464 0 0 0 3 0 
 makeanti K'*bar0 K'*0
 create ThePEG::ParticleData D*1(2600)0
 setup D*1(2600)0 100423 D*1(2600)0 2.627 0.141 0.282 0 0 0 3 0 
 create ThePEG::ParticleData D*1(2600)+
 setup D*1(2600)+ 100413 D*1(2600)+ 2.627 0.141 0.282 0 3 0 3 0 
 create ThePEG::ParticleData Dbar*1(2600)0
 setup Dbar*1(2600)0 -100423 Dbar*1(2600)0 2.627 0.141 0.282 0 0 0 3 0 
 makeanti Dbar*1(2600)0 D*1(2600)0
 create ThePEG::ParticleData D*1(2600)-
 setup D*1(2600)- -100413 D*1(2600)- 2.627 0.141 0.282 0 -3 0 3 0 
 makeanti D*1(2600)- D*1(2600)+
 create ThePEG::ParticleData Ds*1(2700)+
 setup Ds*1(2700)+ 100433 Ds*1(2700)+ 2.714 0.122 0.244 0 3 0 3 0 
 create ThePEG::ParticleData Ds*1(2700)-
 setup Ds*1(2700)- -100433 Ds*1(2700)- 2.714 0.122 0.244 0 -3 0 3 0 
 makeanti Ds*1(2700)- Ds*1(2700)+
 create ThePEG::ParticleData B_c(2S)*+
 setup B_c(2S)*+  100543 B_c(2S)*+ 6.8752 7.2E-5 0.00072 0  3 0 3 0
 create ThePEG::ParticleData B_c(2S)*-
 setup B_c(2S)*- -100543 B_c(2S)*- 6.8752 7.2E-5 0.00072 0 -3 0 3 0
 makeanti B_c(2S)*- B_c(2S)*+
 #
 # the 2^1P_1 multiplet
 #
 create ThePEG::ParticleData h_b(2P)
 setup h_b(2P) 110553 h_b(2P) 10.2598 8.0E-5 0.0008 0 0 0 3 0 
 #
 # the 2^3P_0 multiplet
 #
 create ThePEG::ParticleData chi_b0(2P)
 setup chi_b0(2P) 110551 chi_b0(2P) 10.2325 0.000887 0.00887 0 0 0 1 0 
 #
 # the 2^3P_1 multiplet
 #
 create ThePEG::ParticleData chi_b1(2P)
 setup chi_b1(2P) 120553 chi_b1(2P) 10.25546 7.87E-5 0.000787 0 0 0 3 0 
 #
 # the 2^3P_2 multiplet
 #
 create ThePEG::ParticleData chi_c2(2P)
 setup chi_c2(2P) 100445 chi_c2(2P) 3.929 0.029 0.24 0 0 0 5 0 
 newdef chi_c2(2P):WidthLoCut 0.19
 newdef chi_c2(2P):WidthUpCut 0.29
 create ThePEG::ParticleData chi_b2(2P)
 setup chi_b2(2P) 100555 chi_b2(2P) 10.26865 0.0001847 0.001847 0 0 0 5 0 
 #
 # the 2^1D_2 multiplet
 #
 #
 # the 2^3D_1 multiplet
 #
 create ThePEG::ParticleData Upsilon_1(2D)
 setup Upsilon_1(2D) 130553 Upsilon_1(2D) 10.435 2.64E-5 0.000264 0 0 0 3 0 
 #
 # the 2^3D_2 multiplet
 #
 create ThePEG::ParticleData Upsilon_2(2D)
 setup Upsilon_2(2D) 120555 Upsilon_2(2D) 10.441 2.23E-5 0.000223 0 0 0 5 0 
 #
 # the 2^3D_3 multiplet
 #
 create ThePEG::ParticleData Upsilon_3(2D)
 setup Upsilon_3(2D) 100557 Upsilon_3(2D) 10.444 2.02E-5 0.000202 0 0 0 7 0 
 #
 # the 3^1S_0 multiplet
 #
 create ThePEG::ParticleData eta_b(3S)
 setup eta_b(3S) 200551 eta_b(3S) 10.337 0.0027 0.027 0 0 0 1 0 
 #
 # the 3^3S_1 multiplet
 #
 create ThePEG::ParticleData Upsilon(3S)
 setup Upsilon(3S) 200553 Upsilon(3S) 10.3552 2.032E-5 0.0002032 0 0 0 3 0 
 #
 # the 3^1P_1 multiplet
 #
 #
 # the 3^3P_0 multiplet
 #
 create ThePEG::ParticleData chi_b0(3P)
 setup chi_b0(3P) 210551 chi_b0(3P) 10.5007 0.00071 0.0071 0 0 0 1 0 
 #
 # the 3^3P_1 multiplet
 #
 create ThePEG::ParticleData chi_b1(3P)
 setup chi_b1(3P) 220553 chi_b1(3P) 10.5134 6.6E-5 0.00066 0 0 0 3 0 
 #
 # the 3^3P_2 multiplet
 #
 create ThePEG::ParticleData chi_b2(3P)
 setup chi_b2(3P) 200555 chi_b2(3P) 10.524 0.000146 0.00146 0 0 0 5 0 
 #
 # the 4^3S_1 multiplet
 #
 create ThePEG::ParticleData Upsilon(4S)
 setup Upsilon(4S) 300553 Upsilon(4S) 10.5794 0.0205 0.11275 0 0 0 3 0 
 newdef Upsilon(4S):WidthLoCut 0.0205
 newdef Upsilon(4S):WidthUpCut 0.205
 #
 # the 5^3S_1 multiplet
 #
 create ThePEG::ParticleData Upsilon(5S)
 setup Upsilon(5S) 9000553 Upsilon(5S) 10.8852 0.037 0.185 0 0 0 3 0 
 #
 # The meson which are not part of a multiplet
 #
 create ThePEG::ParticleData f_0(1500)
 setup f_0(1500) 9030221 f_0(1500) 1.507 0.109 0.327 0 0 0 1 0 
 newdef f_0(1500):VariableRatio 1
 create ThePEG::ParticleData sigma
 setup sigma 9000221 sigma 0.86 0.88 1.155 0 0 0 1 0 
 newdef sigma:WidthLoCut 0.55
 newdef sigma:WidthUpCut 1.76
 create ThePEG::ParticleData f_0
 setup f_0 9010221 f_0 0.965 0.1635 0.384 0 0 0 1 0 
 newdef f_0:VariableRatio 1
 newdef f_0:WidthLoCut 0.256
 newdef f_0:WidthUpCut 0.512
 create ThePEG::ParticleData a_00
 setup a_00 9000111 a_00 0.999 0.1778 0.4 0 0 0 1 0 
 newdef a_00:VariableRatio 1
 newdef a_00:WidthLoCut 0.24
 newdef a_00:WidthUpCut 0.56
 create ThePEG::ParticleData a_0+
 setup a_0+ 9000211 a_0+ 0.999 0.1778 0.4 0 3 0 1 0 
 newdef a_0+:VariableRatio 1
 newdef a_0+:WidthLoCut 0.24
 newdef a_0+:WidthUpCut 0.56
 create ThePEG::ParticleData a_0-
 setup a_0- -9000211 a_0- 0.999 0.1778 0.4 0 -3 0 1 0 
 makeanti a_0- a_0+
 newdef a_0-:VariableRatio 1
 newdef a_0-:WidthLoCut 0.24
 newdef a_0-:WidthUpCut 0.56
 create ThePEG::ParticleData eta(1405)
 setup eta(1405) 9020221 eta(1405) 1.4098 0.0511 0.38325 0 0 0 1 0 
 newdef eta(1405):WidthLoCut 0.2555
 newdef eta(1405):WidthUpCut 0.511
 create ThePEG::ParticleData K_S0
 setup K_S0 310 K_S0 0.497611 7.3514250055883E-15 0 26.842 0 0 1 0 
 create ThePEG::ParticleData K_L0
 setup K_L0 130 K_L0 0.497611 1.2871947162427E-17 0 15330 0 0 1 1 
 create ThePEG::ParticleData kappa0
 setup kappa0 9000311 kappa0 0.841 0.618 0.7215 0 0 0 1 0 
 newdef kappa0:WidthLoCut 0.207
 newdef kappa0:WidthUpCut 1.236
 create ThePEG::ParticleData kappabar0
 setup kappabar0 -9000311 kappabar0 0.841 0.618 0.7215 0 0 0 1 0 
 makeanti kappabar0 kappa0
 newdef kappabar0:WidthLoCut 0.207
 newdef kappabar0:WidthUpCut 1.236
 create ThePEG::ParticleData kappa-
 setup kappa- -9000321 kappa- 0.841 0.618 0.7215 0 -3 0 1 0 
 newdef kappa-:WidthLoCut 0.207
 newdef kappa-:WidthUpCut 1.236
 create ThePEG::ParticleData kappa+
 setup kappa+ 9000321 kappa+ 0.841 0.618 0.7215 0 3 0 1 0 
 makeanti kappa+ kappa-
 newdef kappa+:WidthLoCut 0.207
 newdef kappa+:WidthUpCut 1.236