SOURCE
ssiopensmile.dll

SUMMARY
OSWindow OSWindow
OSVad OSVad
OSTransformFFT OSTransformFFT
OSSpecScale OSSpecScale
OSPreemphasis OSPreemphasis
OSPlpChain OSPlpChain
OSPlp OSPlp
OSPitchSmoother OSPitchSmoother
OSPitchShs OSPitchShs
OSPitchDirection OSPitchDirection
OSPitchChain OSPitchChain
OSMfccChain OSMfccChain
OSMfcc OSMfcc
OSMelspec OSMelspec
OSLpc OSLpc
OSIntensity OSIntensity
OSFunctionals OSFunctionals
OSFFTmagphase OSFFTmagphase
OSEnergy OSEnergy
LaughterPreProcessor LaughterPreProcessor
LaughterFeatureExtractor LaughterFeatureExtractor
Deltas Deltas

DETAILS
OSWindow
  OSWindow  OBJECT
 
           This component applies window functions.
 
             +  type   INT   1   '0'   LOCK   0=Hann, 1=Hamming, 2=Rectangular, 3=Sine, 4=Gauss, 5=Triangular, 6=Bartlett, 7=Lanczos, 8=Bartlett-Hann 9=Blackmann, 10=Blackmann-Harris 
             +  offset   DOUBLE   1   '0.00000'   LOCK   This specifies an offset which will be added to the samples after multiplying with the window function. 
             +  gain   DOUBLE   1   '1.00000'   LOCK   This option allows you to specify a scaling factor by which window function (which is by default normalised to max. 1) should be multiplied by. 
             +  sigma   DOUBLE   1   '0.40000'   LOCK   Standard deviation for the Gaussian window. 
             +  alpha   DOUBLE   1   '0.16000'   LOCK   alpha for the Blackmann window. 
             +  sqrt   BOOL   1   'false'   LOCK   use square root of 'winFunc' as actual window function (e.g. to get a root raised cosine window). 
             +  alphas   DOUBLE   4   '0.00000,0.00000,0.00000,0.00000'   LOCK   alphas for Blackmann(-Harris) / Bartlett-Hann windows (optional!). 
 
OSVad
  OSVad  CONSUMER
 
           A voice activity detector based on Line-Spectral-Frequencies, energy and pitch. This component requires input of the following type in the following order: LSP, pitch, energy. Requires 10ms blocks!
 
             +  sname   CHAR   1024   'OSVad'   LOCK   name of sender (if sent to event board) 
             +  ename   CHAR   1024   'VoiceActivity'   LOCK   name of event (if sent to event board) 
             +  minvoicedur   FLOAT   1   '0.10000'   LOCK   minimum voice activity duration to trigger event (in seconds) 
             +  minsilencedur   FLOAT   1   '0.50000'   LOCK   minimum silence duration to trigger event (in seconds) 
             +  threshold   FLOAT   1   '-13.00000'   LOCK   The minimum rms/log energy threshold to use (or the actual rms energy threshold, if disableDynamicVAD==1) 
             +  disableDynamicVAD   BOOL   1   'false'   LOCK   1/0 = yes/no, whether dynamic VAD is disabled (default is enabled) 
 
OSTransformFFT
  OSTransformFFT  FEATURE
 
           This component performs an FFT on a sequence of real values (one frame), the output is the complex domain result of the transform.
 
             +  nfft   UINT   1   '1024'   LOCK   Frame size on which to apply FFT. Must be a power of 2 and should be LARGER than frame size + delta. 
 
OSSpecScale
  OSSpecScale  FILTER
 
           This component performs linear/non-linear axis scaling of FFT magnitude spectra with spline interpolation.
 
             +  dstScale   INT   1   '1'   LOCK   The target scale, one of the following: 0=linear scale, 1=logarithmic, (see 'logScaleBase'), 2=bark scale, 3=mel frequency scale, 4=musical semi-tone scale 
             +  srcScale   INT   1   '0'   LOCK   The source scale (currently only '0=linear' is supported, all other options (as found for target scale) are experimental. 
             +  dstLogScaleBase   DOUBLE   1   '2.00000'   LOCK   The base for log scales (a log base of 2.0 - the default - corresponds to an octave target scale). 
             +  srcLogScaleBase   DOUBLE   1   '2.00000'   LOCK   The base for log source scales (a log base of 2.0 - the default - corresponds to an octave target scale). 
             +  firstNote   DOUBLE   1   '55.00000'   LOCK   The first note (in Hz) for a semi-tone scale. 
             +  minF   DOUBLE   1   '25.00000'   LOCK   The minimum frequency of the target scale. 
             +  maxF   DOUBLE   1   '-1.00000'   LOCK   The maximum frequency of the target scale (-1.0 : set to maximum frequency of the source spectrum). 
             +  nPoints   UINT   1   '0'   LOCK   The number of frequency points in target spectrum (<= 0 : same as input spectrum). 
             +  smooth   BOOL   1   'false'   LOCK   Perform spectral smoothing before applying the scale transformation. 
             +  enhance   BOOL   1   'false'   LOCK   Perform spectral peak enhancement before applying smoothing (if enabled) and scale transformation. 
             +  weight   BOOL   1   'false'   LOCK   Perform post-scale auditory weighting (this is currently only supported for octave (log2) scales). 
             +  fsSec   DOUBLE   1   '-1.00000'   LOCK   Frame size in seconds (if -1.0 calculated from sample rate of input stream). 
 
OSPreemphasis
  OSPreemphasis  FILTER
 
           This component performs pre- and de-emphasis of speech signals using a 1st order difference equation: y(t) = x(t) - k*x(t-1) (de-emphasis: y(t) = x(t) + k*x(t-1)).
 
             +  de   BOOL   1   'false'   LOCK   perform de-emphasis instead of pre-emphasis (i.e. y[n] = x[n] + k*x[n-1]) 
             +  k   FLOAT   1   '0.97000'   LOCK   The pre-emphasis coefficient k in y[n] = x[n] - k*x[n-1]. 
             +  f   DOUBLE   1   '0.00000'   LOCK   The pre-emphasis frequency f in Hz : k = exp( -2*pi * f/sr ) (if > 0, f will override k!). 
 
OSPlpChain
  OSPlpChain  TRANSFORMER
 
           This component chains together OSTransformFFT, OSFFTmagphase, OSSpecScale, OSPitchShs, and OSPitchSmoother.
 
             +  frame   UINT   1   '160'   LOCK   frame size in #samples 
             +  delta   UINT   1   '320'   LOCK   delta size in #samples 
             +  deltas_enable   UINT   1   '0'   LOCK   get deltas of Plps 
 
OSPlp
  OSPlp  FILTER
 
           This component computes PLP and RASTA-PLP (currently the RASTA filter is not yet implemented) cepstral coefficients from a critical band spectrum (generated by the cMelspec component, for example)
 
             +  lpOrder   INT   1   '12'   LOCK   The order of the linear predictor (5th order is optimal according to Hermansky 1990, JASA) 
             +  firstCC   INT   1   '0'   LOCK   The first cepstral coefficient to compute (set to 0 to include the 0th coefficient, which is defined as -log(1/lpcGain) ) 
             +  lastCC   INT   1   '12'   LOCK   The last cepstral coefficient to compute 
             +  doLog   BOOL   1   'true'   LOCK   Take the log of input bands (1=yes / 0=no) 
             +  doAud   BOOL   1   'true'   LOCK   Do auditory processing (equal loudness curve and loudness compression) (1=yes / 0=no) 
             +  RASTA   BOOL   1   'false'   LOCK   Perform RASTA (temporal) filtering (1=yes / 0=no) 
             +  newRASTA   BOOL   1   'false'   LOCK   Perform RASTA (temporal) filtering (more stable filter, Type-II, initial filtering only with FIR part; thanks to Chris Landsiedl for this code!) (1=enable / 0=disable) Note: this option (if set to 1) will disable the 'RASTA' option. 
             +  rastaUpperCutoff   FLOAT   1   '29.00000'   LOCK   Upper cut-off frequency of RASTA bandpass filter in Hz 
             +  rastaLowerCutoff   FLOAT   1   '1.00000'   LOCK   Lower cut-off frequency of RASTA bandpass filter in Hz 
             +  doInvLog   BOOL   1   'true'   LOCK   Apply inverse logarithm after power compression (1=yes / 0=no) 
             +  doIDFT   BOOL   1   'true'   LOCK   Apply I(nverse)DFT after power compression and inverse log (1=yes / 0=no) 
             +  doLP   BOOL   1   'true'   LOCK   Do lp analysis on autocorrelation function (1=yes / 0=no) 
             +  doLpToCeps   BOOL   1   'true'   LOCK   Convert lp coefficients to cepstral coefficients (1=yes / 0=no) 
             +  cepLifter   FLOAT   1   '0.00000'   LOCK   Parameter for cepstral 'liftering', set to 0.0 to disable cepstral liftering 
             +  compression   FLOAT   1   '0.33000'   LOCK   Compression factor for 'power law of hearing' 
             +  melfloor   FLOAT   1   '0.00000'   LOCK   Minimum value of melspectra when computing mfcc (will be forced to 1.0 when htkcompatible=1) 
             +  htkcompatible   BOOL   1   'false'   LOCK   Set correct mel-floor and force HTK compatible PLP output (1/0 = yes/no) htkcompatible == 1, forces the following settings: - melfloor = 1.0 (signal scaling 0..32767*32767) - append 0th coeff instead of having it as first value - doAud = 1 , doLog=0 , doInvLog=0 (doIDFT, doLP, and doLpToCeps are not forced to 1, this enables generation of HTK compatible auditory spectra, etc. (these, of course, are not compatible, i.e. are not the same as HTK's PLP)) - the 0th audspec component is used as dc component in IDFT (else the DC component is zero) 
 
OSPitchSmoother
  OSPitchSmoother  FILTER
 
           This component performs temporal pitch smoothing. Input: candidates produced by a pitchBase descendant (e.g. cPitchSHS). The voicing cutoff threshold is inherited from the input component, thus this smoother component does not provide its own threshold option.
 
             +  medianFilter0   INT   1   '0'   LOCK   Apply median filtering of candidates as the FIRST processing step; filter length is 'medianFilter0' if > 0. 
             +  postSmoothing   INT   1   '0'   LOCK   Apply post processing (median and spike remover) over 'postSmoothing' frames (0=no smoothing or use default set by postSmoothingMethod). 
             +  postSmoothingMethod   INT   1   '1'   LOCK   Post processing method to use. One of the following: 0=disable post smoothing, 1=simple post smoothing using only 1 frame delay (will smooth out 1 frame octave spikes), 2='median' will apply a median filter to the output values (length = value of 'postSmoothing'). 
             +  octaveCorrection   BOOL   1   'true'   LOCK   Enable intelligent cross candidate octave correction. 
             +  F0final   BOOL   1   'true'   LOCK   Enable output of final (corrected and smoothed) F0. 
             +  F0finalEnv   BOOL   1   'false'   LOCK   Enable output of envelope of final smoothed F0 (i.e. there will be no 0 values (except for end and beginning)). 
             +  voicingFinalClipped   BOOL   1   'false'   LOCK   Enable output of final smoothed and clipped voicing (pseudo) probability. 'Clipped' means that the voicing probability is set to 0 for unvoiced regions, i.e. where the probability lies below the voicing threshold. 
             +  voicingFinalUnclipped   BOOL   1   'false'   LOCK   Enable output of final smoothed, raw voicing (pseudo) probability (UNclipped: not set to 0 during unvoiced regions).. 
             +  F0raw   BOOL   1   'false'   LOCK   Enable output of 'F0raw' copied from input. 
             +  voicingC1   BOOL   1   'false'   LOCK   Enable output of 'voicingC1' copied from input. 
             +  voicingClip   BOOL   1   'false'   LOCK   Enable output of 'voicingClip' copied from input. 
 
OSPitchShs
  OSPitchShs  FILTER
 
           This component computes the fundamental frequency via the Sub-Harmonic-Sampling (SHS) method (this is related to the Harmonic Product Spectrum method).
 
             +  baseSr   DOUBLE   1   '16000.00000'   LOCK   Samplerate of original wave input in Hz. 
             +  fsSec   DOUBLE   1   '-1.00000'   LOCK   Frame size in seconds (if -1.0 calculated from sample rate of input stream). 
             +  minPitch   DOUBLE   1   '52.00000'   LOCK   Minimum detectable pitch in Hz. 
             +  maxPitch   DOUBLE   1   '620.00000'   LOCK   Maximum detectable pitch in Hz. 
             +  nCandidates   INT   1   '3'   LOCK   The number of F0 candidates to output [1-20] (0 disables ouput of candidates AND their voicing probs). 
             +  scores   BOOL   1   'true'   LOCK   Output of F0 candidates scores, if available. 
             +  voicing   BOOL   1   'true'   LOCK   Output of voicing probability for F0 candidates. 
             +  F0C1   BOOL   1   'false'   LOCK   Output of raw best F0 candidate without thresholding in unvoiced segments. 
             +  voicingC1   BOOL   1   'false'   LOCK   Output of output voicing (pseudo) probability for best candidate. 
             +  F0raw   BOOL   1   'false'   LOCK   Output of raw F0 (best candidate), > 0 only for voiced segments (using voicingCutoff threshold). 
             +  voicingClip   BOOL   1   'false'   LOCK   Output of voicing of raw F0 (best candidate), > 0 only for voiced segments (using voicingCutoff threshold). 
             +  voicingCutoff   FLOAT   1   '0.70000'   LOCK   This sets the voicing (pseudo) probability threshold for pitch detection. Frames with voicing probability values above this threshold will be considered as voiced. 
             +  octaveCorrection   BOOL   1   'false'   LOCK   If this pitch detector algorithm offers algorithm specific low-level octave correction, enable it. 
             +  nHarmonics   INT   1   '15'   LOCK   Number of harmonics to consider for subharmonic sampling (feasible values: 5-15). 
             +  compressionFactor   FLOAT   1   '0.85000'   LOCK   The factor for successive compression of sub-harmonics. 
             +  greedyPeakAlgo   BOOL   1   'false'   LOCK   use new algorithm to return all maximum score candidates regardless of their order. The old algorithm added new candidates only if they were higher scored as the first one. Enabling this seems to require different viterbi parameters for smoothing though, so use with caution! Default behaviour is 'off' so we remain backwards compatibility. 
 
OSPitchDirection
  OSPitchDirection  FILTER
 
           Reads pitch data and compute pitch direction estimates
 
             +  sname   CHAR   1024   'OSPitchDirection'   LOCK   name of sender (if sent to event board) 
             +  ename   CHAR   1024   'PitchDirection'   LOCK   name of event (if sent to event board) 
             +  ltbs   FLOAT   1   '0.20000'   LOCK   The size of the long-term average buffer in seconds 
             +  stbs   FLOAT   1   '0.05000'   LOCK   The size of the short-term average buffer in seconds 
             +  speakingRateBsize   UINT   1   '100'   LOCK   The buffer size for computation of speaking rate (in input frames, typical frame rate 100 fps) 
             +  F0direction   BOOL   1   'true'   LOCK   1 = enable output of F0 direction as numeric value (fall: -1.0 / flat: 0.0 / rise: 1.0) 
             +  directionScore   BOOL   1   'true'   LOCK   1 = enable output of F0 direction score (short term mean - long term mean) 
             +  speakingRate   BOOL   1   'false'   LOCK   1 = enable output of current speaking rate in Hz (is is output for every frame, thus, a lot of redundancy here) 
             +  F0avg   BOOL   1   'false'   LOCK   1 = enable output of long term average F0 
             +  F0smooth   BOOL   1   'false'   LOCK   1 = enable output of exponentially smoothed F0 
 
OSPitchChain
  OSPitchChain  FEATURE
 
           This component chains together OSTransformFFT, OSFFTmagphase, OSSpecScale, OSPitchShs, and OSPitchSmoother.
 
 
OSMfccChain
  OSMfccChain  FEATURE
 
           This component chains together OSTransformFFT, OSFFTmagphase, OSSpecScale, OSPitchShs, and OSPitchSmoother.
 
             +  deltas_enable   UINT   1   '0'   LOCK   get deltas of MFCC's 
 
OSMfcc
  OSMfcc  FILTER
 
           This component computes Mel-frequency cepstral coefficients (MFCC) from a critical band spectrum (see 'cMelspec'). An I-DCT of type-II is used from transformation from the spectral to the cepstral domain. Liftering of cepstral coefficients is supported. HTK compatible values can be computed.
 
             +  first   UINT   1   '1'   LOCK   The first MFCC to compute. 
             +  last   UINT   1   '12'   LOCK   The last MFCC to compute. 
             +  floor   FLOAT   1   '0.00000'   LOCK   The minimum value allowed for melspectra when taking the log spectrum (this parameter will be forced to 1.0 when htkcompatible=1). 
             +  lift   FLOAT   1   '22.00000'   LOCK   Parameter for cepstral 'liftering', set this to 0.0 to disable cepstral liftering. 
             +  htk   BOOL   1   'false'   LOCK   Appends the 0-th coefficient at the end instead of placing it as the first element of the output vector. 
 
OSMelspec
  OSMelspec  FILTER
 
           This component computes an N-band Mel/Bark/Semitone-frequency spectrum (critical band spectrum) by applying overlapping triangular filters equidistant on the Mel/Bark/Semitone-frequency scale to an FFT magnitude or power spectrum.
 
             +  nBands   UINT   1   '26'   LOCK   The number of Mel/Bark/Semitone band filters the filterbank from 'lofreq'-'hifreq' contains. 
             +  loFreq   FLOAT   1   '20.00000'   LOCK   The upper cut-off frequency of the filterbank (Hz). 
             +  hiFreq   FLOAT   1   '8000.00000'   LOCK   The upper cut-off frequency of the filterbank (Hz). 
             +  usePower   BOOL   1   'false'   LOCK   Use the power spectrum instead of magnitude spectrum, i.e. if set this squares the input data. 
             +  showBank   BOOL   1   'false'   LOCK   Bandwidths and centre frequencies of the filters in the filterbank are printed to openSMILE log output. 
             +  htk   BOOL   1   'false'   LOCK   Enable htk compatible output (audio sample scaling -32767..+32767. 
             +  scale   INT   1   '3'   LOCK   The frequency scale to design the critical band filterbank in (this is the scale in which the filter centre frequencies are placed equi-distant): 3=Mel-frequency scale (m = 1127 ln (1+f/700)), 2=Bark scale approximation (Critical band rate z): z = [26.81 / (1.0 + 1960/f)] - 0.53, 5=Bark scale approximation due to Schroeder (1977): 6*ln( f/600 + [(f/600)^2+1]^0.5 ), 6=Bark scale approximation as used in Speex codec package, 4=semi-tone scale with first note (0) = 'firstNote' (default 27.5Hz) (s=12*log(f/firstNote)/log(2)) [experimental], 1=logarithmic scale with base 'logScaleBase'. 
             +  bwMethod   INT   1   '0'   LOCK   The method to use to compute filter bandwidth: 0=use centre frequencies of left and right neighbours (standard way for mel-spectra and mfcc), 1=bandwidth based on critical bandwidth approximation (ERB), choose this option for computing HFCC instead of MFCC. 
             +  logScaleBase   DOUBLE   1   '2.00000'   LOCK   The base for log scales (a log base of 2.0 - the default - corresponds to an octave target scale) 
             +  firstNote   DOUBLE   1   '27.05000'   LOCK   The first note (in Hz) for a semi-tone scale 
 
OSLpc
  OSLpc  FEATURE
 
           This component computes linear predictive coding (LPC) coefficients from PCM frames. Burg's algorithm and the standard ACF/Durbin based method are implemented for LPC coefficient computation. The output of LPC filter coefficients, reflection coefficients, residual signal, LP spectrum and LSP is supported.
 
             +  method   CHAR   1024   'acf'   LOCK   This option sets the lpc method to use. Choose between: 'acf' acf (autocorrelation) method with Levinson-Durbin algorithm , 'burg' Burg method (N. Anderson (1978)) 
             +  p   UINT   1   '8'   LOCK   Predictor order (= number of lpc coefficients) 
             +  saveLPCoeff   BOOL   1   'true'   LOCK   true = save LP coefficients to output 
             +  lpGain   BOOL   1   'false'   LOCK   true = save lpc gain (error) in output vector 
             +  saveRefCoeff   BOOL   1   'false'   LOCK   true = save reflection coefficients to output 
             +  residual   BOOL   1   'false'   LOCK   true = compute lpc residual signal and store in output frame 
             +  forwardFilter   BOOL   1   'false'   LOCK   true = apply forward instead of inverse filter when computing residual 
             +  lpSpectrum   BOOL   1   'false'   LOCK   true = compute lp spectrum using 'lpSpecDeltaF' as frequency resolution or 'lpSpecBins' bins 
             +  lpSpecDeltaF   FLOAT   1   '10.00000'   LOCK   frequency resolution of lp spectrum (only applicable if 'lpSpectrum=true') 
             +  lpSpecBins   UINT   1   '100'   LOCK   number of bins to compute lp spectrum for (overrides lpSpecDeltaF) (only applicable if 'lpSpectrum=true') 
             +  lsp   BOOL   1   'false'   LOCK   compute LSP (line spectral pairs) from LPC coefficients 
 
OSIntensity
  OSIntensity  FEATURE
 
           This component computes simplified frame OSIntensity (narrow band approximation).
 
             +  intensity   INT   1   '1'   LOCK   1 = enable the output of intensity I (mean of squared input values multiplied by a Hamming window) 
             +  loudness   INT   1   '0'   LOCK   1 = enable the output of loudness L : L = (I/I0)^0.3 ; I0 = 0.000001 (for sample values normalised to the range -1..1) 
 
OSFunctionals
  OSFunctionals  FEATURE
 
           This component computes functionals.
 
             +  nonZeroFuncts   INT   1   '0'   LOCK   If this is set to 1, functionals are only applied to input values unequal 0. If this is set to 2, functionals are only applied to input values greater than 0. 
             +  enabledDimensions   CHAR   1024   ''   LOCK   array of enabled dimensions on which functionals will apply, if left empty all of them will be enabled 
             +  Crossings   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Crossings 
             +  zcr   INT   1   '1'   LOCK   1/0=enable/disable output of zero crossing rate 
             +  mcr   INT   1   '1'   LOCK   1/0=enable/disable output of mean crossing rate (the rate at which the signal crosses its arithmetic mean value (same as zcr for mean normalised signals) 
             +  amean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean 
             +  DCT   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional dct 
             +  firstCoeff   INT   1   '1'   LOCK   The first DCT coefficient to compute (coefficient 0 corresponds to the DC component) 
             +  lastCoeff   INT   1   '1'   LOCK   The last DCT coefficient to compute 
             +  Samples   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional samples 
             +  samplepos   CHAR   1024   ''   LOCK   Array of positions of samples to copy to the output (i.e. 0.1,0.5,..). The size of this array determines the number of sample frames that will be passed to the output. The given positions must be in the range from 0 to 1, indicating the relative position whithin the input segment, where 0 is the beginning and 1 the end of the segment. 
             +  Segments   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional segments 
             +  maxNumSeg   INT   1   '100'   LOCK   Maximum number of segments to detect 
             +  rangeRelThreshold   FLOAT   1   '0.25000'   LOCK   The segment threshold relative to the signal's range (max-min) 
             +  numSegments   INT   1   '1'   LOCK   1/0=enable/disable output of the number of segments (output is relative to maxNumSeg) 
             +  meanSegLen   INT   1   '1'   LOCK   1/0=enable/disable output of the mean segment length 
             +  maxSegLen   INT   1   '1'   LOCK   1/0=enable/disable output of the maximum segment length 
             +  minSegLen   INT   1   '1'   LOCK   1/0=enable/disable output of the minimum segment length 
             +  Times   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional times 
             +  upleveltime25   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is above 0.25*range 
             +  downleveltime25   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is below 0.25*range 
             +  upleveltime50   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is above 0.50*range 
             +  downleveltime50   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is below 0.50*range 
             +  upleveltime75   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is above 0.75*range 
             +  downleveltime75   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is below 0.75*range 
             +  upleveltime90   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is above 0.90*range 
             +  downleveltime90   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is below 0.90*range 
             +  risetime   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is rising 
             +  falltime   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal is falling 
             +  leftctime   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal has left curvature 
             +  rightctime   INT   1   '1'   LOCK   (1/0=yes/no) compute time where signal has right curvature 
             +  duration   INT   1   '1'   LOCK   (1/0=yes/no) compute duration time, in frames (or seconds, if (time)norm==seconds) 
             +  upleveltime   CHAR   1024   ''   LOCK   compute time where signal is above X*range : upleveltime[n]=X i.e. (i.e. 0.1,7.5,..) if empty thus disabled  
             +  downleveltime   CHAR   1024   ''   LOCK   compute time where signal is below X*range : downleveltime[n]=X i.e. (i.e. 1.1,0.5,..) if empty thus disabled 
             +  Extremes   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional extremes 
             +  max   INT   1   '1'   LOCK   1/0=enable/disable output of maximum value 
             +  min   INT   1   '1'   LOCK   1/0=enable/disable output of minimum value 
             +  range   INT   1   '1'   LOCK   1/0=enable/disable output of range (max-min) 
             +  maxpos   INT   1   '1'   LOCK   1/0=enable/disable output of position of maximum value 
             +  minpos   INT   1   '1'   LOCK   1/0=enable/disable output of position of minimum value 
             +  maxameandist   INT   1   '1'   LOCK   1/0=enable/disable output of (max-arithmetic_mean) 
             +  minameandist   INT   1   '1'   LOCK   1/0=enable/disable output of (arithmetic_mean-min) 
             +  Means   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional means 
             +  amean_means   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean 
             +  absmean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of absolute values 
             +  qmean   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic mean 
             +  nzamean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean (of non-zero values only) 
             +  nzabsmean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of absolute values (of non-zero values only) 
             +  nzqmean   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic mean (of non-zero values only) 
             +  nzgmean   INT   1   '1'   LOCK   1/0=enable/disable output of geometric mean (of absolute values of non-zero values only) 
             +  nnz   INT   1   '1'   LOCK   1/0=enable/disable output of number of non-zero values 
             +  flatness   INT   1   '1'   LOCK   1/0=enable/disable output of contour flatness (ratio of geometric mean and absolute value arithmetic mean(absmean))) 
             +  posamean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of positive values only (usually you would apply this to a differential signal to measure how much the original signal is rising) 
             +  negamean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of negative values only 
             +  posqmean   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic mean of positive values only 
             +  posrqmean   INT   1   '1'   LOCK   1/0=enable/disable output of root of quadratic mean of positive values only 
             +  negqmean   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic mean of negative values only 
             +  negrqmean   INT   1   '1'   LOCK   1/0=enable/disable output of root of quadratic mean of negative values only 
             +  rqmean   INT   1   '1'   LOCK   1/0=enable/disable output of square root of quadratic mean 
             +  nzrqmean   INT   1   '1'   LOCK   1/0=enable/disable output of square root of quadratic mean of non zero values 
             +  OnSet   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Onsets 
             +  threshold   FLOAT   1   '0.00000'   LOCK   The absolute threshold used for onset/offset detection (i.e. the first onset will be where the input value is above the threshold for the first time) 
             +  thresholdOnset   FLOAT   1   '0.00000'   LOCK   A separate threshold only for onset detection. This will override the 'threshold' option, if set 
             +  thresholdOffset   FLOAT   1   '0.00000'   LOCK   A separate threshold only for offset detection. This will override the 'threshold' option, if set 
             +  setThresholdOnset   INT   1   '1'   LOCK   1/0=set/unset thresholdOnset value 
             +  setThresholdOffset   INT   1   '1'   LOCK   1/0=set/unset thresholdOnset value 
             +  useAbsVal   INT   1   '1'   LOCK   1/0=yes/no : apply thresholds to absolute input value instead of original input value 
             +  onsetPos   INT   1   '1'   LOCK   1/0=enable/disable output of relative position of first onset found [output name: onsetPos] 
             +  offsetPos   INT   1   '1'   LOCK   1/0=enable/disable output of position of last offset found [output name: offsetPos] 
             +  numOnsets   INT   1   '1'   LOCK   1/0=enable/disable output of the number of onsets found [output name: numOnsets] 
             +  numOffsets   INT   1   '1'   LOCK   1/0=enable/disable output of the number of offsets found (this is usually redundant and the same as numOnsets, use this only for special applications where it may make sense to use it) [output name: numOffsets] 
             +  Peaks   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Peaks 
             +  numPeaks   INT   1   '1'   LOCK   1/0=enable/disable output of number of peaks [output name: numPeaks] 
             +  meanPeakDist   INT   1   '1'   LOCK   1/0=enable/disable output of mean distance between peaks [output name: meanPeakDist] 
             +  peakMean   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of peaks [output name: peakMean] 
             +  peakMeanMeanDist   INT   1   '1'   LOCK   1/0=enable/disable output of aritmetic mean of peaks - aritmetic mean of all values [output name: peakMeanMeanDist] 
             +  peakDistStddev   INT   1   '1'   LOCK   1/0=enable/disable output of standard deviation of inter peak distances [output name: peakDistStddev] 
             +  overlapFlag   INT   1   '1'   LOCK   1/0=yes/no frames overlap (i.e. compute peaks locally only) 
             +  Percentiles   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Percentiles 
             +  quartiles   INT   1   '1'   LOCK   1/0=enable/disable output of all quartiles (overrides individual settings quartile1, quartile2, and quartile3 if disabled) 
             +  quartile1   INT   1   '1'   LOCK   1/0=enable/disable output of quartile1 (0.25) 
             +  quartile2   INT   1   '1'   LOCK   1/0=enable/disable output of quartile2 (0.50) 
             +  quartile3   INT   1   '1'   LOCK   1/0=enable/disable output of quartile3 (0.75) 
             +  iqr   INT   1   '1'   LOCK   1/0=enable/disable output of all inter-quartile ranges (overrides individual settings iqr12, iqr23, and iqr13 if disabled)  
             +  iqr12   INT   1   '1'   LOCK   1/0=enable/disable output of inter-quartile range 1-2 (quartile2-quartile1) 
             +  iqr23   INT   1   '1'   LOCK   1/0=enable/disable output of inter-quartile range 2-3 (quartile3-quartile2) 
             +  iqr13   INT   1   '1'   LOCK   1/0=enable/disable output of inter-quartile range 1-3 (quartile3-quartile1) 
             +  percentile   CHAR   1024   ''   LOCK   Array of p*100 percent percentiles to compute. p = 0..1. (i.e. 0.2,0.8,0.5,....) Array size indicates the number of total percentiles to compute (excluding quartiles), duplicate entries are not checked for and not removed : percentile[n] = p (p=0..1) if empty then disabled 
             +  pctlrange   CHAR   1024   ''   LOCK   Array that specifies which inter percentile ranges to compute. A range is specified as (n11,n12,n21,n22,n31,n32,....) (where ni1 and ni2 are the indicies of the percentiles as they appear in the percentile[] array, starting at 0 with the index of the first percentile) if empty then disabled 
             +  interp   INT   1   '1'   LOCK   If set to 1, percentile values will be linearly interpolated, instead of being rounded to the nearest index in the sorted array 
             +  Regression   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Regression 
             +  linregc1   INT   1   '1'   LOCK   1/0=enable/disable output of slope m (linear regression line) 
             +  linregc2   INT   1   '1'   LOCK   1/0=enable/disable output of offset t (linear regression line) 
             +  linregerrA   INT   1   '1'   LOCK   1/0=enable/disable output of linear error between contour and linear regression line 
             +  linregerrQ   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic error between contour and linear regression line 
             +  qregc1   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic regression coefficient 1 (a) 
             +  qregc2   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic regression coefficient 2 (b) 
             +  qregc3   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic regression coefficient 3 (c = offset) 
             +  qregerrA   INT   1   '1'   LOCK   1/0=enable/disable output of linear error between contour and quadratic regression line (parabola) 
             +  qregerrQ   INT   1   '1'   LOCK   1/0=enable/disable output of quadratic error between contour and quadratic regression line (parabola) 
             +  centroid   INT   1   '1'   LOCK   1/0=enable/disable output of centroid of contour (this is computed as a by-product of the regression coefficients). 
             +  qregls   INT   1   '1'   LOCK   1/0=enable/disable output of left slope of parabola (slope of the line from first point on the parabola at t=0 to the vertex). 
             +  qregrs   INT   1   '1'   LOCK   1/0=enable/disable output of right slope of parabola (slope of the line from the vertex to the last point on the parabola at t=N). 
             +  qregx0   INT   1   '1'   LOCK   1/0=enable/disable output of x coordinate of the parabola vertex (since for very flat parabolas this can be very large/small, it is clipped to range -Nin - +Nin ). 
             +  qregy0   INT   1   '1'   LOCK   1/0=enable/disable output of y coordinate of the parabola vertex. 
             +  qregyr   INT   1   '1'   LOCK   1/0=enable/disable output of y coordinate of the last point on the parabola (t=N). 
             +  qregy0nn   INT   1   '1'   LOCK   1/0=enable/disable output of y coordinate of the parabola vertex. This value is unnormalised, regardless of value of normInput. 
             +  qregc3nn   INT   1   '1'   LOCK   1/0=enable/disable output of y coordinate of the first point on the parabola (t=0). This value is unnormalised, regardless of value of normInput. 
             +  qregyrnn   INT   1   '1'   LOCK   1/0=enable/disable output of y coordinate of the last point on the parabola (t=N). This value is unnormalised, regardless of value of normInput. 
             +  normInputs   INT   1   '1'   LOCK   1/0=enable/disable normalisation of regression coefficients, coordinates, and regression errors on the value scale. If enabled all input values will be normalised to the range 0..1. Use this in conjunction with normRegCoeff. 
             +  normRegCoeff   INT   1   '1'   LOCK   1/0=enable/disable normalisation of regression coefficients. If enabled, the coefficients are scaled (multiplied by the contour length) so that a regression line or parabola approximating the contour can be plotted over an x-axis range from 0 to 1, i.e. this makes the coefficients independent of the contour length (a longer contour with a lower slope will then have the same 'm' (slope) linear regression coefficient as a shorter but steeper slope). 
             +  Moments   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Moments 
             +  variance   INT   1   '1'   LOCK   1/0=enable/disable output of variance 
             +  stddev   INT   1   '1'   LOCK   1/0=enable/disable output of standard deviation 
             +  skewness   INT   1   '1'   LOCK   1/0=enable/disable output of skewness 
             +  kurtosis   INT   1   '1'   LOCK   1/0=enable/disable output of kurtosis 
             +  amean_moments   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean 
             +  Peaks2   INT   1   '0'   LOCK   1/0=enable/disable outputs of functional Peaks2 
             +  numPeaks2   INT   1   '1'   LOCK   1/0=enable/disable output of number of peaks 
             +  meanPeakDist2   INT   1   '1'   LOCK   1/0=enable/disable output of mean distance between peaks (relative to the input segment length, in seconds, or in frames, see the 'norm' option or the 'masterTimeNorm' option of the cFunctionals parent component) 
             +  meanPeakDistDelta   INT   1   '1'   LOCK   1/0=enable/disable output of mean difference between consecutive inter peak distances (relative to the input segment length, in seconds, or in frames, see the 'norm' option or the 'masterTimeNorm' option of the cFunctionals parent component) [NOT YET IMPLEMENTED!] 
             +  peakDistStddev2   INT   1   '1'   LOCK   1/0=enable/disable output of standard deviation of inter peak distances 
             +  peakRangeAbs   INT   1   '1'   LOCK   1/0=enable/disable output of peak range (max peak value - min peak value) 
             +  peakRangeRel   INT   1   '1'   LOCK   1/0=enable/disable output of peak range (max peak value - min peak value) / arithmetic mean 
             +  peakMeanAbs   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of peaks (local maxima) 
             +  peakMeanMeanDist2   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of peaks - arithmetic mean of all values 
             +  peakMeanRel   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of peaks (local maxima) / arithmetic mean of all values 
             +  ptpAmpMeanAbs   INT   1   '1'   LOCK   1/0=enable/disable output of mean peak to peak (amplitude) difference 
             +  ptpAmpMeanRel   INT   1   '1'   LOCK   1/0=enable/disable output of mean peak to peak (amplitude) difference / arithmetic mean 
             +  ptpAmpStddevAbs   INT   1   '1'   LOCK   1/0=enable/disable output of mean peak to peak (amplitude) standard deviation 
             +  ptpAmpStddevRel   INT   1   '1'   LOCK   1/0=enable/disable output of mean peak to peak (amplitude) standard deviation / arithmetic mean 
             +  minRangeAbs   INT   1   '1'   LOCK   1/0=enable/disable output of local minima range (max minmum value - min minimum value) 
             +  minRangeRel   INT   1   '1'   LOCK   1/0=enable/disable output of local minima range (max minmum value - min minimum value) / arithmetic mean 
             +  minMeanAbs   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of local minima 
             +  minMeanMeanDist   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of local minima - arithmetic mean of all values 
             +  minMeanRel   INT   1   '1'   LOCK   1/0=enable/disable output of arithmetic mean of local minima / arithmetic mean 
             +  mtmAmpMeanAbs   INT   1   '1'   LOCK   1/0=enable/disable output of mean minimum to minimum (amplitude) difference 
             +  mtmAmpMeanRel   INT   1   '1'   LOCK   1/0=enable/disable output of mean minimum to minimum (amplitude) difference / arithmetic mean 
             +  mtmAmpStddevAbs   INT   1   '1'   LOCK   1/0=enable/disable output of mean minimum to minimum (amplitude) standard deviation 
             +  mtmAmpStddevRel   INT   1   '1'   LOCK   1/0=enable/disable output of mean minimum to minimum (amplitude) standard deviation 
             +  meanRisingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of the mean of the rising slopes (rising slope is the slope of the line connecting a local minimum (or the beginning of input sample) with the following local maximum/peak or the end of input sample) 
             +  maxRisingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of maximum rising slope 
             +  minRisingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of minimum rising slope 
             +  stddevRisingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of the standard deviation of the rising slopes 
             +  meanFallingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of the mean of the falling slopes (falling slope is the slope of the line connecting a local maximum/peak (or the beginning of input sample) with the following local minimum (or the end of input sample)) 
             +  maxFallingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of maximum falling slope. 
             +  minFallingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of minimum falling slope 
             +  stddevFallingSlope   INT   1   '1'   LOCK   1/0=enable/disable output of the standard deviation of the falling slopes 
             +  useAbsThresh   INT   1   '0'   LOCK   1/0 = enable/disable absolute threshold 
             +  absThresh   FLOAT   1   '0.00000'   LOCK   Gives an absolute threshold for the minimum peak height. Use with caution, use only if you know what you are doing. If this option is not set, relThresh will be used. 
             +  relThresh   FLOAT   1   '0.00000'   LOCK   Gives the threshold relative to the input contour range, which is used to remove peaks and minimima below this threshold. Valid values: 0..1, a higher value will remove more peaks, while a lower value will keep more and less salient peaks. If not using dynRelThresh=1 you should use a default value of ~0.10 otherwise a default of ~0.35 
             +  dynRelThresh   INT   1   '1'   LOCK   1/0 = enable disable dynamic relative threshold. Instead of converting the relThresh to an absolute threshold relThresh*range, the threshold is applied as: abs(a/b-1.0) < relThresh , where a is always larger than b. 
 
OSFFTmagphase
  OSFFTmagphase  FILTER
 
           This component computes magnitude and phase of each array in the input level (it thereby assumes that the arrays contain complex numbers with real and imaginary parts alternating, as computed by the cTransformFFT component).
 
             +  type   INT   1   '0'   LOCK   0=compute magnitude, 1=compute phase, 2=compute both 
             +  norm   BOOL   1   'false'   LOCK   Normalise FFT magnitudes to input window length, to obtain spectral densities. 
             +  power   BOOL   1   'false'   LOCK   Square FFT magnitudes to obtain power spectrum. 
             +  dBpsd   BOOL   1   'false'   LOCK   output logarithmic (dB SPL) power spectral density instead of linear magnitude spectrum (you should use a Hann window for analysis in this case). Setting this option also sets 'norm=true' and 'power=true'. 
             +  dBpnorm   FLOAT   1   '90.30200'   LOCK   Value for dB power normalisation when 'dBpsd=true' (in dB SPL). Default is according to MPEG-1, psy I model. 
 
OSEnergy
  OSEnergy  FEATURE
 
           This component computes logarithmic (log) and root-mean-square (rms) signal energy from PCM frames.
 
             +  type   INT   1   '2'   LOCK   0=root-mean-square energy, 1=logarithmic energy, 2=both 
             +  htk   BOOL   1   'false'   LOCK   compatible with HTK Speech Recognition Toolkit 
             +  scaleLog   FLOAT   1   '1.00000'   LOCK   scale factor to multiply log energy by 
             +  scaleRms   FLOAT   1   '1.00000'   LOCK   scale factor to multiply log energy by 
             +  biasLog   FLOAT   1   '0.00000'   LOCK   bias to add to log energy 
             +  biasRms   FLOAT   1   '0.00000'   LOCK   bias to add to rms energy 
 
LaughterPreProcessor
  LaughterPreProcessor  FEATURE
 
           This component does laughter pre processing (filters).
 
             +  useDeltas   BOOL   1   'true'   LOCK   extract delta coefficients 
 
LaughterFeatureExtractor
  LaughterFeatureExtractor  FEATURE
 
           This component extracts laughter features.
 
 
Deltas
  Deltas  FILTER
 
           This component gives the deltas of a wave form
 
             +  keep original   INT   1   '1'   LOCK   0 = deltas , 1 = keep original stream with deltas 
 


Built with Social Signal Interpretation (SSI) [v1.0.5]
(c) University of Augsburg
http://openssi.net