]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - EVGEN/AliGenSlowNucleons.cxx
adding name strings for canvases and histograms, adding z0 resolution
[u/mrichter/AliRoot.git] / EVGEN / AliGenSlowNucleons.cxx
index 13b0e5b3ce2a4f0e37be0a094e60523d16a5295a..7bf44a4b29350620501fe676ffc0bf44a1379b74 100644 (file)
@@ -44,10 +44,8 @@ AliGenSlowNucleons::AliGenSlowNucleons()
      fMomentum(0.),
      fBeta(0.),
      fPmax (0.),
-     fATarget (0.),
-     fZTarget (0.),
      fCharge(0),
-     fProtonDirection(0.),
+     fProtonDirection(1.),
      fTemperatureG(0.), 
      fBetaSourceG(0.),
      fTemperatureB(0.),
@@ -74,13 +72,11 @@ AliGenSlowNucleons::AliGenSlowNucleons(Int_t npart)
      fMomentum(0.),
      fBeta(0.),
      fPmax (10.),
-     fATarget (208.),
-     fZTarget (82.),
      fCharge(1),
-     fProtonDirection(0.),
-     fTemperatureG(0.04), 
+     fProtonDirection(1.),
+     fTemperatureG(0.05), 
      fBetaSourceG(0.05),
-     fTemperatureB(0.004),
+     fTemperatureB(0.005),
      fBetaSourceB(0.),
      fNgp(0),
      fNgn(0),
@@ -117,9 +113,10 @@ void AliGenSlowNucleons::Init()
   //
   // Initialization
   //
-    Float_t kMass  = TDatabasePDG::Instance()->GetParticle(kProton)->Mass();
-    fMomentum = fCMS/2. * fZTarget / fATarget;
+    Double_t kMass  = TDatabasePDG::Instance()->GetParticle(kProton)->Mass();
+    fMomentum = fCMS/2. * Float_t(fZTarget) / Float_t(fATarget);
     fBeta     = fMomentum / TMath::Sqrt(kMass * kMass + fMomentum * fMomentum);
+    //printf("  fMomentum %f    fBeta %1.10f\n",fMomentum, fBeta);
     if (fDebug) {
        fDebugHist1 = new TH2F("DebugHist1", "nu vs N_slow", 100, 0., 100., 20, 0., 20.);
        fDebugHist2 = new TH2F("DebugHist2", "b  vs N_slow", 100, 0., 100., 15, 0., 15.);
@@ -143,7 +140,7 @@ void AliGenSlowNucleons::FinishRun()
        TCanvas *c = new TCanvas("c","Canvas 1",400,10,600,700);
        c->Divide(2,1);
        c->cd(1);
-       fDebugHist1->Draw();
+       fDebugHist1->Draw("colz");
        c->cd(2);
        fDebugHist2->Draw();
        c->cd(3);
@@ -162,23 +159,23 @@ void AliGenSlowNucleons::Generate()
   // 
     if (fCollisionGeometry) {
        Float_t b   = fCollisionGeometry->ImpactParameter();
-       Int_t  nn   = fCollisionGeometry->NN();
-       Int_t  nwn  = fCollisionGeometry->NwN();
-       Int_t  nnw  = fCollisionGeometry->NNw();
-       Int_t  nwnw = fCollisionGeometry->NwNw();
-
-       fSlowNucleonModel->GetNumberOfSlowNucleons(fCollisionGeometry, fNgp, fNgn, fNbp, fNbn);
+       //      Int_t  nn   = fCollisionGeometry->NN();
+       //      Int_t  nwn  = fCollisionGeometry->NwN();
+       //      Int_t  nnw  = fCollisionGeometry->NNw();
+       //      Int_t  nwnw = fCollisionGeometry->NwNw();
+       
+       //fSlowNucleonModel->GetNumberOfSlowNucleons(fCollisionGeometry, fNgp, fNgn, fNbp, fNbn);
+       fSlowNucleonModel->GetNumberOfSlowNucleons2(fCollisionGeometry, fNgp, fNgn, fNbp, fNbn);
        if (fDebug) {
-           printf("Nucleons %d %d %d %d \n", fNgp, fNgn, fNbp, fNbn);
-           fDebugHist1->Fill(Float_t(fNgp + fNgn + fNbp + fNbn), fCollisionGeometry->NwN(), 1.);
+           //printf("Collision Geometry %f %d %d %d %d\n", b, nn, nwn, nnw, nwnw);
+           printf("Slow nucleons: %d grayp  %d grayn  %d blackp  %d blackn \n", fNgp, fNgn, fNbp, fNbn);
+           fDebugHist1->Fill(Float_t(fNgp + fNgn + fNbp + fNbn), fCollisionGeometry->NNw(), 1.);
            fDebugHist2->Fill(Float_t(fNgp + fNgn + fNbp + fNbn), b, 1.);
-           printf("AliGenSlowNucleons: Impact parameter from Collision Geometry %f %d %d %d %d\n", 
-                  b, nn, nwn, nnw, nwnw);
        }
     }     
 
    //
-    Float_t p[3], theta=0;
+    Float_t p[3] = {0., 0., 0.}, theta=0;
     Float_t origin[3] = {0., 0., 0.};
     Float_t time = 0.;
     Float_t polar [3] = {0., 0., 0.};    
@@ -199,7 +196,7 @@ void AliGenSlowNucleons::Generate()
        GenerateSlow(fCharge, fTemperatureG, fBetaSourceG, p, theta);
        if (fDebug) fCosThetaGrayHist->Fill(TMath::Cos(theta));
        PushTrack(fTrackIt, -1, kf, p, origin, polar,
-                time, kPNoProcess, nt, 1.);
+                time, kPNoProcess, nt, 1.,-2);
        KeepTrack(nt);
     }
 //
@@ -211,7 +208,7 @@ void AliGenSlowNucleons::Generate()
        GenerateSlow(fCharge, fTemperatureG, fBetaSourceG, p, theta);
        if (fDebug) fCosThetaGrayHist->Fill(TMath::Cos(theta));
        PushTrack(fTrackIt, -1, kf, p, origin, polar,
-                time, kPNoProcess, nt, 1.);
+                time, kPNoProcess, nt, 1.,-2);
        KeepTrack(nt);
     }
 //
@@ -222,7 +219,7 @@ void AliGenSlowNucleons::Generate()
     for(i = 0; i < fNbp; i++) {
        GenerateSlow(fCharge, fTemperatureB, fBetaSourceB, p, theta);
        PushTrack(fTrackIt, -1, kf, p, origin, polar,
-                time, kPNoProcess, nt, 1.);
+                time, kPNoProcess, nt, 1.,-1);
        KeepTrack(nt);
     }
 //
@@ -233,7 +230,7 @@ void AliGenSlowNucleons::Generate()
     for(i = 0; i < fNbn; i++) {
        GenerateSlow(fCharge, fTemperatureB, fBetaSourceB, p, theta);
        PushTrack(fTrackIt, -1, kf, p, origin, polar,
-                time, kPNoProcess, nt, 1.);
+                time, kPNoProcess, nt, 1.,-1);
        KeepTrack(nt);
     }
 }
@@ -251,6 +248,8 @@ void AliGenSlowNucleons::GenerateSlow(Int_t charge, Double_t T,
    Three-momentum [GeV/c] is given back in q[3]    
 */
 
+ //printf("Generating slow nuc. with: charge %d. temp. %1.4f, beta %f \n",charge,T,beta);
  Double_t m, pmax, p, f, phi;
  TDatabasePDG * pdg = TDatabasePDG::Instance();
  const Double_t kMassProton  = pdg->GetParticle(kProton) ->Mass();
@@ -262,7 +261,7 @@ void AliGenSlowNucleons::GenerateSlow(Int_t charge, Double_t T,
 
  /* Momentum at maximum of Maxwell-distribution */
 
- pmax = TMath::Sqrt(2*T*(T+sqrt(T*T+m*m)));
+ pmax = TMath::Sqrt(2*T*(T+TMath::Sqrt(T*T+m*m)));
 
  /* Try until proper momentum                                  */
  /* for lack of primitive function of the Maxwell-distribution */
@@ -285,18 +284,21 @@ void AliGenSlowNucleons::GenerateSlow(Int_t charge, Double_t T,
  //
  phi   = 2. * TMath::Pi() * Rndm();
 
+
  /* Determine momentum components in system of the moving source */
  q[0] = p * TMath::Sin(theta) * TMath::Cos(phi);
  q[1] = p * TMath::Sin(theta) * TMath::Sin(phi);
  q[2] = p * TMath::Cos(theta);
 
+
  /* Transform to system of the target nucleus                             */
  /* beta is passed as negative, because the gray nucleons are slowed down */
  Lorentz(m, -beta, q);
-
  /* Transform to laboratory system */
  Lorentz(m, fBeta, q);
  q[2] *= fProtonDirection; 
+
 }
 
 Double_t AliGenSlowNucleons::Maxwell(Double_t m, Double_t p, Double_t T)
@@ -312,7 +314,9 @@ void AliGenSlowNucleons::Lorentz(Double_t m, Double_t beta, Float_t* q)
 {
 /* Lorentz transform in the direction of q[2] */
  
-    Double_t gamma  = 1/sqrt((1.-beta)*(1.+beta)); 
-    Double_t energy = sqrt(m*m + q[0]*q[0] + q[1]*q[1] + q[2]*q[2]);
+    Double_t gamma  = 1./TMath::Sqrt((1.-beta)*(1.+beta)); 
+    Double_t energy = TMath::Sqrt(m*m + q[0]*q[0] + q[1]*q[1] + q[2]*q[2]);
     q[2] = gamma * (q[2] + beta*energy);
+    //printf(" \t beta %1.10f gamma %f energy %f -> p_z = %f\n",beta, gamma, energy,q[2]);
 }
+