X-Git-Url: http://git.uio.no/git/?a=blobdiff_plain;f=TOF%2FAliTOFtrackerMI.cxx;h=01794c5e4a812562e8239dfa07e4fa1ff882da6e;hb=48602d36231e5d3e2f13ff2920d4f695a5bd2c49;hp=24e2d75babe133a71f721ef4abe1d52a90d3f06f;hpb=77a9ea9aeec2babca237e2e2ada17b7145a04549;p=u%2Fmrichter%2FAliRoot.git diff --git a/TOF/AliTOFtrackerMI.cxx b/TOF/AliTOFtrackerMI.cxx index 24e2d75babe..01794c5e4a8 100644 --- a/TOF/AliTOFtrackerMI.cxx +++ b/TOF/AliTOFtrackerMI.cxx @@ -24,11 +24,13 @@ #include #include "TClonesArray.h" +#include "TObjArray.h" #include "TTree.h" #include "TTreeStream.h" #include "AliESDEvent.h" #include "AliESDtrack.h" +#include "AliESDpid.h" #include "AliTOFRecoParam.h" #include "AliTOFReconstructor.h" @@ -36,7 +38,8 @@ #include "AliTOFGeometry.h" #include "AliTOFtrackerMI.h" #include "AliTOFtrack.h" -#include "AliTOFpidESD.h" + +#include "AliMathBase.h" class TGeoManager; @@ -46,9 +49,8 @@ ClassImp(AliTOFtrackerMI) //_____________________________________________________________________________ AliTOFtrackerMI::AliTOFtrackerMI(): - fRecoParam(0x0), + fkRecoParam(0x0), fGeom(0x0), - fPid(0x0), fN(0), fNseeds(0), fNseedsTOF(0), @@ -63,7 +65,7 @@ AliTOFtrackerMI::AliTOFtrackerMI(): fDy(0), fDz(0), fTracks(new TClonesArray("AliTOFtrack")), - fSeeds(new TClonesArray("AliESDtrack")), + fSeeds(new TObjArray(100)), fDebugStreamer(0x0) { //AliTOFtrackerMI main Ctor @@ -76,15 +78,14 @@ AliTOFtrackerMI::AliTOFtrackerMI(): //_____________________________________________________________________________ AliTOFtrackerMI::~AliTOFtrackerMI(){ // - // + // Destructor // if (fDebugStreamer) { //fDebugStreamer->Close(); delete fDebugStreamer; } - delete fRecoParam; + delete fkRecoParam; delete fGeom; - delete fPid; if (fTracks){ fTracks->Delete(); delete fTracks; @@ -96,30 +97,34 @@ AliTOFtrackerMI::~AliTOFtrackerMI(){ fSeeds=0x0; } } +//_____________________________________________________________________________ +void AliTOFtrackerMI::GetPidSettings(AliESDpid *esdPID) { + // + // Sets TOF resolution from RecoParams + // + if (fkRecoParam) + esdPID->GetTOFResponse().SetTimeResolution(fkRecoParam->GetTimeResolution()); + else + AliWarning("fkRecoParam not yet set; cannot set PID settings"); +} //_____________________________________________________________________________ -Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent* event) { +Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent * const event) { // // Gets seeds from ESD event and Match with TOF Clusters // // initialize RecoParam for current event + AliDebug(1,"Initializing params for TOF"); - AliInfo("Initializing params for TOF... "); + fkRecoParam = AliTOFReconstructor::GetRecoParam(); // instantiate reco param from STEER... - fRecoParam = AliTOFReconstructor::GetRecoParam(); // instantiate reco param from STEER... - - if (fRecoParam == 0x0) { + if (fkRecoParam == 0x0) { AliFatal("No Reco Param found for TOF!!!"); } - //fRecoParam->Dump(); - //if(fRecoParam->GetApplyPbPbCuts())fRecoParam=fRecoParam->GetPbPbparam(); - //fRecoParam->PrintParameters(); - - Double_t parPID[2]; - parPID[0]=fRecoParam->GetTimeResolution(); - parPID[1]=fRecoParam->GetTimeNSigma(); - fPid=new AliTOFpidESD(parPID); + //fkRecoParam->Dump(); + //if(fkRecoParam->GetApplyPbPbCuts())fkRecoParam=fkRecoParam->GetPbPbparam(); + //fkRecoParam->PrintParameters(); //Initialise some counters @@ -132,15 +137,10 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent* event) { Int_t ntrk=event->GetNumberOfTracks(); fNseeds = ntrk; - TClonesArray &aESDTrack = *fSeeds; - //Load ESD tracks into a local Array of ESD Seeds - - for (Int_t i=0; iGetTrack(i); - new(aESDTrack[i]) AliESDtrack(*t); - } + for (Int_t i=0; iAddLast(event->GetTrack(i)); //Prepare ESD tracks candidates for TOF Matching CollectESD(); @@ -153,43 +153,62 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent* event) { MatchTracksMI(kFALSE); // assign track to clusters MatchTracksMI(kTRUE); // assign clusters to esd - Info("PropagateBack","Number of matched tracks: %d",fnmatch); - Info("PropagateBack","Number of good matched tracks: %d",fngoodmatch); - Info("PropagateBack","Number of bad matched tracks: %d",fnbadmatch); + AliInfo(Form("Number of matched tracks = %d (good = %d, bad = %d)",fnmatch,fngoodmatch,fnbadmatch)); //Update the matched ESD tracks for (Int_t i=0; iGetTrack(i); - AliESDtrack *seed =(AliESDtrack*)fSeeds->UncheckedAt(i); - if(seed->GetTOFsignal()>0){ - t->SetTOFsignal(seed->GetTOFsignal()); - t->SetTOFcluster(seed->GetTOFcluster()); - Int_t tlab[3]; - seed->GetTOFLabel(tlab); - t->SetTOFLabel(tlab); - AliTOFtrack *track = new AliTOFtrack(*seed); - Float_t info[10]; - Double_t times[10]; - seed->GetTOFInfo(info); - seed->GetIntegratedTimes(times); - t->UpdateTrackParams(track,AliESDtrack::kTOFout); - t->SetIntegratedLength(seed->GetIntegratedLength()); - t->SetIntegratedTimes(times); - t->SetTOFsignalToT(seed->GetTOFsignalToT()); - t->SetTOFCalChannel(seed->GetTOFCalChannel()); - // - t->SetTOFInfo(info); - delete track; + AliESDtrack *seed =(AliESDtrack*)fSeeds->At(i); + + if ( (seed->GetStatus()&AliESDtrack::kTOFin)!=0 ) { + t->SetStatus(AliESDtrack::kTOFin); + //if(seed->GetTOFsignal()>0){ + if ( (seed->GetStatus()&AliESDtrack::kTOFout)!=0 ) { + t->SetStatus(AliESDtrack::kTOFout); + t->SetTOFsignal(seed->GetTOFsignal()); + t->SetTOFcluster(seed->GetTOFcluster()); + Int_t tlab[3]; seed->GetTOFLabel(tlab); + t->SetTOFLabel(tlab); + + // Check done: + // by calling the AliESDtrack::UpdateTrackParams, + // the current track parameters are changed + // and it could cause refit problems. + // We need to update only the following track parameters: + // the track length and expected times. + // Removed AliESDtrack::UpdateTrackParams call + // Called AliESDtrack::SetIntegratedTimes(...) and + // AliESDtrack::SetIntegratedLength() routines. + /* + AliTOFtrack *track = new AliTOFtrack(*seed); + t->UpdateTrackParams(track,AliESDtrack::kTOFout); + delete track; + */ + + Double_t times[10]; seed->GetIntegratedTimes(times); + t->SetIntegratedTimes(times); + t->SetIntegratedLength(seed->GetIntegratedLength()); + t->SetTOFsignalToT(seed->GetTOFsignalToT()); + t->SetTOFCalChannel(seed->GetTOFCalChannel()); + t->SetTOFDeltaBC(seed->GetTOFDeltaBC()); + t->SetTOFL0L1(seed->GetTOFL0L1()); + // + // Make attention, please: + // AliESDtrack::fTOFInfo array does not be stored in the AliESDs.root file + // it is there only for a check during the reconstruction step. + Float_t info[10]; + seed->GetTOFInfo(info); + t->SetTOFInfo(info); + } } } //Make TOF PID - fPid->MakePID(event); fSeeds->Clear(); - fTracks->Clear(); + fTracks->Delete(); return 0; } @@ -202,30 +221,30 @@ void AliTOFtrackerMI::CollectESD() { Int_t c1=0; for (Int_t i=0; iUncheckedAt(i); + AliESDtrack *t =(AliESDtrack*)fSeeds->At(i); if ((t->GetStatus()&AliESDtrack::kTPCout)==0)continue; - // TRD good tracks, already propagated at 372 cm - AliTOFtrack *track = new AliTOFtrack(*t); // New - Double_t x = track->GetX(); //New - - if (((t->GetStatus()&AliESDtrack::kTRDout)!=0 ) && - ( x >= AliTOFGeometry::RinTOF()) ){ - track->SetSeedIndex(i); - t->UpdateTrackParams(track,AliESDtrack::kTOFout); - new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); - fNseedsTOF++; - c0++; - delete track; + Float_t x = (Float_t)track->GetX(); //New + + // TRD good tracks, already propagated at 371 cm + if ( ( (t->GetStatus()&AliESDtrack::kTRDout)!=0 ) && + ( x >= AliTOFGeometry::Rmin() ) ) { + if ( track->PropagateToInnerTOF() ) { + track->SetSeedIndex(i); + t->UpdateTrackParams(track,AliESDtrack::kTOFin); + new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); + fNseedsTOF++; + c0++; + delete track; + } } - // Propagate the rest of TPCbp - + // Propagate the rest of TPCbp else { - if(track->PropagateToInnerTOF()){ // temporary solution + if ( track->PropagateToInnerTOF() ) { // temporary solution track->SetSeedIndex(i); - t->UpdateTrackParams(track,AliESDtrack::kTOFout); + t->UpdateTrackParams(track,AliESDtrack::kTOFin); new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); fNseedsTOF++; c1++; @@ -242,16 +261,8 @@ void AliTOFtrackerMI::CollectESD() { } - - - - - - -// -// //_________________________________________________________________________ -void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/){ +void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/) const { return; } // @@ -260,10 +271,10 @@ void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/){ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ //Match ESD tracks to clusters in TOF - const Float_t kTofOffset = 26; // time offset - const Float_t kMinQuality = -6.; // minimal quality - const Float_t kMaxQualityD = 1.; // max delta quality if cluster used - const Float_t kForbiddenR = 0.1; // minimal PID according TPC + const Float_t kTofOffset = 26; // time offset + const Float_t kMinQuality = -6.; // minimal quality + const Float_t kMaxQualityD = 1.; // max delta quality if cluster used + const Float_t kForbiddenR = 0.1; // minimal PID according TPC static const Double_t kMasses[]={ 0.000511, 0.105658, 0.139570, 0.493677, 0.938272, 1.875613 @@ -271,30 +282,28 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ Int_t nSteps=(Int_t)(fTOFHeigth/0.1); - //AliTOFcalib *calib = new AliTOFcalib(); // AdC - //PH Arrays (moved outside of the loop) Float_t * trackPos[4]; for (Int_t ii=0; ii<4; ii++) trackPos[ii] = new Float_t[nSteps]; Int_t * clind = new Int_t[fN]; // Some init - - Int_t index[1000]; - Float_t quality[1000]; - Float_t dist3D[1000][6]; - Double_t times[1000][6]; - Float_t mintimedist[1000]; - Float_t likelihood[1000]; - Float_t length[1000]; - AliTOFcluster *clusters[1000]; + const Int_t kNclusterMax = 1000; // related to fN value + AliTOFcluster *clusters[kNclusterMax]; + Int_t index[kNclusterMax]; + Float_t quality[kNclusterMax]; + Float_t dist3D[kNclusterMax][6]; + Double_t times[kNclusterMax][6]; + Float_t mintimedist[kNclusterMax]; + Float_t likelihood[kNclusterMax]; + Float_t length[kNclusterMax]; Double_t tpcpid[5]; dist3D[0][0]=1; for (Int_t i=0; iUncheckedAt(i); - AliESDtrack *t =(AliESDtrack*)fSeeds->UncheckedAt(track->GetSeedIndex()); + AliESDtrack *t =(AliESDtrack*)fSeeds->At(track->GetSeedIndex()); Bool_t hasTime = ( (t->GetStatus()& AliESDtrack::kTIME)>0) ? kTRUE:kFALSE; // did we integrate time Float_t trdquality = t->GetTRDQuality(); // @@ -346,13 +355,20 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ trackTOFin->GetExternalParameters(x,par); Double_t cov[15]; trackTOFin->GetExternalCovariance(cov); + + if (cov[0]<0. || cov[2]<0.) { + AliWarning(Form("Very strange track (%d)! At least one of its covariance matrix diagonal elements is negative!",i)); + //delete trackTOFin; + //continue; + } + Float_t scalefact=3.; Double_t dphi= scalefact* - ((5*TMath::Sqrt(cov[0]) + 3.*fDy +10.*TMath::Abs(par[2]))/fR); + ((5*TMath::Sqrt(TMath::Abs(cov[0])) + 3.*fDy + 10.*TMath::Abs(par[2]))/fR); Double_t dz= scalefact* - (5*TMath::Sqrt(cov[2]) + 3.*fDz +10.*TMath::Abs(par[3])); + (5*TMath::Sqrt(TMath::Abs(cov[2])) + 3.*fDz + 10.*TMath::Abs(par[3])); Double_t phi=TMath::ATan2(par[0],x) + trackTOFin->GetAlpha(); if (phi<-TMath::Pi())phi+=2*TMath::Pi(); @@ -364,6 +380,12 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // find the clusters in the window of the track for (Int_t k=FindClusterIndex(z-dz); k=kNclusterMax) { + AliWarning("No more matchable clusters can be stored! Please, increase the corresponding vectors size."); + break; + } + AliTOFcluster *c=fClusters[k]; if (c->GetZ() > z+dz) break; // if (c->IsUsed()) continue; @@ -376,6 +398,8 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ nc++; } + AliDebug(1,Form(" Number of matchable TOF clusters for the track number %d: %d",i,nc)); + // // select close clusters // @@ -383,10 +407,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // Bool_t dump = kTRUE; for (Int_t icl=0; icl=1000) break; + index[nfound]=clind[icl]; AliTOFcluster *cluster = fClusters[clind[icl]]; - GetLinearDistances(trackTOFin,cluster, distances); + GetLinearDistances(trackTOFin, cluster, distances); dist3D[nfound][0] = distances[4]; dist3D[nfound][1] = distances[1]; dist3D[nfound][2] = distances[2]; @@ -401,7 +425,7 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // clusters[nfound] = cluster; // - //length and TOF updates + //length and TOF updates trackTOFin->GetIntegratedTimes(times[nfound]); length[nfound] = trackTOFin->GetIntegratedLength(); length[nfound]+=distances[4]; @@ -426,7 +450,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ } // nfound++; - } + } + + AliDebug(1,Form(" Number of track points for the track number %d: %d",i,nfound)); + if (nfound == 0 ) { fnunmatch++; delete trackTOFin; @@ -435,9 +462,9 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // //choose the best cluster // - //Float_t quality[1000]; - //Int_t index[1000]; - for (Int_t kk=0; kk<1000; kk++) quality[kk]=0; + //Float_t quality[kNclusterMax]; + //Int_t index[kNclusterMax]; + for (Int_t kk=0; kkGetTDC()-350; // in ps Double_t tof2=AliTOFGeometry::TdcBinWidth()*cgold->GetTDC()+kTofOffset; // in ps Float_t tgamma = TMath::Sqrt(cgold->GetR()*cgold->GetR()+cgold->GetZ()*cgold->GetZ())/0.03; - Float_t info[11]={dist3D[igold][0],dist3D[igold][1],dist3D[igold][2],dist3D[igold][3],dist3D[igold][4],mintimedist[igold], - -1,tgamma, qualityGold,cgold->GetQuality(),0}; + Float_t info[10]={dist3D[igold][0], + dist3D[igold][1], + dist3D[igold][2], + dist3D[igold][3], + dist3D[igold][4], + mintimedist[igold], + -1, + tgamma, + qualityGold, + cgold->GetQuality()}; // GetLinearDistances(trackTOFin,cgold,&info[6]); if (inonfake>=0){ info[6] = inonfake; @@ -517,6 +552,8 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ t->SetTOFInfo(info); t->SetTOFsignal(tof2); t->SetTOFcluster(cgold->GetIndex()); + t->SetTOFDeltaBC(cgold->GetDeltaBC()); + t->SetTOFL0L1(cgold->GetL0L1Latency()); AliDebug(2, Form("%7i %7i %10i %10i %10i %10i %7i", i, @@ -572,7 +609,8 @@ Int_t AliTOFtrackerMI::LoadClusters(TTree *cTree) { for (Int_t i=0; iUncheckedAt(i); - fClusters[i]=new AliTOFcluster(*c); fN++; +//PH fClusters[i]=new AliTOFcluster(*c); fN++; + fClusters[i]=c; fN++; //AliInfo(Form("%4i %4i %f %f %f %f %f %2i %1i %2i %1i %2i",i, fClusters[i]->GetIndex(),fClusters[i]->GetZ(),fClusters[i]->GetR(),fClusters[i]->GetPhi(), fClusters[i]->GetTDC(),fClusters[i]->GetADC(),fClusters[i]->GetDetInd(0),fClusters[i]->GetDetInd(1),fClusters[i]->GetDetInd(2),fClusters[i]->GetDetInd(3),fClusters[i]->GetDetInd(4))); //AliInfo(Form("%i %f",i, fClusters[i]->GetZ())); @@ -588,7 +626,7 @@ void AliTOFtrackerMI::UnloadClusters() { //This function unloads TOF clusters //-------------------------------------------------------------------- for (Int_t i=0; iGetAngles(cluster->fdetIndex[1],cluster->fdetIndex[2])/kRaddeg; //tiltangle Int_t cind[5]; @@ -661,7 +699,7 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * Float_t phi = TMath::ATan2(cpos[1],cpos[0]); if(phi<0) phi=2.*TMath::Pi()+phi; // Get the local angle in the sector philoc - Float_t phiangle = (Int_t (phi*kRaddeg/20.) + 0.5)*20./kRaddeg; + Float_t phiangle = (Int_t (phi*kRaddeg/20.) + 0.5)*20./kRaddeg; // Double_t v0[3]; Double_t dir[3]; @@ -682,27 +720,27 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * temp = cpos[0]*cosphi+cpos[1]*sinphi; cpos[1] = -cpos[0]*sinphi+cpos[1]*cosphi; cpos[0] = temp; - temp = v0[0]*cosphi+v0[1]*sinphi; + temp = v0[0]*cosphi+v0[1]*sinphi; v0[1] = -v0[0]*sinphi+v0[1]*cosphi; v0[0] = temp; // temp = cpos[0]*costh+cpos[2]*sinth; cpos[2] = -cpos[0]*sinth+cpos[2]*costh; cpos[0] = temp; - temp = v0[0]*costh+v0[2]*sinth; - v0[2] = -v0[0]*sinth+v0[2]*costh; - v0[0] = temp; + temp = v0[0]*costh+v0[2]*sinth; + v0[2] = -v0[0]*sinth+v0[2]*costh; + v0[0] = temp; // // //rotate direction vector // - temp = dir[0]*cosphi+dir[1]*sinphi; + temp = dir[0]*cosphi+dir[1]*sinphi; dir[1] = -dir[0]*sinphi+dir[1]*cosphi; dir[0] = temp; // - temp = dir[0]*costh+dir[2]*sinth; - dir[2] = -dir[0]*sinth+dir[2]*costh; - dir[0] = temp; + temp = dir[0]*costh+dir[2]*sinth; + dir[2] = -dir[0]*sinth+dir[2]*costh; + dir[0] = temp; // Float_t v3[3]; Float_t k = (cpos[0]-v0[0])/dir[0]; @@ -719,7 +757,9 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * // // Debuging part of the matching // - if (track->GetLabel()==cluster->GetLabel(0) ||track->GetLabel()==cluster->GetLabel(1) ){ + if (track->GetLabel()==cluster->GetLabel(0) || + track->GetLabel()==cluster->GetLabel(1) || + track->GetLabel()==cluster->GetLabel(2) ){ TTreeSRedirector& cstream = *fDebugStreamer; Float_t tdc = cluster->GetTDC(); cstream<<"Tracks"<< @@ -737,9 +777,8 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * return distances[3]; } - - -void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *cov, AliTOFtrack * /*track*/, Float_t & py, Float_t &pz) +//_________________________________________________________________________ +void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *cov, AliTOFtrack * /*track*/, Float_t & py, Float_t &pz) const { // // get likelihood - track covariance taken @@ -753,8 +792,8 @@ void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *c Float_t normwidth, normd, p0,p1; - Float_t sigmay = TMath::Max(TMath::Sqrt(cov[0]+kMeanSigmaY*kMeanSigmaY),kMaxSigmaY); - Float_t sigmaz = TMath::Max(TMath::Sqrt(cov[2]+kMeanSigmaZ*kMeanSigmaZ),kMaxSigmaZ); + Float_t sigmay = TMath::Max(TMath::Sqrt(TMath::Abs(cov[0])+kMeanSigmaY*kMeanSigmaY),kMaxSigmaY); + Float_t sigmaz = TMath::Max(TMath::Sqrt(TMath::Abs(cov[2])+kMeanSigmaZ*kMeanSigmaZ),kMaxSigmaZ); py=0; pz=0; @@ -763,28 +802,28 @@ void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *c // normwidth = fDy/sigmay; normd = dy/sigmay; - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); py+= 0.75*(p1-p0); // normwidth = fDy/(3.*sigmay); normd = dy/(3.*sigmay); - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); py+= 0.25*(p1-p0); // // pz calculation - 75% admixture of original sigma - 25% tails // normwidth = fDz/sigmaz; normd = dz/sigmaz; - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); pz+= 0.75*(p1-p0); // normwidth = fDz/(3.*sigmaz); normd = dz/(3.*sigmaz); - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); pz+= 0.25*(p1-p0); } //_________________________________________________________________________