ELIBSDIR:=
ELIBS:= MUON TPCbase TPCsim TPCrec TPCfast \
- ITS PMD TRD FMD TOF PHOS CRT RICH ZDC VZERO EMCAL \
+ ITS PMD TRDbase TRDsim TRDrec TRDfast \
+ FMD TOF PHOS CRT RICH ZDC VZERO EMCAL \
STRUCT START EVGEN STEER CONTAINERS pythia6 AliPythia6 pdf THijing \
hijing TMEVSIM mevsim THbtp HBTP THerwig herwig TEPEMGEN EPEMGEN \
TPHIC FASTSIM microcern RAW
#include "AliMagF.h"
#include "AliRun.h"
#include "AliTRD.h"
-#include "AliTRDcluster.h"
#include "AliTRDdigit.h"
#include "AliTRDdigitizer.h"
#include "AliTRDdigitsManager.h"
#include "AliTRDgeometryHole.h"
#include "AliTRDhit.h"
#include "AliTRDpoints.h"
-#include "AliTRDrecPoint.h"
#include "AliTRDtrackHits.h"
#include "AliTrackReference.h"
#include "AliMC.h"
fHits = 0;
fDigits = 0;
- fRecPoints = 0;
- fNRecPoints = 0;
-
fGeometry = 0;
fGasDensity = 0;
exit(1);
}
+ // Save the geometry
+ TDirectory* saveDir = gDirectory;
+ gAlice->GetRunLoader()->CdGAFile();
+ fGeometry->Write("TRDgeometry");
+ saveDir->cd();
+
// Allocate the hit array
fHits = new TClonesArray("AliTRDhit" ,405);
gAlice->GetMCApp()->AddHitList(fHits);
// Allocate the digits array
fDigits = 0;
- // Allocate the rec point array
- fRecPoints = new TObjArray(400);
- fNRecPoints = 0;
-
fIshunt = 0;
fGasMix = 1;
delete fHits;
fHits = 0;
}
- if (fRecPoints) {
- delete fRecPoints;
- fRecPoints = 0;
- }
+// if (fRecPoints) {
+// delete fRecPoints;
+// fRecPoints = 0;
+// }
if (fTrackHits) {
delete fTrackHits;
fTrackHits = 0;
}
-//_____________________________________________________________________________
-void AliTRD::AddCluster(Float_t *pos, Int_t det, Float_t amp
- , Int_t *tracks, Float_t *sig, Int_t iType)
-{
- //
- // Add a cluster for the TRD
- //
-
- AliTRDcluster *c = new AliTRDcluster();
-
- c->SetDetector(det);
- c->AddTrackIndex(tracks);
- c->SetQ(amp);
- c->SetY(pos[0]);
- c->SetZ(pos[1]);
- c->SetSigmaY2(sig[0]);
- c->SetSigmaZ2(sig[1]);
- c->SetLocalTimeBin(((Int_t) pos[2]));
-
- switch (iType) {
- case 0:
- c->Set2pad();
- break;
- case 1:
- c->Set3pad();
- break;
- case 2:
- c->Set4pad();
- break;
- case 3:
- c->Set5pad();
- break;
- case 4:
- c->SetLarge();
- break;
- };
-
- fRecPoints->Add(c);
-
-}
-
//_____________________________________________________________________________
void AliTRD::Hits2Digits()
{
((AliTRD &) trd).fGasMix = fGasMix;
((AliTRD &) trd).fGeometry = fGeometry;
- ((AliTRD &) trd).fRecPoints = fRecPoints;
- ((AliTRD &) trd).fNRecPoints = fNRecPoints;
((AliTRD &) trd).fGasDensity = fGasDensity;
((AliTRD &) trd).fFoilDensity = fFoilDensity;
((AliTRD &) trd).fDrawTR = fDrawTR;
}
-//_____________________________________________________________________________
-void AliTRD::ResetRecPoints()
-{
- //
- // Reset number of reconstructed points and the point array
- //
-
- if (fRecPoints) {
- fNRecPoints = 0;
- Int_t nentr = fRecPoints->GetEntriesFast();
- for (Int_t i = 0; i < nentr; i++) delete fRecPoints->RemoveAt(i);
- }
-
-}
-
//_____________________________________________________________________________
void AliTRD::SetTreeAddress()
{
// Set the branch addresses for the trees.
//
- Char_t branchname[15];
-
if ( fLoader->TreeH() && (fHits == 0x0)) fHits = new TClonesArray("AliTRDhit",405);
AliDetector::SetTreeAddress();
- TBranch *branch;
- TTree *treeR = fLoader->TreeR();
-
- if (treeR) {
- sprintf(branchname,"%scluster",GetName());
- if (fRecPoints == 0x0) fRecPoints = new TObjArray(400);
- if (fRecPoints) {
- branch = treeR->GetBranch(branchname);
- if (branch) {
- branch->SetAddress(&fRecPoints);
- }
- }
- }
-
if (fHitType > 0) {
SetTreeAddress2();
}
AliTRD &operator=(const AliTRD &trd);
virtual void AddHit(Int_t track, Int_t det, Float_t *hits, Int_t q, Bool_t inDrift);
- virtual void AddCluster(Float_t *pos, Int_t det, Float_t amp, Int_t *tracks
- , Float_t *sig, Int_t iType);
virtual void BuildGeometry();
virtual void Copy(TObject &trd);
virtual void CreateGeometry();
virtual void DrawModule() const;
Int_t DistancetoPrimitive(Int_t px, Int_t py) const;
virtual void LoadPoints(Int_t track);
- TObjArray *RecPoints() const { return fRecPoints; };
virtual void Init();
virtual Int_t IsVersion() const = 0;
virtual void MakeBranch(Option_t* option);
virtual void ResetDigits();
- virtual void ResetRecPoints();
virtual void StepManager() = 0;
virtual void SetTreeAddress();
AliTRDgeometry *fGeometry; // The TRD geometry
- TObjArray *fRecPoints; // Array of reconstructed points / cluster
- Int_t fNRecPoints; //! Number of reconstructed points / cluster
-
Float_t fGasDensity; // The density of the drift gas
Float_t fFoilDensity; // The density of the entrance window foil
#include "AliTRDReconstructor.h"
#include "AliRunLoader.h"
#include "AliTRDparameter.h"
-#include "AliTRD.h"
#include "AliTRDclusterizerV1.h"
#include "AliTRDtracker.h"
#include <TFile.h>
#include "AliRunLoader.h"
#include "AliLoader.h"
-#include "AliTRD.h"
#include "AliTRDclusterizer.h"
#include "AliTRDcluster.h"
#include "AliTRDrecPoint.h"
//
fClusterTree = NULL;
- fTRD = 0;
- fEvent = 0;
+ fRecPoints = 0;
fVerbose = 0;
fPar = 0;
//
fClusterTree = NULL;
- fEvent = 0;
+ fRecPoints = 0;
fVerbose = 0;
fPar = 0;
// AliTRDclusterizer destructor
//
+ if (fRecPoints) {
+ fRecPoints->Delete();
+ delete fRecPoints;
+ }
}
//_____________________________________________________________________________
//
((AliTRDclusterizer &) c).fClusterTree = NULL;
- ((AliTRDclusterizer &) c).fEvent = 0;
+ ((AliTRDclusterizer &) c).fRecPoints = NULL;
((AliTRDclusterizer &) c).fVerbose = fVerbose;
((AliTRDclusterizer &) c).fPar = 0;
}
}
- fEvent = nEvent;
-
// Import the Trees for the event nEvent in the file
- fRunLoader->GetEvent(fEvent);
+ fRunLoader->GetEvent(nEvent);
- // Get the TRD object
- fTRD = (AliTRD*) gAlice->GetDetector("TRD");
- if (!fTRD) {
- printf("AliTRDclusterizer::OpenInput -- ");
- printf("No TRD detector object found\n");
- return kFALSE;
- }
-
return kTRUE;
}
if ((det >= 0) && (det < AliTRDgeometry::Ndet())) {
- Int_t nRecPoints = fTRD->RecPoints()->GetEntriesFast();
+ Int_t nRecPoints = RecPoints()->GetEntriesFast();
TObjArray *detRecPoints = new TObjArray(400);
for (Int_t i = 0; i < nRecPoints; i++) {
- AliTRDcluster *c = (AliTRDcluster *) fTRD->RecPoints()->UncheckedAt(i);
+ AliTRDcluster *c = (AliTRDcluster *) RecPoints()->UncheckedAt(i);
if (det == c->GetDetector()) {
detRecPoints->AddLast(c);
}
if (det == -1) {
Info("WriteClusters","Writing the cluster tree %s for event %d."
- ,fClusterTree->GetName(),fEvent);
+ ,fClusterTree->GetName(),fRunLoader->GetEventNumber());
/*
fClusterTree->Write();
AliTRDgeometry *geo = fTRD->GetGeometry();
}
+//_____________________________________________________________________________
+void AliTRDclusterizer::AddCluster(Float_t *pos, Int_t det, Float_t amp
+ , Int_t *tracks, Float_t *sig, Int_t iType)
+{
+ //
+ // Add a cluster for the TRD
+ //
+ AliTRDcluster *c = new AliTRDcluster();
+
+ c->SetDetector(det);
+ c->AddTrackIndex(tracks);
+ c->SetQ(amp);
+ c->SetY(pos[0]);
+ c->SetZ(pos[1]);
+ c->SetSigmaY2(sig[0]);
+ c->SetSigmaZ2(sig[1]);
+ c->SetLocalTimeBin(((Int_t) pos[2]));
+
+ switch (iType) {
+ case 0:
+ c->Set2pad();
+ break;
+ case 1:
+ c->Set3pad();
+ break;
+ case 2:
+ c->Set4pad();
+ break;
+ case 3:
+ c->Set5pad();
+ break;
+ case 4:
+ c->SetLarge();
+ break;
+ };
+
+ RecPoints()->Add(c);
+
+}
/* $Id$ */
#include <TNamed.h>
+#include <TObjArray.h>
class TFile;
+class TTree;
class AliRunLoader;
class AliTRDparameter;
+class AliTRD;
///////////////////////////////////////////////////////
// Finds and handles cluster //
AliTRDparameter *GetParameter() const { return fPar; };
+ TObjArray* RecPoints() {if (!fRecPoints) fRecPoints = new TObjArray(400); return fRecPoints;}
+ virtual void AddCluster(Float_t *pos, Int_t det, Float_t amp, Int_t *tracks
+ , Float_t *sig, Int_t iType);
+ void ResetRecPoints() {if (fRecPoints) fRecPoints->Delete();}
+
+
protected:
AliRunLoader * fRunLoader; //! Run Loader
TTree *fClusterTree; //! Tree with the cluster
- AliTRD *fTRD; //! The TRD object
AliTRDparameter *fPar; // TRD digitization parameter object
- Int_t fEvent; //! Event number
+ TObjArray* fRecPoints; //! Array of clusters
Int_t fVerbose; // Sets the verbose level
ClassDef(AliTRDclusterizer,3) // TRD-Cluster manager base class
#include "AliRunLoader.h"
#include "AliLoader.h"
-#include "AliTRD.h"
#include "AliTRDclusterizerMI.h"
#include "AliTRDmatrix.h"
#include "AliTRDgeometry.h"
-#include "AliTRDdigitizer.h"
#include "AliTRDdataArrayF.h"
#include "AliTRDdataArrayI.h"
#include "AliTRDdigitsManager.h"
//////////////////////
//STUPIDITY to be fixed later
- fClusterContainer = fTRD->RecPoints();
+ fClusterContainer = RecPoints();
Int_t row, col, time;
+ /*
if (fTRD->IsVersion() != 1) {
printf("<AliTRDclusterizerMI::MakeCluster> ");
printf("TRD must be version 1 (slow simulator).\n");
return kFALSE;
}
+ */
// Get the geometry
- AliTRDgeometry *geo = fTRD->GetGeometry();
+ AliTRDgeometry *geo = AliTRDgeometry::GetGeometry(fRunLoader);
// Create a default parameter class if none is defined
if (!fPar) {
Int_t chamBeg = 0;
Int_t chamEnd = AliTRDgeometry::Ncham();
- if (fTRD->GetSensChamber() >= 0) {
- chamBeg = fTRD->GetSensChamber();
- chamEnd = chamBeg + 1;
- }
Int_t planBeg = 0;
Int_t planEnd = AliTRDgeometry::Nplan();
- if (fTRD->GetSensPlane() >= 0) {
- planBeg = fTRD->GetSensPlane();
- planEnd = planBeg + 1;
- }
Int_t sectBeg = 0;
Int_t sectEnd = AliTRDgeometry::Nsect();
for (Int_t iplan = planBeg; iplan < planEnd; iplan++) {
for (Int_t isect = sectBeg; isect < sectEnd; isect++) {
- if (fTRD->GetSensSector() >= 0) {
- Int_t sens1 = fTRD->GetSensSector();
- Int_t sens2 = sens1 + fTRD->GetSensSectorRange();
- sens2 -= ((Int_t) (sens2 / AliTRDgeometry::Nsect()))
- * AliTRDgeometry::Nsect();
- if (sens1 < sens2) {
- if ((isect < sens1) || (isect >= sens2)) continue;
- }
- else {
- if ((isect < sens1) && (isect >= sens2)) continue;
- }
- }
-
Int_t idet = geo->GetDetector(iplan,icham,isect);
Int_t nClusters = 0;
// Write the cluster and reset the array
WriteClusters(idet);
- fTRD->ResetRecPoints();
+ ResetRecPoints();
if (fVerbose > 0) {
printf("<AliTRDclusterizerMI::MakeCluster> ");
ClassImp(AliTRDclusterizerV0)
//_____________________________________________________________________________
-AliTRDclusterizerV0::AliTRDclusterizerV0():AliTRDclusterizer()
+ AliTRDclusterizerV0::AliTRDclusterizerV0():AliTRDclusterizer(), fTRD(NULL)
{
//
// AliTRDclusterizerV0 default constructor
//_____________________________________________________________________________
AliTRDclusterizerV0::AliTRDclusterizerV0(const Text_t* name, const Text_t* title)
- :AliTRDclusterizer(name,title)
+ :AliTRDclusterizer(name,title), fTRD(NULL)
{
//
// AliTRDclusterizerV0 default constructor
// Generates the cluster
//
+ // Get the TRD object
+ fTRD = (AliTRD*) gAlice->GetDetector("TRD");
+ if (!fTRD) {
+ printf("AliTRDclusterizerV0::makClusters -- ");
+ printf("No TRD detector object found\n");
+ return kFALSE;
+ }
+
if (fTRD->IsVersion() != 0) {
printf("AliTRDclusterizerV0::MakeCluster -- ");
printf("TRD must be version 0 (fast simulator).\n");
pos[0] = smear[1];
pos[1] = smear[0];
pos[2] = (time0 - smear[2]) / timeBinSize;
- fTRD->AddCluster(pos,detector,0.0,tr,sigma,0);
+ AddCluster(pos,detector,0.0,tr,sigma,0);
}
}
printf("AliTRDclusterizerV0::MakeCluster -- ");
- printf("Found %d points.\n",fTRD->RecPoints()->GetEntries());
+ printf("Found %d points.\n",RecPoints()->GetEntries());
printf("AliTRDclusterizerV0::MakeCluster -- ");
printf("Fill the cluster tree.\n");
clusterTree->Fill();
protected:
+ AliTRD *fTRD; //! The TRD object
+
Float_t fRphiSigma; // Gaussian position smearing in rphi-direction
Float_t fRphiDist; // Maximum distance for non-overlapping cluster
#include "AliRunLoader.h"
#include "AliLoader.h"
-#include "AliTRD.h"
#include "AliTRDclusterizerV1.h"
#include "AliTRDmatrix.h"
#include "AliTRDgeometry.h"
-#include "AliTRDdigitizer.h"
#include "AliTRDdataArrayF.h"
#include "AliTRDdataArrayI.h"
#include "AliTRDdigitsManager.h"
Int_t row, col, time;
+ /*
if (fTRD->IsVersion() != 1) {
printf("<AliTRDclusterizerV1::MakeCluster> ");
printf("TRD must be version 1 (slow simulator).\n");
return kFALSE;
}
+ */
// Get the geometry
- AliTRDgeometry *geo = fTRD->GetGeometry();
+ AliTRDgeometry *geo = AliTRDgeometry::GetGeometry(fRunLoader);
// Create a default parameter class if none is defined
if (!fPar) {
Int_t chamBeg = 0;
Int_t chamEnd = AliTRDgeometry::Ncham();
- if (fTRD->GetSensChamber() >= 0) {
- chamBeg = fTRD->GetSensChamber();
- chamEnd = chamBeg + 1;
- }
Int_t planBeg = 0;
Int_t planEnd = AliTRDgeometry::Nplan();
- if (fTRD->GetSensPlane() >= 0) {
- planBeg = fTRD->GetSensPlane();
- planEnd = planBeg + 1;
- }
Int_t sectBeg = 0;
Int_t sectEnd = AliTRDgeometry::Nsect();
for (Int_t iplan = planBeg; iplan < planEnd; iplan++) {
for (Int_t isect = sectBeg; isect < sectEnd; isect++) {
- if (fTRD->GetSensSector() >= 0) {
- Int_t sens1 = fTRD->GetSensSector();
- Int_t sens2 = sens1 + fTRD->GetSensSectorRange();
- sens2 -= ((Int_t) (sens2 / AliTRDgeometry::Nsect()))
- * AliTRDgeometry::Nsect();
- if (sens1 < sens2) {
- if ((isect < sens1) || (isect >= sens2)) continue;
- }
- else {
- if ((isect < sens1) && (isect >= sens2)) continue;
- }
- }
-
Int_t idet = geo->GetDetector(iplan,icham,isect);
Int_t nClusters = 0;
clusterSig[1] = rowSize * rowSize / 12.;
// Add the cluster to the output array
- fTRD->AddCluster(clusterPos
- ,idet
- ,clusterCharge
- ,clusterTracks
- ,clusterSig
- ,iType);
+ AddCluster(clusterPos
+ ,idet
+ ,clusterCharge
+ ,clusterTracks
+ ,clusterSig
+ ,iType);
}
}
// Write the cluster and reset the array
WriteClusters(idet);
- fTRD->ResetRecPoints();
+ ResetRecPoints();
if (fVerbose > 0) {
printf("<AliTRDclusterizerV1::MakeCluster> ");
//Write parameters
orl->CdGAFile();
- if (!gFile->Get("TRDParameter")) GetParameter()->Write();
+ if (!gFile->Get("TRDparameter")) GetParameter()->Write();
if (fDebug > 0) {
printf("<AliTRDdigitizer::Exec> ");
// Writes out the TRD-digits and the dictionaries
//
+ //Write parameters
+ fRunLoader->CdGAFile();
+ if (!gFile->Get("TRDparameter")) GetParameter()->Write();
+
// Store the digits and the dictionary in the tree
return fDigitsManager->WriteDigits();
#include "AliTRDdataArrayI.h"
#include "AliTRDdigit.h"
#include "AliTRDgeometry.h"
-#include "AliTRD.h"
ClassImp(AliTRDdigitsManager)
Bool_t status = kTRUE;
- AliTRD *trd = (AliTRD *) gAlice->GetDetector("TRD") ;
-
if (tree) {
fTree = tree;
}
if (fDigits) {
const AliTRDdataArray *kDigits = (AliTRDdataArray *) fDigits->At(0);
if (kDigits) {
- trd->MakeBranchInTree(fTree,"TRDdigits",kDigits->IsA()->GetName()
- ,&kDigits,buffersize,99);
+ if (!fTree) return kFALSE;
+ TBranch* branch = fTree->GetBranch("TRDdigits");
+ if (!branch) fTree->Branch("TRDdigits",kDigits->IsA()->GetName(),
+ &kDigits,buffersize,99);
if (fDebug > 0) {
printf("<AliTRDdigitsManager::MakeBranch> ");
printf("Making branch TRDdigits\n");
const AliTRDdataArray *kDictionary =
(AliTRDdataArray *) fDictionary[iDict]->At(0);
if (kDictionary) {
- trd->MakeBranchInTree(fTree,branchname,kDictionary->IsA()->GetName()
- ,&kDictionary,buffersize,99);
+ if (!fTree) return kFALSE;
+ TBranch* branch = fTree->GetBranch(branchname);
+ if (!branch) fTree->Branch(branchname,kDictionary->IsA()->GetName(),
+ &kDictionary,buffersize,99);
if (fDebug > 0) {
printf("<AliTRDdigitsManager::MakeBranch> ");
printf("Making branch %s\n",branchname);
///////////////////////////////////////////////////////////////////////////////
+#include <TError.h>
+
+#include "AliRunLoader.h"
#include "AliTRDgeometry.h"
#include "AliTRDparameter.h"
}
}
+
+//_____________________________________________________________________________
+AliTRDgeometry* AliTRDgeometry::GetGeometry(AliRunLoader* runLoader)
+{
+ //
+ // load the geometry from the galice file
+ //
+
+ if (!runLoader) runLoader = AliRunLoader::GetRunLoader();
+ if (!runLoader) {
+ ::Error("AliTRDgeometry::GetGeometry", "No run loader");
+ return NULL;
+ }
+
+ TDirectory* saveDir = gDirectory;
+ runLoader->CdGAFile();
+
+ AliTRDgeometry* geom = (AliTRDgeometry*) gDirectory->Get("TRDgeometry");
+ if (!geom) ::Error("AliTRDgeometry::GetGeometry", "Geometry not found");
+
+ saveDir->cd();
+ return geom;
+}
#include "AliGeometry.h"
+class AliRunLoader;
class AliTRDparameter;
class AliTRDgeometry : public AliGeometry {
static Double_t GetAlpha() { return 2 * 3.14159265358979323846 / fgkNsect; };
+ static AliTRDgeometry* GetGeometry(AliRunLoader* runLoader = NULL);
+
protected:
static const Int_t fgkNsect; // Number of sectors in the full detector (18)
// //
///////////////////////////////////////////////////////////////////////////////
+#include <TRandom.h>
+
#include "AliRun.h"
#include "AliMagF.h"
-#include "AliTRD.h"
#include "AliTRDparameter.h"
#include "AliTRDgeometryFull.h"
#include <TParticle.h>
#include "AliRun.h"
-#include "AliTRD.h"
#include "AliTRDpid.h"
#include "AliTRDcluster.h"
#include "AliTRDtrack.h"
}
gAlice->GetEvent(event);
- AliTRD *trd = (AliTRD *) gAlice->GetDetector("TRD");
- if (!trd) {
- printf("AliTRDpid::ReadKine -- ");
- printf("No TRD object found\n");
- return kFALSE;
- }
-
- fGeometry = trd->GetGeometry();
+ fGeometry = AliTRDgeometry::GetGeometry(gAlice->GetRunLoader());
if (!fGeometry) {
printf("AliTRDpid::ReadKine -- ");
printf("No TRD geometry found\n");
#include <TParticle.h>
#include "AliRun.h"
-#include "AliTRD.h"
#include "AliTRDpidLQ.h"
#include "AliTRDcluster.h"
#include "AliTRDtrack.h"
#include "AliTRDgeometry.h"
#include "AliTRDrecPoint.h"
-#include "AliTRD.h"
ClassImp(AliTRDrecPoint)
fDetector = 0;
- AliTRD *trd;
- if ((gAlice) &&
- (trd = ((AliTRD*) gAlice->GetDetector("TRD")))) {
- fGeom = trd->GetGeometry();
- }
- else {
- fGeom = NULL;
- }
+ fGeom = AliTRDgeometry::GetGeometry();
}
fDetector = 0;
- AliTRD *trd;
- if ((gAlice) &&
- (trd = ((AliTRD*) gAlice->GetDetector("TRD")))) {
- fGeom = trd->GetGeometry();
- }
- else {
- fGeom = NULL;
- }
+ fGeom = AliTRDgeometry::GetGeometry();
}
#include "AliRun.h"
-#include "AliTRD.h"
#include "AliTRDgeometry.h"
#include "AliTRDsegmentArray.h"
#include "AliTRDdataArray.h"
if (gAlice) {
- AliTRDgeometry *geo = ((AliTRD*) gAlice->GetDetector("TRD"))->GetGeometry();
+ AliTRDgeometry *geo = AliTRDgeometry::GetGeometry(gAlice->GetRunLoader());
Int_t det = geo->GetDetector(pla,cha,sec);
return GetDataArray(det);
#include "AliTRDgeometry.h"
#include "AliTRDcluster.h"
#include "AliTRDtrack.h"
-#include "../TPC/AliTPCtrack.h"
#include "AliESDtrack.h"
#include "AliTRDclusterCorrection.h"
class AliTRDparameter;
class AliTRDtrack;
class AliTRDcluster;
-class AliTRDmcTrack;
class AliBarrelTrack;
class AliESD;
#include "AliRun.h"
#include "AliTRDgeometry.h"
#include "AliTRDhit.h"
-#include "AliTRDmatrix.h"
#include "AliTRDsim.h"
#include "AliTRDv1.h"
#include "AliMC.h"
+++ /dev/null
-#ifdef __CINT__
-/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
- * See cxx source for full Copyright notice */
-
-/* $Id$ */
-
-#pragma link off all globals;
-#pragma link off all classes;
-#pragma link off all functions;
-
-#pragma link C++ class AliTRD+;
-#pragma link C++ class AliTRDv0+;
-#pragma link C++ class AliTRDv1+;
-#pragma link C++ class AliTRDv2+;
-#pragma link C++ class AliTRDhit+;
-#pragma link C++ class AliTRDdigit+;
-#pragma link C++ class AliTRDdigitsManager+;
-#pragma link C++ class AliTRDpixel+;
-#pragma link C++ class AliTRDmatrix+;
-#pragma link C++ class AliTRDgeometry+;
-#pragma link C++ class AliTRDgeometryFull+;
-#pragma link C++ class AliTRDgeometryHole+;
-#pragma link C++ class AliTRDgeometryDetail+;
-#pragma link C++ class AliTRDdigitizer+;
-#pragma link C++ class AliTRDclusterizer+;
-#pragma link C++ class AliTRDclusterizerV0+;
-#pragma link C++ class AliTRDclusterizerV1+;
-#pragma link C++ class AliTRDclusterizerMI+;
-#pragma link C++ class AliTRDclusterCorrection+;
-
-#pragma link C++ class AliTRDrecPoint+;
-#pragma link C++ class AliTRDsegmentArray+;
-#pragma link C++ class AliTRDdataArray+;
-#pragma link C++ class AliTRDdataArrayI+;
-#pragma link C++ class AliTRDdataArrayF+;
-#pragma link C++ class AliTRDsim+;
-#pragma link C++ class AliTRDpoints+;
-#pragma link C++ class AliTRDtrack+;
-#pragma link C++ class AliTRDtracker+;
-#pragma link C++ class AliTRDtrackHits+;
-#pragma link C++ class AliTRDcluster+;
-#pragma link C++ class AliTRDclusterMI+;
-
-#pragma link C++ class AliTRDpid+;
-#pragma link C++ class AliTRDpidLQ+;
-#pragma link C++ class AliTRDmcTrack+;
-#pragma link C++ class AliTRDsimple+;
-#pragma link C++ class AliTRDsimpleMC+;
-#pragma link C++ class AliTRDsimpleGen+;
-#pragma link C++ class AliTRDsegmentID+;
-#pragma link C++ class AliTRDsegmentArrayBase+;
-#pragma link C++ class AliTRDarrayI+;
-#pragma link C++ class AliTRDarrayF+;
-#pragma link C++ class AliTRDparameter+;
-#pragma link C++ class AliTRDPartID+;
-
-#pragma link C++ class AliTRDReconstructor+;
-
-#endif
--- /dev/null
+#ifdef __CINT__
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice */
+
+/* $Id$ */
+
+#pragma link off all globals;
+#pragma link off all classes;
+#pragma link off all functions;
+
+#pragma link C++ class AliTRDarrayI+;
+#pragma link C++ class AliTRDarrayF+;
+#pragma link C++ class AliTRDsegmentID+;
+
+#pragma link C++ class AliTRDdataArray+;
+#pragma link C++ class AliTRDdataArrayI+;
+#pragma link C++ class AliTRDdataArrayF+;
+
+#pragma link C++ class AliTRDsegmentArrayBase+;
+#pragma link C++ class AliTRDsegmentArray+;
+
+#pragma link C++ class AliTRDgeometry+;
+#pragma link C++ class AliTRDgeometryFull+;
+#pragma link C++ class AliTRDgeometryHole+;
+#pragma link C++ class AliTRDgeometryDetail+;
+#pragma link C++ class AliTRDparameter+;
+
+#pragma link C++ class AliTRDdigit+;
+#pragma link C++ class AliTRDdigitsManager+;
+
+#endif
--- /dev/null
+#ifdef __CINT__
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice */
+
+/* $Id$ */
+
+#pragma link off all globals;
+#pragma link off all classes;
+#pragma link off all functions;
+
+#pragma link C++ class AliTRDclusterizerV0+;
+
+#endif
--- /dev/null
+#ifdef __CINT__
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice */
+
+/* $Id$ */
+
+#pragma link off all globals;
+#pragma link off all classes;
+#pragma link off all functions;
+
+#pragma link C++ class AliTRDpixel+;
+#pragma link C++ class AliTRDmatrix+;
+
+#pragma link C++ class AliTRDrecPoint+;
+#pragma link C++ class AliTRDcluster+;
+#pragma link C++ class AliTRDclusterMI+;
+
+#pragma link C++ class AliTRDclusterizer+;
+#pragma link C++ class AliTRDclusterizerV1+;
+
+#pragma link C++ class AliTRDclusterCorrection+;
+#pragma link C++ class AliTRDclusterizerMI+;
+
+#pragma link C++ class AliTRDtrack+;
+#pragma link C++ class AliTRDtracker+;
+
+#pragma link C++ class AliTRDpid+;
+#pragma link C++ class AliTRDpidLQ+;
+#pragma link C++ class AliTRDPartID+;
+
+#pragma link C++ class AliTRDReconstructor+;
+
+#endif
--- /dev/null
+#ifdef __CINT__
+/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
+ * See cxx source for full Copyright notice */
+
+/* $Id$ */
+
+#pragma link off all globals;
+#pragma link off all classes;
+#pragma link off all functions;
+
+#pragma link C++ class AliTRDhit+;
+#pragma link C++ class AliTRDtrackHits+;
+#pragma link C++ class AliTRDpoints+;
+
+#pragma link C++ class AliTRDsim+;
+#pragma link C++ class AliTRD+;
+#pragma link C++ class AliTRDv0+;
+#pragma link C++ class AliTRDv1+;
+#pragma link C++ class AliTRDv2+;
+
+#pragma link C++ class AliTRDmcTrack+;
+#pragma link C++ class AliTRDsimple+;
+#pragma link C++ class AliTRDsimpleMC+;
+#pragma link C++ class AliTRDsimpleGen+;
+
+#pragma link C++ class AliTRDdigitizer+;
+
+#endif
+++ /dev/null
-SRCS= AliTRD.cxx \
- AliTRDv0.cxx \
- AliTRDv1.cxx \
- AliTRDv2.cxx \
- AliTRDhit.cxx \
- AliTRDdigit.cxx \
- AliTRDpixel.cxx \
- AliTRDmatrix.cxx \
- AliTRDgeometry.cxx \
- AliTRDgeometryFull.cxx \
- AliTRDgeometryDetail.cxx \
- AliTRDgeometryHole.cxx \
- AliTRDdigitizer.cxx \
- AliTRDclusterizer.cxx \
- AliTRDclusterizerV0.cxx \
- AliTRDclusterizerV1.cxx \
- AliTRDrecPoint.cxx \
- AliTRDsegmentArray.cxx \
- AliTRDdataArray.cxx \
- AliTRDdataArrayI.cxx \
- AliTRDdataArrayF.cxx \
- AliTRDdigitsManager.cxx \
- AliTRDsim.cxx \
- AliTRDsegmentID.cxx \
- AliTRDsegmentArrayBase.cxx \
- AliTRDarrayI.cxx \
- AliTRDarrayF.cxx \
- AliTRDpoints.cxx \
- AliTRDtrack.cxx \
- AliTRDtracker.cxx \
- AliTRDtrackHits.cxx \
- AliTRDcluster.cxx \
- AliTRDpid.cxx \
- AliTRDpidLQ.cxx \
- AliTRDmcTrack.cxx \
- AliTRDsimple.cxx \
- AliTRDsimpleMC.cxx \
- AliTRDsimpleGen.cxx \
- AliTRDparameter.cxx \
- AliTRDPartID.cxx \
- AliTRDclusterMI.cxx \
- AliTRDclusterizerMI.cxx \
- AliTRDclusterCorrection.cxx \
- AliTRDReconstructor.cxx
-
-HDRS= $(SRCS:.cxx=.h)
-
-DHDR= TRDLinkDef.h
--- /dev/null
+SRCS= AliTRDarrayI.cxx \
+ AliTRDarrayF.cxx \
+ AliTRDsegmentID.cxx \
+ AliTRDdataArray.cxx \
+ AliTRDdataArrayI.cxx \
+ AliTRDdataArrayF.cxx \
+ AliTRDsegmentArrayBase.cxx \
+ AliTRDsegmentArray.cxx \
+ AliTRDgeometry.cxx \
+ AliTRDgeometryFull.cxx \
+ AliTRDgeometryDetail.cxx \
+ AliTRDgeometryHole.cxx \
+ AliTRDparameter.cxx \
+ AliTRDdigit.cxx \
+ AliTRDdigitsManager.cxx
+
+HDRS= $(SRCS:.cxx=.h)
+
+DHDR= TRDbaseLinkDef.h
--- /dev/null
+SRCS= AliTRDclusterizerV0.cxx
+
+HDRS= $(SRCS:.cxx=.h)
+
+DHDR= TRDfastLinkDef.h
--- /dev/null
+SRCS= AliTRDpixel.cxx \
+ AliTRDmatrix.cxx \
+ AliTRDrecPoint.cxx \
+ AliTRDcluster.cxx \
+ AliTRDclusterMI.cxx \
+ AliTRDclusterizer.cxx \
+ AliTRDclusterizerV1.cxx \
+ AliTRDclusterCorrection.cxx \
+ AliTRDclusterizerMI.cxx \
+ AliTRDtrack.cxx \
+ AliTRDtracker.cxx \
+ AliTRDpid.cxx \
+ AliTRDpidLQ.cxx \
+ AliTRDPartID.cxx \
+ AliTRDReconstructor.cxx
+
+HDRS= $(SRCS:.cxx=.h)
+
+DHDR= TRDrecLinkDef.h
--- /dev/null
+SRCS= AliTRDhit.cxx \
+ AliTRDtrackHits.cxx \
+ AliTRDpoints.cxx \
+ AliTRDsim.cxx \
+ AliTRD.cxx \
+ AliTRDv0.cxx \
+ AliTRDv1.cxx \
+ AliTRDv2.cxx \
+ AliTRDmcTrack.cxx \
+ AliTRDsimple.cxx \
+ AliTRDsimpleMC.cxx \
+ AliTRDsimpleGen.cxx \
+ AliTRDdigitizer.cxx
+
+HDRS= $(SRCS:.cxx=.h)
+
+DHDR= TRDsimLinkDef.h
TOF/module.mk: TOF/libTOF.pkg
TPC/module.mk: TPC/libTPCbase.pkg TPC/libTPCsim.pkg TPC/libTPCrec.pkg TPC/libTPCfast.pkg
TPHIC/module.mk: TPHIC/libTPHIC.pkg
-TRD/module.mk: TRD/libTRD.pkg
+TRD/module.mk: TRD/libTRDbase.pkg TRD/libTRDsim.pkg TRD/libTRDrec.pkg TRD/libTRDfast.pkg
VZERO/module.mk: VZERO/libVZERO.pkg
ZDC/module.mk: ZDC/libZDC.pkg
+TRACKING/module.mk: TRACKING/libTRACKING.pkg