1 /**************************************************************************
2 * Copyright(c) 1998-2010 ALICE Experiment at CERN, All rights reserved. *
4 * Author: The ALICE Off-line Project. *
5 * Contributors are mentioned in the code where appropriate. *
7 * Permission to use, copy, modify and distribute this software and its *
8 * documentation strictly for non-commercial purposes is hereby granted *
9 * without fee, provided that the above copyright notice appears in all *
10 * copies and that both the copyright notice and this permission notice *
11 * appear in the supporting documentation. The authors make no claims *
12 * about the suitability of this software for any purpose. It is *
13 * provided "as is" without express or implied warranty. *
14 **************************************************************************/
18 /* History of cvs commits:
22 //______________________________________________________
23 // Author : Aleksei Pavlinov; IHEP, Protvino, Russia
25 // Implementation of fit procedure from ALICE-INT-2008-026:
26 // "Time and amplitude reconstruction from sampling
27 // measurements of the PHOS signal profile"
28 // M.Yu.Bogolyubsky and ..
30 // Fit by function en*x*x*exp(-2.*x): x = (t-t0)/tau.
31 // The main goal is fast estimation of amplitude and t0.
34 // --- AliRoot header files ---
35 #include "AliCaloFastAltroFitv0.h"
40 #include <TGraphErrors.h>
45 ClassImp(AliCaloFastAltroFitv0)
47 //____________________________________________________________________________
48 AliCaloFastAltroFitv0::AliCaloFastAltroFitv0()
50 fSig(0),fTau(0),fN(0),fPed(0), fAmp(0),fAmpErr(0),fT0(0),fT0Err(0),fChi2(0.),fNDF(0)
51 ,fNoFit(0),fNfit(0),fTfit(0),fAmpfit(0), fStdFun(0)
55 //____________________________________________________________________________
56 AliCaloFastAltroFitv0::AliCaloFastAltroFitv0(const char* name, const char* title,
57 const Double_t sig, const Double_t tau, const Double_t n)
58 : TNamed(name, title),
59 fSig(sig),fTau(tau),fN(n),fPed(0), fAmp(0),fAmpErr(0),fT0(0),fT0Err(0),fChi2(0.),fNDF(0)
60 ,fNoFit(0),fNfit(0),fTfit(0),fAmpfit(0), fStdFun(0)
62 if(strlen(name)==0) SetName("CaloFastAltroFitv0");
65 //____________________________________________________________________________
66 AliCaloFastAltroFitv0::AliCaloFastAltroFitv0(const AliCaloFastAltroFitv0 &obj)
68 fSig(0),fTau(0),fN(2.),fPed(0), fAmp(0),fAmpErr(0),fT0(0),fT0Err(0),fChi2(0.),fNDF(0)
69 ,fNoFit(0),fNfit(0),fTfit(0),fAmpfit(0), fStdFun(0)
73 //____________________________________________________________________________
74 AliCaloFastAltroFitv0::~AliCaloFastAltroFitv0()
76 if(fTfit) delete [] fTfit;
77 if(fAmpfit) delete [] fAmpfit;
80 //____________________________________________________________________________
81 AliCaloFastAltroFitv0& AliCaloFastAltroFitv0::operator= (const AliCaloFastAltroFitv0 &/*obj*/)
83 // Not implemented yet
87 void AliCaloFastAltroFitv0::FastFit(Int_t* t, Int_t* y, Int_t nPoints, Double_t sig, Double_t tau,
88 Double_t /*n*/, Double_t ped, Double_t tMax)
97 CutRightPart(t,y,nPoints,tMax, ii);
101 fTfit = new Double_t[nPoints];
102 fAmpfit = new Double_t[nPoints];
105 DeductPedestal(t,y,nPoints, tau,ped, fTfit,fAmpfit,fNfit);
106 // printf(" n %i : fNfit %i : ped %f \n", n, fNfit, ped);
107 // for(int i=0; i<fNfit; i++)
108 // printf(" i %i : fAmpfit %7.2f : fTfit %7.2f \n", i, fAmpfit[i], fTfit[i]);
111 FastFit(fTfit,fAmpfit,fNfit,sig,tau, fAmp,fAmpErr, fT0,fT0Err,fChi2);
120 Reset(); // What to do here => fT0 = fTfit[0]; fAmp = fAmpFit[0] ??
126 //____________________________________________________________________________
127 void AliCaloFastAltroFitv0::FastFit(TH1F* h, Double_t sig, Double_t tau, Double_t n,
128 Double_t ped, Double_t tMax)
130 // Service method for convinience only
131 // h - hist with altro response, could have empty bin
132 // and center of bin could be different from bin number
136 Int_t nPoints = h->GetNbinsX();
137 if(nPoints<2) return; // Sep 07, 09
139 Int_t* t = new Int_t[nPoints];
140 Int_t* y = new Int_t[nPoints];
143 for(Int_t i=0; i<nPoints; i++) {
144 if(h->GetBinContent(i+1) > 0.0){ // Get only positive
145 y[nPositive] = Int_t(h->GetBinContent(i+1));
146 t[nPositive] = Int_t(h->GetBinCenter(i+1)+0.0001);
152 FastFit(t,y,nPoints, sig,tau,n,ped, tMax);
154 if(fChi2<=0.0) fNoFit++;
160 void AliCaloFastAltroFitv0::Reset()
164 fAmp = fAmpErr = fT0 = fT0Err = 0.0;
168 if(fTfit) delete [] fTfit;
169 if(fAmpfit) delete [] fAmpfit;
174 void AliCaloFastAltroFitv0::GetFitResult(Double_t &,Double_t &eamp,Double_t &t0,Double_t &et0,
175 Double_t &chi2, Int_t &ndf) const
177 // Return results of fitting procedure
186 void AliCaloFastAltroFitv0::GetFittedPoints(Int_t &nfit, Double_t* ar[2]) const
195 void AliCaloFastAltroFitv0::CutRightPart(Int_t *t,Int_t *y,Int_t nPoints,Double_t tMax, Int_t &ii)
197 // Cut right part of altro sample : static function
199 for(Int_t i=0; i<nPoints; i++) {
201 if(tMax && tt <= Int_t(tMax)) {
207 if(0) printf(" ii %i -> ii %i : tMax %7.2f \n", nPoints, ii, tMax);
210 void AliCaloFastAltroFitv0::DeductPedestal(Int_t* t, Int_t* y, Int_t nPoints, Double_t tau, Double_t ped,
211 Double_t* tn, Double_t* yn, Int_t &nPointsOut)
213 // Pedestal deduction if ped is positive : static function
214 // Discard part od samle if it is not compact.
215 static Double_t yMinUnderPed=2.; // should be tune
216 Int_t ymax=0, nmax=0;
217 for(Int_t i=0; i<nPoints; i++){
223 Int_t i1 = nmax - Int_t(tau);
229 Double_t yd=0.0, tdiff=0.0;;
230 for(Int_t i=i1; i<i2; i++) {
232 yd = Double_t(y[i]) - ped;
236 if(yd < yMinUnderPed) continue;
238 if(i>i1 && nPointsOut>0){
239 tdiff = t[i] - tn[nPointsOut-1];
240 // printf(" i %i : nPointsOut %i : tdiff %6.2f : tn[nPointsOut] %6.2f \n", i,nPointsOut, tdiff, tn[nPointsOut-1]);
242 // discard previous points if its are before maximum point and with gap>1
244 nPointsOut = 0; // nPointsOut--;
245 // if point with gap after maximum - finish selection
246 } else if(i>=nmax ) {
250 // Far away from maximum
251 //if(i-nmax > Int_t(5*tau)) break;
253 tn[nPointsOut] = Double_t(t[i]);
255 //printf("i %i : nPointsOut %i : tn %6.2f : yn %6.2f \n", i, nPointsOut, tn[nPointsOut], yn[nPointsOut]);
258 //printf(" nmax %i : nPointsIn %i :nPointsOut %i i1 %i \n", nmax, nPointsIn, nPointsOut, i1);
261 void AliCaloFastAltroFitv0::FastFit(const Double_t* t, const Double_t* y, const Int_t nPoints,
262 const Double_t sig, const Double_t tau,
263 Double_t &, Double_t &eamp, Double_t &t0, Double_t &et0, Double_t &chi2)
266 // It is case of n=k=2 : fnn = x*x*exp(2 - 2*x)
268 //nPoints - number of points
269 // t[] - array of time bins
270 // y[] - array of amplitudes after pedestal subtractions;
271 // sig - error of amplitude measurement (one value for all channels)
272 // tau - filter time response (in timebin units)
274 // amp - amplitude at t0;
275 // eamp - error of amplitude;
276 // t0 - time of max amplitude;
277 // et0 - error of t0;
279 static Double_t xx; // t/tau
280 static Double_t a, b, c;
281 static Double_t f02, f12, f22; // functions
282 static Double_t f02d, f12d, f22d; // functions derivations
287 printf(" AliCaloFastAltroFitv0::FastFit : nPoints<=%i \n", nPoints);
292 for(Int_t i=0; i<nPoints; i++){
300 f22d = 2.*(f12 - f22);
306 Double_t t01=0.0, t02=0.0;
307 Double_t amp1=0.0, amp2=0.0, chi21=0.0, chi22=0.0;
308 if(QuadraticRoots(a,b,c, t01,t02)) {
311 Amplitude(t,y,nPoints, sig, tau, t01, amp1, chi21);
312 Amplitude(t,y,nPoints, sig, tau, t02, amp2, chi22);
314 printf(" t01 %f : t02 %f \n", t01, t02);
315 printf(" amp1 %f : amp2 %f \n", amp1, amp2);
316 printf(" chi21 %f : chi22 %f \n", chi21, chi22);
318 // t0 less on one tau with comparing with value from "canonical equation"
327 if(tau<3.) { // EMCAL case : small tau
328 t0 += -0.03; // Discard bias in t0
329 Amplitude(t,y,nPoints, sig, tau, t0, amp, chi2);
331 CalculateParsErrors(t, y, nPoints, sig, tau, amp, t0, eamp, et0);
335 // DrawFastFunction(amp, t0, fUtils->GetPedestalValue(), "1");
336 // DrawFastFunction(amp1, t01, fUtils->GetPedestalValue(), "1");
337 // DrawFastFunction(amp2, t02, fUtils->GetPedestalValue(), "2");
339 chi2 = t01; // no roots, bad fit - negative chi2
343 Bool_t AliCaloFastAltroFitv0::QuadraticRoots(const Double_t a, const Double_t b, const Double_t c,
344 Double_t &x1, Double_t &x2)
346 // Resolve quadratic equations a*x**2 + b*x + c
347 //printf(" a %12.5e b %12.5e c %12.5e \n", a, b, c);
348 static Double_t dtmp = 0.0, dtmpCut = -1.e-6;
349 static Int_t iWarning=0, iNoSolution=0;
352 if(dtmp>=dtmpCut && dtmp<0.0) {
353 if(iWarning<5 || iWarning%1000==0)
354 printf("<W> %i small neg. sq. : dtmp %12.5e \n", iWarning, dtmp);
360 x1 = (-b + dtmp) / (2.*a);
361 x2 = (-b - dtmp) / (2.*a);
363 // printf(" x1 %f : x2 %f \n", x1, x2);
367 if(iNoSolution<5 || iNoSolution%1000==0)
368 printf("<No solution> %i neg. sq. : dtmp %12.5e \n", iNoSolution, dtmp);
374 void AliCaloFastAltroFitv0::Amplitude(const Double_t* t,const Double_t* y,const Int_t nPoints,
375 const Double_t sig, const Double_t tau, const Double_t t0,
376 Double_t &, Double_t &chi2)
378 // Calculate parameters error too - Mar 24,09
379 // sig is independent from points
381 Double_t x=0.0, f=0.0, den=0.0, f02;
382 for(Int_t i=0; i<nPoints; i++){
389 if(den>0.0) amp /= den;
395 for(Int_t i=0; i<nPoints; i++){
401 // printf(" %i : y %f -> f %f : dy %f \n", i, y[i], f, dy);
406 void AliCaloFastAltroFitv0::CalculateParsErrors(const Double_t* t, const Double_t* /*y*/, const Int_t nPoints,
407 const Double_t sig, const Double_t tau,
408 Double_t &, Double_t &t0, Double_t &eamp, Double_t &et0)
410 // Remember that fmax = exp(-n);
411 // fmax_nk = (n/k)**n*exp(-n) => n=k=2 => exp(-n) = exp(-2.)
412 static Double_t cc = exp(-2.);
413 // static Double_t cc = exp(-fN); // mean(N)~1.5 ??
415 Double_t sumf2=0.0, sumfd2=0.0, x, f02, f12, f22, f22d;
417 for(Int_t i=0; i<nPoints; i++){
424 f22d = 2.*(f12 - f22);
425 sumfd2 += f22d * f22d;
427 et0 = (sig/amp)/sqrt(sumfd2);
428 eamp = sig/sqrt(sumf2);
437 TCanvas* AliCaloFastAltroFitv0::DrawFastFunction()
440 if(fNfit<=0) return 0; // no points
442 static TCanvas *c = 0;
444 c = new TCanvas("fastFun","fastFun",800,600);
449 Double_t* eamp = new Double_t[fNfit];
450 Double_t* et = new Double_t[fNfit];
452 for(Int_t i=0; i<fNfit; i++) {
457 TGraphErrors *gr = new TGraphErrors(fNfit, fTfit,fAmpfit, et,eamp);
459 gr->SetTitle(Form("Fast Fit : #chi^{2}/ndf = %8.2f / %i", GetChi2(), GetNDF()));
460 gr->GetHistogram()->SetXTitle(" time bin ");
461 gr->GetHistogram()->SetYTitle(" amplitude ");
464 fStdFun = new TF1("stdFun", StdResponseFunction, 0., fTfit[fNfit-1]+2., 5);
465 fStdFun->SetParNames("amp","t0","tau","N","ped");
467 fStdFun->SetParameter(0, GetEnergy());
468 fStdFun->SetParameter(1, GetTime() + GetTau());
469 fStdFun->SetParameter(2, GetTau()); //
470 fStdFun->SetParameter(3, GetN()); // 2
471 fStdFun->SetParameter(4, 0.); //
473 fStdFun->SetLineColor(kBlue);
474 fStdFun->SetLineWidth(1);
476 fStdFun->Draw("same");
486 Double_t AliCaloFastAltroFitv0::StdResponseFunction(const Double_t *x, const Double_t *par)
488 // Static Standard Response Function :
489 // look to Double_t AliEMCALRawUtils::RawResponseFunction(Double_t *x, Double_t *par)
490 // Using for drawing only.
492 // Shape of the electronics raw reponse:
493 // It is a semi-gaussian, 2nd order Gamma function (n=2) of the general form
495 // t' = (t - t0 + tau) / tau
496 // F = A * t**N * exp( N * ( 1 - t) ) for t >= 0
500 // A: par[0] // Amplitude = peak value
506 static Double_t signal , tau, n, ped, xx;
511 xx = ( x[0] - par[1] + tau ) / tau ;
516 signal = ped + par[0] * TMath::Power(xx , n) * TMath::Exp(n * (1 - xx )) ;