rb Namespace Reference


Classes

class  TDFun
class  TPhoton
class  TPhotonD

Functions

double Gamma (const double Q2, const double M2, const double G, const double mkpp2, const double mkmp2)
complex_t R (double Q2, double M2, double G, double Mp2, double Mm2)
TLorentzVector PseudoScalars3 (const TLorentzVector &qp, const TLorentzVector &qm, const TLorentzVector &q0)

Variables

const double me = 0.51099907
const double mpi = 139.57018
const double mpi0 = 134.9766
const double meta = 547.853
const double Metap = 957.66
const double Getap = 0.205
const double Mrho = 775.5
const double Grho = 149.4
const double mkc = 493.677
const double mk0 = 497.614
const double Mphi = 1019.33
const double Gphi = 4.26
const double Meta = 547.853
const double Mrhop = 1.35*1000
const double Grhop = 0.3*1000
const double Mrhopp = 1.7*1000
const double Grhopp = 0.235*1000
const double Mrhoppp = 2150
const double Grhoppp = 350
const double Momega = 0.782*1000
const double Gomega = 0.0085*1000
const double me2 = me*me
const double mpi2 = mpi*mpi
const double mpi02 = mpi0*mpi0
const double Mrho2 = Mrho*Mrho
const double Mrhop2 = Mrhop*Mrhop
const double Mrhopp2 = Mrhopp*Mrhopp
const double Mrhoppp2 = Mrhoppp*Mrhoppp
const double Momega2 = Momega*Momega
const double mkc2 = mkc*mkc
const double mk02 = mk0*mk0
const double Mphi2 = Mphi*Mphi
const double Meta2 = Meta*Meta
const double alpha = 7.2973525376e-3
const double hc = 197.3269631
const double MeV2nb = hc*hc*1e7
const double Mpsi = 3096.916
const double Gpsi = 93.2*1e-3
const double Mpsi2 = Mpsi*Mpsi
const double Geepsi = 5.55*1e-3
const double Mpsip = 3686.09
const double Gpsip = 317*1e-3
const double Mpsip2 = Mpsip*Mpsip
const double Geepsip = 2.38*1e-3
const double Mpsipp = 3.772*1000
const double Gpsipp = 27.3
const double Mpsipp2 = Mpsipp*Mpsipp
const double Geepsipp = 0.265*1e-3
const double MKstar = 895.5
const double GKstar = 46.2
const double MKstar2 = MKstar*MKstar
const double Mb1 = 1229.5
const double Gb1 = 142
const double Mb12 = Mb1*Mb1


Function Documentation

double rb::Gamma ( const double  Q2,
const double  M2,
const double  G,
const double  mkpp2,
const double  mkmp2 
) [inline]

Definition at line 16 of file TUtil.h.

Referenced by BgsPhysicsList::ConstructLeptHad(), StepLimiter::ConstructParticle(), ExN04EMPhysics::ConstructProcess(), BesEMPhysics::ConstructProcess(), EvtVPHOtoVISR::decay(), R(), Rrho(), and Rrho0().

00018                                                              {
00019     const double mkmp22 = mkmp2*mkmp2;
00020     double beta2_q = (Q2*Q2 - 2*Q2*mkpp2 + mkmp22)/pow(Q2 - mkpp2,2);
00021     double beta2_M = (M2*M2 - 2*M2*mkpp2 + mkmp22)/pow(M2 - mkpp2,2);
00022     double beta2 = beta2_q/beta2_M;
00023     double beta = sqrt(beta2);
00024     return G*M2/Q2*beta2*beta;
00025   }

complex_t rb::R ( double  Q2,
double  M2,
double  G,
double  Mp2,
double  Mm2 
) [inline]

Definition at line 27 of file TUtil.h.

References Gamma(), and I.

Referenced by TBuilder0::buildStereo(), TBuilder0::buildStereo0(), TConformalFinder::crossPoints(), EvtMultibody::decay(), EvtJ2BB2::decay(), EvtJ2BB1::decay(), EvtCalHelAmp::decay(), BesMdcGeoParameter::Dump(), FillTofHisto(), findTwoHits(), ExtMucKal::Fit(), TCurlFinder::fitWDD(), TBuilderCurl::fitWDD(), FK0K0Eta(), FK0KcPc(), FKcKcEta(), FKcKcP0(), TGGCrossPart::K_SV(), TCurlFinder::makeCdcFrame(), TTrackManager::maskCurlHits(), TTrackManager::merge(), TCurlFinder::merge3DTrack(), KalmanKinematicFit::pInfit(), TCurlFinder::plotCircle(), TCurlFinder::plotTrack(), KalmanKinematicFit::pOrigin(), EvtPto3PAmpFactory::processAmp(), MdcGeomSvc::ReadFilePar(), BesTofDigitizerBrV2::Reflectivity(), EvtResonance::relBrWig(), TEPCrossPart::RGamma(), TEPCrossPart::RGamma_kuraev_eidelman(), EvtVectorParticle::rotateToHelicityBasis(), EvtTensorParticle::rotateToHelicityBasis(), EvtScalarParticle::rotateToHelicityBasis(), EvtRaritaSchwingerParticle::rotateToHelicityBasis(), EvtPhotonParticle::rotateToHelicityBasis(), EvtHighSpinParticle::rotateToHelicityBasis(), EvtDiracParticle::rotateToHelicityBasis(), EvtParticle::setSpinDensityForwardHelicityBasis(), EvtEvalHelAmp::setUpRotationMatrices(), BesMdcGeoParameter::SignalWire(), TBuilderCurl::stereoHit(), EmcRecBarrelGeo::Transform2Column1(), KalmanKinematicFit::updateConstraints(), ExtSteppingAction::UserSteppingAction(), and BesMdcGeoParameter::Wire().

00029                                             {
00030     if(Q2<Mp2) return 0;
00031     const complex_t I(0,1);
00032     double Q = sqrt(Q2);
00033     complex_t prop = M2/(Q2 - M2 + I*(Gamma(Q2,M2,G,Mp2,Mm2)*Q));
00034     return prop;
00035   }  

TLorentzVector rb::PseudoScalars3 ( const TLorentzVector &  qp,
const TLorentzVector &  qm,
const TLorentzVector &  q0 
) [inline]

Definition at line 37 of file TUtil.h.

Referenced by J5pi().

00039                                                                 {
00040     // The hadronic current
00041     // here for 3pi J_\mu=\epsilon_{a b g \mu}q+_{a}q-_{b}q0_{g}
00042 
00043     double Jx = qp.Y()*qm.Z()*q0.T()
00044       -    qp.Y()*qm.T()*q0.Z()
00045       +    qp.T()*qm.Y()*q0.Z()
00046       -    qp.T()*qm.Z()*q0.Y()
00047       +    qp.Z()*qm.T()*q0.Y()
00048       -    qp.Z()*qm.Y()*q0.T();
00049     
00050     double Jy = qp.X()*qm.Z()*q0.T()
00051       -    qp.X()*qm.T()*q0.Z()
00052       +    qp.T()*qm.X()*q0.Z()
00053       -    qp.T()*qm.Z()*q0.X()
00054       +    qp.Z()*qm.T()*q0.X()
00055       -    qp.Z()*qm.X()*q0.T();
00056     
00057     double Jz = qp.Y()*qm.X()*q0.T()
00058       -    qp.Y()*qm.T()*q0.X()
00059       +    qp.T()*qm.Y()*q0.X()
00060       -    qp.T()*qm.X()*q0.Y()
00061       +    qp.X()*qm.T()*q0.Y()
00062       -    qp.X()*qm.Y()*q0.T();
00063     
00064     double Jt = qp.Y()*qm.Z()*q0.X()
00065       -    qp.Y()*qm.X()*q0.Z()
00066       +    qp.X()*qm.Y()*q0.Z()
00067       -    qp.X()*qm.Z()*q0.Y()
00068       +    qp.Z()*qm.X()*q0.Y()
00069       -    qp.Z()*qm.Y()*q0.X();
00070     
00071     TLorentzVector J(Jx,Jy,Jz,Jt);
00072     return J;
00073   }


Variable Documentation

const double rb::me = 0.51099907

Definition at line 5 of file TConstant.h.

Referenced by rb::TDFun::TDFun(), and rb::TPhoton::TPhoton().

const double rb::mpi = 139.57018

Definition at line 6 of file TConstant.h.

const double rb::mpi0 = 134.9766

Definition at line 7 of file TConstant.h.

const double rb::meta = 547.853

Definition at line 8 of file TConstant.h.

const double rb::Metap = 957.66

Definition at line 9 of file TConstant.h.

const double rb::Getap = 0.205

Definition at line 10 of file TConstant.h.

const double rb::Mrho = 775.5

Definition at line 11 of file TConstant.h.

Referenced by bw_rho(), and Rrho().

const double rb::Grho = 149.4

Definition at line 12 of file TConstant.h.

Referenced by bw_rho(), Rrho(), and Rrho0().

const double rb::mkc = 493.677

Definition at line 13 of file TConstant.h.

Referenced by TKKEtaCrossPart::TKKEtaCrossPart(), and TKKPCrossPart::TKKPCrossPart().

const double rb::mk0 = 497.614

Definition at line 14 of file TConstant.h.

const double rb::Mphi = 1019.33

Definition at line 15 of file TConstant.h.

Referenced by AmpOmegaPhi().

const double rb::Gphi = 4.26

Definition at line 16 of file TConstant.h.

Referenced by AmpOmegaPhi(), FK0K0Eta(), and FKcKcEta().

const double rb::Meta = 547.853

Definition at line 17 of file TConstant.h.

const double rb::Mrhop = 1.35*1000

Definition at line 18 of file TConstant.h.

Referenced by bw_rho().

const double rb::Grhop = 0.3*1000

Definition at line 19 of file TConstant.h.

Referenced by bw_rho(), Rrho(), and Rrho0().

const double rb::Mrhopp = 1.7*1000

Definition at line 20 of file TConstant.h.

const double rb::Grhopp = 0.235*1000

Definition at line 21 of file TConstant.h.

Referenced by Rrho(), and Rrho0().

const double rb::Mrhoppp = 2150

Definition at line 22 of file TConstant.h.

const double rb::Grhoppp = 350

Definition at line 23 of file TConstant.h.

Referenced by Rrho().

const double rb::Momega = 0.782*1000

Definition at line 24 of file TConstant.h.

Referenced by AmpOmegaPhi(), bw_om(), Rrho(), and Rrho0().

const double rb::Gomega = 0.0085*1000

Definition at line 25 of file TConstant.h.

Referenced by AmpOmegaPhi(), bw_om(), Rrho(), and Rrho0().

const double rb::me2 = me*me

Definition at line 27 of file TConstant.h.

Referenced by TGGCrossPart::R_3_Gamma(), TMuCrossPart::R_e_Gamma(), TMuCrossPart::R_e_mu_Gamma_t(), TPiCrossPart::R_Gamma(), TPiCrossPart::R_Gamma_kuraev_eidelman(), TPiCrossPart::R_Gamma_t(), TEPCrossPart::RGamma(), and TEPCrossPart::RGamma_kuraev_eidelman().

const double rb::mpi2 = mpi*mpi

Definition at line 28 of file TConstant.h.

Referenced by FK0KcPc(), Gamma(), TPiCrossPart::R_Gamma(), TPiCrossPart::R_Gamma_kuraev_eidelman(), TPiCrossPart::R_Gamma_t(), Rrho(), Rrho0(), TRhoEtaCrossPart::SetJ(), and T3piCrossPart::SetJ().

const double rb::mpi02 = mpi0*mpi0

Definition at line 29 of file TConstant.h.

Referenced by FKcKcP0(), TRhoEtaCrossPart::SetJ(), and T3piCrossPart::SetJ().

const double rb::Mrho2 = Mrho*Mrho

Definition at line 30 of file TConstant.h.

Referenced by Rrho(), and Rrho0().

const double rb::Mrhop2 = Mrhop*Mrhop

Definition at line 31 of file TConstant.h.

Referenced by Rrho(), and Rrho0().

const double rb::Mrhopp2 = Mrhopp*Mrhopp

Definition at line 32 of file TConstant.h.

Referenced by Rrho(), and Rrho0().

const double rb::Mrhoppp2 = Mrhoppp*Mrhoppp

Definition at line 33 of file TConstant.h.

Referenced by Rrho().

const double rb::Momega2 = Momega*Momega

Definition at line 34 of file TConstant.h.

Referenced by AmpOmegaPhi(), bw_om(), Rrho(), and Rrho0().

const double rb::mkc2 = mkc*mkc

Definition at line 35 of file TConstant.h.

Referenced by FK0KcPc(), FKcKcEta(), and FKcKcP0().

const double rb::mk02 = mk0*mk0

Definition at line 36 of file TConstant.h.

Referenced by FK0K0Eta(), and FK0KcPc().

const double rb::Mphi2 = Mphi*Mphi

Definition at line 37 of file TConstant.h.

Referenced by AmpOmegaPhi(), FK0K0Eta(), and FKcKcEta().

const double rb::Meta2 = Meta*Meta

Definition at line 38 of file TConstant.h.

const double rb::alpha = 7.2973525376e-3

Definition at line 40 of file TConstant.h.

Referenced by rb::TDFun::TDFun().

const double rb::hc = 197.3269631

Definition at line 41 of file TConstant.h.

Referenced by EvtbTosllAmp::GetC9Eff(), EvtBtoXsllUtil::GetC9Eff0(), and EvtDecay::isCharmonium().

const double rb::MeV2nb = hc*hc*1e7

Definition at line 42 of file TConstant.h.

Referenced by TCrossPart::rad(), and TCrossPart::radB().

const double rb::Mpsi = 3096.916

Definition at line 43 of file TConstant.h.

Referenced by Amp().

const double rb::Gpsi = 93.2*1e-3

Definition at line 44 of file TConstant.h.

Referenced by Amp().

const double rb::Mpsi2 = Mpsi*Mpsi

Definition at line 45 of file TConstant.h.

Referenced by Amp().

const double rb::Geepsi = 5.55*1e-3

Definition at line 46 of file TConstant.h.

Referenced by Amp().

const double rb::Mpsip = 3686.09

Definition at line 48 of file TConstant.h.

Referenced by Amp(), and EvtJPE::decay().

const double rb::Gpsip = 317*1e-3

Definition at line 49 of file TConstant.h.

Referenced by Amp().

const double rb::Mpsip2 = Mpsip*Mpsip

Definition at line 50 of file TConstant.h.

Referenced by Amp().

const double rb::Geepsip = 2.38*1e-3

Definition at line 51 of file TConstant.h.

Referenced by Amp().

const double rb::Mpsipp = 3.772*1000

Definition at line 53 of file TConstant.h.

Referenced by Amp(), and EvtJPE::decay().

const double rb::Gpsipp = 27.3

Definition at line 54 of file TConstant.h.

Referenced by Amp().

const double rb::Mpsipp2 = Mpsipp*Mpsipp

Definition at line 55 of file TConstant.h.

Referenced by Amp().

const double rb::Geepsipp = 0.265*1e-3

Definition at line 56 of file TConstant.h.

Referenced by Amp().

const double rb::MKstar = 895.5

Definition at line 58 of file TConstant.h.

const double rb::GKstar = 46.2

Definition at line 59 of file TConstant.h.

Referenced by FK0KcPc(), and FKcKcP0().

const double rb::MKstar2 = MKstar*MKstar

Definition at line 60 of file TConstant.h.

Referenced by FK0KcPc(), and FKcKcP0().

const double rb::Mb1 = 1229.5

Definition at line 62 of file TConstant.h.

Referenced by bw_b1().

const double rb::Gb1 = 142

Definition at line 63 of file TConstant.h.

Referenced by bw_b1().

const double rb::Mb12 = Mb1*Mb1

Definition at line 64 of file TConstant.h.

Referenced by bw_b1().


Generated on Tue Nov 29 23:36:35 2016 for BOSS_7.0.2 by  doxygen 1.4.7