#include <TCanvas.h>
#include <TClonesArray.h>
#include <TDatabasePDG.h>
#include <TF1.h>
#include <TH1F.h>
#include <TLorentzVector.h>
#include <TMath.h>
#include <TParticle.h>
#include <TParticlePDG.h>
#include <TROOT.h>
#include <TVirtualMC.h>
#include "AliDecayer.h"
#include "AliGenMUONlib.h"
#include "AliGenParam.h"
#include "AliMC.h"
#include "AliRun.h"
#include "AliGenEventHeader.h"
ClassImp(AliGenParam)
/*
<img src="picts/AliGenParam.gif">
*/
//End_Html
AliGenParam::AliGenParam()
: fPtParaFunc(0),
fYParaFunc(0),
fIpParaFunc(0),
fV2ParaFunc(0),
fPtPara(0),
fYPara(0),
fV2Para(0),
fdNdPhi(0),
fParam(0),
fdNdy0(0.),
fYWgt(0.),
fPtWgt(0.),
fBias(0.),
fTrials(0),
fDeltaPt(0.01),
fSelectAll(kFALSE),
fDecayer(0),
fForceConv(kFALSE),
fKeepParent(kFALSE),
fKeepIfOneChildSelected(kFALSE)
{
}
AliGenParam::AliGenParam(Int_t npart, const AliGenLib * Library, Int_t param, const char* tname)
:AliGenMC(npart),
fPtParaFunc(Library->GetPt(param, tname)),
fYParaFunc (Library->GetY (param, tname)),
fIpParaFunc(Library->GetIp(param, tname)),
fV2ParaFunc(Library->GetV2(param, tname)),
fPtPara(0),
fYPara(0),
fV2Para(0),
fdNdPhi(0),
fParam(param),
fdNdy0(0.),
fYWgt(0.),
fPtWgt(0.),
fBias(0.),
fTrials(0),
fDeltaPt(0.01),
fSelectAll(kFALSE),
fDecayer(0),
fForceConv(kFALSE),
fKeepParent(kFALSE),
fKeepIfOneChildSelected(kFALSE)
{
fName = "Param";
fTitle= "Particle Generator using pT and y parameterisation";
fAnalog = kAnalog;
SetForceDecay();
}
AliGenParam::AliGenParam(Int_t npart, Int_t param, const char* tname, const char* name):
AliGenMC(npart),
fPtParaFunc(0),
fYParaFunc (0),
fIpParaFunc(0),
fV2ParaFunc(0),
fPtPara(0),
fYPara(0),
fV2Para(0),
fdNdPhi(0),
fParam(param),
fdNdy0(0.),
fYWgt(0.),
fPtWgt(0.),
fBias(0.),
fTrials(0),
fDeltaPt(0.01),
fSelectAll(kFALSE),
fDecayer(0),
fForceConv(kFALSE),
fKeepParent(kFALSE),
fKeepIfOneChildSelected(kFALSE)
{
fName = name;
fTitle= "Particle Generator using pT and y parameterisation";
AliGenLib* pLibrary = new AliGenMUONlib();
fPtParaFunc = pLibrary->GetPt(param, tname);
fYParaFunc = pLibrary->GetY (param, tname);
fIpParaFunc = pLibrary->GetIp(param, tname);
fV2ParaFunc = pLibrary->GetV2(param, tname);
fAnalog = kAnalog;
fChildSelect.Set(5);
for (Int_t i=0; i<5; i++) fChildSelect[i]=0;
SetForceDecay();
SetCutOnChild();
SetChildMomentumRange();
SetChildPtRange();
SetChildPhiRange();
SetChildThetaRange();
}
AliGenParam::AliGenParam(Int_t npart, Int_t param,
Double_t (*PtPara) (const Double_t*, const Double_t*),
Double_t (*YPara ) (const Double_t* ,const Double_t*),
Double_t (*V2Para) (const Double_t* ,const Double_t*),
Int_t (*IpPara) (TRandom *))
:AliGenMC(npart),
fPtParaFunc(PtPara),
fYParaFunc(YPara),
fIpParaFunc(IpPara),
fV2ParaFunc(V2Para),
fPtPara(0),
fYPara(0),
fV2Para(0),
fdNdPhi(0),
fParam(param),
fdNdy0(0.),
fYWgt(0.),
fPtWgt(0.),
fBias(0.),
fTrials(0),
fDeltaPt(0.01),
fSelectAll(kFALSE),
fDecayer(0),
fForceConv(kFALSE),
fKeepParent(kFALSE),
fKeepIfOneChildSelected(kFALSE)
{
fName = "Param";
fTitle= "Particle Generator using pT and y parameterisation";
fAnalog = kAnalog;
fChildSelect.Set(5);
for (Int_t i=0; i<5; i++) fChildSelect[i]=0;
SetForceDecay();
SetCutOnChild();
SetChildMomentumRange();
SetChildPtRange();
SetChildPhiRange();
SetChildThetaRange();
}
AliGenParam::~AliGenParam()
{
delete fPtPara;
delete fYPara;
delete fV2Para;
delete fdNdPhi;
}
TVector3 AliGenParam::OrthogonalVector(TVector3 &inVec){
double abc[]={inVec.x(), inVec.y(), inVec.z()};
double xyz[]={1,1,1};
int solvDim=0;
double tmp=abc[0];
for(int i=0; i<3; i++)
if(fabs(abc[i])>tmp){
solvDim=i;
tmp=fabs(abc[i]);
}
xyz[solvDim]=(-abc[(1+solvDim)%3]-abc[(2+solvDim)%3])/abc[(0+solvDim)%3];
TVector3 res(xyz[0],xyz[1],xyz[2]);
return res;
}
void AliGenParam::RotateVector(Double_t *pin, Double_t *pout, Double_t costheta, Double_t sintheta,
Double_t cosphi, Double_t sinphi)
{
pout[0] = pin[0]*costheta*cosphi-pin[1]*sinphi+pin[2]*sintheta*cosphi;
pout[1] = pin[0]*costheta*sinphi+pin[1]*cosphi+pin[2]*sintheta*sinphi;
pout[2] = -1.0 * pin[0] * sintheta + pin[2] * costheta;
return;
}
double AliGenParam::ScreenFunction1(double screenVariable){
if(screenVariable>1)
return 42.24 - 8.368 * log(screenVariable + 0.952);
else
return 42.392 - screenVariable * (7.796 - 1.961 * screenVariable);
}
double AliGenParam::ScreenFunction2(double screenVariable){
if(screenVariable>1)
return 42.24 - 8.368 * log(screenVariable + 0.952);
else
return 41.405 - screenVariable * (5.828 - 0.8945 * screenVariable);
}
double AliGenParam::RandomEnergyFraction(double Z, double photonEnergy){
double aZ=Z/137.036;
double epsilon ;
double epsilon0Local = 0.000511 / photonEnergy ;
if (photonEnergy < 0.002 )
{
epsilon = epsilon0Local + (0.5 - epsilon0Local) * fRandom->Rndm();
}
else
{
double fZ = 8*log(Z)/3;
double fcZ=(aZ*aZ)*(1/(1+aZ*aZ)+0.20206-0.0368*aZ*aZ+0.0083*aZ*aZ*aZ);
if (photonEnergy > 0.050) fZ += 8*fcZ;
double screenFactor = 136. * epsilon0Local / pow (Z,1/3);
double screenMax = exp ((42.24 - fZ)/8.368) - 0.952 ;
double screenMin = std::min(4.*screenFactor,screenMax) ;
double epsilon1 = 0.5 - 0.5 * sqrt(1. - screenMin / screenMax) ;
double epsilonMin = std::max(epsilon0Local,epsilon1);
double epsilonRange = 0.5 - epsilonMin ;
double screen;
double gReject ;
double f10 = ScreenFunction1(screenMin) - fZ;
double f20 = ScreenFunction2(screenMin) - fZ;
double normF1 = std::max(f10 * epsilonRange * epsilonRange,0.);
double normF2 = std::max(1.5 * f20,0.);
do
{
if (normF1 / (normF1 + normF2) > fRandom->Rndm() )
{
epsilon = 0.5 - epsilonRange * pow(fRandom->Rndm(), 0.333333) ;
screen = screenFactor / (epsilon * (1. - epsilon));
gReject = (ScreenFunction1(screen) - fZ) / f10 ;
}
else
{
epsilon = epsilonMin + epsilonRange * fRandom->Rndm();
screen = screenFactor / (epsilon * (1 - epsilon));
gReject = (ScreenFunction2(screen) - fZ) / f20 ;
}
} while ( gReject < fRandom->Rndm() );
}
return epsilon;
}
double AliGenParam::RandomPolarAngle(){
double u;
const double a1 = 0.625;
double a2 = 3. * a1;
if (0.25 > fRandom->Rndm())
{
u = - log(fRandom->Rndm() * fRandom->Rndm()) / a1 ;
}
else
{
u = - log(fRandom->Rndm() * fRandom->Rndm()) / a2 ;
}
return u*0.000511;
}
Double_t AliGenParam::RandomMass(Double_t mh){
while(true){
double y=fRandom->Rndm();
double mee=2*0.000511*TMath::Power(2*0.000511/mh,-y);
double apxkw=2.0/3.0/137.036/TMath::Pi()/mee;
double val=fRandom->Uniform(0,apxkw);
double kw=apxkw*sqrt(1-4*0.000511*0.000511/mee/mee)*(1+2*0.000511*0.000511/mee/mee)*1*1*TMath::Power(1-mee*mee/mh/mh,3);
if(val<kw)
return mee;
}
}
Int_t AliGenParam::VirtualGammaPairProduction(TClonesArray *particles, Int_t nPart)
{
Int_t nPartNew=nPart;
for(int iPart=0; iPart<nPart; iPart++){
TParticle *gamma = (TParticle *) particles->At(iPart);
if(gamma->GetPdgCode()!=220000) continue;
if(gamma->Pt()<0.002941) continue;
double mass=RandomMass(gamma->Pt());
double Ee=mass/2;
double Pe=TMath::Sqrt((Ee+0.000511)*(Ee-0.000511));
double costheta = (2.0 * gRandom->Rndm()) - 1.;
double sintheta = TMath::Sqrt((1. + costheta) * (1. - costheta));
double phi = 2.0 * TMath::ACos(-1.) * gRandom->Rndm();
double sinphi = TMath::Sin(phi);
double cosphi = TMath::Cos(phi);
Double_t pProd1[3] = {Pe * sintheta * cosphi,
Pe * sintheta * sinphi,
Pe * costheta};
Double_t pProd2[3] = {-1.0 * Pe * sintheta * cosphi,
-1.0 * Pe * sintheta * sinphi,
-1.0 * Pe * costheta};
Double_t pRot1[3] = {0.};
RotateVector(pProd1, pRot1, costheta, -sintheta, -cosphi, -sinphi);
Double_t pRot2[3] = {0.};
RotateVector(pProd2, pRot2, costheta, -sintheta, -cosphi, -sinphi);
TLorentzVector e1V4(pRot1[0],pRot1[1],pRot1[2],Ee);
TLorentzVector e2V4(pRot2[0],pRot2[1],pRot2[2],Ee);
TVector3 boost(gamma->Px(),gamma->Py(),gamma->Pz());
boost*=1/sqrt(gamma->P()*gamma->P()+mass*mass);
e1V4.Boost(boost);
e2V4.Boost(boost);
TLorentzVector vtx;
gamma->ProductionVertex(vtx);
new((*particles)[nPartNew]) TParticle(11, gamma->GetStatusCode(), iPart+1, -1, 0, 0, e1V4, vtx);
nPartNew++;
new((*particles)[nPartNew]) TParticle(-11, gamma->GetStatusCode(), iPart+1, -1, 0, 0, e2V4, vtx);
nPartNew++;
}
return nPartNew;
}
Int_t AliGenParam::ForceGammaConversion(TClonesArray *particles, Int_t nPart)
{
Int_t nPartNew=nPart;
for(int iPart=0; iPart<nPart; iPart++){
TParticle *gamma = (TParticle *) particles->At(iPart);
if(gamma->GetPdgCode()!=22) continue;
if(gamma->Energy()<0.001022) continue;
TVector3 gammaV3(gamma->Px(),gamma->Py(),gamma->Pz());
double frac=RandomEnergyFraction(1,gamma->Energy());
double Ee1=frac*gamma->Energy();
double Ee2=(1-frac)*gamma->Energy();
double Pe1=sqrt((Ee1+0.000511)*(Ee1-0.000511));
double Pe2=sqrt((Ee2+0.000511)*(Ee2-0.000511));
TVector3 rotAxis(OrthogonalVector(gammaV3));
Float_t az=fRandom->Uniform(TMath::Pi()*2);
rotAxis.Rotate(az,gammaV3);
TVector3 e1V3(gammaV3);
double u=RandomPolarAngle();
e1V3.Rotate(u/Ee1,rotAxis);
e1V3=e1V3.Unit();
e1V3*=Pe1;
TVector3 e2V3(gammaV3);
e2V3.Rotate(-u/Ee2,rotAxis);
e2V3=e2V3.Unit();
e2V3*=Pe2;
gamma->SetFirstDaughter(nPartNew+1);
gamma->SetLastDaughter(nPartNew+2);
TLorentzVector vtx;
gamma->ProductionVertex(vtx);
new((*particles)[nPartNew]) TParticle(11, gamma->GetStatusCode(), iPart+1, -1, 0, 0, TLorentzVector(e1V3,Ee1), vtx);
nPartNew++;
new((*particles)[nPartNew]) TParticle(-11, gamma->GetStatusCode(), iPart+1, -1, 0, 0, TLorentzVector(e2V3,Ee2), vtx);
nPartNew++;
}
return nPartNew;
}
void AliGenParam::Init()
{
if (TVirtualMC::GetMC()) fDecayer = TVirtualMC::GetMC()->GetDecayer();
/*
<img src="picts/AliGenParam.gif">
*/
//End_Html
char name[256];
snprintf(name, 256, "pt-parameterisation for %s", GetName());
if (fPtPara) fPtPara->Delete();
fPtPara = new TF1(name, fPtParaFunc, fPtMin, fPtMax,0);
gROOT->GetListOfFunctions()->Remove(fPtPara);
Int_t npx= Int_t((fPtMax - fPtMin) / fDeltaPt);
fPtPara->SetNpx(npx);
snprintf(name, 256, "y-parameterisation for %s", GetName());
if (fYPara) fYPara->Delete();
fYPara = new TF1(name, fYParaFunc, fYMin, fYMax, 0);
gROOT->GetListOfFunctions()->Remove(fYPara);
snprintf(name, 256, "v2-parameterisation for %s", GetName());
if (fV2Para) fV2Para->Delete();
fV2Para = new TF1(name, fV2ParaFunc, fPtMin, fPtMax, 0);
snprintf(name, 256, "dNdPhi for %s", GetName());
if (fdNdPhi) fdNdPhi->Delete();
fdNdPhi = new TF1(name, "1+2*[0]*TMath::Cos(2*(x-[1]))", fPhiMin, fPhiMax);
snprintf(name, 256, "pt-for-%s", GetName());
TF1 ptPara(name ,fPtParaFunc, 0, 15, 0);
snprintf(name, 256, "y-for-%s", GetName());
TF1 yPara(name, fYParaFunc, -6, 6, 0);
Double_t y1=0;
Double_t y2=0;
fdNdy0=fYParaFunc(&y1,&y2);
#if ROOT_VERSION_CODE < ROOT_VERSION(5,99,0)
Float_t intYS = yPara.Integral(fYMin, fYMax,(Double_t*) 0x0,1.e-6);
Float_t intPt0 = ptPara.Integral(0,15,(Double_t *) 0x0,1.e-6);
Float_t intPtS = ptPara.Integral(fPtMin,fPtMax,(Double_t*) 0x0,1.e-6);
#else
Float_t intYS = yPara.Integral(fYMin, fYMax,1.e-6);
Float_t intPt0 = ptPara.Integral(0,15,1.e-6);
Float_t intPtS = ptPara.Integral(fPtMin,fPtMax,1.e-6);
#endif
Float_t phiWgt=(fPhiMax-fPhiMin)/2./TMath::Pi();
if (fAnalog == kAnalog) {
fYWgt = intYS/fdNdy0;
fPtWgt = intPtS/intPt0;
fParentWeight = fYWgt*fPtWgt*phiWgt/fNpart;
} else {
fYWgt = intYS/fdNdy0;
fPtWgt = (fPtMax-fPtMin)/intPt0;
fParentWeight = fYWgt*fPtWgt*phiWgt/fNpart;
}
fDecayer->SetForceDecay(fForceDecay);
fDecayer->Init();
AliGenMC::Init();
}
void AliGenParam::Generate()
{
GenerateN(1);
}
void AliGenParam::GenerateN(Int_t ntimes)
{
fDecayer->SetForceDecay(fForceDecay);
fDecayer->Init();
Float_t polar[3]= {0,0,0};
Float_t origin0[3];
Float_t time0;
Float_t pt, pl, ptot;
Float_t phi, theta;
Float_t p[3], pc[3],
och[3];
Double_t ty, xmt;
Int_t nt, i, j;
Float_t wgtp, wgtch;
Double_t dummy;
static TClonesArray *particles;
if(!particles) particles = new TClonesArray("TParticle",1000);
TDatabasePDG *pDataBase = TDatabasePDG::Instance();
Float_t random[6];
for (j=0;j<3;j++) origin0[j]=fOrigin[j];
time0 = fTimeOrigin;
if(fVertexSmear==kPerEvent) {
Vertex();
for (j=0;j<3;j++) origin0[j]=fVertex[j];
time0 = fTime;
}
Int_t ipa=0;
fNprimaries = 0;
Int_t nGen = fNpart*ntimes;
while (ipa<nGen) {
while(1) {
Int_t iPart = fIpParaFunc(fRandom);
Int_t iTemp = iPart;
if(iPart==220000) iPart=22;
fChildWeight=(fDecayer->GetPartialBranchingRatio(iPart))*fParentWeight;
TParticlePDG *particle = pDataBase->GetParticle(iPart);
Float_t am = particle->Mass();
Rndm(random,2);
ty = TMath::TanH(fYPara->GetRandom());
if (fAnalog == kAnalog) {
pt=fPtPara->GetRandom();
wgtp=fParentWeight;
wgtch=fChildWeight;
} else {
pt=fPtMin+random[1]*(fPtMax-fPtMin);
Double_t ptd=pt;
wgtp=fParentWeight*fPtParaFunc(& ptd, &dummy);
wgtch=fChildWeight*fPtParaFunc(& ptd, &dummy);
}
xmt=sqrt(pt*pt+am*am);
if (TMath::Abs(ty)==1.) {
ty=0.;
Fatal("AliGenParam",
"Division by 0: Please check you rapidity range !");
}
double v2 = fV2Para->Eval(pt);
fdNdPhi->SetParameter(0,v2);
fdNdPhi->SetParameter(1,fEvPlane);
phi=fdNdPhi->GetRandom();
pl=xmt*ty/sqrt((1.-ty)*(1.+ty));
theta=TMath::ATan2(pt,pl);
if(theta<fThetaMin || theta>fThetaMax) continue;
ptot=TMath::Sqrt(pt*pt+pl*pl);
if(ptot<fPMin || ptot>fPMax) continue;
p[0]=pt*TMath::Cos(phi);
p[1]=pt*TMath::Sin(phi);
p[2]=pl;
if(fVertexSmear==kPerTrack) {
Rndm(random,6);
for (j=0;j<3;j++) {
origin0[j]=
fOrigin[j]+fOsigma[j]*TMath::Cos(2*random[2*j]*TMath::Pi())*
TMath::Sqrt(-2*TMath::Log(random[2*j+1]));
}
Rndm(random,2);
time0 = fTimeOrigin + fOsigma[2]/TMath::Ccgs()*
TMath::Cos(2*random[0]*TMath::Pi())*
TMath::Sqrt(-2*TMath::Log(random[1]));
}
Bool_t decayed = kFALSE;
if (fForceDecay != kNoDecay) {
Float_t energy=TMath::Sqrt(ptot*ptot+am*am);
TLorentzVector pmom(p[0], p[1], p[2], energy);
fDecayer->Decay(iPart,&pmom);
Int_t np=fDecayer->ImportParticles(particles);
iPart=iTemp;
if(iPart==220000){
TParticle *gamma = (TParticle *)particles->At(0);
gamma->SetPdgCode(iPart);
np=VirtualGammaPairProduction(particles,np);
}
if(fForceConv) np=ForceGammaConversion(particles,np);
if (fGeometryAcceptance)
if (!CheckAcceptanceGeometry(np,particles)) continue;
Int_t ncsel=0;
Int_t* pFlag = new Int_t[np];
Int_t* pParent = new Int_t[np];
Int_t* pSelected = new Int_t[np];
Int_t* trackIt = new Int_t[np];
for (i=0; i<np; i++) {
pFlag[i] = 0;
pSelected[i] = 0;
pParent[i] = -1;
}
if (np >1) {
decayed = kTRUE;
TParticle* iparticle = 0;
Int_t ipF, ipL;
for (i = 1; i<np ; i++) {
trackIt[i] = 1;
iparticle = (TParticle *) particles->At(i);
Int_t kf = iparticle->GetPdgCode();
Int_t ks = iparticle->GetStatusCode();
if (pFlag[i] == 1) {
ipF = iparticle->GetFirstDaughter();
ipL = iparticle->GetLastDaughter();
if (ipF > 0) for (j=ipF-1; j<ipL; j++) pFlag[j]=1;
continue;
}
if (ks != 1) {
Double_t lifeTime = fDecayer->GetLifetime(kf);
if (lifeTime > (Double_t) fMaxLifeTime) {
ipF = iparticle->GetFirstDaughter();
ipL = iparticle->GetLastDaughter();
if (ipF > 0) for (j=ipF-1; j<ipL; j++) pFlag[j]=1;
} else{
trackIt[i] = 0;
pSelected[i] = 1;
}
}
if ((ChildSelected(TMath::Abs(kf)) || fForceDecay == kAll || fSelectAll) && trackIt[i])
{
if (fCutOnChild) {
pc[0]=iparticle->Px();
pc[1]=iparticle->Py();
pc[2]=iparticle->Pz();
Bool_t childok = KinematicSelection(iparticle, 1);
if(childok) {
pSelected[i] = 1;
ncsel++;
} else {
if(!fKeepIfOneChildSelected){
ncsel=-1;
break;
}
}
} else {
pSelected[i] = 1;
ncsel++;
}
}
}
}
Int_t iparent;
if (fKeepParent || (fCutOnChild && ncsel >0) || !fCutOnChild){
PushTrack(0, -1, iPart, p, origin0, polar, time0, kPPrimary, nt, wgtp, ((decayed)? 11 : 1));
pParent[0] = nt;
KeepTrack(nt);
fNprimaries++;
if ((fCutOnChild && ncsel >0) || !fCutOnChild){
ipa++;
}
for (i = 1; i < np; i++) {
if (pSelected[i]) {
TParticle* iparticle = (TParticle *) particles->At(i);
Int_t kf = iparticle->GetPdgCode();
Int_t ksc = iparticle->GetStatusCode();
Int_t jpa = iparticle->GetFirstMother()-1;
och[0] = origin0[0]+iparticle->Vx();
och[1] = origin0[1]+iparticle->Vy();
och[2] = origin0[2]+iparticle->Vz();
pc[0] = iparticle->Px();
pc[1] = iparticle->Py();
pc[2] = iparticle->Pz();
if (jpa > -1) {
iparent = pParent[jpa];
} else {
iparent = -1;
}
PushTrack(fTrackIt * trackIt[i], iparent, kf,
pc, och, polar,
time0 + iparticle->T(), kPDecay, nt, wgtch, ksc);
pParent[i] = nt;
KeepTrack(nt);
fNprimaries++;
}
}
}
particles->Clear();
if (pFlag) delete[] pFlag;
if (pParent) delete[] pParent;
if (pSelected) delete[] pSelected;
if (trackIt) delete[] trackIt;
}
else
{
gAlice->GetMCApp()->
PushTrack(fTrackIt,-1,iPart,p,origin0,polar,time0,kPPrimary,nt,wgtp, 1);
ipa++;
fNprimaries++;
}
break;
}
}
SetHighWaterMark(nt);
AliGenEventHeader* header = new AliGenEventHeader("PARAM");
header->SetPrimaryVertex(fVertex);
header->SetInteractionTime(fTime);
header->SetNProduced(fNprimaries);
AddHeader(header);
}
Float_t AliGenParam::GetRelativeArea(Float_t ptMin, Float_t ptMax, Float_t yMin, Float_t yMax, Float_t phiMin, Float_t phiMax)
{
#if ROOT_VERSION_CODE < ROOT_VERSION(5,99,0)
Float_t ratio =
fPtPara->Integral(ptMin,ptMax,(Double_t *)0,1.e-6) / fPtPara->Integral( fPtPara->GetXmin(), fPtPara->GetXmax(),(Double_t *)0,1.e-6) *
fYPara->Integral(yMin,yMax,(Double_t *)0,1.e-6)/fYPara->Integral(fYPara->GetXmin(),fYPara->GetXmax(),(Double_t *)0,1.e-6) *
(phiMax-phiMin)/360.;
#else
Float_t ratio =
fPtPara->Integral(ptMin,ptMax,1.e-6) / fPtPara->Integral( fPtPara->GetXmin(), fPtPara->GetXmax(),1.e-6) *
fYPara->Integral(yMin,yMax,1.e-6)/fYPara->Integral(fYPara->GetXmin(),fYPara->GetXmax(),1.e-6) *
(phiMax-phiMin)/360.;
#endif
return TMath::Abs(ratio);
}
void AliGenParam::Draw( const char * )
{
TCanvas *c0 = new TCanvas("c0","Canvas 0",400,10,600,700);
c0->Divide(2,1);
c0->cd(1);
fPtPara->Draw();
fPtPara->GetHistogram()->SetXTitle("p_{T} (GeV)");
c0->cd(2);
fYPara->Draw();
fYPara->GetHistogram()->SetXTitle("y");
}