]> git.uio.no Git - u/mrichter/AliRoot.git/commitdiff
Coding rule violations corrected.
authormorsch <morsch@f7af4fe6-9843-0410-8265-dc069ae4e863>
Fri, 14 Nov 2003 11:01:41 +0000 (11:01 +0000)
committermorsch <morsch@f7af4fe6-9843-0410-8265-dc069ae4e863>
Fri, 14 Nov 2003 11:01:41 +0000 (11:01 +0000)
29 files changed:
EVGEN/AliGenAfterBurnerFlow.cxx
EVGEN/AliGenAfterBurnerFlow.h
EVGEN/AliGenBeamGas.cxx
EVGEN/AliGenBeamGas.h
EVGEN/AliGenBox.cxx
EVGEN/AliGenBox.h
EVGEN/AliGenCocktail.h
EVGEN/AliGenCocktailAfterBurner.h
EVGEN/AliGenCocktailEntry.h
EVGEN/AliGenExtFile.h
EVGEN/AliGenFLUKAsource.h
EVGEN/AliGenFixed.cxx
EVGEN/AliGenFixed.h
EVGEN/AliGenGeVSim.cxx
EVGEN/AliGenGeVSim.h
EVGEN/AliGenHIJINGpara.cxx
EVGEN/AliGenHIJINGpara.h
EVGEN/AliGenHIJINGparaBa.cxx
EVGEN/AliGenHIJINGparaBa.h
EVGEN/AliGenHaloProtvino.cxx
EVGEN/AliGenHaloProtvino.h
EVGEN/AliGenReader.h
EVGEN/AliGenReaderCwn.h
EVGEN/AliGenScan.cxx
EVGEN/AliGenScan.h
EVGEN/AliGenThetaSlice.cxx
EVGEN/AliGenThetaSlice.h
EVGEN/AliStructFuncType.cxx
EVGEN/AliStructFuncType.h

index 11d3522673beb72e230ec5b63d8af65a1806bb08..cdad4bdcf3563c9a37217308de0bb2741f7d1676 100644 (file)
@@ -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
index 00a2d40b5f1b63502d27f9ed9c8367c956c6b96d..52aa0e4d952957146f055fa62218a99ca587019f 100644 (file)
@@ -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)
 
index 7591626fadbde5aaa32eab77a1f060737c214aa5..7d3f6472d2921e0aef639626eb33e4f2b67f552e 100644 (file)
 // 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 <TParticle.h>
-#include <TFile.h>
-#include <TTree.h>
 
 
 ClassImp(AliGenBeamGas)
index 98a79855e112d66d1f6b8ee978027b9dab8d84d0..405b1f169003c3daf3100362a80b7601d13698e7 100644 (file)
@@ -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
index 60a93346d5ac572e98ce0d006cfda086d92d5277..ebe0548d5e33d648092e5357b8a7e3d9ed8b17bb 100644 (file)
 // 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
-/*
-<img src="picts/AliGeneratorClass.gif">
-</pre>
-<br clear=left>
-<font size=+2 color=red>
-<p>The responsible person for this module is
-<a href="mailto:andreas.morsch@cern.ch">Andreas Morsch</a>.
-</font>
-<pre>
-*/
-//End_Html
-//                                                               //
-///////////////////////////////////////////////////////////////////
+
 
 #include "TPDGCode.h"
 
index 238fa8313225ada3d28f90df48af61ea053b42b3..73f0600e7ad1fba8c60827ce673de21525feff11 100644 (file)
@@ -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
index eb53bd95b8e9514dc792428f24a9665a411d521c..00b59fe0458354554a922bbc37641b984af7f543 100644 (file)
@@ -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
 };
 
index 0628df7875cf13ff4e64f64a3a8820cd54649fdb..a2d54cdaa798bc1b027bdbfa2a68f69f200825d9 100644 (file)
@@ -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
 };
index f9423ab2584bc3530a9fe6f61544645ab0279f5c..d7963dfa0aa542fb92341f672fbfb197635d2311 100644 (file)
@@ -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
 };
index dac7ebc476bbf3d998ae26f32d96d7fc7568be11..5d784f42ca7e0d15da42ee0ab1fe6b6020727209 100644 (file)
@@ -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
     
index a885a59f8860239690ab6280718ed188e4bf73f3..8307f26e7c13377121011e40c3fd964dacd6fefe 100644 (file)
@@ -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
 };
index 22d7c713b2fe7ab273cde67dd942f5cd448e517d..4fab8afbf460b0c7a9ccbd3af87e9e95fa279a28 100644 (file)
 
 // 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
-/*
-<img src="picts/AliGeneratorClass.gif">
-</pre>
-<br clear=left>
-<font size=+2 color=red>
-<p>The responsible person for this module is
-<a href="mailto:andreas.morsch@cern.ch">Andreas Morsch</a>.
-</font>
-<pre>
-*/
-//End_Html
-//                                                               //
-///////////////////////////////////////////////////////////////////
 
 #include "TPDGCode.h"
 
index 36be844e9c3f93ecbdd616f477a5df50ca77d28b..f0443cdd9fb9d7fb77287737592bd80e5619cab3 100644 (file)
@@ -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
 };
index 5c1c4c67fc649b02acb80116b37c883848a006ad..60bc647379c0818cf316d9283c46901ecb05310f 100644 (file)
@@ -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()
   //
index 242810b31581e309b85832b4303c54e2835f685b..1eda6ba960a079d67d73f0b55a036eeb1236f049 100644 (file)
@@ -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);
index 99d8b5a95866bd7c1d35c92e8346726797e212b3..dc4b01a96756262839c6616c9d1a86cfac48ad1d 100644 (file)
@@ -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;i<fNpart;i++) {
        while(1) {
-           Rndm(random,3);
+           Rndm(random,4);
            if(random[0]<kBorne) {
                part=kPions[Int_t (random[1]*3)];
                ptf=fPtpi;
                etaf=fETApic;
+               wgt = fPtWgtPi;
            } else {
                part=kKaons[Int_t (random[1]*4)];
                ptf=fPtka;
                etaf=fETAkac;
+               wgt = fPtWgtKa;
            }
            phi=fPhiMin+random[2]*(fPhiMax-fPhiMin);
            theta=2*TMath::ATan(TMath::Exp(-etaf->GetRandom()));
            if(theta<fThetaMin || theta>fThetaMax) 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(ptot<fPMin || ptot>fPMax) 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
index b6366dac4c229267619ce66ad751651726183216..141fcd4a81a4363371332270cbc2fb9cf3de9f11 100644 (file)
@@ -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 &para) const;
   ClassDef(AliGenHIJINGpara,3) // Hijing parametrisation generator
index 48d609f3409efd225ba62e61d8239c20b42966e2..170711a09f0d743cd4238f8d1bcfe64453e77d6f 100644 (file)
@@ -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()
 {
index 267ff689e46c8ccc8f20086c83ef89b318313fed..a159629a9643681e89c8db3b249cef7d1ce4df69 100644 (file)
@@ -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) 
+       {para.Copy(*this); return (*this);}
     virtual ~AliGenHIJINGparaBa();
     virtual void Generate();
     virtual void Init();
index 843865e5d0c8e546c333fd1c295a80c2e13c3051..d7134eaffd17548c519cffbc300366ef28b57e44 100644 (file)
@@ -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
        }
     }
     
index 36e56336b92bbf7a8336ff774b74cea48455426c..bcafd316cd69074e2b1027498a0f3efcd56a4a31 100644 (file)
@@ -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
 
index 3ccc9e822482285ec8f422fe554c5105cfdebcc9..31433698ca812171ab6117e352a093b03ab977b8 100644 (file)
@@ -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);
 
index 25319262541b99e9c5d2d32c2b197eb44a2bab03..334ad971e3b1f30aab03d7560d149de235e48cad 100644 (file)
@@ -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
index 9bd6a6927aa2bc0144b77478c86fddfe6b7b55fa..c540cab0d7b805029af67558c4563806d2231d71 100644 (file)
 
 /* $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"
 
index 2fb39daef1f4270c43f02e740f43169ab40d10a4..e2c4765922ab7e10d3c73773db86004943f10487 100644 (file)
@@ -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
index 47e5970db3ac996941d5e1fcd5fec64e6ce8c1fa..3d0343251734e7105e691c2df1891b56f69348d3 100644 (file)
 
 /* $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 <TPDGCode.h>
 
index 1759fb4687ba0a00aeb156696160593b4039cceb..24da05c77a8df8aed399628fdb9083cd11e4a16a 100644 (file)
@@ -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
index ee13c47b121170130bfed7e25066eaae39726d1b..ce5bd69ec9b95f7ca4c15ebb6ee4952be5d79365 100644 (file)
 
 /* $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
index 89f723a9089941e41a8a27b4c2401a8ca3140940..3c800cbfafb4e1a61e0de15910bccc300c52cc3e 100644 (file)
@@ -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 <TObject.h>
 
 class AliStructFuncType : public TObject {