X-Git-Url: http://git.uio.no/git/?a=blobdiff_plain;f=ITS%2FAliITStrackerMI.h;h=1a8b6bdb986de8263b1f95d1ece70bf10a1d2202;hb=09929b1a52822f9e303089fc99971172c15ab94e;hp=a8e26ead5c6088f2138209a9f6389318b7d2e94a;hpb=65780d250b0175702c85ed127ca799bcbb3bbfc5;p=u%2Fmrichter%2FAliRoot.git diff --git a/ITS/AliITStrackerMI.h b/ITS/AliITStrackerMI.h index a8e26ead5c6..1a8b6bdb986 100644 --- a/ITS/AliITStrackerMI.h +++ b/ITS/AliITStrackerMI.h @@ -1,106 +1,142 @@ #ifndef ALIITSTRACKERMI_H #define ALIITSTRACKERMI_H -/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. * +/* Copyright(c) 2007-2009, ALICE Experiment at CERN, All rights reserved. * * See cxx source for full Copyright notice */ +/* $Id$ */ + //------------------------------------------------------------------------- // ITS tracker // reads AliITSclusterMI clusters and creates AliITStrackMI tracks // Origin: Marian Ivanov, CERN, Marian.Ivanov@cern.ch +// Current support and development: +// Andrea Dainese, andrea.dainese@lnl.infn.it //------------------------------------------------------------------------- -#include - -#include "AliTracker.h" -#include "AliITStrackMI.h" -#include "AliITSclusterV2.h" -#include "AliV0vertex.h" - -class AliESD; -class AliITSgeom; class TTree; -class AliHelix; -class AliV0vertex; -class AliESDV0MI; +class TTreeSRedirector; +class AliESDEvent; +class AliITSPlaneEff; +class AliITSChannelStatus; +class AliITSDetTypeRec; +class AliPlaneEff; +#include +#include "AliITStrackMI.h" +#include "AliITSRecPoint.h" +#include "AliTracker.h" +#include "AliRefArray.h" +#include "AliITSPIDResponse.h" //------------------------------------------------------------------------- class AliITStrackerMI : public AliTracker { public: - AliITStrackerMI():AliTracker(){} - virtual ~AliITStrackerMI() { - delete[] fCoeficients; - } - - AliITStrackerMI(const AliITSgeom *geom); + AliITStrackerMI(); + AliITStrackerMI(const Char_t *geom); + virtual ~AliITStrackerMI(); AliCluster *GetCluster(Int_t index) const; - AliITSclusterV2 *GetClusterLayer(Int_t layn, Int_t ncl) const + virtual Bool_t GetTrackPoint(Int_t index, AliTrackPoint& p) const; + virtual Bool_t GetTrackPointTrackingError(Int_t index, + AliTrackPoint& p, const AliESDtrack *t); + AliITSRecPoint *GetClusterLayer(Int_t layn, Int_t ncl) const {return fgLayers[layn].GetCluster(ncl);} Int_t GetNumberOfClustersLayer(Int_t layn) const {return fgLayers[layn].GetNumberOfClusters();} Int_t LoadClusters(TTree *cf); void UnloadClusters(); - Int_t Clusters2Tracks(AliESD *event); - Int_t PropagateBack(AliESD *event); - Int_t RefitInward(AliESD *event); - Bool_t RefitAt(Double_t x, AliITStrackMI *seed, const AliITStrackMI *t); - void SetupFirstPass(Int_t *flags, Double_t *cuts=0); - void SetupSecondPass(Int_t *flags, Double_t *cuts=0); + void FillClusterArray(TObjArray* array) const; + Int_t Clusters2Tracks(AliESDEvent *event); + Int_t PropagateBack(AliESDEvent *event); + Int_t RefitInward(AliESDEvent *event); + Bool_t RefitAt(Double_t x, AliITStrackMI *track, + const AliITStrackMI *clusters, Bool_t extra=kFALSE, Bool_t planeeff=kFALSE); + Bool_t RefitAt(Double_t x, AliITStrackMI *track, + const Int_t *clusters, Bool_t extra=kFALSE, Bool_t planeeff=kFALSE); + void SetupFirstPass(const Int_t *flags,const Double_t *cuts=0); + void SetupSecondPass(const Int_t *flags,const Double_t *cuts=0); void SetLastLayerToTrackTo(Int_t l=0) {fLastLayerToTrackTo=l;} - void SetLayersNotToSkip(Int_t *l); void UseClusters(const AliKalmanTrack *t, Int_t from=0) const; - void GetNTeor(Int_t layer, const AliITSclusterV2* cl, Float_t theta, Float_t phi, Float_t &ny, Float_t &nz); - Int_t GetError(Int_t layer, const AliITSclusterV2*cl, Float_t theta, Float_t phi, Float_t expQ, Float_t &erry, Float_t &errz); - Double_t GetPredictedChi2MI(AliITStrackMI* track, const AliITSclusterV2 *cluster,Int_t layer); - Int_t UpdateMI(AliITStrackMI* track, const AliITSclusterV2* cl,Double_t chi2,Int_t layer) const; + + void GetDCASigma(const AliITStrackMI* track, Float_t & sigmarfi, Float_t &sigmaz); + Double_t GetPredictedChi2MI(AliITStrackMI* track, const AliITSRecPoint *cluster,Int_t layer); + Int_t UpdateMI(AliITStrackMI* track, const AliITSRecPoint* cl,Double_t chi2,Int_t layer) const; + AliPlaneEff *GetPlaneEff() {return (AliPlaneEff*)fPlaneEff;} // return the pointer to AliPlaneEff + void SetDetTypeRec(const AliITSDetTypeRec *detTypeRec) {fkDetTypeRec = detTypeRec; ReadBadFromDetTypeRec(); } + TObjArray* GetTrackHypothesys() {return &fTrackHypothesys;} + TObjArray* GetBestHypothesys() {return &fBestHypothesys;} + TObjArray* GetOriginal() {return &fOriginal;} + TTreeSRedirector *GetDebugStreamer() const {return fDebugStreamer;} + static Int_t CorrectForTPCtoITSDeadZoneMaterial(AliITStrackMI *t); + void SetForceSkippingOfLayer(); + Int_t ForceSkippingOfLayer(Int_t l) const { return fForceSkippingOfLayer[l]; } + // + // methods for debugging (RS) >> + Int_t FindClusterOfTrack(int label, int lr, int* store) const; + // Int_t GetPattern(const AliITStrackMI* track, char* patt); + // methods for debugging (RS) << + // class AliITSdetector { public: - AliITSdetector(){} - AliITSdetector(Double_t r,Double_t phi) {fR=r; fPhi=phi; fSinPhi = TMath::Sin(phi); fCosPhi = TMath::Cos(phi); - fYmin=10000;fYmax=-1000; fZmin=10000;fZmax=-1000;} - inline void GetGlobalXYZ( const AliITSclusterV2 *cl, Double_t xyz[3]) const; + AliITSdetector():fR(0),fRmisal(0),fPhi(0),fSinPhi(0),fCosPhi(0),fYmin(0),fYmax(0),fZmin(0),fZmax(0),fIsBad(kFALSE),fNChips(0),fChipIsBad(0) {} + AliITSdetector(Double_t r,Double_t phi):fR(r),fRmisal(r),fPhi(phi),fSinPhi(TMath::Sin(phi)),fCosPhi(TMath::Cos(phi)),fYmin(10000),fYmax(-1000),fZmin(10000),fZmax(-1000),fIsBad(kFALSE),fNChips(0),fChipIsBad(0) {} + ~AliITSdetector() {if(fChipIsBad) delete [] fChipIsBad;} + inline void GetGlobalXYZ( const AliITSRecPoint *cl, Double_t xyz[3]) const; Double_t GetR() const {return fR;} + Double_t GetRmisal() const {return fRmisal;} Double_t GetPhi() const {return fPhi;} Double_t GetYmin() const {return fYmin;} Double_t GetYmax() const {return fYmax;} Double_t GetZmin() const {return fZmin;} Double_t GetZmax() const {return fZmax;} + Bool_t IsBad() const {return fIsBad;} + Int_t GetNChips() const {return fNChips;} + Bool_t IsChipBad(Int_t iChip) const {return (fChipIsBad ? fChipIsBad[iChip] : kFALSE);} + void SetRmisal(Double_t rmisal) {fRmisal = rmisal;} void SetYmin(Double_t min) {fYmin = min;} void SetYmax(Double_t max) {fYmax = max;} void SetZmin(Double_t min) {fZmin = min;} void SetZmax(Double_t max) {fZmax = max;} + void SetBad() {fIsBad = kTRUE;} + void ReadBadDetectorAndChips(Int_t ilayer,Int_t idet,const AliITSDetTypeRec *detTypeRec); private: - Double_t fR; // polar coordinates - Double_t fPhi; // of this detector + AliITSdetector(const AliITSdetector& det); + AliITSdetector & operator=(const AliITSdetector& det){ + this->~AliITSdetector();new(this) AliITSdetector(det); + return *this;} + Double_t fR; // polar coordinates: r + Double_t fRmisal; // polar coordinates: r, with misalignment + Double_t fPhi; // polar coordinates: phi Double_t fSinPhi; // sin of phi; Double_t fCosPhi; // cos of phi Double_t fYmin; // local y minimal Double_t fYmax; // local max y Double_t fZmin; // local z min Double_t fZmax; // local z max + Bool_t fIsBad; // is detector dead or noisy? + Int_t fNChips; // number of chips + Bool_t *fChipIsBad; //[fNChips] is chip dead or noisy? }; class AliITSlayer { - friend class AliITStrackerMI; public: AliITSlayer(); AliITSlayer(Double_t r, Double_t p, Double_t z, Int_t nl, Int_t nd); - ~AliITSlayer(); - Int_t InsertCluster(AliITSclusterV2 *c); + ~AliITSlayer(); + Int_t InsertCluster(AliITSRecPoint *c); void SortClusters(); void ResetClusters(); void ResetWeights(); - void SelectClusters(Double_t zmi,Double_t zma,Double_t ymi,Double_t yma); - const AliITSclusterV2 *GetNextCluster(Int_t &ci); + void SelectClusters(Double_t zmin,Double_t zmax,Double_t ymin,Double_t ymax); + const AliITSRecPoint *GetNextCluster(Int_t &ci,Bool_t test=kFALSE); void ResetRoad(); Double_t GetRoad() const {return fRoad;} Double_t GetR() const {return fR;} Int_t FindClusterIndex(Float_t z) const; - AliITSclusterV2 *GetCluster(Int_t i) const {return i~AliITSlayer();new(this) AliITSlayer(layer); + return *this;} Double_t fR; // mean radius of this layer Double_t fPhiOffset; // offset of the first detector in Phi Int_t fNladders; // number of ladders @@ -121,45 +163,46 @@ public: Int_t fNdetectors; // detectors/ladder AliITSdetector *fDetectors; // array of detectors Int_t fN; // number of clusters - AliITSclusterV2 *fClusters[kMaxClusterPerLayer]; // pointers to clusters - Int_t fClusterIndex[kMaxClusterPerLayer]; // pointers to clusters - Float_t fY[kMaxClusterPerLayer]; // y position of the clusters - Float_t fZ[kMaxClusterPerLayer]; // z position of the clusters + AliITSRecPoint *fClusters[AliITSRecoParam::kMaxClusterPerLayer]; // pointers to clusters + Int_t fClusterIndex[AliITSRecoParam::kMaxClusterPerLayer]; // pointers to clusters + Float_t fY[AliITSRecoParam::kMaxClusterPerLayer]; // y position of the clusters + Float_t fZ[AliITSRecoParam::kMaxClusterPerLayer]; // z position of the clusters Float_t fYB[2]; // ymin and ymax // - AliITSclusterV2 *fClusters5[6][kMaxClusterPerLayer5]; // pointers to clusters - slice in y - Int_t fClusterIndex5[6][kMaxClusterPerLayer5]; // pointers to clusters - slice in y - Float_t fY5[6][kMaxClusterPerLayer5]; // y position of the clusters slice in y - Float_t fZ5[6][kMaxClusterPerLayer5]; // z position of the clusters slice in y + AliITSRecPoint *fClusters5[6][AliITSRecoParam::kMaxClusterPerLayer5]; // pointers to clusters - slice in y + Int_t fClusterIndex5[6][AliITSRecoParam::kMaxClusterPerLayer5]; // pointers to clusters - slice in y + Float_t fY5[6][AliITSRecoParam::kMaxClusterPerLayer5]; // y position of the clusters slice in y + Float_t fZ5[6][AliITSRecoParam::kMaxClusterPerLayer5]; // z position of the clusters slice in y Int_t fN5[6]; // number of cluster in slice Float_t fDy5; //delta y Float_t fBy5[6][2]; //slice borders // - AliITSclusterV2 *fClusters10[11][kMaxClusterPerLayer10]; // pointers to clusters - slice in y - Int_t fClusterIndex10[11][kMaxClusterPerLayer10]; // pointers to clusters - slice in y - Float_t fY10[11][kMaxClusterPerLayer10]; // y position of the clusters slice in y - Float_t fZ10[11][kMaxClusterPerLayer10]; // z position of the clusters slice in y + AliITSRecPoint *fClusters10[11][AliITSRecoParam::kMaxClusterPerLayer10]; // pointers to clusters - slice in y + Int_t fClusterIndex10[11][AliITSRecoParam::kMaxClusterPerLayer10]; // pointers to clusters - slice in y + Float_t fY10[11][AliITSRecoParam::kMaxClusterPerLayer10]; // y position of the clusters slice in y + Float_t fZ10[11][AliITSRecoParam::kMaxClusterPerLayer10]; // z position of the clusters slice in y Int_t fN10[11]; // number of cluster in slice Float_t fDy10; // delta y Float_t fBy10[11][2]; // slice borders // - AliITSclusterV2 *fClusters20[21][kMaxClusterPerLayer20]; // pointers to clusters - slice in y - Int_t fClusterIndex20[21][kMaxClusterPerLayer20]; // pointers to clusters - slice in y - Float_t fY20[21][kMaxClusterPerLayer20]; // y position of the clusters slice in y - Float_t fZ20[21][kMaxClusterPerLayer20]; // z position of the clusters slice in y + AliITSRecPoint *fClusters20[21][AliITSRecoParam::kMaxClusterPerLayer20]; // pointers to clusters - slice in y + Int_t fClusterIndex20[21][AliITSRecoParam::kMaxClusterPerLayer20]; // pointers to clusters - slice in y + Float_t fY20[21][AliITSRecoParam::kMaxClusterPerLayer20]; // y position of the clusters slice in y + Float_t fZ20[21][AliITSRecoParam::kMaxClusterPerLayer20]; // z position of the clusters slice in y Int_t fN20[21]; // number of cluster in slice Float_t fDy20; //delta y Float_t fBy20[21][2]; //slice borders // - AliITSclusterV2** fClustersCs; //clusters table in current slice + AliITSRecPoint** fClustersCs; //clusters table in current slice Int_t *fClusterIndexCs; //cluster index in current slice Float_t *fYcs; //y position in current slice Float_t *fZcs; //z position in current slice Int_t fNcs; //number of clusters in current slice Int_t fCurrentSlice; //current slice // - Float_t fClusterWeight[kMaxClusterPerLayer]; // probabilistic weight of the cluster - Int_t fClusterTracks[4][kMaxClusterPerLayer]; //tracks registered to given cluster + Float_t fClusterWeight[AliITSRecoParam::kMaxClusterPerLayer]; // probabilistic weight of the cluster + Int_t fClusterTracks[4][AliITSRecoParam::kMaxClusterPerLayer]; //tracks registered to given cluster + Float_t fZmin; // the Float_t fZmax; // edges Float_t fYmin; // of the Float_t fYmax; // "window" @@ -168,18 +211,25 @@ public: Int_t fSkip; // indicates possibility to skip cluster Int_t fAccepted; // accept indicator Double_t fRoad; // road defined by the cluster density + Double_t fMaxSigmaClY; // maximum cluster error Y (to enlarge road) + Double_t fMaxSigmaClZ; // maximum cluster error Z (to enlarge road) + Double_t fNMaxSigmaCl; // number of sigma for road enlargement }; AliITStrackerMI::AliITSlayer & GetLayer(Int_t layer) const; AliITStrackerMI::AliITSdetector & GetDetector(Int_t layer, Int_t n) const {return GetLayer(layer).GetDetector(n); } - + Int_t GetNearestLayer(const Double_t *xr) const; //get nearest upper layer close to the point xr + void SetCurrentEsdTrack(Int_t i) {fCurrentEsdTrack=i;} + void FollowProlongationTree(AliITStrackMI * otrack, Int_t esdindex, Bool_t constrain); + // + void FlagFakes(const TObjArray &itsTracks); + // protected: - void FindV0(AliESD *event); //try to find V0 - Double_t TestV0(AliHelix *h1, AliHelix *h2, AliESDV0MI *vertex); //try to find V0 - return DCA - Double_t FindBestPair(Int_t esdtrack0, Int_t esdtrack1,AliESDV0MI *vertex); // try to find best pair from the tree of track hyp. + Bool_t ComputeRoad(AliITStrackMI* track,Int_t ilayer,Int_t idet,Double_t &zmin,Double_t &zmax,Double_t &ymin,Double_t &ymax) const; + void CookLabel(AliKalmanTrack *t,Float_t wrong) const; void CookLabel(AliITStrackMI *t,Float_t wrong) const; - Double_t GetEffectiveThickness(Double_t y, Double_t z) const; - void FollowProlongationTree(AliITStrackMI * otrack, Int_t esdindex); + Double_t GetEffectiveThickness(); + Int_t GetEffectiveThicknessLbyL(Double_t* xMS, Double_t* x2x0MS); void ResetBestTrack() { fBestTrack.~AliITStrackMI(); new(&fBestTrack) AliITStrackMI(fTrackToFollow); @@ -189,48 +239,104 @@ protected: new(&fTrackToFollow) AliITStrackMI(t); } void CookdEdx(AliITStrackMI* track); + + Int_t GetParticleId(const AliESDtrack* track) const{ + ULong_t trStatus=track->GetStatus(); + Bool_t isSA=kTRUE; if(trStatus&AliESDtrack::kTPCin) isSA=kFALSE; + return fITSPid->GetParticleIdFromdEdxVsP(track->P(),track->GetITSsignal(),isSA); + } + Int_t GetParticleId(const AliITStrackV2* track) const{ + if(track->GetESDtrack()) return GetParticleId(track->GetESDtrack()); + return fITSPid->GetParticleIdFromdEdxVsP(track->P(),track->GetdEdx(),kFALSE); + } + Double_t GetNormalizedChi2(AliITStrackMI * track, Int_t mode); - Double_t GetTruncatedChi2(AliITStrackMI * track, Float_t fac); + Double_t GetTruncatedChi2(const AliITStrackMI * track, Float_t fac); Double_t NormalizedChi2(AliITStrackMI * track, Int_t layer); - Double_t GetInterpolatedChi2(AliITStrackMI * forwardtrack, AliITStrackMI * backtrack); - Double_t GetMatchingChi2(AliITStrackMI * track1, AliITStrackMI * track2); - Double_t GetDeadZoneProbability(Double_t zpos, Double_t zerr); + Double_t GetInterpolatedChi2(const AliITStrackMI * forwardtrack,const AliITStrackMI * backtrack); + Double_t GetMatchingChi2(const AliITStrackMI * track1,const AliITStrackMI * track2); + Double_t GetSPDDeadZoneProbability(Double_t zpos, Double_t zerr) const; Float_t *GetWeight(Int_t index); void AddTrackHypothesys(AliITStrackMI * track, Int_t esdindex); void SortTrackHypothesys(Int_t esdindex, Int_t maxcut, Int_t mode); AliITStrackMI * GetBestHypothesys(Int_t esdindex, AliITStrackMI * original, Int_t checkmax); void GetBestHypothesysMIP(TObjArray &itsTracks); - void RegisterClusterTracks(AliITStrackMI* track, Int_t id); - void UnRegisterClusterTracks(AliITStrackMI* track, Int_t id); - Float_t GetNumberOfSharedClusters(AliITStrackMI* track,Int_t id, Int_t list[6], AliITSclusterV2 *clist[6]); - Int_t GetOverlapTrack(AliITStrackMI *track, Int_t trackID, Int_t &shared, Int_t clusterlist[6], Int_t overlist[6]); - AliITStrackMI * GetBest2Tracks(Int_t trackID1, Int_t treackID2, Float_t th0, Float_t th1); - Float_t * GetErrY(Int_t trackindex) const {return &fCoeficients[trackindex*48];} - Float_t * GetErrZ(Int_t trackindex) const {return &fCoeficients[trackindex*48+12];} - Float_t * GetNy(Int_t trackindex) const {return &fCoeficients[trackindex*48+24];} - Float_t * GetNz(Int_t trackindex) const {return &fCoeficients[trackindex*48+36];} - void SignDeltas( TObjArray *ClusterArray, Float_t zv); - void MakeCoeficients(Int_t ntracks); + void RegisterClusterTracks(const AliITStrackMI* track, Int_t id); + void UnRegisterClusterTracks(const AliITStrackMI* track, Int_t id); + Float_t GetNumberOfSharedClusters(AliITStrackMI* track,Int_t id, Int_t list[6], AliITSRecPoint *clist[6]); + Int_t GetOverlapTrack(const AliITStrackMI *track, Int_t trackID, Int_t &shared, Int_t clusterlist[6], Int_t overlist[6]); + AliITStrackMI * GetBest2Tracks(Int_t trackID1, Int_t treackID2, Float_t th0, Float_t th1,AliITStrackMI* original); + Float_t * GetErrY(Int_t trackindex) const {return &fCoefficients[trackindex*48];} + Float_t * GetErrZ(Int_t trackindex) const {return &fCoefficients[trackindex*48+12];} + Float_t * GetNy(Int_t trackindex) const {return &fCoefficients[trackindex*48+24];} + Float_t * GetNz(Int_t trackindex) const {return &fCoefficients[trackindex*48+36];} + void SignDeltas(const TObjArray *clusterArray, Float_t zv); + void MakeCoefficients(Int_t ntracks); + void BuildMaterialLUT(TString material); + void MakeTrksMaterialLUT(Int_t ntracks); + void DeleteTrksMaterialLUT(); + Int_t CorrectForPipeMaterial(AliITStrackMI *t, TString direction="inward"); + Int_t CorrectForShieldMaterial(AliITStrackMI *t, TString shield, TString direction="inward"); + Int_t CorrectForLayerMaterial(AliITStrackMI *t, Int_t layerindex, Double_t oldGlobXYZ[3], TString direction="inward"); void UpdateESDtrack(AliITStrackMI* track, ULong_t flags) const; + void ReadBadFromDetTypeRec(); + Int_t CheckSkipLayer(const AliITStrackMI *track,Int_t ilayer,Int_t idet) const; + Int_t CheckDeadZone(AliITStrackMI *track,Int_t ilayer,Int_t idet,Double_t dz,Double_t dy,Bool_t noClusters=kFALSE) const; + Bool_t LocalModuleCoord(Int_t ilayer,Int_t idet,const AliITStrackMI *track, + Float_t &xloc,Float_t &zloc) const; +// method to be used for Plane Efficiency evaluation + Bool_t IsOKForPlaneEff(const AliITStrackMI* track, const Int_t *clusters, Int_t ilayer); // Check if a track is usable + // for Plane Eff evaluation + void UseTrackForPlaneEff(const AliITStrackMI* track, Int_t ilayer); // Use this track for Plane Eff +// Int_t fI; // index of the current layer - static AliITSlayer fgLayers[kMaxLayer];// ITS layers - AliITStrackMI fTracks[kMaxLayer]; // track estimations at the ITS layers + static AliITSlayer fgLayers[AliITSgeomTGeo::kNLayers];// ITS layers + AliITStrackMI fTracks[AliITSgeomTGeo::kNLayers]; // track estimations at the ITS layers AliITStrackMI fBestTrack; // "best" track AliITStrackMI fTrackToFollow; // followed track TObjArray fTrackHypothesys; // ! array with track hypothesys- ARRAY is the owner of tracks- MI - TObjArray fV0Array; // ! array of V0 + TObjArray fBestHypothesys; // ! array with track hypothesys- ARRAY is the owner of tracks- MI + TObjArray fOriginal; // ! array with seeds from the TPC Int_t fBestTrackIndex[100000]; // ! index of the best track Int_t fCurrentEsdTrack; // ! current esd track - MI Int_t fPass; // current pass through the data Int_t fConstraint[2]; // constraint flags - - Int_t fLayersNotToSkip[kMaxLayer]; // layer masks + Bool_t fAfterV0; //indicates V0 founded + Int_t fForceSkippingOfLayer[AliITSgeomTGeo::kNLayers]; // layers to be skipped Int_t fLastLayerToTrackTo; // the innermost layer to track to - Float_t * fCoeficients; //! working array with errors and mean cluser shape - private: - AliITStrackerMI(const AliITStrackerMI * /*tracker*/){;} - ClassDef(AliITStrackerMI,2) //ITS tracker MI + Float_t * fCoefficients; //! working array with errors and mean cluster shape + AliESDEvent * fEsd; //! pointer to the ESD event + Double_t fSPDdetzcentre[4]; // centres of SPD modules in z + TString fTrackingPhase; // current tracking phase + Int_t fUseTGeo; // use TGeo to get material budget + Int_t fNtracks; // number of tracks to prolong + Bool_t fFlagFakes; // request fakes flagging + Bool_t fSelectBestMIP03; // use Chi2MIP[0]*Chi2MIP[3] in hypothesis analysis instead of Chi2MIP[0] + Bool_t fUseImproveKalman; // use Kalman version of Improve + Float_t fxOverX0Pipe; // material budget + Float_t fxTimesRhoPipe; // material budget + Float_t fxOverX0Shield[2]; // material budget + Float_t fxTimesRhoShield[2]; // material budget + Float_t fxOverX0Layer[6]; // material budget + Float_t fxTimesRhoLayer[6]; // material budget + Float_t *fxOverX0PipeTrks; //! material budget + Float_t *fxTimesRhoPipeTrks; //! material budget + Float_t *fxOverX0ShieldTrks; //! material budget + Float_t *fxTimesRhoShieldTrks; //! material budget + Float_t *fxOverX0LayerTrks; //! material budget + Float_t *fxTimesRhoLayerTrks; //! material budget + TTreeSRedirector *fDebugStreamer; //!debug streamer + AliITSChannelStatus *fITSChannelStatus;//! bitmaps with channel status for SPD and SDD + const AliITSDetTypeRec *fkDetTypeRec; //! ITS det type rec, from AliITSReconstructor + AliITSPlaneEff *fPlaneEff; //! Pointer to the ITS plane efficicency + Bool_t* fSPDChipIntPlaneEff; //! Map of the SPD chips already intersected by a track (for FO studies) + AliITSPIDResponse *fITSPid; //! parameters for ITS pid + // +private: + AliITStrackerMI(const AliITStrackerMI &tracker); + AliITStrackerMI & operator=(const AliITStrackerMI &tracker); + ClassDef(AliITStrackerMI,11) //ITS tracker MI }; @@ -244,7 +350,7 @@ protected: -inline void AliITStrackerMI::SetupFirstPass(Int_t *flags, Double_t *cuts) { +inline void AliITStrackerMI::SetupFirstPass(const Int_t *flags,const Double_t *cuts) { // This function sets up flags and cuts for the first tracking pass // // flags[0] - vertex constaint flag @@ -253,10 +359,10 @@ inline void AliITStrackerMI::SetupFirstPass(Int_t *flags, Double_t *cuts) { // positive means "normal constraint" fConstraint[0]=flags[0]; - if (cuts==0) return; + if (!cuts) return; } -inline void AliITStrackerMI::SetupSecondPass(Int_t *flags, Double_t *cuts) { +inline void AliITStrackerMI::SetupSecondPass(const Int_t *flags,const Double_t *cuts) { // This function sets up flags and cuts for the second tracking pass // // flags[0] - vertex constaint flag @@ -265,7 +371,7 @@ inline void AliITStrackerMI::SetupSecondPass(Int_t *flags, Double_t *cuts) { // positive means "normal constraint" fConstraint[1]=flags[0]; - if (cuts==0) return; + if (!cuts) return; } inline void AliITStrackerMI::CookLabel(AliKalmanTrack *t,Float_t wrong) const { @@ -288,13 +394,13 @@ inline Double_t AliITStrackerMI::NormalizedChi2(AliITStrackMI * track, Int_t lay //-------------------------------------------------------------------- //get normalize chi2 //-------------------------------------------------------------------- - track->fNormChi2[layer] = 2.*track->fNSkipped+0.25*track->fNDeadZone+track->fdEdxMismatch+track->GetChi2()/ + track->SetNormChi2(layer,2.*track->GetNSkipped()+0.25*track->GetNDeadZone()+track->GetdEdxMismatch()+track->GetChi2()/ //track->fNormChi2[layer] = 2.*track->fNSkipped+0.25*track->fNDeadZone+track->fdEdxMismatch+track->fChi22/ - TMath::Max(double(track->GetNumberOfClusters()-track->fNSkipped), - 1./(1.+track->fNSkipped)); - return track->fNormChi2[layer]; + TMath::Max(double(track->GetNumberOfClusters()-track->GetNSkipped()), + 1./(1.+track->GetNSkipped()))); + return track->GetNormChi2(layer); } -inline void AliITStrackerMI::AliITSdetector::GetGlobalXYZ(const AliITSclusterV2 *cl, Double_t xyz[3]) const +inline void AliITStrackerMI::AliITSdetector::GetGlobalXYZ(const AliITSRecPoint *cl, Double_t xyz[3]) const { // // get cluster coordinates in global cooordinate @@ -304,3 +410,4 @@ inline void AliITStrackerMI::AliITSdetector::GetGlobalXYZ(const AliITSclusterV2 xyz[1] = fR*fSinPhi + cl->GetY()*fCosPhi; } #endif +