From 0af12c00a39ec44e138214fa2c156f236a68f52a Mon Sep 17 00:00:00 2001 From: morsch Date: Fri, 14 Nov 2003 11:01:41 +0000 Subject: [PATCH] Coding rule violations corrected. --- EVGEN/AliGenAfterBurnerFlow.cxx | 6 +++--- EVGEN/AliGenAfterBurnerFlow.h | 5 ++--- EVGEN/AliGenBeamGas.cxx | 6 ++---- EVGEN/AliGenBeamGas.h | 13 ++++++------ EVGEN/AliGenBox.cxx | 17 +--------------- EVGEN/AliGenBox.h | 10 +++++----- EVGEN/AliGenCocktail.h | 5 +++-- EVGEN/AliGenCocktailAfterBurner.h | 6 +++--- EVGEN/AliGenCocktailEntry.h | 9 ++++----- EVGEN/AliGenExtFile.h | 2 -- EVGEN/AliGenFLUKAsource.h | 6 +++--- EVGEN/AliGenFixed.cxx | 16 ++------------- EVGEN/AliGenFixed.h | 8 ++++---- EVGEN/AliGenGeVSim.cxx | 19 ++++++++++++++++-- EVGEN/AliGenGeVSim.h | 6 +++++- EVGEN/AliGenHIJINGpara.cxx | 33 +++++++++++++++++++++++++++---- EVGEN/AliGenHIJINGpara.h | 1 - EVGEN/AliGenHIJINGparaBa.cxx | 18 +++++++++++------ EVGEN/AliGenHIJINGparaBa.h | 5 +++++ EVGEN/AliGenHaloProtvino.cxx | 6 +++--- EVGEN/AliGenHaloProtvino.h | 7 +++++-- EVGEN/AliGenReader.h | 2 +- EVGEN/AliGenReaderCwn.h | 9 +++++++-- EVGEN/AliGenScan.cxx | 6 ++++++ EVGEN/AliGenScan.h | 4 ++++ EVGEN/AliGenThetaSlice.cxx | 9 +++------ EVGEN/AliGenThetaSlice.h | 10 +++++----- EVGEN/AliStructFuncType.cxx | 6 ++++++ EVGEN/AliStructFuncType.h | 8 ++++++-- 29 files changed, 153 insertions(+), 105 deletions(-) diff --git a/EVGEN/AliGenAfterBurnerFlow.cxx b/EVGEN/AliGenAfterBurnerFlow.cxx index 11d3522673b..cdad4bdcf35 100644 --- a/EVGEN/AliGenAfterBurnerFlow.cxx +++ b/EVGEN/AliGenAfterBurnerFlow.cxx @@ -169,7 +169,7 @@ void AliGenAfterBurnerFlow::SetFlowParameters // Defaults if (pdg == 0) { - index = kN - order; + index = fgkN - order; newEntry = kFALSE; } @@ -185,7 +185,7 @@ void AliGenAfterBurnerFlow::SetFlowParameters // check fCounter - if (newEntry && (fCounter > kN-3)) { + if (newEntry && (fCounter > fgkN-3)) { Error("AliAfterBurnerFlow","Overflow"); return; } @@ -225,7 +225,7 @@ Float_t AliGenAfterBurnerFlow::GetCoefficient // and particle momentum (Pt, Y) // - Int_t index = kN - n; // default index + Int_t index = fgkN - n; // default index Float_t v = 0; // try to find specific parametrs diff --git a/EVGEN/AliGenAfterBurnerFlow.h b/EVGEN/AliGenAfterBurnerFlow.h index 00a2d40b5f1..52aa0e4d952 100644 --- a/EVGEN/AliGenAfterBurnerFlow.h +++ b/EVGEN/AliGenAfterBurnerFlow.h @@ -44,16 +44,15 @@ class AliGenAfterBurnerFlow : public AliGenerator { private: - static const Int_t kN = 30; + static const Int_t fgkN = 30; // Size of array fParams Float_t GetCoefficient(Int_t pdg, Int_t n, Float_t Pt, Float_t Y); void SetFlowParameters(Int_t pdg, Int_t order, Int_t type, Float_t v1, Float_t v2, Float_t v3, Float_t v4); Float_t fReactionPlane; // Reaction plane angle (in rad) - Float_t fParams[kN][7]; // parameters (0: pdg, 1: order, 2: type, 3-6: actual parameters) + Float_t fParams[fgkN][7]; // parameters (0: pdg, 1: order, 2: type, 3-6: actual parameters) Int_t fCounter; // counter - public: ClassDef(AliGenAfterBurnerFlow,2) diff --git a/EVGEN/AliGenBeamGas.cxx b/EVGEN/AliGenBeamGas.cxx index 7591626fadb..7d3f6472d29 100644 --- a/EVGEN/AliGenBeamGas.cxx +++ b/EVGEN/AliGenBeamGas.cxx @@ -19,14 +19,12 @@ // Generator to simulate beam gas interactions. // At present single interactions are read from an external file. // Several interactions are combined in one event. - +// By default the vertex is smeared between +/- 20 m +// Author: andreas.morsch@cern.ch #include "AliGenBeamGas.h" -#include "AliRun.h" #include -#include -#include ClassImp(AliGenBeamGas) diff --git a/EVGEN/AliGenBeamGas.h b/EVGEN/AliGenBeamGas.h index 98a79855e11..405b1f16900 100644 --- a/EVGEN/AliGenBeamGas.h +++ b/EVGEN/AliGenBeamGas.h @@ -5,11 +5,12 @@ /* $Id$ */ +// +// Generator to simulate beam gas interactions. +// At present single interactions are read from an external file. +// Author: andreas.morsch@cern.ch #include "AliGenExtFile.h" -#include "AliGenReader.h" - -class TTree; class AliGenBeamGas : public AliGenExtFile { @@ -24,12 +25,12 @@ class AliGenBeamGas : public AliGenExtFile virtual void Init(); // generate event virtual void Generate(); + protected: + Int_t fInteractions; // Number of interactions private: void Copy(AliGenBeamGas&) const; - protected: - Int_t fInteractions; - ClassDef(AliGenBeamGas,1) //Generate for beam gas interactions + ClassDef(AliGenBeamGas,1) //Generator for beam gas interactions }; #endif diff --git a/EVGEN/AliGenBox.cxx b/EVGEN/AliGenBox.cxx index 60a93346d5a..ebe0548d5e3 100644 --- a/EVGEN/AliGenBox.cxx +++ b/EVGEN/AliGenBox.cxx @@ -20,23 +20,8 @@ // kinematic range (flat distribution) // Note that for a given theta pt and p are not independent // Range for only one variable (pt or p) should be given. -// // Comments and suggestions: andreas.morsch@cern.ch -// -//Begin_Html -/* - - -
- -

The responsible person for this module is -Andreas Morsch. - -

-*/
-//End_Html
-//                                                               //
-///////////////////////////////////////////////////////////////////
+
 
 #include "TPDGCode.h"
 
diff --git a/EVGEN/AliGenBox.h b/EVGEN/AliGenBox.h
index 238fa831322..73f0600e7ad 100644
--- a/EVGEN/AliGenBox.h
+++ b/EVGEN/AliGenBox.h
@@ -5,11 +5,11 @@
 
 /* $Id$ */
 
-/*
- Generator for particles in a preset
- kinematic range (flat distribution)
- Comments and suggestions: andreas.morsch@cern.ch
-*/
+
+// Generator for particles in a preset
+// kinematic range (flat distribution)
+// Comments and suggestions: andreas.morsch@cern.ch
+
 
 #include "AliGenerator.h"
 class AliGenBox : public AliGenerator
diff --git a/EVGEN/AliGenCocktail.h b/EVGEN/AliGenCocktail.h
index eb53bd95b8e..00b59fe0458 100644
--- a/EVGEN/AliGenCocktail.h
+++ b/EVGEN/AliGenCocktail.h
@@ -36,14 +36,15 @@ class AliGenCocktail : public AliGenerator
     void FirstGeneratorPair(AliGenCocktailEntry*&e1, AliGenCocktailEntry*&e2);
     void NextGeneratorPair (AliGenCocktailEntry*&e1, AliGenCocktailEntry*&e2);
     AliGenCocktail & operator=(const AliGenCocktail & rhs);
- private:
-    void Copy(AliGenCocktail &arun) const;
+
  protected:
     Int_t fNGenerators;   // Number of generators booked
     TList  *fEntries;     // List of Generators
     TObjLink *flnk1;      // ! Iterator for first generator
     TObjLink *flnk2;      // ! Iterator for second generator
 //
+ private:
+    void Copy(AliGenCocktail &arun) const;
     ClassDef(AliGenCocktail,1) // Particle cocktail generator a la SHAKER
 };
 
diff --git a/EVGEN/AliGenCocktailAfterBurner.h b/EVGEN/AliGenCocktailAfterBurner.h
index 0628df7875c..a2d54cdaa79 100644
--- a/EVGEN/AliGenCocktailAfterBurner.h
+++ b/EVGEN/AliGenCocktailAfterBurner.h
@@ -48,8 +48,7 @@ class AliGenCocktailAfterBurner : public  AliGenCocktail
     void          SetNBgEvents(Int_t nbg=0){fNBgEvents = nbg;}
 
     static TMCProcess IntToMCProcess(Int_t no);
- private:
-    void Copy(AliGenCocktailAfterBurner &arun) const;
+
  protected:
     Int_t fNAfterBurners;       // Number of afterburners  
     TList  *fAfterBurnerEntries;// List of afterburners
@@ -73,7 +72,8 @@ class AliGenCocktailAfterBurner : public  AliGenCocktail
                                           //needed by some afterburners that works better with higher statistics 
                                           //this generates such a artificial one
  private:
-    
+    void Copy(AliGenCocktailAfterBurner &arun) const;    
+
     ClassDef(AliGenCocktailAfterBurner,2) // Particle cocktail generator a la SHAKER
                                           //background events added
 };
diff --git a/EVGEN/AliGenCocktailEntry.h b/EVGEN/AliGenCocktailEntry.h
index f9423ab2584..d7963dfa0aa 100644
--- a/EVGEN/AliGenCocktailEntry.h
+++ b/EVGEN/AliGenCocktailEntry.h
@@ -26,13 +26,11 @@ class AliGenCocktailEntry : public TNamed
     void SetGenerator(AliGenerator* generator){fGenerator=generator;}
     void SetFirst(Int_t first){fFirst=first;}
     void SetLast (Int_t last ){fLast =last;}
-    Int_t GetFirst(){return fFirst;}
-    Int_t GetLast (){return fLast;}
-    Float_t Rate(){return fRate;}
+    Int_t GetFirst() const {return fFirst;}
+    Int_t GetLast () const {return fLast;}
+    Float_t Rate()   const {return fRate;}
     void  PrintInfo();
     AliGenCocktailEntry & operator =(const AliGenCocktailEntry & rhs);
- private:
-    void Copy(AliGenCocktailEntry&) const;
  protected:
     AliGenerator *fGenerator;   // Pointer to generator
     Int_t fNGenerated;          // Number of primaries generated
@@ -41,6 +39,7 @@ class AliGenCocktailEntry : public TNamed
     Float_t fRate;              // Rate per event
     Float_t fKineBias;          // Bias due to kinematic selecion
     Float_t fBias;              // Bias
+    void Copy(AliGenCocktailEntry&) const;
  private:
     ClassDef(AliGenCocktailEntry,1) // Generator entry of AliGenCocktail
 };
diff --git a/EVGEN/AliGenExtFile.h b/EVGEN/AliGenExtFile.h
index dac7ebc476b..5d784f42ca7 100644
--- a/EVGEN/AliGenExtFile.h
+++ b/EVGEN/AliGenExtFile.h
@@ -30,9 +30,7 @@ class AliGenExtFile : public AliGenMC
     void SetReader(AliGenReader* reader) {fReader = reader;}
  protected:
     void CdEventFile();
- private:
     void Copy(AliGenExtFile&) const;
- protected:    
     const Text_t     *fFileName;      //! File to read from
     AliGenReader     *fReader;        //! Reader to read the file
     
diff --git a/EVGEN/AliGenFLUKAsource.h b/EVGEN/AliGenFLUKAsource.h
index a885a59f886..8307f26e7c1 100644
--- a/EVGEN/AliGenFLUKAsource.h
+++ b/EVGEN/AliGenFLUKAsource.h
@@ -46,8 +46,7 @@ public:
     // generate event
     virtual void Generate();
     AliGenFLUKAsource & operator=(const AliGenFLUKAsource & rhs);
- private:
-    void Copy(AliGenFLUKAsource &arun) const;
+
  protected:
 
     Int_t       fIkine;         // Flag to choose type of particles to be read
@@ -80,7 +79,8 @@ public:
     Float_t         fPtg;    // Pt of primary particle
     Float_t         fAge;    // Time of flight
 
-
+ private:
+    void Copy(AliGenFLUKAsource &arun) const;
 
     ClassDef(AliGenFLUKAsource,1) //Boundary source
 };
diff --git a/EVGEN/AliGenFixed.cxx b/EVGEN/AliGenFixed.cxx
index 22d7c713b2f..4fab8afbf46 100644
--- a/EVGEN/AliGenFixed.cxx
+++ b/EVGEN/AliGenFixed.cxx
@@ -17,21 +17,9 @@
 
 // Simple particle gun. 
 // Momentum, phi and theta of the partice as well as the particle type can be set.
+// If fExplicit is true the user set momentum vector is used,
+// otherwise it is calculated.
 // andreas.morsch@cern.ch
-//Begin_Html
-/*
-
-
-
- -

The responsible person for this module is -Andreas Morsch. - -

-*/
-//End_Html
-//                                                               //
-///////////////////////////////////////////////////////////////////
 
 #include "TPDGCode.h"
 
diff --git a/EVGEN/AliGenFixed.h b/EVGEN/AliGenFixed.h
index 36be844e9c3..f0443cdd9fb 100644
--- a/EVGEN/AliGenFixed.h
+++ b/EVGEN/AliGenFixed.h
@@ -6,7 +6,7 @@
 /* $Id$ */
 
 // Simple particle gun. 
-// Momentum, phi and theta of the partice as well as the particle type can be set.
+// Momentum, phi and theta of the particle as well as the particle type can be set.
 // andreas.morsch@cern.ch
 
 
@@ -31,9 +31,9 @@ class AliGenFixed : public AliGenerator
  
 protected:
 
-  Int_t fIpart; // Particle type
-  Int_t fExplicit;
-  Float_t fP[3];
+  Int_t fIpart;    // Particle type
+  Int_t fExplicit; // True if momentum vector has been set by user. 
+  Float_t fP[3];   // Momentum vector
 
   ClassDef(AliGenFixed,1) // Single particle generator
 };
diff --git a/EVGEN/AliGenGeVSim.cxx b/EVGEN/AliGenGeVSim.cxx
index 5c1c4c67fc6..60bc647379c 100644
--- a/EVGEN/AliGenGeVSim.cxx
+++ b/EVGEN/AliGenGeVSim.cxx
@@ -1,4 +1,19 @@
-////////////////////////////////////////////////////////////////////////////////
+/**************************************************************************
+ * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ *                                                                        *
+ * Author: The ALICE Off-line Project.                                    *
+ * Contributors are mentioned in the code where appropriate.              *
+ *                                                                        *
+ * Permission to use, copy, modify and distribute this software and its   *
+ * documentation strictly for non-commercial purposes is hereby granted   *
+ * without fee, provided that the above copyright notice appears in all   *
+ * copies and that both the copyright notice and this permission notice   *
+ * appear in the supporting documentation. The authors make no claims     *
+ * about the suitability of this software for any purpose. It is          *
+ * provided "as is" without express or implied warranty.                  *
+ **************************************************************************/
+
+/* $Id$ */
 //
 // AliGenGeVSim is a class implementing GeVSim event generator.
 // 
@@ -134,7 +149,7 @@ AliGenGeVSim::~AliGenGeVSim() {
 
 //////////////////////////////////////////////////////////////////////////////////
 
-Bool_t AliGenGeVSim::CheckPtYPhi(Float_t pt, Float_t y, Float_t phi) {
+Bool_t AliGenGeVSim::CheckPtYPhi(Float_t pt, Float_t y, Float_t phi) const {
   //
   // private function used by Generate()
   //
diff --git a/EVGEN/AliGenGeVSim.h b/EVGEN/AliGenGeVSim.h
index 242810b3158..1eda6ba960a 100644
--- a/EVGEN/AliGenGeVSim.h
+++ b/EVGEN/AliGenGeVSim.h
@@ -1,5 +1,9 @@
 #ifndef ALIGENGEVSIM_H
 #define ALIGENGEVSIM_H
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice                               */
+
+/* $Id$ */
 
 ////////////////////////////////////////////////////////////////////////////////
 //
@@ -106,7 +110,7 @@ class AliGenGeVSim : public AliGenerator {
 
   Float_t GetdNdYToTotal();
   
-  Bool_t CheckPtYPhi(Float_t pt, Float_t y, Float_t phi);  // for histograms only
+  Bool_t CheckPtYPhi(Float_t pt, Float_t y, Float_t phi) const;  // for histograms only
   Bool_t CheckAcceptance(Float_t p[3]);
   
   Float_t FindScaler(Int_t paramId, Int_t pdg);
diff --git a/EVGEN/AliGenHIJINGpara.cxx b/EVGEN/AliGenHIJINGpara.cxx
index 99d8b5a9586..dc4b01a9675 100644
--- a/EVGEN/AliGenHIJINGpara.cxx
+++ b/EVGEN/AliGenHIJINGpara.cxx
@@ -246,8 +246,16 @@ void AliGenHIJINGpara::Init()
 //  Fraction of events corresponding to the selected phi-range    
     Float_t phiFrac    = (fPhiMax-fPhiMin)/2/TMath::Pi();
 
+    
     fParentWeight = Float_t(fNpart)/(intETASel*ptFrac*phiFrac);
     
+    if (fAnalog != 0) {
+	fPtWgtPi = (fPtMax - fPtMin) / fPtpi->Integral(0., 20.);
+	fPtWgtKa = (fPtMax - fPtMin) / fPtka->Integral(0., 20.);
+	fParentWeight = Float_t(fNpart)/(intETASel*phiFrac);
+    }
+    
+    
     printf("%s: The number of particles in the selected kinematic region corresponds to %f percent of a full event\n ", 
 	   ClassName(),100.*fParentWeight);
 
@@ -282,7 +290,7 @@ void AliGenHIJINGpara::Generate()
     const Int_t kKaons[4] = {kK0Long, kK0Short, kKPlus, kKMinus};
     //
     Float_t origin[3];
-    Float_t pt, pl, ptot;
+    Float_t pt, pl, ptot, wgt;
     Float_t phi, theta;
     Float_t p[3];
     Int_t i, part, j;
@@ -303,23 +311,32 @@ void AliGenHIJINGpara::Generate()
     eventVertex[0] = origin[0];
     eventVertex[1] = origin[1];
     eventVertex[2] = origin[2];
-
+     
     for(i=0;iGetRandom()));
 	    if(thetafThetaMax) continue;
-	    pt=ptf->GetRandom();
+	 
+	    if (fAnalog == 0) { 
+		pt = ptf->GetRandom();
+	    } else {
+		pt = fPtMin + random[3] * (fPtMax - fPtMin);
+	    }
+	    
+	    
 	    pl=pt/TMath::Tan(theta);
 	    ptot=TMath::Sqrt(pt*pt+pl*pl);
 	    if(ptotfPMax) continue;
@@ -333,6 +350,14 @@ void AliGenHIJINGpara::Generate()
 			TMath::Sqrt(-2*TMath::Log(random[2*j+1]));
 		}
 	    }
+	    
+	    if (fAnalog == 0) { 
+		wgt = fParentWeight;
+	    } else {
+		wgt *= (fParentWeight * ptf->Eval(pt));
+	    }
+	    
+	    
 	    if (part == kPi0 && fPi0Decays){
 //
 //          Decay pi0 if requested
diff --git a/EVGEN/AliGenHIJINGpara.h b/EVGEN/AliGenHIJINGpara.h
index b6366dac4c2..141fcd4a81a 100644
--- a/EVGEN/AliGenHIJINGpara.h
+++ b/EVGEN/AliGenHIJINGpara.h
@@ -41,7 +41,6 @@ class AliGenHIJINGpara : public AliGenerator
   TF1* fETAkac;         // Parametrised eta distribution fro ka
   AliDecayer* fDecayer; // ! Pointer to pythia object for decays
 
- private:
   void DecayPi0(Float_t* orig, Float_t * p);
   void Copy(AliGenHIJINGpara ¶) const;
   ClassDef(AliGenHIJINGpara,3) // Hijing parametrisation generator
diff --git a/EVGEN/AliGenHIJINGparaBa.cxx b/EVGEN/AliGenHIJINGparaBa.cxx
index 48d609f3409..170711a09f0 100644
--- a/EVGEN/AliGenHIJINGparaBa.cxx
+++ b/EVGEN/AliGenHIJINGparaBa.cxx
@@ -143,13 +143,13 @@ static Double_t etakac( Double_t *py, Double_t *)
 {
 // eta-distribution
 //____________________________________________________________
-    const Float_t p0 =  1.10343e+02;
-    const Float_t p1 =  1.73247e+01;
-    const Float_t p2 = -7.23808e+00;
-    const Float_t p3 =  4.48334e-01;
-    const Double_t y = TMath::Abs(*py);
+    const Float_t  kp0 =  1.10343e+02;
+    const Float_t  kp1 =  1.73247e+01;
+    const Float_t  kp2 = -7.23808e+00;
+    const Float_t  kp3 =  4.48334e-01;
+    const Double_t ky = TMath::Abs(*py);
 //
-    return (p0+p1*y+p2*y*y+p3*y*y*y)/20.;
+    return (kp0+kp1*ky+kp2*ky*ky+kp3*ky*ky*ky)/20.;
 }
 
 AliGenHIJINGparaBa::AliGenHIJINGparaBa()
@@ -177,6 +177,12 @@ AliGenHIJINGparaBa::AliGenHIJINGparaBa(Int_t npart)
     fPtba  = 0;
 }
 
+AliGenHIJINGparaBa::AliGenHIJINGparaBa(const AliGenHIJINGparaBa& para) : AliGenHIJINGpara(para)
+{
+// Copy constructor
+    para.Copy(*this);
+}
+
 //_____________________________________________________________________________
 AliGenHIJINGparaBa::~AliGenHIJINGparaBa()
 {
diff --git a/EVGEN/AliGenHIJINGparaBa.h b/EVGEN/AliGenHIJINGparaBa.h
index 267ff689e46..a159629a964 100644
--- a/EVGEN/AliGenHIJINGparaBa.h
+++ b/EVGEN/AliGenHIJINGparaBa.h
@@ -6,6 +6,8 @@
 /* $Id$ */
 
 // Parameterisation of pi, K, n and p eta and pt distributions
+// eta: according to HIJING (shadowing + quenching)              
+// pT : according to CDF measurement at 1.8 TeV                  
 // Author: andreas.morsch@cern.ch
 
 #include "AliGenHIJINGpara.h"
@@ -16,6 +18,9 @@ class AliGenHIJINGparaBa : public AliGenHIJINGpara
  public:
     AliGenHIJINGparaBa();
     AliGenHIJINGparaBa(Int_t npart);
+    AliGenHIJINGparaBa(const AliGenHIJINGparaBa &HIJINGpara);
+    AliGenHIJINGparaBa& operator = (const AliGenHIJINGparaBa ¶) 
+	{para.Copy(*this); return (*this);}
     virtual ~AliGenHIJINGparaBa();
     virtual void Generate();
     virtual void Init();
diff --git a/EVGEN/AliGenHaloProtvino.cxx b/EVGEN/AliGenHaloProtvino.cxx
index 843865e5d0c..d7134eaffd1 100644
--- a/EVGEN/AliGenHaloProtvino.cxx
+++ b/EVGEN/AliGenHaloProtvino.cxx
@@ -130,15 +130,15 @@ void AliGenHaloProtvino::Init()
 //
 //  Transform into interaction rates
 //
-    const Float_t crossSection = 0.094e-28;     // m^2
+    const Float_t kCrossSection = 0.094e-28;     // m^2
     Float_t pFlux[5] = {0.2, 0.2, 0.3, 0.3, 1.0};
 
     for (j = 0; j <  5; j++) {
 	pFlux[j] *= 1.e11/25.e-9;
 	for (i = 0; i < 21; i++)  
 	{
-	    fG1[i][j] = fG1[i][j] * crossSection * pFlux[j]; // 1/m/s 
-	    fG2[i][j] = fG2[i][j] * crossSection * pFlux[j]; // 1/m/s
+	    fG1[i][j] = fG1[i][j] * kCrossSection * pFlux[j]; // 1/m/s 
+	    fG2[i][j] = fG2[i][j] * kCrossSection * pFlux[j]; // 1/m/s
 	}
     }
     
diff --git a/EVGEN/AliGenHaloProtvino.h b/EVGEN/AliGenHaloProtvino.h
index 36e56336b92..bcafd316cd6 100644
--- a/EVGEN/AliGenHaloProtvino.h
+++ b/EVGEN/AliGenHaloProtvino.h
@@ -32,8 +32,7 @@ public:
     
 
     AliGenHaloProtvino & operator=(const AliGenHaloProtvino & rhs);
- private:
-    void Copy(AliGenHaloProtvino&) const;
+
 protected:
   FILE*    fFile;                       // ! Pointer to file
   TString  fFileName;                   //   Choose the file
@@ -43,7 +42,11 @@ protected:
   Int_t    fNskip;                      //   Number of entries to skip
   Float_t  fZ1[21],    fZ2[21];         // ! z-positions for gas pressure tables
   Float_t  fG1[21][5], fG2[21][5];      // ! gas pressures
+ private:
+  void Copy(AliGenHaloProtvino&) const;
   ClassDef(AliGenHaloProtvino,1)        //   LHC background boundary source (Protvino Group results)
+      
+
 };
 #endif
 
diff --git a/EVGEN/AliGenReader.h b/EVGEN/AliGenReader.h
index 3ccc9e82248..31433698ca8 100644
--- a/EVGEN/AliGenReader.h
+++ b/EVGEN/AliGenReader.h
@@ -25,7 +25,7 @@ class AliGenReader : public TObject
     virtual Int_t NextEvent()                                              = 0;
     virtual TParticle* NextParticle()                                      = 0;
     virtual void RewindEvent()                                             = 0;
-    enum Code_t {kPDG, kGEANT3};
+    typedef enum {kPDG, kGEANT3} Code_t;
     void SetParticleCode(Code_t code) {fCode = code;}
     AliGenReader & operator=(const AliGenReader & rhs);
 
diff --git a/EVGEN/AliGenReaderCwn.h b/EVGEN/AliGenReaderCwn.h
index 25319262541..334ad971e3b 100644
--- a/EVGEN/AliGenReaderCwn.h
+++ b/EVGEN/AliGenReaderCwn.h
@@ -5,6 +5,11 @@
 
 /* $Id$ */
 
+//
+// Realisation of AliGenReader to be used with AliGenExtFile
+// It reads events from a ntuple like event structure.
+// Author: andreas.morsch@cern.ch
+//
 #include "AliGenReader.h"
 
 
@@ -23,8 +28,6 @@ class AliGenReaderCwn : public AliGenReader
     virtual TParticle*  NextParticle();
     virtual void RewindEvent(){;}
     AliGenReaderCwn & operator=(const AliGenReaderCwn & rhs);
- private:
-    void Copy(AliGenReaderCwn&) const;
     
  protected:
     Int_t             fNcurrent;      // points to the next entry
@@ -41,6 +44,8 @@ class AliGenReaderCwn : public AliGenReader
     Float_t         fPhi;             // Phi
     Float_t         fP;               // Total momentum
     Float_t         fE;               // Total energy
+ private:
+    void Copy(AliGenReaderCwn&) const;
     ClassDef(AliGenReaderCwn,1) // Read particles from cwn-ntuple
 };
 #endif
diff --git a/EVGEN/AliGenScan.cxx b/EVGEN/AliGenScan.cxx
index 9bd6a6927aa..c540cab0d7b 100644
--- a/EVGEN/AliGenScan.cxx
+++ b/EVGEN/AliGenScan.cxx
@@ -15,6 +15,12 @@
 
 /* $Id$ */
 
+// Realisation of AliGenerator that generates particles with
+// vertices on a user defined grid.
+// The vertex positions can be smeared. 
+// Momentum vectors are defined through the methods provided by AliGenerator.
+// Author: andreas.morsch@cern.ch
+
 #include "AliGenScan.h"
 #include "AliRun.h"
 
diff --git a/EVGEN/AliGenScan.h b/EVGEN/AliGenScan.h
index 2fb39daef1f..e2c4765922a 100644
--- a/EVGEN/AliGenScan.h
+++ b/EVGEN/AliGenScan.h
@@ -5,6 +5,10 @@
 
 /* $Id$ */
 
+// Realisation of AliGenerator that generates particles with
+// vertices on a user defined grid.
+// Author: andreas.morsch@cern.ch
+
 #include "AliGenerator.h"
 
 class AliGenScan : public AliGenerator
diff --git a/EVGEN/AliGenThetaSlice.cxx b/EVGEN/AliGenThetaSlice.cxx
index 47e5970db3a..3d034325173 100644
--- a/EVGEN/AliGenThetaSlice.cxx
+++ b/EVGEN/AliGenThetaSlice.cxx
@@ -15,20 +15,17 @@
 
 /* $Id$ */
 
-////////////////////////////////////////////////////////////////////////
-//
-// generates n particles with in the same phi angle, varies theta
+
+// Generates n particles with in the same phi angle, varies theta
 // in equidistant intervals
 // This class is intended to use for studies of TPC response
 // via merging with background event.
-// 
 // Note that for a given theta pt and p are not independent 
 // Range for only one variable (pt or p) should be given.
 // Based on the AliGenBox class written by andreas.morsch@cern.ch
 //
 // Comments and suggestions: Jiri.Chudoba@cern.ch
-//
-////////////////////////////////////////////////////////////////////////
+
 
 #include 
 
diff --git a/EVGEN/AliGenThetaSlice.h b/EVGEN/AliGenThetaSlice.h
index 1759fb4687b..24da05c77a8 100644
--- a/EVGEN/AliGenThetaSlice.h
+++ b/EVGEN/AliGenThetaSlice.h
@@ -5,11 +5,11 @@
 
 /* $Id$ */
 
-/*
- generates n particles with in the same phi angle, varies theta
- in equidistant intervals
- Comments and suggestions: Jiri.Chudoba@cern.ch
-*/
+
+// Generates n particles with in the same phi angle, varies theta
+// In equidistant intervals
+// Comments and suggestions: Jiri.Chudoba@cern.ch
+
 
 #include "AliGenerator.h"
 class AliGenThetaSlice : public AliGenerator
diff --git a/EVGEN/AliStructFuncType.cxx b/EVGEN/AliStructFuncType.cxx
index ee13c47b121..ce5bd69ec9b 100644
--- a/EVGEN/AliStructFuncType.cxx
+++ b/EVGEN/AliStructFuncType.cxx
@@ -15,6 +15,12 @@
 
 /* $Id$ */
 
+// Helper class to interface pdflib and the TPythia 
+// the c++ interface for Pythia
+// The pdf codes used  in pdflib are mapped
+// to a more user friendly enumeration type.
+// Author: andreas.morsch@cern.ch
+
 #include "AliStructFuncType.h"
 
 #ifndef WIN32
diff --git a/EVGEN/AliStructFuncType.h b/EVGEN/AliStructFuncType.h
index 89f723a9089..3c800cbfafb 100644
--- a/EVGEN/AliStructFuncType.h
+++ b/EVGEN/AliStructFuncType.h
@@ -1,10 +1,14 @@
-#ifndef ALISTRUCFUNCTYPE_H
-#define ALISTRUCFUNCTYPE_H
+#ifndef ALISTRUCTFUNCTYPE_H
+#define ALISTRUCTFUNCTYPE_H
 /* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
  * See cxx source for full Copyright notice                               */
 
 /* $Id$ */
 
+// Helper class to interface pdflib and the TPythia 
+// the c++ interface for Pythia
+// Author: andreas.morsch@cern.ch
+
 #include 
 
 class AliStructFuncType : public TObject {
-- 
2.43.0