Main Page | Namespace List | Class Hierarchy | Alphabetical List | Class List | Directories | File List | Namespace Members | Class Members | File Members | Related Pages

EvtVubHybrid Class Reference

#include <EvtVubHybrid.hh>

Inheritance diagram for EvtVubHybrid:

EvtDecayIncoherent EvtDecayBase List of all members.

Public Member Functions

void checkNArg (int a1, int a2=-1, int a3=-1, int a4=-1)
void checkNDaug (int d1, int d2=-1)
void checkQ ()
void checkSpinDaughter (int d1, EvtSpinType::spintype sp)
void checkSpinParent (EvtSpinType::spintype sp)
EvtDecayBaseclone ()
virtual void command (std::string cmd)
virtual std::string commandName ()
void decay (EvtParticle *p)
void disableCheckQ ()
 EvtVubHybrid ()
double getArg (int j)
double * getArgs ()
std::string * getArgsStr ()
std::string getArgStr (int j)
double getBranchingFraction ()
EvtId getDaug (int i)
EvtIdgetDaugs ()
int getDSum ()
std::string getModelName ()
void getName (std::string &name)
int getNArg ()
int getNDaug ()
EvtId getParentId ()
int getPHOTOS ()
double getProbMax (double prob)
double getWeight (double mX, double q2, double El)
void init ()
void initProbMax ()
int isDaughterSpinDensitySet (int daughter)
void makeDecay (EvtParticle *p)
virtual bool matchingDecay (const EvtDecayBase &other) const
void noProbMax ()
virtual int nRealDaughters ()
void printSummary ()
void readWeights (int startArg=0)
double resetProbMax (double prob)
void saveDecayInfo (EvtId ipar, int ndaug, EvtId *daug, int narg, std::vector< std::string > &args, std::string name, double brfr)
void setDaughterSpinDensity (int daughter)
void setPHOTOS ()
void setProbMax (double prbmx)
void setSummary ()
void setVerbose ()
int summary ()
int verbose ()
virtual ~EvtVubHybrid ()

Static Public Member Functions

void findMass (EvtParticle *p)
void findMasses (EvtParticle *p, int ndaugs, EvtId daugs[10], double masses[10])
double findMaxMass (EvtParticle *p)

Protected Member Functions

bool daugsDecayedByParentModel ()

Protected Attributes

bool _daugsDecayedByParentModel

Private Types

enum  { nParameters = 3, nVariables = 3 }

Private Member Functions

double findPFermi ()

Private Attributes

double _a
double _alphas
double * _bins_El
double * _bins_mX
double * _bins_q2
EvtVubdGamma_dGamma
double _dGMax
double _masscut
double _mb
int _nbins
int _nbins_El
int _nbins_mX
int _nbins_q2
bool _noHybrid
std::vector< double > _pf
bool _storeQplus
double * _weights

Member Enumeration Documentation

anonymous enum [private]
 

Enumeration values:
nParameters 
nVariables 
00068 { nParameters = 3, nVariables = 3 };


Constructor & Destructor Documentation

EvtVubHybrid::EvtVubHybrid  ) 
 

00052   : _noHybrid(false), _storeQplus(true),
00053     _mb(4.62), _a(2.27), _alphas(0.22), _dGMax(3.),
00054     _nbins_mX(0), _nbins_q2(0), _nbins_El(0), _nbins(0),
00055     _masscut(0.28), _bins_mX(0), _bins_q2(0), _bins_El(0),
00056     _weights(0), _dGamma(0)
00057 {}

EvtVubHybrid::~EvtVubHybrid  )  [virtual]
 

00059                             {
00060   delete _dGamma;
00061   delete [] _bins_mX;
00062   delete [] _bins_q2;
00063   delete [] _bins_El;
00064   delete [] _weights;
00065 
00066 }


Member Function Documentation

void EvtDecayBase::checkNArg int  a1,
int  a2 = -1,
int  a3 = -1,
int  a4 = -1
[inherited]
 

00483                                                            {
00484 
00485   if ( _narg != a1 && _narg != a2 && _narg != a3 && _narg != a4 ) {
00486     report(ERROR,"EvtGen") << _modelname.c_str() << " generator expected "<<endl;
00487     report(ERROR,"EvtGen") << a1<<endl;; 
00488     if ( a2>-1) {
00489       report(ERROR,"EvtGen") << " or " << a2<<endl; 
00490     }
00491     if ( a3>-1) {
00492       report(ERROR,"EvtGen") << " or " << a3<<endl; 
00493     }
00494     if ( a4>-1) {
00495       report(ERROR,"EvtGen") << " or " << a4<<endl; 
00496     }
00497     report(ERROR,"EvtGen") << " arguments but found:"<< _narg << endl;
00498     printSummary();
00499     report(ERROR,"EvtGen") << "Will terminate execution!"<<endl;
00500     ::abort();
00501 
00502   } 
00503 
00504 }

void EvtDecayBase::checkNDaug int  d1,
int  d2 = -1
[inherited]
 

00505                                            {
00506 
00507   if ( _ndaug != d1 && _ndaug != d2 ) {
00508     report(ERROR,"EvtGen") << _modelname.c_str() << " generator expected ";
00509     report(ERROR,"EvtGen") << d1; 
00510     if ( d2>-1) {
00511       report(ERROR,"EvtGen") << " or " << d2; 
00512     }
00513     report(ERROR,"EvtGen") << " daughters but found:"<< _ndaug << endl;
00514     printSummary();
00515     report(ERROR,"EvtGen") << "Will terminate execution!"<<endl;
00516     ::abort();
00517   } 
00518 
00519 }

void EvtDecayBase::checkQ  )  [inherited]
 

00035                           {
00036   int i;
00037   int q=0;
00038   int qpar;
00039 
00040   //If there are no daughters (jetset etc) then we do not
00041   //want to do this test.  Why?  Because sometimes the parent
00042   //will have a nonzero charge.
00043 
00044   if ( _ndaug != 0) {
00045     for(i=0; i<_ndaug; i++ ) {
00046       q += EvtPDL::chg3(_daug[i]);
00047     }
00048     qpar = EvtPDL::chg3(_parent);
00049 
00050     if ( q != qpar ) {
00051       report(ERROR,"EvtGen") <<_modelname.c_str()<< " generator expected "
00052                              << " charge to be conserved, found:"<<endl;
00053       report(ERROR,"EvtGen") << "Parent charge of "<<(qpar/3)<<endl;
00054       report(ERROR,"EvtGen") << "Sum of daughter charge of "<<(q/3)<<endl;
00055       report(ERROR,"EvtGen") << "The parent is "<< EvtPDL::name(_parent).c_str()<<endl;
00056       for(i=0; i<_ndaug; i++ ) {
00057       report(ERROR,"EvtGen") << "Daughter "<< EvtPDL::name(_daug[i]).c_str()<<endl;
00058       }
00059       report(ERROR,"EvtGen") << "Will terminate execution!"<<endl;
00060       
00061       ::abort();
00062     }
00063   }
00064 }

void EvtDecayBase::checkSpinDaughter int  d1,
EvtSpinType::spintype  sp
[inherited]
 

00534                                                                    {
00535 
00536   EvtSpinType::spintype parenttype = EvtPDL::getSpinType(getDaug(d1));
00537   if ( parenttype != sp ) {
00538     report(ERROR,"EvtGen") << _modelname.c_str() 
00539                            << " did not get the correct daughter spin d=" 
00540                            << d1 << endl;
00541     printSummary();
00542     report(ERROR,"EvtGen") << "Will terminate execution!"<<endl;
00543     ::abort();
00544   } 
00545 
00546 }

void EvtDecayBase::checkSpinParent EvtSpinType::spintype  sp  )  [inherited]
 

00521                                                          {
00522 
00523   EvtSpinType::spintype parenttype = EvtPDL::getSpinType(getParentId());
00524   if ( parenttype != sp ) {
00525     report(ERROR,"EvtGen") << _modelname.c_str() 
00526                            << " did not get the correct parent spin\n";
00527     printSummary();
00528     report(ERROR,"EvtGen") << "Will terminate execution!"<<endl;
00529     ::abort();
00530   } 
00531 
00532 }

EvtDecayBase * EvtVubHybrid::clone  )  [virtual]
 

Implements EvtDecayBase.

00074                                  {
00075 
00076   return new EvtVubHybrid;
00077 
00078 }

void EvtDecayBase::command std::string  cmd  )  [virtual, inherited]
 

Reimplemented in EvtJetSet, EvtLunda, EvtLundCharm, EvtPythia, and EvtTauola.

00132                                        {
00133   report(ERROR,"EvtGen") << "Should never call EvtDecayBase::command"<<endl;
00134   ::abort();
00135 }

std::string EvtDecayBase::commandName  )  [virtual, inherited]
 

Reimplemented in EvtJetSet, EvtLunda, EvtLundCharm, EvtPythia, and EvtTauola.

00129                                    {
00130   return std::string("");
00131 }

bool EvtDecayBase::daugsDecayedByParentModel  )  [inline, protected, inherited]
 

00111 {return _daugsDecayedByParentModel;}

void EvtVubHybrid::decay EvtParticle p  )  [virtual]
 

Implements EvtDecayBase.

00187                                         {
00188 
00189   int j;
00190   // B+ -> u-bar specflav l+ nu
00191   
00192   EvtParticle *xuhad, *lepton, *neutrino;
00193   EvtVector4R p4;
00194   // R. Faccini 21/02/03
00195   // move the reweighting up , before also shooting the fermi distribution
00196   double x,z,p2;
00197   double sh=0.0;
00198   double mB,ml,xlow,xhigh,qplus;
00199   double El=0.0;
00200   double Eh=0.0;
00201   double kplus;
00202   double q2, mX;
00203 
00204   const double lp2epsilon=-10;
00205   bool rew(true);
00206   while(rew){
00207     
00208     p->initializePhaseSpace(getNDaug(),getDaugs());
00209     
00210     xuhad=p->getDaug(0);
00211     lepton=p->getDaug(1);
00212     neutrino=p->getDaug(2);
00213     
00214     mB = p->mass();
00215     ml = lepton->mass();
00216     
00217     xlow = -_mb;
00218     xhigh = mB-_mb;    
00219     
00220     // Fermi motion does not need to be computed inside the
00221     // tryit loop as m_b in Gamma0 does not need to be replaced by (m_b+kplus).
00222     // The difference however should be of the Order (lambda/m_b)^2 which is
00223     // beyond the considered orders in the paper anyway ...
00224     
00225     // for alpha_S = 0 and a mass cut on X_u not all values of kplus are 
00226     // possible. The maximum value is mB/2-_mb + sqrt(mB^2/4-_masscut^2)
00227     kplus = 2*xhigh;
00228     
00229     while( kplus >= xhigh || kplus <= xlow 
00230            || (_alphas == 0 && kplus >= mB/2-_mb 
00231                + sqrt(mB*mB/4-_masscut*_masscut))) {
00232       kplus = findPFermi(); //_pFermi->shoot();
00233       kplus = xlow + kplus*(xhigh-xlow);
00234     }
00235     qplus = mB-_mb-kplus;
00236     if( (mB-qplus)/2.<=ml) continue;
00237    
00238     int tryit = 1;
00239     while (tryit) {
00240       
00241       x = EvtRandom::Flat();
00242       z = EvtRandom::Flat(0,2);
00243       p2=EvtRandom::Flat();
00244       p2 = pow(10,lp2epsilon*p2);
00245       
00246       El = x*(mB-qplus)/2;
00247       if ( El > ml && El < mB/2) {
00248         
00249         Eh = z*(mB-qplus)/2+qplus;
00250         if ( Eh > 0 && Eh < mB ) {
00251           
00252           sh = p2*pow(mB-qplus,2)+2*qplus*(Eh-qplus)+qplus*qplus;
00253           if ( sh > _masscut*_masscut
00254                && mB*mB + sh - 2*mB*Eh > ml*ml) {
00255             
00256             double xran = EvtRandom::Flat();
00257             
00258             double y = _dGamma->getdGdxdzdp(x,z,p2)/_dGMax*p2;
00259             
00260             if ( y > 1 ) report(WARNING,"EvtVubHybrid")
00261               <<"EvtVubHybrid decay probability > 1 found: " << y << endl;
00262             if ( y >= xran ) tryit = 0;
00263           }
00264         }
00265       }
00266     }
00267 
00268     // compute all kinematic variables needed for reweighting (J. Dingfelder)
00269     mX = sqrt(sh);
00270     q2 = mB*mB + sh - 2*mB*Eh;
00271 
00272     // Reweighting in bins of mX, q2, El (J. Dingfelder)
00273     if (_nbins>0) {
00274       double xran1 = EvtRandom::Flat();
00275       double w = 1.0;
00276       if (!_noHybrid) w = getWeight(mX, q2, El); 
00277       if ( w >= xran1 ) rew = false;
00278     } 
00279     else {
00280       rew = false;
00281     }
00282   }
00283 
00284   // o.k. we have the three kineamtic variables 
00285   // now calculate a flat cos Theta_H [-1,1] distribution of the 
00286   // hadron flight direction w.r.t the B flight direction 
00287   // because the B is a scalar and should decay isotropic.
00288   // Then chose a flat Phi_H [0,2Pi] w.r.t the B flight direction 
00289   // and and a flat Phi_L [0,2Pi] in the W restframe w.r.t the 
00290   // W flight direction.
00291 
00292   double ctH = EvtRandom::Flat(-1,1);
00293   double phH = EvtRandom::Flat(0,2*M_PI);
00294   double phL = EvtRandom::Flat(0,2*M_PI);
00295 
00296   // now compute the four vectors in the B Meson restframe
00297     
00298   double ptmp,sttmp;
00299   // calculate the hadron 4 vector in the B Meson restframe
00300 
00301   sttmp = sqrt(1-ctH*ctH);
00302   ptmp = sqrt(Eh*Eh-sh);
00303   double pHB[4] = {Eh,ptmp*sttmp*cos(phH),ptmp*sttmp*sin(phH),ptmp*ctH};
00304   p4.set(pHB[0],pHB[1],pHB[2],pHB[3]);
00305   xuhad->init( getDaug(0), p4);
00306 
00307   if (_storeQplus ) {
00308     // cludge to store the hidden parameter q+ with the decay; 
00309     // the lifetime of the Xu is abused for this purpose.
00310     // tau = 1 ps corresponds to ctau = 0.3 mm -> in order to
00311     // stay well below BaBars sensitivity we take q+/(10000 GeV) which 
00312     // goes up to 0.0005 in the most extreme cases as ctau in mm.
00313     // To extract q+ back from the StdHepTrk its necessary to get
00314     // delta_ctau = Xu->anyDaughter->getVertexTime()-Xu->getVertexTime()
00315     // where these pseudo calls refere to the StdHep time stored at
00316     // the production vertex in the lab for each particle. The boost 
00317     // has to be reversed and the result is:
00318     //
00319     // q+ = delta_ctau * 10000 GeV/mm * Mass_Xu/Energy_Xu     
00320     //
00321     xuhad->setLifetime(qplus/10000.);
00322   }
00323 
00324   // calculate the W 4 vector in the B Meson restrframe
00325 
00326   double apWB = ptmp;
00327   double pWB[4] = {mB-Eh,-pHB[1],-pHB[2],-pHB[3]};
00328 
00329   // first go in the W restframe and calculate the lepton and
00330   // the neutrino in the W frame
00331 
00332   double mW2   = mB*mB + sh - 2*mB*Eh;
00333   double beta  = ptmp/pWB[0];
00334   double gamma = pWB[0]/sqrt(mW2);
00335 
00336   double pLW[4];
00337     
00338   ptmp = (mW2-ml*ml)/2/sqrt(mW2);
00339   pLW[0] = sqrt(ml*ml + ptmp*ptmp);
00340 
00341   double ctL = (El - gamma*pLW[0])/beta/gamma/ptmp;
00342   if ( ctL < -1 ) ctL = -1;
00343   if ( ctL >  1 ) ctL =  1;
00344   sttmp = sqrt(1-ctL*ctL);
00345 
00346   // eX' = eZ x eW
00347   double xW[3] = {-pWB[2],pWB[1],0};
00348   // eZ' = eW
00349   double zW[3] = {pWB[1]/apWB,pWB[2]/apWB,pWB[3]/apWB};
00350   
00351   double lx = sqrt(xW[0]*xW[0]+xW[1]*xW[1]);
00352   for (j=0;j<2;j++) 
00353     xW[j] /= lx;
00354 
00355   // eY' = eZ' x eX'
00356   double yW[3] = {-pWB[1]*pWB[3],-pWB[2]*pWB[3],pWB[1]*pWB[1]+pWB[2]*pWB[2]};
00357   double ly = sqrt(yW[0]*yW[0]+yW[1]*yW[1]+yW[2]*yW[2]);
00358   for (j=0;j<3;j++) 
00359     yW[j] /= ly;
00360 
00361   // p_lep = |p_lep| * (  sin(Theta) * cos(Phi) * eX'
00362   //                    + sin(Theta) * sin(Phi) * eY'
00363   //                    + cos(Theta) *            eZ')
00364   for (j=0;j<3;j++)
00365     pLW[j+1] = sttmp*cos(phL)*ptmp*xW[j] 
00366       +        sttmp*sin(phL)*ptmp*yW[j]
00367       +          ctL         *ptmp*zW[j];
00368 
00369   double apLW = ptmp;
00370   // calculate the neutrino 4 vector in the W restframe
00371   //double pNW[4] = {sqrt(mW2)-pLW[0],-pLW[1],-pLW[2],-pLW[3]};
00372     
00373   // boost them back in the B Meson restframe
00374   
00375   double appLB = beta*gamma*pLW[0] + gamma*ctL*apLW;
00376  
00377   ptmp = sqrt(El*El-ml*ml);
00378   double ctLL = appLB/ptmp;
00379 
00380   if ( ctLL >  1 ) ctLL =  1;
00381   if ( ctLL < -1 ) ctLL = -1;
00382     
00383   double pLB[4] = {El,0,0,0};
00384   double pNB[4] = {pWB[0]-El,0,0,0};
00385 
00386   for (j=1;j<4;j++) {
00387     pLB[j] = pLW[j] + (ctLL*ptmp - ctL*apLW)/apWB*pWB[j];
00388     pNB[j] = pWB[j] - pLB[j];
00389   }
00390 
00391   p4.set(pLB[0],pLB[1],pLB[2],pLB[3]);
00392   lepton->init( getDaug(1), p4);
00393 
00394   p4.set(pNB[0],pNB[1],pNB[2],pNB[3]);
00395   neutrino->init( getDaug(2), p4);
00396 
00397   return ;
00398 }

void EvtDecayBase::disableCheckQ  )  [inline, inherited]
 

00062 {_chkCharge=0;};

void EvtDecayBase::findMass EvtParticle p  )  [static, inherited]
 

00347                                           {
00348 
00349   //Need to also check that this mass does not screw
00350   //up the parent
00351   //This code assumes that for the ith daughter, 0..i-1
00352   //already have a mass
00353   double maxOkMass=findMaxMass(p);
00354 
00355   int count=0;
00356   double mass;
00357   bool massOk=false;
00358   int i;
00359   while (!massOk) { 
00360     count++;
00361     if ( count > 10000 ) {
00362       report(INFO,"EvtGen") << "Can not find a valid mass for: " << EvtPDL::name(p->getId()).c_str() <<endl;
00363       report(INFO,"EvtGen") << "Now printing parent and/or grandparent tree\n";
00364       if ( p->getParent() ) {
00365         if ( p->getParent()->getParent() ) {
00366           p->getParent()->getParent()->printTree();
00367           report(INFO,"EvtGen") << p->getParent()->getParent()->mass() <<endl;
00368           report(INFO,"EvtGen") << p->getParent()->mass() <<endl;
00369         }
00370         else{
00371           p->getParent()->printTree();
00372           report(INFO,"EvtGen") << p->getParent()->mass() <<endl;
00373         }
00374       }
00375       else  p->printTree();
00376       report(INFO,"EvtGen") << "maxokmass=" << maxOkMass << " " << EvtPDL::getMinMass(p->getId()) << " " << EvtPDL::getMaxMass(p->getId())<<endl;
00377       if ( p->getNDaug() ) { 
00378         for (i=0; i<p->getNDaug(); i++) {
00379           report(INFO,"EvtGen") << p->getDaug(i)->mass()<<" ";
00380         }
00381         report(INFO,"EvtGen") << endl;
00382       }
00383       if ( maxOkMass >= EvtPDL::getMinMass(p->getId()) ) {
00384         report(INFO,"EvtGen") << "taking a default value\n";
00385         p->setMass(maxOkMass);
00386         return;
00387       } 
00388       assert(0);
00389     }
00390     mass = EvtPDL::getMass(p->getId());
00391     //Just need to check that this mass is > than
00392     //the mass of all daughters
00393     double massSum=0.;
00394     if ( p->getNDaug() ) { 
00395       for (i=0; i<p->getNDaug(); i++) {
00396         massSum+= p->getDaug(i)->mass();
00397       }
00398     }
00399     //some special cases are handled with 0 (stable) or 1 (k0->ks/kl) daughters
00400     if (p->getNDaug()<2)  massOk=true;
00401     if ( p->getParent() ) {
00402       if ( p->getParent()->getNDaug()==1 ) massOk=true;
00403     }
00404     if ( !massOk ) { 
00405       if (massSum < mass) massOk=true;
00406       if ( mass> maxOkMass) massOk=false;
00407     }
00408   }
00409 
00410   p->setMass(mass);
00411   
00412 }

void EvtDecayBase::findMasses EvtParticle p,
int  ndaugs,
EvtId  daugs[10],
double  masses[10]
[static, inherited]
 

00416                                                                      {
00417 
00418   int i;
00419   double mass_sum;
00420 
00421   int count=0;
00422 
00423   if (!( p->firstornot() )) {
00424     for (i = 0; i < ndaugs; i++ ) {
00425       masses[i] = p->getDaug(i)->mass();
00426     } //for
00427   } //if
00428   else {
00429     p->setFirstOrNot();
00430     // if only one daughter do it
00431 
00432     if (ndaugs==1) {
00433       masses[0]=p->mass();
00434       return;
00435     }
00436     
00437     //until we get a combo whose masses are less than _parent mass.
00438     do {
00439       mass_sum = 0.0;
00440 
00441       for (i = 0; i < ndaugs; i++ ) {
00442         masses[i] = EvtPDL::getMass(daugs[i]);
00443         mass_sum = mass_sum + masses[i];
00444       } 
00445 
00446       count++;
00447 
00448      
00449       if(count==10000) {
00450         report(ERROR,"EvtGen") <<"Decaying particle:"<<
00451           EvtPDL::name(p->getId()).c_str()<<" (m="<<p->mass()<<")"<<endl;
00452         report(ERROR,"EvtGen") <<"To the following daugthers"<<endl;
00453         for (i = 0; i < ndaugs; i++ ) {
00454           report(ERROR,"EvtGen") <<  
00455             EvtPDL::name(daugs[i]).c_str() << endl;
00456         } 
00457         report(ERROR,"EvtGen") << "Has been rejected "<<count
00458                                << " times, will now take minimal masses "
00459                                << " of daugthers"<<endl;
00460         
00461         mass_sum=0.;
00462         for (i = 0; i < ndaugs; i++ ) {
00463           masses[i] = EvtPDL::getMinMass(daugs[i]);
00464           mass_sum = mass_sum + masses[i];
00465         } 
00466         if (mass_sum > p->mass()){
00467           report(ERROR,"EvtGen") << "Parent mass="<<p->mass()
00468                                  << "to light for daugthers."<<endl
00469                                  << "Will throw the event away."<<endl;
00470           //dont terminate - start over on the event.
00471           EvtStatus::setRejectFlag();
00472           mass_sum=0.;
00473           //      ::abort();
00474         }
00475 
00476       }
00477     } while ( mass_sum > p->mass());
00478   } //else
00479   
00480   return;
00481 }       

double EvtDecayBase::findMaxMass EvtParticle p  )  [static, inherited]
 

00312                                                {
00313 
00314   
00315   double maxOkMass=EvtPDL::getMaxMass(p->getId());
00316 
00317   //protect against vphotons
00318   if ( maxOkMass < 0.0000000001 ) return 10000000.;
00319   //and against already determined masses
00320   if ( p->hasValidP4() ) maxOkMass=p->mass();
00321 
00322   EvtParticle *par=p->getParent();
00323   if ( par ) {
00324     double maxParMass=findMaxMass(par);
00325     int i;
00326     double minDaugMass=0.;
00327     for(i=0;i<par->getNDaug();i++){
00328       EvtParticle *dau=par->getDaug(i);
00329       if ( dau!=p) {
00330         // it might already have a mass
00331         if ( dau->isInitialized() || dau->hasValidP4() )
00332           minDaugMass+=dau->mass();
00333         else
00334         //give it a bit of phase space 
00335           minDaugMass+=1.000001*EvtPDL::getMinMass(dau->getId());
00336       }
00337     }
00338     if ( maxOkMass>(maxParMass-minDaugMass)) maxOkMass=maxParMass-minDaugMass;
00339   }
00340   return maxOkMass;
00341 }

double EvtVubHybrid::findPFermi  )  [private]
 

00401                                 {
00402 
00403   double ranNum=EvtRandom::Flat();
00404   double oOverBins= 1.0/(float(_pf.size()));
00405   int nBinsBelow = 0;     // largest k such that I[k] is known to be <= rand
00406   int nBinsAbove = _pf.size();  // largest k such that I[k] is known to be >  rand
00407   int middle;
00408   
00409   while (nBinsAbove > nBinsBelow+1) {
00410     middle = (nBinsAbove + nBinsBelow+1)>>1;
00411     if (ranNum >= _pf[middle]) {
00412       nBinsBelow = middle;
00413     } else {
00414       nBinsAbove = middle;
00415     }
00416   } 
00417 
00418   double bSize = _pf[nBinsAbove] - _pf[nBinsBelow];
00419   // binMeasure is always aProbFunc[nBinsBelow], 
00420   
00421   if ( bSize == 0 ) { 
00422     // rand lies right in a bin of measure 0.  Simply return the center
00423     // of the range of that bin.  (Any value between k/N and (k+1)/N is 
00424     // equally good, in this rare case.)
00425     return (nBinsBelow + .5) * oOverBins;
00426   }
00427   
00428   HepDouble bFract = (ranNum - _pf[nBinsBelow]) / bSize;
00429   
00430   return (nBinsBelow + bFract) * oOverBins;
00431 
00432 } 

double EvtDecayBase::getArg int  j  )  [inherited]
 

00565                                  {
00566 
00567   // Verify string
00568 
00569   const char* str = _args[j].c_str();
00570   int i = 0;
00571   while(str[i]!=0){
00572     if (isalpha(str[i]) && str[i]!='e') {
00573 
00574       report(INFO,"EvtGen") << "String " << str << " is not a number" << endl;
00575       assert(0);
00576     }
00577     i++;
00578   }
00579   
00580   char** tc=0; 
00581   return strtod(_args[j].c_str(),tc);
00582 }

double * EvtDecayBase::getArgs  )  [inherited]
 

00548                               {
00549 
00550   if ( _argsD ) return _argsD;
00551   //The user has asked for a list of doubles - the arguments 
00552   //better all be doubles...
00553   if ( _narg==0 ) return _argsD;
00554 
00555   _argsD = new double[_narg];
00556 
00557   int i;
00558   char * tc;
00559   for(i=0;i<_narg;i++) { 
00560     _argsD[i] =  strtod(_args[i].c_str(),&tc);
00561   }
00562   return _argsD;
00563 }

std::string* EvtDecayBase::getArgsStr  )  [inline, inherited]
 

00073 {return _args;}

std::string EvtDecayBase::getArgStr int  j  )  [inline, inherited]
 

00075 {return _args[j];}

double EvtDecayBase::getBranchingFraction  )  [inline, inherited]
 

00061 {return _brfr;}

EvtId EvtDecayBase::getDaug int  i  )  [inline, inherited]
 

00066 {return _daug[i];}

EvtId* EvtDecayBase::getDaugs  )  [inline, inherited]
 

00065 {return _daug;}

int EvtDecayBase::getDSum  )  [inline, inherited]
 

00077 {return _dsum; }

std::string EvtDecayBase::getModelName  )  [inline, inherited]
 

00076 {return _modelname; }

void EvtVubHybrid::getName std::string &  name  )  [virtual]
 

Implements EvtDecayBase.

00068                                                {
00069 
00070   model_name="VUBHYBRID";     
00071 
00072 }

int EvtDecayBase::getNArg  )  [inline, inherited]
 

00067 {return _narg;}

int EvtDecayBase::getNDaug  )  [inline, inherited]
 

00064 {return _ndaug;}

EvtId EvtDecayBase::getParentId  )  [inline, inherited]
 

00060 {return _parent;}

int EvtDecayBase::getPHOTOS  )  [inline, inherited]
 

00068 {return _photos;}

double EvtDecayBase::getProbMax double  prob  )  [inherited]
 

00067                                              {
00068 
00069   int i;
00070 
00071   //diagnostics
00072   sum_prob+=prob;
00073   if (prob>max_prob) max_prob=prob;
00074 
00075 
00076   if ( defaultprobmax && ntimes_prob<=500 ) { 
00077     //We are building up probmax with this iteration
00078      ntimes_prob += 1;
00079      if ( prob > probmax ) { probmax = prob;}
00080      if (ntimes_prob==500) { 
00081        probmax*=1.2;
00082      }
00083      return 1000000.0*prob;
00084   }
00085 
00086   if ( prob> probmax*1.0001) {
00087 
00088     report(INFO,"EvtGen") << "prob > probmax:("<<prob<<">"<<probmax<<")";
00089     report(INFO,"") << "("<<_modelname.c_str()<<") ";
00090     report(INFO,"") << EvtPDL::name(_parent).c_str()<<" -> ";
00091     for(i=0;i<_ndaug;i++){
00092        report(INFO,"") << EvtPDL::name(_daug[i]).c_str() << " ";
00093     }
00094     report(INFO,"") << endl;
00095 
00096     if (defaultprobmax) probmax = prob;
00097 
00098   }
00099 
00100   ntimes_prob += 1;
00101 
00102 
00103   return probmax;
00104 
00105 } //getProbMax

double EvtVubHybrid::getWeight double  mX,
double  q2,
double  El
 

00435                                                               {
00436 
00437   int ibin_mX = -1;
00438   int ibin_q2 = -1;
00439   int ibin_El = -1;
00440 
00441   for (int i = 0; i < _nbins_mX; i++) {
00442     if (mX >= _bins_mX[i]) ibin_mX = i;
00443   }
00444   for (int i = 0; i < _nbins_q2; i++) {
00445     if (q2 >= _bins_q2[i]) ibin_q2 = i;
00446   }
00447   for (int i = 0; i < _nbins_El; i++) {
00448     if (El >= _bins_El[i]) ibin_El = i;
00449   }
00450   int ibin = ibin_mX + ibin_q2*_nbins_mX + ibin_El*_nbins_mX*_nbins_q2;
00451 
00452   if ( (ibin_mX < 0) || (ibin_q2 < 0) || (ibin_El < 0) ) {
00453     report(ERROR,"EvtVubHybrid") << "Cannot determine hybrid weight "
00454                                  << "for this event " 
00455                                  << "-> assign weight = 0" << endl;
00456     return 0.0;
00457   }
00458 
00459   return _weights[ibin];
00460 }

void EvtVubHybrid::init  )  [virtual]
 

Reimplemented from EvtDecayBase.

00080                        {
00081 
00082   // check that there are at least 3 arguments
00083   if (getNArg() < EvtVubHybrid::nParameters) {
00084     report(ERROR,"EvtVubHybrid") << "EvtVub generator expected "
00085                                  << "at least " << EvtVubHybrid::nParameters
00086                                  << " arguments but found: " << getNArg()
00087                                  << "\nWill terminate execution!"<<endl;
00088     ::abort(); 
00089   } else if (getNArg() == EvtVubHybrid::nParameters) {
00090     report(WARNING,"EvtVubHybrid") << "EvtVub: generate B -> Xu l nu events " 
00091                                    << "without using the hybrid reweighting." 
00092                                    << endl;
00093     _noHybrid = true;
00094   } else if (getNArg() < EvtVubHybrid::nParameters+EvtVubHybrid::nVariables) {
00095      report(ERROR,"EvtVubHybrid") << "EvtVub could not read number of bins for "
00096                                   << "all variables used in the reweighting\n"
00097                                   << "Will terminate execution!" << endl;
00098      ::abort();    
00099   }
00100 
00101   // check that there are 3 daughters
00102   checkNDaug(3);
00103 
00104   // read minimum required parameters from decay.dec
00105   _mb     = getArg(0);
00106   _a      = getArg(1);
00107   _alphas = getArg(2);
00108 
00109   // the maximum dGamma*p2 value depends on alpha_s only:
00110   const double dGMax0 = 3.;
00111   _dGMax = 0.21344+8.905*_alphas;
00112   if ( _dGMax < dGMax0 ) _dGMax = dGMax0;
00113 
00114   // for the Fermi Motion we need a B-Meson mass - but it's not critical
00115   // to get an exact value; in order to stay in the phase space for
00116   // B+- and B0 use the smaller mass
00117   
00118   static double mB0 = EvtPDL::getMaxMass(EvtPDL::getId("B0"));
00119   static double mBP = EvtPDL::getMaxMass(EvtPDL::getId("B+"));
00120   static double mB = (mB0<mBP?mB0:mBP);
00121   
00122   const double xlow = -_mb;
00123   const double xhigh = mB-_mb;
00124   const int aSize = 10000;
00125 
00126   EvtPFermi pFermi(_a,mB,_mb);
00127   // pf is the cumulative distribution normalized to 1.
00128   _pf.resize(aSize);
00129   for(int i=0;i<aSize;i++){
00130     double kplus = xlow + (double)(i+0.5)/((double)aSize)*(xhigh-xlow);
00131     if ( i== 0 )
00132       _pf[i] = pFermi.getFPFermi(kplus);
00133     else
00134       _pf[i] = _pf[i-1] + pFermi.getFPFermi(kplus);
00135   }
00136   for (int i=0; i<_pf.size(); i++) _pf[i]/=_pf[_pf.size()-1];
00137 
00138   _dGamma = new EvtVubdGamma(_alphas);
00139   
00140   if (_noHybrid) return;        // Without hybrid weighting, nothing else to do
00141 
00142   _nbins_mX = abs((int)getArg(3));
00143   _nbins_q2 = abs((int)getArg(4));
00144   _nbins_El = abs((int)getArg(5));
00145 
00146   int nextArg = EvtVubHybrid::nParameters + EvtVubHybrid::nVariables;
00147 
00148   _nbins = _nbins_mX*_nbins_q2*_nbins_El;       // Binning of weight table
00149 
00150   int expectArgs = nextArg + _nbins_mX +_nbins_q2 + _nbins_El + _nbins;
00151 
00152   if (getNArg() < expectArgs) {
00153     report(ERROR,"EvtVubHybrid")
00154       << " finds " << getNArg() << " arguments, expected " << expectArgs
00155       << ".  Something is wrong with the tables of weights or thresholds."
00156       << "\nWill terminate execution!" << endl;
00157     ::abort();        
00158   }
00159 
00160   // read bin boundaries from decay.dec
00161   int i;
00162 
00163   _bins_mX  = new double[_nbins_mX];
00164   for (i = 0; i < _nbins_mX; i++,nextArg++) {
00165     _bins_mX[i] = getArg(nextArg);
00166   }
00167   _masscut = _bins_mX[0];
00168 
00169   _bins_q2  = new double[_nbins_q2];
00170   for (i = 0; i < _nbins_q2; i++,nextArg++) {
00171     _bins_q2[i] = getArg(nextArg);    
00172   }
00173 
00174   _bins_El  = new double[_nbins_El];
00175   for (i = 0; i < _nbins_El; i++,nextArg++) {
00176     _bins_El[i] = getArg(nextArg);    
00177   }
00178     
00179   // read in weights (and rescale to range 0..1)
00180   readWeights(nextArg); 
00181 }

void EvtVubHybrid::initProbMax  )  [virtual]
 

Reimplemented from EvtDecayBase.

00183                               {
00184   noProbMax();
00185 }

int EvtDecayIncoherent::isDaughterSpinDensitySet int  daughter  )  [inline, inherited]
 

00041   {return spinDensitySet[daughter];}

void EvtDecayIncoherent::makeDecay EvtParticle p  )  [virtual, inherited]
 

Implements EvtDecayBase.

00030                                                 {
00031 
00032   int i;
00033   //initialize this the hard way..
00034   //Lange June 26, 2000
00035   for (i=0; i<MAX_DAUG; i++ ) { spinDensitySet[i]=0;}
00036   _daugsDecayedByParentModel=false;
00037 
00038   decay(p);
00039   p->setDecayProb(1.);
00040 
00041   EvtSpinDensity rho;
00042 
00043   rho.SetDiag(p->getSpinStates());
00044 
00045   p->setSpinDensityBackward(rho);
00046 
00047   if (getPHOTOS() || EvtRadCorr::alwaysRadCorr()) {
00048     EvtRadCorr::doRadCorr(p);
00049   }
00050 
00051   //Now decay the daughters.
00052 
00053   if ( !daugsDecayedByParentModel()) {
00054     
00055     for(i=0;i<p->getNDaug();i++){
00056       //Need to set the spin density of the daughters to be
00057       //diagonal.
00058       rho.SetDiag(p->getDaug(i)->getSpinStates());
00059       //if (p->getDaug(i)->getNDaug()==0){
00060       //only do this if the user has not already set the 
00061       //spin density matrix herself.
00062       //Lange June 26, 2000
00063       if ( isDaughterSpinDensitySet(i)==0 ) { 
00064         p->getDaug(i)->setSpinDensityForward(rho);
00065       }
00066       else{
00067         //report(INFO,"EvtGen") << "spinDensitymatrix already set!!!\n";
00068         EvtSpinDensity temp=p->getDaug(i)->getSpinDensityForward();
00069         //      report(INFO,"EvtGen") <<temp<<endl;
00070       }
00071       //Now decay the daughter.  Really!
00072       p->getDaug(i)->decay();
00073       //}
00074     } 
00075   }
00076                             
00077 }

bool EvtDecayBase::matchingDecay const EvtDecayBase other  )  const [virtual, inherited]
 

00588                                                                 {
00589 
00590   if ( _ndaug != other._ndaug) return false;
00591   if ( _parent != other._parent) return false;
00592   
00593   std::vector<int> useDs;
00594   for ( unsigned int i=0; i<_ndaug; i++) useDs.push_back(0);
00595 
00596   for ( unsigned int i=0; i<_ndaug; i++) {
00597     bool foundIt=false;
00598     for ( unsigned int j=0; j<_ndaug; j++) {
00599       if ( useDs[j] == 1 ) continue;
00600       if ( _daug[i] == other._daug[j] && _daug[i].getAlias() == other._daug[j].getAlias()) {
00601         foundIt=true;
00602         useDs[j]=1;
00603         break;
00604       }
00605     }
00606     if ( foundIt==false) return false;
00607   }
00608   for ( unsigned int i=0; i<_ndaug; i++) if ( useDs[i]==0) return false;
00609 
00610   return true;
00611 
00612 }

void EvtDecayBase::noProbMax  )  [inherited]
 

00305                             {
00306 
00307   defaultprobmax=0;
00308 
00309 }

virtual int EvtDecayBase::nRealDaughters  )  [inline, virtual, inherited]
 

Reimplemented in EvtBtoKD3P, and EvtVSSBMixCPT.

00105 { return _ndaug;}

void EvtDecayBase::printSummary  )  [inherited]
 

00259                                 {
00260 
00261   int i;
00262 
00263   if (ntimes_prob>0) {
00264 
00265     report(INFO,"EvtGen") << "Calls="<<ntimes_prob<<" eff:"<<
00266       sum_prob/(probmax*ntimes_prob)<<" frac. max:"<<max_prob/probmax;
00267     report(INFO,"") <<" probmax:"<<probmax<<" max:"<<max_prob<<" : ";
00268   }
00269 
00270   report(INFO,"") << EvtPDL::name(_parent).c_str()<<" -> ";
00271   for(i=0;i<_ndaug;i++){
00272     report(INFO,"") << EvtPDL::name(_daug[i]).c_str() << " ";
00273   }
00274   report(INFO,"") << " ("<<_modelname.c_str()<<"):"<< endl;
00275   
00276   
00277   
00278 }

void EvtVubHybrid::readWeights int  startArg = 0  ) 
 

00463                                            {
00464   _weights  = new double[_nbins];
00465 
00466   double maxw = 0.0;
00467   for (int i = 0; i < _nbins; i++, startArg++) {
00468     _weights[i] = getArg(startArg);
00469     if (_weights[i] > maxw) maxw = _weights[i];
00470   }
00471 
00472   if (maxw == 0) {
00473     report(ERROR,"EvtVubHybrid") << "EvtVub generator expected at least one " 
00474                                  << " weight > 0, but found none! " 
00475                                  << "Will terminate execution!"<<endl;
00476     ::abort();
00477   }
00478 
00479   // rescale weights (to be in range 0..1)
00480   for (int i = 0; i < _nbins; i++) {
00481     _weights[i] /= maxw;
00482   }
00483 }

double EvtDecayBase::resetProbMax double  prob  )  [inherited]
 

00108                                              {
00109   
00110   report(INFO,"EvtGen") << "Reseting prob max\n"; 
00111   report(INFO,"EvtGen") << "prob > probmax:("<<prob<<">"<<probmax<<")";
00112   report(INFO,"") << "("<<_modelname.c_str()<<")";
00113   report(INFO,"") << EvtPDL::getStdHep(_parent)<<"->";
00114   
00115   for( int i=0;i<_ndaug;i++){
00116     report(INFO,"") << EvtPDL::getStdHep(_daug[i]) << " ";
00117   }
00118   report(INFO,"") << endl;
00119   
00120   probmax = 0.0;
00121   defaultprobmax = 0;
00122   ntimes_prob = 0;
00123   
00124   return prob;
00125 
00126 }

void EvtDecayBase::saveDecayInfo EvtId  ipar,
int  ndaug,
EvtId daug,
int  narg,
std::vector< std::string > &  args,
std::string  name,
double  brfr
[inherited]
 

00170                                               {
00171 
00172   int i;
00173 
00174   _brfr=brfr;
00175   _ndaug=ndaug;
00176   _narg=narg;
00177   _parent=ipar; 
00178 
00179   _dsum=0;
00180 
00181   if (_ndaug>0) {
00182     _daug=new EvtId [_ndaug];
00183     for(i=0;i<_ndaug;i++){
00184       _daug[i]=daug[i];
00185       _dsum+=daug[i].getAlias();
00186     }
00187   }
00188   else{
00189     _daug=0;
00190   }
00191 
00192   if (_narg>0) {
00193     _args=new std::string[_narg+1];
00194     for(i=0;i<_narg;i++){
00195       _args[i]=args[i];
00196     }
00197   }
00198   else{
00199      _args = 0;
00200   }
00201 
00202   _modelname=name;
00203 
00204   this->init();
00205   this->initProbMax();
00206 
00207   if (_chkCharge){
00208     this->checkQ();
00209   }
00210 
00211 
00212   if (defaultprobmax){
00213     report(INFO,"EvtGen") << "No default probmax for ";
00214     report(INFO,"") << "("<<_modelname.c_str()<<") ";
00215     report(INFO,"") << EvtPDL::name(_parent).c_str()<<" -> ";
00216     for(i=0;i<_ndaug;i++){
00217       report(INFO,"") << EvtPDL::name(_daug[i]).c_str() << " ";
00218     }
00219     report(INFO,"") << endl;
00220     report(INFO,"") << "This is fine for development, but must be provided for production."<<endl;
00221     report(INFO,"EvtGen") << "Never fear though - the decay will use the \n";
00222     report(INFO,"EvtGen") << "500 iterations to build up a good probmax \n";
00223     report(INFO,"EvtGen") << "before accepting a decay. "<<endl;
00224   }
00225 
00226 }

void EvtDecayIncoherent::setDaughterSpinDensity int  daughter  )  [inline, inherited]
 

00038   { spinDensitySet[daughter]=1; return;}

void EvtDecayBase::setPHOTOS  )  [inline, inherited]
 

00069 {_photos=1;}

void EvtDecayBase::setProbMax double  prbmx  )  [inherited]
 

00298                                          {
00299 
00300   defaultprobmax=0;
00301   probmax=prbmx;
00302 
00303 }

void EvtDecayBase::setSummary  )  [inline, inherited]
 

00071 {_summary=1;}

void EvtDecayBase::setVerbose  )  [inline, inherited]
 

00070 {_verbose=1;}

int EvtDecayBase::summary  )  [inline, inherited]
 

00078 {return _summary; }

int EvtDecayBase::verbose  )  [inline, inherited]
 

00079 {return _verbose; }


Member Data Documentation

double EvtVubHybrid::_a [private]
 

double EvtVubHybrid::_alphas [private]
 

double* EvtVubHybrid::_bins_El [private]
 

double* EvtVubHybrid::_bins_mX [private]
 

double* EvtVubHybrid::_bins_q2 [private]
 

bool EvtDecayBase::_daugsDecayedByParentModel [protected, inherited]
 

EvtVubdGamma* EvtVubHybrid::_dGamma [private]
 

double EvtVubHybrid::_dGMax [private]
 

double EvtVubHybrid::_masscut [private]
 

double EvtVubHybrid::_mb [private]
 

int EvtVubHybrid::_nbins [private]
 

int EvtVubHybrid::_nbins_El [private]
 

int EvtVubHybrid::_nbins_mX [private]
 

int EvtVubHybrid::_nbins_q2 [private]
 

bool EvtVubHybrid::_noHybrid [private]
 

std::vector<double> EvtVubHybrid::_pf [private]
 

bool EvtVubHybrid::_storeQplus [private]
 

double* EvtVubHybrid::_weights [private]
 


The documentation for this class was generated from the following files:
Generated on Wed Feb 2 16:13:20 2011 for BOSS6.5.5 by  doxygen 1.3.9.1