KaliVeda
Toolkit for HIC analysis
KVSignal Class Reference

Detailed Description

Definition at line 14 of file KVSignal.h.

#include <KVSignal.h>

Inheritance diagram for KVSignal:

Public Types

enum  SignalType {
  kQH1 , kI1 , kQL1 , kQ2 ,
  kI2 , kQ3 , kADC , kUNKDT
}
 

Public Member Functions

 KVSignal ()
 Default constructor. More...
 
 KVSignal (const char *name, const char *title)
 Write your code here. More...
 
 KVSignal (const TString &name, const TString &title)
 
virtual ~KVSignal ()
 Destructor. More...
 
void Add (Double_t fact)
 
void ApplyModifications (TGraph *newSignal=0, Int_t nsa=-1)
 apply modifications of fAdc to the original signal More...
 
double ApplyNewton (double l, double x0)
 
void ApplyWindowing (int window_type=3)
 fast fourier transform and windowing of the signal (modify only fAdc) More...
 
Double_t ARC_CFD (Double_t threshold=0.3, Double_t tdelay=10)
 Interpolations. More...
 
virtual void BuildCubicSignal (double taufinal)
 
virtual void BuildCubicSplineSignal (double taufinal)
 
void BuildReverseTimeSignal ()
 
virtual void BuildSmoothingSplineSignal (double taufinal, double l=1, int nbits=-1)
 
void ChangeChannelWidth (Double_t newwidth)
 
Double_t ComputeAmplitude ()
 Compute and return the absolute value of the signal amplitude. More...
 
virtual Double_t ComputeBaseLine ()
 
Double_t ComputeCFDThreshold (Double_t threshold=0.5)
 calculate the time during which the signal is higher than th*fAmplitude More...
 
virtual Double_t ComputeDuration (Double_t th=0.2)
 calculate the time during which the signal is higher than th*fAmplitude More...
 
virtual Double_t ComputeEndLine ()
 
Bool_t ComputeMeanAndSigma (Double_t start, Double_t stop, Double_t &mean, Double_t &sigma)
 
Bool_t ComputeMeanAndSigma (Int_t start, Int_t stop, Double_t &mean, Double_t &sigma)
 compute mean value and rms of a subset of samples More...
 
virtual void ComputeRawAmplitude (void)
 
Double_t ComputeRiseTime ()
 
KVSignalConvertTo (const Char_t *type)
 
void Copy (TObject &obj) const
 
Double_t CubicInterpolation (float *data, int x2, double fmax, int Nrecurr)
 
void DeduceFromName ()
 
virtual double EvalCubicSpline (double X)
 
int FFT (bool p_bInverseTransform, double *p_lpRealOut, double *p_lpImagOut)
 returns the lenght of FFT( power of 2) More...
 
TH1 * FFT2Histo (int output, TH1 *hh=0)
 
Double_t FindTzeroCFDCubic (double level, int Nrecurr)
 
double FindTzeroCFDCubic_rev (double level, double tend, int Nrecurr)
 
double FindTzeroLeadingEdgeCubic (double LEVEL, int Nrecurr)
 
void FIR_ApplyMovingAverage (int npoints)
 
void FIR_ApplyRCHighPass (double time_usec, int reverse=0)
 
void FIR_ApplyRCLowPass (double time_usec, int reverse=0)
 
void FIR_ApplyRecursiveFilter (double a0, int N, double *a, double *b, int reverse)
 signal will be: y[n]=a0*x[n]+sum a[k] x[k] + sum b[k] y[k] More...
 
void FIR_ApplySemigaus (double tau_usec)
 
int FIR_ApplySmoothingSpline (double l, int nbits=-1)
 
void FIR_ApplyTrapezoidal (double trise, double tflat)
 different shapers (modify only fAdc) More...
 
Double_t GetAmplitude () const
 
Double_t GetAmplitudeTriggerValue () const
 routines to manage threshold for minimum charge in the detector More...
 
TArrayF * GetArray ()
 
Double_t GetBaseLine () const
 
Double_t GetBLFirst () const
 
Double_t GetBLLength () const
 
Double_t GetChannelWidth () const
 
virtual double GetDataCubicSpline (double t)
 see HSIEH S.HOU IEEE Trans. Acoustic Speech, vol. ASSP-26, NO.6, DECEMBER 1978 More...
 
virtual double GetDataInter (double t)
 
virtual double GetDataInterCubic (double t)
 
virtual double GetDataSmoothingSplineLTI (double t)
 
const Char_t * GetDetectorName () const
 
Double_t GetEndLine () const
 
Int_t GetIndex () const
 
Double_t GetInterpolatedChannelWidth () const
 
Int_t GetNFPGAValues () const
 
Int_t GetNSamples () const
 
Double_t GetPSAParameter (const Char_t *parname)
 DeduceFromName has to be called before. More...
 
virtual void GetPSAResult (KVDetector *) const
 
Double_t GetRawAmplitude () const
 
Double_t GetRiseTime () const
 
Double_t GetSemiGaussSigma () const
 
Double_t GetShaperFlatTop () const
 
Double_t GetShaperRiseTime () const
 
Double_t GetSigmaBaseLine () const
 
Double_t GetSigmaEndLine () const
 
Double_t GetTauRC () const
 
const Char_t * GetType () const
 
Double_t GetYmax () const
 
Double_t GetYmin () const
 
Bool_t HasFPGA () const
 
virtual Bool_t IsCharge () const
 
virtual Bool_t IsCurrent () const
 
Bool_t IsFired ()
 ComputeBaseLine and ComputeEndLine methods have to be called before. More...
 
Bool_t IsLongEnough () const
 
virtual bool IsOK ()
 
virtual void LoadPSAParameters ()
 
void Multiply (Double_t fact)
 multiply the signal (modify only fAdc) More...
 
void PoleZeroSuppression (Double_t tauRC)
 
void Print (Option_t *chopt="") const
 
Bool_t PSAHasBeenComputed () const
 
virtual void RemoveBaseLine ()
 
virtual void Set (Int_t n)
 
void SetADCData ()
 
void SetAmplitudeTriggerValue (Double_t val)
 
void SetBaseLineLength (Int_t length, Int_t first=0)
 
void SetChannelWidth (double width)
 
void SetData (Int_t nn, Double_t *xx, Double_t *yy)
 operation on data arrays More...
 
virtual void SetDefaultValues ()
 To be defined in child class. More...
 
void SetDetectorName (const Char_t *name)
 
void SetInterpolatedChannelWidth (double width)
 
void SetInterpolation (Bool_t with=kTRUE)
 
void SetMaxT (double t)
 
void SetNSamples (int nn)
 
void SetPoleZeroCorrection (Bool_t with=kTRUE)
 
void SetSemiGaussSigma (Double_t sig)
 
void SetShaperFlatTop (Double_t flat)
 
void SetShaperRiseTime (Double_t rise)
 
void SetTauRC (Int_t taurc)
 
void SetTrapShaperParameters (Double_t rise, Double_t flat)
 
void SetType (const Char_t *type)
 
void ShiftLeft (double)
 ---------------— OPERATORI ------------------—// More...
 
void ShiftRight (double)
 
void TestDraw ()
 
Bool_t TestWidth () const
 
virtual void TreateSignal ()
 
virtual void UpdatePSAParameter (KVDBParameterList *par)
 

Static Public Member Functions

static int FFT (unsigned int p_nSamples, bool p_bInverseTransform, double *p_lpRealIn, double *p_lpImagIn, double *p_lpRealOut, double *p_lpImagOut)
 
static KVSignalMakeSignal (const char *sig_type)
 Create new KVSignal instance corresponding to sig_type. More...
 

Private Member Functions

virtual void BuildCubicSignal ()
 
virtual void BuildCubicSplineSignal ()
 
virtual void BuildSmoothingSplineSignal ()
 
void init ()
 
void ResetIndexes ()
 
void TreateOldSignalName ()
 

Private Attributes

TArrayF fAdc
 
Double_t fAmplitude
 results of signal treatement More...
 
Double_t fBaseLine
 base line mean value More...
 
Int_t fChannel
 signal type (see KVSignal::SignalType enum) More...
 
Double_t fChannelWidth
 channel width in ns More...
 
Double_t fChannelWidthInt
 internal parameter channel width of interpolated signal in ns More...
 
TString fDetName
 name of the detector, the signal is linked to, needed to find it in the KVMultiDetector More...
 
Double_t fEndLine
 mean value of the signal line at the end More...
 
Int_t fFirstBL
 
Int_t fFPGAOutputNumbers
 ASsociated FPGA energy outputs. More...
 
Double_t fIMax
 position of the maximum in channel More...
 
Int_t fIndex
 index deduced from block, quartet and telescope numbering More...
 
Double_t fInterpolatedChannelWidth
 channel width used to produced the interpolated signal More...
 
Int_t fLastBL
 first and last channel number to compute the base line More...
 
Double_t fMinimumValueForAmplitude
 Minimum value to say if detector has been hitted. More...
 
Bool_t fPSAIsDone
 indicate if PSA has been done More...
 
Double_t fRiseTime
 rise time of the signal More...
 
Double_t fSemiGaussSigma
 sigma of the semi-gaussian shaper More...
 
Double_t fSigmaBase
 base line rms More...
 
Double_t fSigmaEnd
 rms value of the signal line at the end More...
 
Double_t fTauRC
 tau_rc of the electronics. Used for pole zero cancellation. More...
 
Double_t fTMax
 position of the maximum in ns More...
 
Double_t fTrapFlatTop
 flat top of the trapezoidal shaper More...
 
Double_t fTrapRiseTime
 rise time of the trapezoidal shaper More...
 
TString fType
 string to identify the signal type : "QH1", "I2" etc ... More...
 
Bool_t fWithInterpolation
 use of interpolation or not More...
 
Bool_t fWithPoleZeroCorrection
 use or nor pole zero correction More...
 
Double_t fYmax
 raw min/max of the signal More...
 
Double_t fYmin
 

Member Enumeration Documentation

◆ SignalType

Enumerator
kQH1 
kI1 
kQL1 
kQ2 
kI2 
kQ3 
kADC 
kUNKDT 

Definition at line 16 of file KVSignal.h.

Constructor & Destructor Documentation

◆ KVSignal() [1/3]

KVSignal::KVSignal ( )

Default constructor.

Definition at line 88 of file KVSignal.cpp.

◆ KVSignal() [2/3]

KVSignal::KVSignal ( const char *  name,
const char *  title 
)

Write your code here.

Definition at line 100 of file KVSignal.cpp.

◆ KVSignal() [3/3]

KVSignal::KVSignal ( const TString &  name,
const TString &  title 
)

Definition at line 112 of file KVSignal.cpp.

◆ ~KVSignal()

KVSignal::~KVSignal ( )
virtual

Destructor.

Definition at line 124 of file KVSignal.cpp.

Member Function Documentation

◆ Add()

void KVSignal::Add ( Double_t  fact)

Definition at line 1790 of file KVSignal.cpp.

◆ ApplyModifications()

void KVSignal::ApplyModifications ( TGraph *  newSignal = 0,
Int_t  nsa = -1 
)

apply modifications of fAdc to the original signal

Info("ApplyModifications","called with %d",((newSignal==0)?0:1));.

Definition at line 1765 of file KVSignal.cpp.

◆ ApplyNewton()

double KVSignal::ApplyNewton ( double  l,
double  x0 
)

Definition at line 1515 of file KVSignal.cpp.

◆ ApplyWindowing()

void KVSignal::ApplyWindowing ( int  window_type = 3)

fast fourier transform and windowing of the signal (modify only fAdc)

vedi pag. 468 oppenheim-shafer

Definition at line 926 of file KVSignal.cpp.

◆ ARC_CFD()

Double_t KVSignal::ARC_CFD ( Double_t  threshold = 0.3,
Double_t  tdelay = 10 
)

Interpolations.

time of passage of the threshold

Definition at line 654 of file KVSignal.cpp.

◆ BuildCubicSignal() [1/2]

void KVSignal::BuildCubicSignal ( )
privatevirtual

Definition at line 1386 of file KVSignal.cpp.

◆ BuildCubicSignal() [2/2]

void KVSignal::BuildCubicSignal ( double  taufinal)
virtual

Definition at line 1363 of file KVSignal.cpp.

◆ BuildCubicSplineSignal() [1/2]

void KVSignal::BuildCubicSplineSignal ( )
privatevirtual

Definition at line 1351 of file KVSignal.cpp.

◆ BuildCubicSplineSignal() [2/2]

void KVSignal::BuildCubicSplineSignal ( double  taufinal)
virtual

Definition at line 1328 of file KVSignal.cpp.

◆ BuildReverseTimeSignal()

void KVSignal::BuildReverseTimeSignal ( )

Definition at line 606 of file KVSignal.cpp.

◆ BuildSmoothingSplineSignal() [1/2]

void KVSignal::BuildSmoothingSplineSignal ( )
privatevirtual

Definition at line 1424 of file KVSignal.cpp.

◆ BuildSmoothingSplineSignal() [2/2]

void KVSignal::BuildSmoothingSplineSignal ( double  taufinal,
double  l = 1,
int  nbits = -1 
)
virtual

Definition at line 1396 of file KVSignal.cpp.

◆ ChangeChannelWidth()

void KVSignal::ChangeChannelWidth ( Double_t  newwidth)

Definition at line 474 of file KVSignal.cpp.

◆ ComputeAmplitude()

Double_t KVSignal::ComputeAmplitude ( )

Compute and return the absolute value of the signal amplitude.

routines dedicated to calculate the amplitude (use of filter)

Definition at line 619 of file KVSignal.cpp.

◆ ComputeBaseLine()

Double_t KVSignal::ComputeBaseLine ( )
virtual

compute mean value of the signal and the rms between limits defined by fFirstBL and fLastBL

Reimplemented in KVI2, and KVI1.

Definition at line 491 of file KVSignal.cpp.

◆ ComputeCFDThreshold()

Double_t KVSignal::ComputeCFDThreshold ( Double_t  threshold = 0.5)

calculate the time during which the signal is higher than th*fAmplitude

Definition at line 539 of file KVSignal.cpp.

◆ ComputeDuration()

Double_t KVSignal::ComputeDuration ( Double_t  th = 0.2)
virtual

calculate the time during which the signal is higher than th*fAmplitude

Definition at line 509 of file KVSignal.cpp.

◆ ComputeEndLine()

Double_t KVSignal::ComputeEndLine ( )
virtual

same as ComputeBaseLine method but made on the end of the signal in the same length as for the base line

Definition at line 564 of file KVSignal.cpp.

◆ ComputeMeanAndSigma() [1/2]

Bool_t KVSignal::ComputeMeanAndSigma ( Double_t  start,
Double_t  stop,
Double_t &  mean,
Double_t &  sigma 
)

assuming that X axis is in time unit (ms) divide the X values by the fChannelWidth value which allow to set the Xaxis in time units compute mean value and sigma values between "start" and "stop" point included

Definition at line 745 of file KVSignal.cpp.

◆ ComputeMeanAndSigma() [2/2]

Bool_t KVSignal::ComputeMeanAndSigma ( Int_t  start,
Int_t  stop,
Double_t &  mean,
Double_t &  sigma 
)

compute mean value and rms of a subset of samples

compute mean value and sigma values between "start" point included and "stop" point excluded for example : ComputeMeanAndSigma(0,50,mean,sigma) compute values for the first 50 points

Definition at line 693 of file KVSignal.cpp.

◆ ComputeRawAmplitude()

void KVSignal::ComputeRawAmplitude ( void  )
virtual

routines to calculate the raw amplitude without filter

Definition at line 440 of file KVSignal.cpp.

◆ ComputeRiseTime()

Double_t KVSignal::ComputeRiseTime ( )

routines dedicated to calculate the rise time (use of filter)

Definition at line 636 of file KVSignal.cpp.

◆ ConvertTo()

KVSignal * KVSignal::ConvertTo ( const Char_t *  type)

Definition at line 133 of file KVSignal.cpp.

◆ Copy()

void KVSignal::Copy ( TObject &  obj) const

This method copies the current state of 'this' object into 'obj' You should add here any member variables, for example: (supposing a member variable KVSignal::fToto) CastedObj.fToto = fToto; or CastedObj.SetToto( GetToto() ); TGraph::Copy((TGraph&)obj); KVSignal& CastedObj = (KVSignal&)obj;

Definition at line 169 of file KVSignal.cpp.

◆ CubicInterpolation()

Double_t KVSignal::CubicInterpolation ( float *  data,
int  x2,
double  fmax,
int  Nrecurr 
)

NOTA: tutti i conti fatti con i tempi in "canali". aggiungero' il *fChannelWidth solo nel return.

Definition at line 1163 of file KVSignal.cpp.

◆ DeduceFromName()

void KVSignal::DeduceFromName ( )

methods used to identify to from which detector/telescope/quartet/block the signal is associated it is assumed that the name of the signal is defined as it is in the raw data generated by fazia_reader which convert raw acquisition file in raw ROOT files

Definition at line 288 of file KVSignal.cpp.

◆ EvalCubicSpline()

double KVSignal::EvalCubicSpline ( double  X)
virtual

Definition at line 1577 of file KVSignal.cpp.

◆ FFT() [1/2]

int KVSignal::FFT ( bool  p_bInverseTransform,
double *  p_lpRealOut,
double *  p_lpImagOut 
)

returns the lenght of FFT( power of 2)

Definition at line 1071 of file KVSignal.cpp.

◆ FFT() [2/2]

int KVSignal::FFT ( unsigned int  p_nSamples,
bool  p_bInverseTransform,
double *  p_lpRealIn,
double *  p_lpImagIn,
double *  p_lpRealOut,
double *  p_lpImagOut 
)
static

copiata e adattata da: http://www.codeproject.com/audio/waveInFFT.asp l'unico vettore che puo' essere NULL e' p_lpImagIn

Definition at line 962 of file KVSignal.cpp.

◆ FFT2Histo()

TH1 * KVSignal::FFT2Histo ( int  output,
TH1 *  hh = 0 
)

Definition at line 1104 of file KVSignal.cpp.

◆ FindTzeroCFDCubic()

Double_t KVSignal::FindTzeroCFDCubic ( double  level,
int  Nrecurr 
)

recurr=1 means: linear + 1 approx recurr=0 == FindTzeroCFD

Definition at line 885 of file KVSignal.cpp.

◆ FindTzeroCFDCubic_rev()

double KVSignal::FindTzeroCFDCubic_rev ( double  level,
double  tend,
int  Nrecurr 
)

recurr=1 means: linear + 1 approx recurr=0 == FindTzeroCFD

Definition at line 1591 of file KVSignal.cpp.

◆ FindTzeroLeadingEdgeCubic()

double KVSignal::FindTzeroLeadingEdgeCubic ( double  LEVEL,
int  Nrecurr 
)

Definition at line 676 of file KVSignal.cpp.

◆ FIR_ApplyMovingAverage()

void KVSignal::FIR_ApplyMovingAverage ( int  npoints)

Definition at line 1731 of file KVSignal.cpp.

◆ FIR_ApplyRCHighPass()

void KVSignal::FIR_ApplyRCHighPass ( double  time_usec,
int  reverse = 0 
)

f=1/(2*pi*tau) se tau[ns] allora f->[GHz] fsampling=1/fChannelWidth [GHz] printf("fChannelWidth=%f\n",fChannelWidth);

Definition at line 1654 of file KVSignal.cpp.

◆ FIR_ApplyRCLowPass()

void KVSignal::FIR_ApplyRCLowPass ( double  time_usec,
int  reverse = 0 
)

f=1/(2*pi*tau) se tau[ns] allora f->[GHz] fsampling=1/fChannelWidth [GHz]

Definition at line 1632 of file KVSignal.cpp.

◆ FIR_ApplyRecursiveFilter()

void KVSignal::FIR_ApplyRecursiveFilter ( double  a0,
int  N,
double *  a,
double *  b,
int  reverse 
)

signal will be: y[n]=a0*x[n]+sum a[k] x[k] + sum b[k] y[k]

non con double! memcpy(datax, datay, NSamples*sizeof(float));

Definition at line 1675 of file KVSignal.cpp.

◆ FIR_ApplySemigaus()

void KVSignal::FIR_ApplySemigaus ( double  tau_usec)

Definition at line 1613 of file KVSignal.cpp.

◆ FIR_ApplySmoothingSpline()

int KVSignal::FIR_ApplySmoothingSpline ( double  l,
int  nbits = -1 
)

This method is never called with nbits>2, therefore nmax=50 ALWAYS and dynamic arrays xvec & yvec can safely be of fixed size If ever we want to use nbits>2, this will have to be changed

Definition at line 1437 of file KVSignal.cpp.

◆ FIR_ApplyTrapezoidal()

void KVSignal::FIR_ApplyTrapezoidal ( double  trise,
double  tflat 
)

different shapers (modify only fAdc)

Definition at line 839 of file KVSignal.cpp.

◆ GetAmplitude()

Double_t KVSignal::GetAmplitude ( ) const
inline

Definition at line 250 of file KVSignal.h.

◆ GetAmplitudeTriggerValue()

Double_t KVSignal::GetAmplitudeTriggerValue ( ) const
inline

routines to manage threshold for minimum charge in the detector

Definition at line 343 of file KVSignal.h.

◆ GetArray()

TArrayF* KVSignal::GetArray ( )
inline

Definition at line 124 of file KVSignal.h.

◆ GetBaseLine()

Double_t KVSignal::GetBaseLine ( ) const
inline

Definition at line 219 of file KVSignal.h.

◆ GetBLFirst()

Double_t KVSignal::GetBLFirst ( ) const
inline

Definition at line 201 of file KVSignal.h.

◆ GetBLLength()

Double_t KVSignal::GetBLLength ( ) const
inline

Definition at line 205 of file KVSignal.h.

◆ GetChannelWidth()

Double_t KVSignal::GetChannelWidth ( ) const
inline

Definition at line 172 of file KVSignal.h.

◆ GetDataCubicSpline()

double KVSignal::GetDataCubicSpline ( double  t)
virtual

see HSIEH S.HOU IEEE Trans. Acoustic Speech, vol. ASSP-26, NO.6, DECEMBER 1978

Definition at line 1241 of file KVSignal.cpp.

◆ GetDataInter()

double KVSignal::GetDataInter ( double  t)
virtual

Definition at line 1201 of file KVSignal.cpp.

◆ GetDataInterCubic()

double KVSignal::GetDataInterCubic ( double  t)
virtual

Definition at line 1220 of file KVSignal.cpp.

◆ GetDataSmoothingSplineLTI()

double KVSignal::GetDataSmoothingSplineLTI ( double  t)
virtual

Definition at line 1558 of file KVSignal.cpp.

◆ GetDetectorName()

const Char_t* KVSignal::GetDetectorName ( ) const
inline

routines to link signal to its detector in kaliveda framework

Definition at line 85 of file KVSignal.h.

◆ GetEndLine()

Double_t KVSignal::GetEndLine ( ) const
inline

Definition at line 228 of file KVSignal.h.

◆ GetIndex()

Int_t KVSignal::GetIndex ( ) const
inline

Definition at line 104 of file KVSignal.h.

◆ GetInterpolatedChannelWidth()

Double_t KVSignal::GetInterpolatedChannelWidth ( ) const
inline

Definition at line 320 of file KVSignal.h.

◆ GetNFPGAValues()

Int_t KVSignal::GetNFPGAValues ( ) const
inline

Definition at line 129 of file KVSignal.h.

◆ GetNSamples()

Int_t KVSignal::GetNSamples ( ) const
inline

Definition at line 188 of file KVSignal.h.

◆ GetPSAParameter()

Double_t KVSignal::GetPSAParameter ( const Char_t *  parname)

DeduceFromName has to be called before.

routines to read/change PSA parameters from configuration file or database

Definition at line 341 of file KVSignal.cpp.

◆ GetPSAResult()

virtual void KVSignal::GetPSAResult ( KVDetector ) const
inlinevirtual

store results of PSA in detector signals

Reimplemented in KVQL1, KVQH1, KVQ3, KVQ2, KVI2, and KVI1.

Definition at line 155 of file KVSignal.h.

◆ GetRawAmplitude()

Double_t KVSignal::GetRawAmplitude ( ) const
inline

Definition at line 329 of file KVSignal.h.

◆ GetRiseTime()

Double_t KVSignal::GetRiseTime ( ) const
inline

Definition at line 241 of file KVSignal.h.

◆ GetSemiGaussSigma()

Double_t KVSignal::GetSemiGaussSigma ( ) const
inline

Definition at line 288 of file KVSignal.h.

◆ GetShaperFlatTop()

Double_t KVSignal::GetShaperFlatTop ( ) const
inline

Definition at line 275 of file KVSignal.h.

◆ GetShaperRiseTime()

Double_t KVSignal::GetShaperRiseTime ( ) const
inline

Definition at line 271 of file KVSignal.h.

◆ GetSigmaBaseLine()

Double_t KVSignal::GetSigmaBaseLine ( ) const
inline

Definition at line 223 of file KVSignal.h.

◆ GetSigmaEndLine()

Double_t KVSignal::GetSigmaEndLine ( ) const
inline

Definition at line 232 of file KVSignal.h.

◆ GetTauRC()

Double_t KVSignal::GetTauRC ( ) const
inline

Definition at line 304 of file KVSignal.h.

◆ GetType()

const Char_t* KVSignal::GetType ( ) const
inline

Definition at line 98 of file KVSignal.h.

◆ GetYmax()

Double_t KVSignal::GetYmax ( ) const
inline

Definition at line 337 of file KVSignal.h.

◆ GetYmin()

Double_t KVSignal::GetYmin ( ) const
inline

Definition at line 333 of file KVSignal.h.

◆ HasFPGA()

Bool_t KVSignal::HasFPGA ( ) const
inline

Definition at line 134 of file KVSignal.h.

◆ init()

void KVSignal::init ( void  )
private

Definition at line 42 of file KVSignal.cpp.

◆ IsCharge()

virtual Bool_t KVSignal::IsCharge ( ) const
inlinevirtual

Reimplemented in KVQL1, KVQH1, KVQ3, and KVQ2.

Definition at line 109 of file KVSignal.h.

◆ IsCurrent()

virtual Bool_t KVSignal::IsCurrent ( ) const
inlinevirtual

Reimplemented in KVI2, and KVI1.

Definition at line 113 of file KVSignal.h.

◆ IsFired()

Bool_t KVSignal::IsFired ( )

ComputeBaseLine and ComputeEndLine methods have to be called before.

Definition at line 581 of file KVSignal.cpp.

◆ IsLongEnough()

Bool_t KVSignal::IsLongEnough ( ) const

Definition at line 186 of file KVSignal.cpp.

◆ IsOK()

bool KVSignal::IsOK ( )
virtual

Definition at line 149 of file KVSignal.cpp.

◆ LoadPSAParameters()

void KVSignal::LoadPSAParameters ( )
virtual

Reimplemented in KVQL1, KVQH1, KVQ3, KVQ2, KVI2, KVI1, KVCurrentSignal, and KVChargeSignal.

Definition at line 387 of file KVSignal.cpp.

◆ MakeSignal()

KVSignal * KVSignal::MakeSignal ( const char *  sig_type)
static

Create new KVSignal instance corresponding to sig_type.

Definition at line 1852 of file KVSignal.cpp.

◆ Multiply()

void KVSignal::Multiply ( Double_t  fact)

multiply the signal (modify only fAdc)

double FindMedia(double tsta, double tsto); double FindMedia(int tsta, int tsto); double FindSigma2(double tsta, double tsto); double FindSigma2(int tsta, int tsto);

Definition at line 1781 of file KVSignal.cpp.

◆ PoleZeroSuppression()

void KVSignal::PoleZeroSuppression ( Double_t  tauRC)

Definition at line 1748 of file KVSignal.cpp.

◆ Print()

void KVSignal::Print ( Option_t *  chopt = "") const

Definition at line 415 of file KVSignal.cpp.

◆ PSAHasBeenComputed()

Bool_t KVSignal::PSAHasBeenComputed ( ) const
inline

Definition at line 159 of file KVSignal.h.

◆ RemoveBaseLine()

void KVSignal::RemoveBaseLine ( )
virtual

Definition at line 594 of file KVSignal.cpp.

◆ ResetIndexes()

void KVSignal::ResetIndexes ( )
private

Definition at line 76 of file KVSignal.cpp.

◆ Set()

void KVSignal::Set ( Int_t  n)
virtual

Definition at line 195 of file KVSignal.cpp.

◆ SetADCData()

void KVSignal::SetADCData ( )

Definition at line 229 of file KVSignal.cpp.

◆ SetAmplitudeTriggerValue()

void KVSignal::SetAmplitudeTriggerValue ( Double_t  val)
inline

Definition at line 347 of file KVSignal.h.

◆ SetBaseLineLength()

void KVSignal::SetBaseLineLength ( Int_t  length,
Int_t  first = 0 
)
inline

routines dedicated to calculate the baseline

Definition at line 196 of file KVSignal.h.

◆ SetChannelWidth()

void KVSignal::SetChannelWidth ( double  width)
inline

Indicate the value in (ns or us) of TGraph X axis width

Definition at line 167 of file KVSignal.h.

◆ SetData()

void KVSignal::SetData ( Int_t  nn,
Double_t *  xx,
Double_t *  yy 
)

operation on data arrays

Definition at line 207 of file KVSignal.cpp.

◆ SetDefaultValues()

void KVSignal::SetDefaultValues ( )
virtual

To be defined in child class.

Reimplemented in KVQL1, KVQH1, KVQ3, KVQ2, KVI2, KVI1, KVCurrentSignal, and KVChargeSignal.

Definition at line 397 of file KVSignal.cpp.

◆ SetDetectorName()

void KVSignal::SetDetectorName ( const Char_t *  name)
inline

Definition at line 89 of file KVSignal.h.

◆ SetInterpolatedChannelWidth()

void KVSignal::SetInterpolatedChannelWidth ( double  width)
inline

Definition at line 316 of file KVSignal.h.

◆ SetInterpolation()

void KVSignal::SetInterpolation ( Bool_t  with = kTRUE)
inline

parameters for interpolation

Definition at line 312 of file KVSignal.h.

◆ SetMaxT()

void KVSignal::SetMaxT ( double  t)
inline

Definition at line 179 of file KVSignal.h.

◆ SetNSamples()

void KVSignal::SetNSamples ( int  nn)
inline

Definition at line 184 of file KVSignal.h.

◆ SetPoleZeroCorrection()

void KVSignal::SetPoleZeroCorrection ( Bool_t  with = kTRUE)
inline

parameters for Pole-Zero correction

Definition at line 296 of file KVSignal.h.

◆ SetSemiGaussSigma()

void KVSignal::SetSemiGaussSigma ( Double_t  sig)
inline

parameters for semi gaussian filter

Definition at line 284 of file KVSignal.h.

◆ SetShaperFlatTop()

void KVSignal::SetShaperFlatTop ( Double_t  flat)
inline

Definition at line 267 of file KVSignal.h.

◆ SetShaperRiseTime()

void KVSignal::SetShaperRiseTime ( Double_t  rise)
inline

Definition at line 263 of file KVSignal.h.

◆ SetTauRC()

void KVSignal::SetTauRC ( Int_t  taurc)
inline

Definition at line 300 of file KVSignal.h.

◆ SetTrapShaperParameters()

void KVSignal::SetTrapShaperParameters ( Double_t  rise,
Double_t  flat 
)
inline

parameters for trapezoidal filter

Definition at line 258 of file KVSignal.h.

◆ SetType()

void KVSignal::SetType ( const Char_t *  type)
inline

Definition at line 94 of file KVSignal.h.

◆ ShiftLeft()

void KVSignal::ShiftLeft ( double  tshift)

---------------— OPERATORI ------------------—//

Definition at line 1800 of file KVSignal.cpp.

◆ ShiftRight()

void KVSignal::ShiftRight ( double  tshift)

Definition at line 1819 of file KVSignal.cpp.

◆ TestDraw()

void KVSignal::TestDraw ( )

Definition at line 1841 of file KVSignal.cpp.

◆ TestWidth()

Bool_t KVSignal::TestWidth ( ) const

Definition at line 458 of file KVSignal.cpp.

◆ TreateOldSignalName()

void KVSignal::TreateOldSignalName ( )
private

Definition at line 243 of file KVSignal.cpp.

◆ TreateSignal()

void KVSignal::TreateSignal ( )
virtual

routines to launch and control PSA

Reimplemented in KVQL1, KVQH1, KVQ3, KVQ2, KVI2, and KVI1.

Definition at line 406 of file KVSignal.cpp.

◆ UpdatePSAParameter()

void KVSignal::UpdatePSAParameter ( KVDBParameterList par)
virtual

Reimplemented in KVQ3.

Definition at line 359 of file KVSignal.cpp.

Member Data Documentation

◆ fAdc

TArrayF KVSignal::fAdc
private

needed to use the psa methods copied from FClasses of Firenze

Definition at line 36 of file KVSignal.h.

◆ fAmplitude

Double_t KVSignal::fAmplitude
private

results of signal treatement

amplitude of the signal

Definition at line 38 of file KVSignal.h.

◆ fBaseLine

Double_t KVSignal::fBaseLine
private

base line mean value

Definition at line 43 of file KVSignal.h.

◆ fChannel

Int_t KVSignal::fChannel
private

signal type (see KVSignal::SignalType enum)

Definition at line 29 of file KVSignal.h.

◆ fChannelWidth

Double_t KVSignal::fChannelWidth
private

channel width in ns

parameters for signal treatment which can be changed in the LoadPSAParameters() method if they are defined in the .kvrootrc file

Definition at line 51 of file KVSignal.h.

◆ fChannelWidthInt

Double_t KVSignal::fChannelWidthInt
private

internal parameter channel width of interpolated signal in ns

Definition at line 65 of file KVSignal.h.

◆ fDetName

TString KVSignal::fDetName
private

name of the detector, the signal is linked to, needed to find it in the KVMultiDetector

Definition at line 31 of file KVSignal.h.

◆ fEndLine

Double_t KVSignal::fEndLine
private

mean value of the signal line at the end

Definition at line 45 of file KVSignal.h.

◆ fFirstBL

Int_t KVSignal::fFirstBL
private

Definition at line 53 of file KVSignal.h.

◆ fFPGAOutputNumbers

Int_t KVSignal::fFPGAOutputNumbers
private

ASsociated FPGA energy outputs.

Definition at line 34 of file KVSignal.h.

◆ fIMax

Double_t KVSignal::fIMax
private

position of the maximum in channel

Definition at line 40 of file KVSignal.h.

◆ fIndex

Int_t KVSignal::fIndex
private

index deduced from block, quartet and telescope numbering

Definition at line 28 of file KVSignal.h.

◆ fInterpolatedChannelWidth

Double_t KVSignal::fInterpolatedChannelWidth
private

channel width used to produced the interpolated signal

Definition at line 52 of file KVSignal.h.

◆ fLastBL

Int_t KVSignal::fLastBL
private

first and last channel number to compute the base line

Definition at line 53 of file KVSignal.h.

◆ fMinimumValueForAmplitude

Double_t KVSignal::fMinimumValueForAmplitude
private

Minimum value to say if detector has been hitted.

Definition at line 60 of file KVSignal.h.

◆ fPSAIsDone

Bool_t KVSignal::fPSAIsDone
private

indicate if PSA has been done

internal parameters

Definition at line 64 of file KVSignal.h.

◆ fRiseTime

Double_t KVSignal::fRiseTime
private

rise time of the signal

Definition at line 39 of file KVSignal.h.

◆ fSemiGaussSigma

Double_t KVSignal::fSemiGaussSigma
private

sigma of the semi-gaussian shaper

Definition at line 57 of file KVSignal.h.

◆ fSigmaBase

Double_t KVSignal::fSigmaBase
private

base line rms

Definition at line 44 of file KVSignal.h.

◆ fSigmaEnd

Double_t KVSignal::fSigmaEnd
private

rms value of the signal line at the end

Definition at line 46 of file KVSignal.h.

◆ fTauRC

Double_t KVSignal::fTauRC
private

tau_rc of the electronics. Used for pole zero cancellation.

Definition at line 54 of file KVSignal.h.

◆ fTMax

Double_t KVSignal::fTMax
private

position of the maximum in ns

Definition at line 41 of file KVSignal.h.

◆ fTrapFlatTop

Double_t KVSignal::fTrapFlatTop
private

flat top of the trapezoidal shaper

Definition at line 56 of file KVSignal.h.

◆ fTrapRiseTime

Double_t KVSignal::fTrapRiseTime
private

rise time of the trapezoidal shaper

Definition at line 55 of file KVSignal.h.

◆ fType

TString KVSignal::fType
private

string to identify the signal type : "QH1", "I2" etc ...

Definition at line 32 of file KVSignal.h.

◆ fWithInterpolation

Bool_t KVSignal::fWithInterpolation
private

use of interpolation or not

Definition at line 59 of file KVSignal.h.

◆ fWithPoleZeroCorrection

Bool_t KVSignal::fWithPoleZeroCorrection
private

use or nor pole zero correction

Definition at line 58 of file KVSignal.h.

◆ fYmax

Double_t KVSignal::fYmax
private

raw min/max of the signal

Definition at line 42 of file KVSignal.h.

◆ fYmin

Double_t KVSignal::fYmin
private

Definition at line 42 of file KVSignal.h.