KaliVeda
1.13/01
Heavy-Ion Analysis Toolkit
|
Definition at line 14 of file KVSignal.h.
Public Types | |
enum | SignalType { kQH1 , kI1 , kQL1 , kQ2 , kI2 , kQ3 , kADC , kUNKDT } |
Public Types inherited from TGraph | |
enum | EStatusBits |
Public Types inherited from TObject | |
enum | EDeprecatedStatusBits |
enum | EStatusBits |
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 () |
KVSignal * | ConvertTo (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) |
Public Member Functions inherited from TGraph | |
TGraph () | |
TGraph (const char *filename, const char *format="%lg %lg", Option_t *option="") | |
TGraph (const TF1 *f, Option_t *option="") | |
TGraph (const TGraph &gr) | |
TGraph (const TH1 *h) | |
TGraph (const TVectorD &vx, const TVectorD &vy) | |
TGraph (const TVectorF &vx, const TVectorF &vy) | |
TGraph (Int_t n) | |
TGraph (Int_t n, const Double_t *x, const Double_t *y) | |
TGraph (Int_t n, const Float_t *x, const Float_t *y) | |
TGraph (Int_t n, const Int_t *x, const Int_t *y) | |
virtual | ~TGraph () |
virtual void | AddPoint (Double_t x, Double_t y) |
virtual void | Apply (TF1 *f) |
virtual void | Browse (TBrowser *b) |
virtual Double_t | Chisquare (TF1 *f1, Option_t *option="") const |
virtual void | ComputeRange (Double_t &xmin, Double_t &ymin, Double_t &xmax, Double_t &ymax) const |
virtual Int_t | DistancetoPrimitive (Int_t px, Int_t py) |
virtual void | Draw (Option_t *chopt="") |
virtual void | DrawGraph (Int_t n, const Double_t *x=nullptr, const Double_t *y=nullptr, Option_t *option="") |
virtual void | DrawGraph (Int_t n, const Float_t *x, const Float_t *y, Option_t *option="") |
virtual void | DrawGraph (Int_t n, const Int_t *x, const Int_t *y, Option_t *option="") |
virtual void | DrawPanel () |
virtual Double_t | Eval (Double_t x, TSpline *spline=nullptr, Option_t *option="") const |
virtual void | ExecuteEvent (Int_t event, Int_t px, Int_t py) |
virtual void | Expand (Int_t newsize) |
virtual void | Expand (Int_t newsize, Int_t step) |
virtual TObject * | FindObject (const char *name) const |
virtual TObject * | FindObject (const TObject *obj) const |
virtual TFitResultPtr | Fit (const char *formula, Option_t *option="", Option_t *goption="", Axis_t xmin=0, Axis_t xmax=0) |
virtual TFitResultPtr | Fit (TF1 *f1, Option_t *option="", Option_t *goption="", Axis_t xmin=0, Axis_t xmax=0) |
virtual void | FitPanel () |
virtual Double_t | GetCorrelationFactor () const |
virtual Double_t | GetCovariance () const |
Bool_t | GetEditable () const |
virtual Double_t | GetErrorX (Int_t bin) const |
virtual Double_t | GetErrorXhigh (Int_t bin) const |
virtual Double_t | GetErrorXlow (Int_t bin) const |
virtual Double_t | GetErrorY (Int_t bin) const |
virtual Double_t | GetErrorYhigh (Int_t bin) const |
virtual Double_t | GetErrorYlow (Int_t bin) const |
virtual Double_t * | GetEX () const |
virtual Double_t * | GetEXhigh () const |
virtual Double_t * | GetEXhighd () const |
virtual Double_t * | GetEXlow () const |
virtual Double_t * | GetEXlowd () const |
virtual Double_t * | GetEY () const |
virtual Double_t * | GetEYhigh () const |
virtual Double_t * | GetEYhighd () const |
virtual Double_t * | GetEYlow () const |
virtual Double_t * | GetEYlowd () const |
TF1 * | GetFunction (const char *name) const |
TH1F * | GetHistogram () const |
TList * | GetListOfFunctions () const |
Double_t | GetMaximum () const |
Int_t | GetMaxSize () const |
virtual Double_t | GetMean (Int_t axis=1) const |
Double_t | GetMinimum () const |
Int_t | GetN () const |
virtual char * | GetObjectInfo (Int_t px, Int_t py) const |
virtual Int_t | GetPoint (Int_t i, Double_t &x, Double_t &y) const |
virtual Double_t | GetPointX (Int_t i) const |
virtual Double_t | GetPointY (Int_t i) const |
virtual Double_t | GetRMS (Int_t axis=1) const |
Double_t * | GetX () const |
TAxis * | GetXaxis () const |
Double_t * | GetY () const |
TAxis * | GetYaxis () const |
virtual void | InitExpo (Double_t xmin=0, Double_t xmax=0) |
virtual void | InitGaus (Double_t xmin=0, Double_t xmax=0) |
virtual void | InitPolynom (Double_t xmin=0, Double_t xmax=0) |
virtual Int_t | InsertPoint () |
virtual void | InsertPointBefore (Int_t ipoint, Double_t x, Double_t y) |
virtual Double_t | Integral (Int_t first=0, Int_t last=-1) const |
virtual Bool_t | IsEditable () const |
virtual Bool_t | IsHighlight () const |
virtual Int_t | IsInside (Double_t x, Double_t y) const |
virtual void | LeastSquareFit (Int_t m, Double_t *a, Double_t xmin=0, Double_t xmax=0) |
virtual void | LeastSquareLinearFit (Int_t n, Double_t &a0, Double_t &a1, Int_t &ifail, Double_t xmin=0, Double_t xmax=0) |
virtual Int_t | Merge (TCollection *list) |
virtual void | MovePoints (Double_t dx, Double_t dy, Bool_t logx=kFALSE, Bool_t logy=kFALSE) |
TGraph & | operator= (const TGraph &) |
virtual void | Paint (Option_t *chopt="") |
void | PaintGraph (Int_t npoints, const Double_t *x, const Double_t *y, Option_t *chopt) |
void | PaintGrapHist (Int_t npoints, const Double_t *x, const Double_t *y, Option_t *chopt) |
virtual void | PaintStats (TF1 *fit) |
virtual void | RecursiveRemove (TObject *obj) |
virtual Int_t | RemovePoint () |
virtual Int_t | RemovePoint (Int_t ipoint) |
virtual void | SavePrimitive (std::ostream &out, Option_t *option="") |
virtual void | SetEditable (Bool_t editable=kTRUE) |
virtual void | SetHighlight (Bool_t set=kTRUE) |
virtual void | SetHistogram (TH1F *h) |
virtual void | SetMaximum (Double_t maximum=-1111) |
virtual void | SetMinimum (Double_t minimum=-1111) |
virtual void | SetName (const char *name="") |
virtual void | SetNameTitle (const char *name="", const char *title="") |
virtual void | SetPoint (Int_t i, Double_t x, Double_t y) |
virtual void | SetPointX (Int_t i, Double_t x) |
virtual void | SetPointY (Int_t i, Double_t y) |
virtual void | SetStats (Bool_t stats=kTRUE) |
virtual void | SetTitle (const char *title="") |
virtual void | Sort (Bool_t(*greater)(const TGraph *, Int_t, Int_t)=&TGraph::CompareX, Bool_t ascending=kTRUE, Int_t low=0, Int_t high=-1111) |
virtual void | UseCurrentStyle () |
void | Zero (Int_t &k, Double_t AZ, Double_t BZ, Double_t E2, Double_t &X, Double_t &Y, Int_t maxiterations) |
Public Member Functions inherited from TNamed | |
TNamed () | |
TNamed (const char *name, const char *title) | |
TNamed (const TNamed &named) | |
TNamed (const TString &name, const TString &title) | |
virtual | ~TNamed () |
virtual void | Clear (Option_t *option="") |
virtual TObject * | Clone (const char *newname="") const |
virtual Int_t | Compare (const TObject *obj) const |
virtual void | FillBuffer (char *&buffer) |
virtual const char * | GetName () const |
virtual const char * | GetTitle () const |
virtual ULong_t | Hash () const |
virtual Bool_t | IsSortable () const |
virtual void | ls (Option_t *option="") const |
TNamed & | operator= (const TNamed &rhs) |
virtual Int_t | Sizeof () const |
Public Member Functions inherited from TObject | |
TObject () | |
TObject (const TObject &object) | |
virtual | ~TObject () |
void | AbstractMethod (const char *method) const |
virtual void | AppendPad (Option_t *option="") |
ULong_t | CheckedHash () |
virtual const char * | ClassName () const |
virtual void | Delete (Option_t *option="") |
virtual void | DrawClass () const |
virtual TObject * | DrawClone (Option_t *option="") const |
virtual void | Dump () const |
virtual void | Error (const char *method, const char *msgfmt,...) const |
virtual void | Execute (const char *method, const char *params, Int_t *error=0) |
virtual void | Execute (TMethod *method, TObjArray *params, Int_t *error=0) |
virtual void | Fatal (const char *method, const char *msgfmt,...) const |
virtual Option_t * | GetDrawOption () const |
virtual const char * | GetIconName () const |
virtual Option_t * | GetOption () const |
virtual UInt_t | GetUniqueID () const |
virtual Bool_t | HandleTimer (TTimer *timer) |
Bool_t | HasInconsistentHash () const |
virtual void | Info (const char *method, const char *msgfmt,...) const |
virtual Bool_t | InheritsFrom (const char *classname) const |
virtual Bool_t | InheritsFrom (const TClass *cl) const |
virtual void | Inspect () const |
void | InvertBit (UInt_t f) |
virtual Bool_t | IsEqual (const TObject *obj) const |
virtual Bool_t | IsFolder () const |
R__ALWAYS_INLINE Bool_t | IsOnHeap () const |
R__ALWAYS_INLINE Bool_t | IsZombie () const |
void | MayNotUse (const char *method) const |
virtual Bool_t | Notify () |
void | Obsolete (const char *method, const char *asOfVers, const char *removedFromVers) const |
void | operator delete (void *ptr) |
void | operator delete[] (void *ptr) |
void * | operator new (size_t sz) |
void * | operator new (size_t sz, void *vp) |
void * | operator new[] (size_t sz) |
void * | operator new[] (size_t sz, void *vp) |
TObject & | operator= (const TObject &rhs) |
virtual void | Pop () |
virtual Int_t | Read (const char *name) |
void | ResetBit (UInt_t f) |
virtual void | SaveAs (const char *filename="", Option_t *option="") const |
void | SetBit (UInt_t f) |
void | SetBit (UInt_t f, Bool_t set) |
virtual void | SetDrawOption (Option_t *option="") |
virtual void | SetUniqueID (UInt_t uid) |
virtual void | SysError (const char *method, const char *msgfmt,...) const |
R__ALWAYS_INLINE Bool_t | TestBit (UInt_t f) const |
Int_t | TestBits (UInt_t f) const |
virtual void | Warning (const char *method, const char *msgfmt,...) const |
virtual Int_t | Write (const char *name=0, Int_t option=0, Int_t bufsize=0) |
virtual Int_t | Write (const char *name=0, Int_t option=0, Int_t bufsize=0) const |
Public Member Functions inherited from TAttLine | |
TAttLine () | |
TAttLine (Color_t lcolor, Style_t lstyle, Width_t lwidth) | |
virtual | ~TAttLine () |
void | Copy (TAttLine &attline) const |
Int_t | DistancetoLine (Int_t px, Int_t py, Double_t xp1, Double_t yp1, Double_t xp2, Double_t yp2) |
virtual Color_t | GetLineColor () const |
virtual Style_t | GetLineStyle () const |
virtual Width_t | GetLineWidth () const |
virtual void | Modify () |
virtual void | ResetAttLine (Option_t *option="") |
virtual void | SaveLineAttributes (std::ostream &out, const char *name, Int_t coldef=1, Int_t stydef=1, Int_t widdef=1) |
virtual void | SetLineAttributes () |
virtual void | SetLineColor (Color_t lcolor) |
virtual void | SetLineColorAlpha (Color_t lcolor, Float_t lalpha) |
virtual void | SetLineStyle (Style_t lstyle) |
virtual void | SetLineWidth (Width_t lwidth) |
Public Member Functions inherited from TAttFill | |
TAttFill () | |
TAttFill (Color_t fcolor, Style_t fstyle) | |
virtual | ~TAttFill () |
void | Copy (TAttFill &attfill) const |
virtual Color_t | GetFillColor () const |
virtual Style_t | GetFillStyle () const |
virtual Bool_t | IsTransparent () const |
virtual void | Modify () |
virtual void | ResetAttFill (Option_t *option="") |
virtual void | SaveFillAttributes (std::ostream &out, const char *name, Int_t coldef=1, Int_t stydef=1001) |
virtual void | SetFillAttributes () |
virtual void | SetFillColor (Color_t fcolor) |
virtual void | SetFillColorAlpha (Color_t fcolor, Float_t falpha) |
virtual void | SetFillStyle (Style_t fstyle) |
Public Member Functions inherited from TAttMarker | |
TAttMarker () | |
TAttMarker (Color_t color, Style_t style, Size_t msize) | |
virtual | ~TAttMarker () |
void | Copy (TAttMarker &attmarker) const |
virtual Color_t | GetMarkerColor () const |
virtual Size_t | GetMarkerSize () const |
virtual Style_t | GetMarkerStyle () const |
virtual void | Modify () |
virtual void | ResetAttMarker (Option_t *toption="") |
virtual void | SaveMarkerAttributes (std::ostream &out, const char *name, Int_t coldef=1, Int_t stydef=1, Int_t sizdef=1) |
virtual void | SetMarkerAttributes () |
virtual void | SetMarkerColor (Color_t mcolor=1) |
virtual void | SetMarkerColorAlpha (Color_t mcolor, Float_t malpha) |
virtual void | SetMarkerSize (Size_t msize=1) |
virtual void | SetMarkerStyle (Style_t mstyle=1) |
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 KVSignal * | MakeSignal (const char *sig_type) |
Create new KVSignal instance corresponding to sig_type. More... | |
Static Public Member Functions inherited from TGraph | |
static Bool_t | CompareArg (const TGraph *gr, Int_t left, Int_t right) |
static Bool_t | CompareRadius (const TGraph *gr, Int_t left, Int_t right) |
static Bool_t | CompareX (const TGraph *gr, Int_t left, Int_t right) |
static Bool_t | CompareY (const TGraph *gr, Int_t left, Int_t right) |
Static Public Member Functions inherited from TObject | |
static Longptr_t | GetDtorOnly () |
static Bool_t | GetObjectStat () |
static void | SetDtorOnly (void *obj) |
static void | SetObjectStat (Bool_t stat) |
Static Public Member Functions inherited from TAttMarker | |
static Width_t | GetMarkerLineWidth (Style_t style) |
static Style_t | GetMarkerStyleBase (Style_t style) |
Protected Member Functions | |
virtual void | BuildCubicSignal () |
virtual void | BuildCubicSplineSignal () |
virtual void | BuildSmoothingSplineSignal () |
void | init () |
void | ResetIndexes () |
void | TreateOldSignalName () |
Protected Member Functions inherited from TGraph | |
virtual Double_t ** | Allocate (Int_t newsize) |
Double_t ** | AllocateArrays (Int_t Narrays, Int_t arraySize) |
virtual void | CopyAndRelease (Double_t **newarrays, Int_t ibegin, Int_t iend, Int_t obegin) |
virtual Bool_t | CopyPoints (Double_t **newarrays, Int_t ibegin, Int_t iend, Int_t obegin) |
Bool_t | CtorAllocate () |
virtual Bool_t | DoMerge (const TGraph *g) |
Double_t ** | ExpandAndCopy (Int_t size, Int_t iend) |
virtual void | FillZero (Int_t begin, Int_t end, Bool_t from_ctor=kTRUE) |
Double_t ** | ShrinkAndCopy (Int_t size, Int_t iend) |
virtual void | SwapPoints (Int_t pos1, Int_t pos2) |
Protected Member Functions inherited from TObject | |
virtual void | DoError (int level, const char *location, const char *fmt, va_list va) const |
void | MakeZombie () |
Protected 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 |
Protected Attributes inherited from TGraph | |
TList * | fFunctions |
TH1F * | fHistogram |
Double_t | fMaximum |
Int_t | fMaxSize |
Double_t | fMinimum |
Int_t | fNpoints |
Double_t * | fX |
Double_t * | fY |
Protected Attributes inherited from TNamed | |
TString | fName |
TString | fTitle |
Protected Attributes inherited from TObject | |
kOnlyPrepStep | |
Protected Attributes inherited from TAttLine | |
Color_t | fLineColor |
Style_t | fLineStyle |
Width_t | fLineWidth |
Protected Attributes inherited from TAttFill | |
Color_t | fFillColor |
Style_t | fFillStyle |
Protected Attributes inherited from TAttMarker | |
Color_t | fMarkerColor |
Size_t | fMarkerSize |
Style_t | fMarkerStyle |
Additional Inherited Members | |
Public Attributes inherited from TGraph | |
kClipFrame | |
kIsHighlight | |
kIsSortedX | |
kNoStats | |
kNotEditable | |
kResetHisto | |
Public Attributes inherited from TObject | |
kBitMask | |
kCanDelete | |
kCannotPick | |
kHasUUID | |
kInconsistent | |
kInvalidObject | |
kIsOnHeap | |
kIsReferenced | |
kMustCleanup | |
kNoContextMenu | |
kNotDeleted | |
kObjInCanvas | |
kOverwrite | |
kSingleKey | |
kWriteDelete | |
kZombie | |
Static Protected Member Functions inherited from TGraph | |
static void | SwapValues (Double_t *arr, Int_t pos1, Int_t pos2) |
#include <KVSignal.h>
enum KVSignal::SignalType |
Enumerator | |
---|---|
kQH1 | |
kI1 | |
kQL1 | |
kQ2 | |
kI2 | |
kQ3 | |
kADC | |
kUNKDT |
Definition at line 16 of file KVSignal.h.
KVSignal::KVSignal | ( | ) |
Default constructor.
Definition at line 88 of file KVSignal.cpp.
KVSignal::KVSignal | ( | const char * | name, |
const char * | title | ||
) |
Write your code here.
Definition at line 100 of file KVSignal.cpp.
Definition at line 112 of file KVSignal.cpp.
|
virtual |
Destructor.
Definition at line 124 of file KVSignal.cpp.
Definition at line 1790 of file KVSignal.cpp.
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.
Definition at line 1515 of file KVSignal.cpp.
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.
|
protectedvirtual |
Definition at line 1386 of file KVSignal.cpp.
Definition at line 1363 of file KVSignal.cpp.
|
protectedvirtual |
Definition at line 1351 of file KVSignal.cpp.
Definition at line 1328 of file KVSignal.cpp.
void KVSignal::BuildReverseTimeSignal | ( | ) |
Definition at line 606 of file KVSignal.cpp.
|
protectedvirtual |
Definition at line 1424 of file KVSignal.cpp.
Definition at line 1396 of file KVSignal.cpp.
Definition at line 474 of file KVSignal.cpp.
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.
|
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.
calculate the time during which the signal is higher than th*fAmplitude
Definition at line 539 of file KVSignal.cpp.
calculate the time during which the signal is higher than th*fAmplitude
Definition at line 509 of file KVSignal.cpp.
|
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.
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.
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.
routines to calculate the raw amplitude without filter
Definition at line 440 of file KVSignal.cpp.
Double_t KVSignal::ComputeRiseTime | ( | ) |
routines dedicated to calculate the rise time (use of filter)
Definition at line 636 of file KVSignal.cpp.
Definition at line 133 of file KVSignal.cpp.
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;
Reimplemented from TNamed.
Definition at line 169 of file KVSignal.cpp.
NOTA: tutti i conti fatti con i tempi in "canali". aggiungero' il *fChannelWidth solo nel return.
Definition at line 1163 of file KVSignal.cpp.
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.
Definition at line 1577 of file KVSignal.cpp.
returns the lenght of FFT( power of 2)
Definition at line 1071 of file KVSignal.cpp.
|
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.
Definition at line 1104 of file KVSignal.cpp.
recurr=1 means: linear + 1 approx recurr=0 == FindTzeroCFD
Definition at line 885 of file KVSignal.cpp.
recurr=1 means: linear + 1 approx recurr=0 == FindTzeroCFD
Definition at line 1591 of file KVSignal.cpp.
Definition at line 676 of file KVSignal.cpp.
void KVSignal::FIR_ApplyMovingAverage | ( | int | npoints | ) |
Definition at line 1731 of file KVSignal.cpp.
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.
f=1/(2*pi*tau) se tau[ns] allora f->[GHz] fsampling=1/fChannelWidth [GHz]
Definition at line 1632 of file KVSignal.cpp.
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.
Definition at line 1613 of file KVSignal.cpp.
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.
different shapers (modify only fAdc)
Definition at line 839 of file KVSignal.cpp.
|
inline |
Definition at line 250 of file KVSignal.h.
|
inline |
routines to manage threshold for minimum charge in the detector
Definition at line 343 of file KVSignal.h.
|
inline |
Definition at line 124 of file KVSignal.h.
|
inline |
Definition at line 219 of file KVSignal.h.
|
inline |
Definition at line 201 of file KVSignal.h.
|
inline |
Definition at line 205 of file KVSignal.h.
|
inline |
Definition at line 172 of file KVSignal.h.
see HSIEH S.HOU IEEE Trans. Acoustic Speech, vol. ASSP-26, NO.6, DECEMBER 1978
Definition at line 1241 of file KVSignal.cpp.
Definition at line 1201 of file KVSignal.cpp.
Definition at line 1220 of file KVSignal.cpp.
Definition at line 1558 of file KVSignal.cpp.
|
inline |
routines to link signal to its detector in kaliveda framework
Definition at line 85 of file KVSignal.h.
|
inline |
Definition at line 228 of file KVSignal.h.
|
inline |
Definition at line 104 of file KVSignal.h.
|
inline |
Definition at line 320 of file KVSignal.h.
|
inline |
Definition at line 129 of file KVSignal.h.
|
inline |
Definition at line 188 of file KVSignal.h.
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.
|
inlinevirtual |
|
inline |
Definition at line 329 of file KVSignal.h.
|
inline |
Definition at line 241 of file KVSignal.h.
|
inline |
Definition at line 288 of file KVSignal.h.
|
inline |
Definition at line 275 of file KVSignal.h.
|
inline |
Definition at line 271 of file KVSignal.h.
|
inline |
Definition at line 223 of file KVSignal.h.
|
inline |
Definition at line 232 of file KVSignal.h.
|
inline |
Definition at line 304 of file KVSignal.h.
|
inline |
Definition at line 98 of file KVSignal.h.
|
inline |
Definition at line 337 of file KVSignal.h.
|
inline |
Definition at line 333 of file KVSignal.h.
|
inline |
Definition at line 134 of file KVSignal.h.
Definition at line 42 of file KVSignal.cpp.
|
inlinevirtual |
|
inlinevirtual |
Reimplemented in KVI2, and KVI1.
Definition at line 113 of file KVSignal.h.
Bool_t KVSignal::IsFired | ( | ) |
ComputeBaseLine and ComputeEndLine methods have to be called before.
Definition at line 581 of file KVSignal.cpp.
Bool_t KVSignal::IsLongEnough | ( | ) | const |
Definition at line 186 of file KVSignal.cpp.
|
virtual |
Definition at line 149 of file KVSignal.cpp.
|
virtual |
Reimplemented in KVQL1, KVQH1, KVQ3, KVQ2, KVI2, KVI1, KVCurrentSignal, and KVChargeSignal.
Definition at line 387 of file KVSignal.cpp.
|
static |
Create new KVSignal instance corresponding to sig_type.
Definition at line 1852 of file KVSignal.cpp.
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.
Definition at line 1748 of file KVSignal.cpp.
Reimplemented from TGraph.
Definition at line 415 of file KVSignal.cpp.
|
inline |
Definition at line 159 of file KVSignal.h.
|
virtual |
Definition at line 594 of file KVSignal.cpp.
|
protected |
Definition at line 76 of file KVSignal.cpp.
Reimplemented from TGraph.
Definition at line 195 of file KVSignal.cpp.
void KVSignal::SetADCData | ( | ) |
Definition at line 229 of file KVSignal.cpp.
Definition at line 347 of file KVSignal.h.
routines dedicated to calculate the baseline
Definition at line 196 of file KVSignal.h.
Indicate the value in (ns or us) of TGraph X axis width
Definition at line 167 of file KVSignal.h.
operation on data arrays
Definition at line 207 of file KVSignal.cpp.
|
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.
Definition at line 89 of file KVSignal.h.
Definition at line 316 of file KVSignal.h.
parameters for interpolation
Definition at line 312 of file KVSignal.h.
Definition at line 179 of file KVSignal.h.
|
inline |
Definition at line 184 of file KVSignal.h.
parameters for Pole-Zero correction
Definition at line 296 of file KVSignal.h.
parameters for semi gaussian filter
Definition at line 284 of file KVSignal.h.
Definition at line 267 of file KVSignal.h.
Definition at line 263 of file KVSignal.h.
Definition at line 300 of file KVSignal.h.
parameters for trapezoidal filter
Definition at line 258 of file KVSignal.h.
Definition at line 94 of file KVSignal.h.
---------------— OPERATORI ------------------—//
Definition at line 1800 of file KVSignal.cpp.
Definition at line 1819 of file KVSignal.cpp.
void KVSignal::TestDraw | ( | ) |
Definition at line 1841 of file KVSignal.cpp.
Bool_t KVSignal::TestWidth | ( | ) | const |
Definition at line 458 of file KVSignal.cpp.
|
protected |
Definition at line 243 of file KVSignal.cpp.
|
virtual |
|
virtual |
Reimplemented in KVQ3.
Definition at line 359 of file KVSignal.cpp.
|
protected |
needed to use the psa methods copied from FClasses of Firenze
Definition at line 36 of file KVSignal.h.
|
protected |
|
protected |
base line mean value
Definition at line 43 of file KVSignal.h.
|
protected |
signal type (see KVSignal::SignalType enum)
Definition at line 29 of file KVSignal.h.
|
protected |
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.
|
protected |
internal parameter channel width of interpolated signal in ns
Definition at line 65 of file KVSignal.h.
|
protected |
name of the detector, the signal is linked to, needed to find it in the KVMultiDetector
Definition at line 31 of file KVSignal.h.
|
protected |
mean value of the signal line at the end
Definition at line 45 of file KVSignal.h.
|
protected |
Definition at line 53 of file KVSignal.h.
|
protected |
ASsociated FPGA energy outputs.
Definition at line 34 of file KVSignal.h.
|
protected |
position of the maximum in channel
Definition at line 40 of file KVSignal.h.
|
protected |
index deduced from block, quartet and telescope numbering
Definition at line 28 of file KVSignal.h.
|
protected |
channel width used to produced the interpolated signal
Definition at line 52 of file KVSignal.h.
|
protected |
first and last channel number to compute the base line
Definition at line 53 of file KVSignal.h.
|
protected |
Minimum value to say if detector has been hitted.
Definition at line 60 of file KVSignal.h.
|
protected |
|
protected |
rise time of the signal
Definition at line 39 of file KVSignal.h.
|
protected |
sigma of the semi-gaussian shaper
Definition at line 57 of file KVSignal.h.
|
protected |
base line rms
Definition at line 44 of file KVSignal.h.
|
protected |
rms value of the signal line at the end
Definition at line 46 of file KVSignal.h.
|
protected |
tau_rc of the electronics. Used for pole zero cancellation.
Definition at line 54 of file KVSignal.h.
|
protected |
position of the maximum in ns
Definition at line 41 of file KVSignal.h.
|
protected |
flat top of the trapezoidal shaper
Definition at line 56 of file KVSignal.h.
|
protected |
rise time of the trapezoidal shaper
Definition at line 55 of file KVSignal.h.
|
protected |
string to identify the signal type : "QH1", "I2" etc ...
Definition at line 32 of file KVSignal.h.
|
protected |
use of interpolation or not
Definition at line 59 of file KVSignal.h.
|
protected |
use or nor pole zero correction
Definition at line 58 of file KVSignal.h.
|
protected |
raw min/max of the signal
Definition at line 42 of file KVSignal.h.
|
protected |
Definition at line 42 of file KVSignal.h.