remove un-needed files after refactor
authordrowe67 <drowe67@01035d8c-6547-0410-b346-abe4f91aad63>
Fri, 20 Aug 2010 06:45:28 +0000 (06:45 +0000)
committerdrowe67 <drowe67@01035d8c-6547-0410-b346-abe4f91aad63>
Fri, 20 Aug 2010 06:45:28 +0000 (06:45 +0000)
git-svn-id: https://svn.code.sf.net/p/freetel/code@177 01035d8c-6547-0410-b346-abe4f91aad63

codec2/src/refine.c [deleted file]
codec2/src/spec.c [deleted file]
codec2/src/synth.c [deleted file]
codec2/src/synth.h [deleted file]
codec2/src/window.c [deleted file]
codec2/src/window.h [deleted file]

diff --git a/codec2/src/refine.c b/codec2/src/refine.c
deleted file mode 100644 (file)
index 163f9fa..0000000
+++ /dev/null
@@ -1,162 +0,0 @@
-/*---------------------------------------------------------------------------*\
-
-  FILE........: refine.c
-  AUTHOR......: David Rowe                  
-  DATE CREATED: 27/5/94          
-                                               
-  Functions for refining the pitch estimate using the harmonic sum method.
-
-\*---------------------------------------------------------------------------*/
-
-/*
-  Copyright (C) 2009 David Rowe
-
-  All rights reserved.
-
-  This program is free software; you can redistribute it and/or modify
-  it under the terms of the GNU General Public License version 2, as
-  published by the Free Software Foundation.  This program is
-  distributed in the hope that it will be useful, but WITHOUT ANY
-  WARRANTY; without even the implied warranty of MERCHANTABILITY or
-  FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public
-  License for more details.
-
-  You should have received a copy of the GNU General Public License
-  along with this program; if not, write to the Free Software
-  Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
-*/
-
-#include "sine.h"
-
-/*---------------------------------------------------------------------------*\
-                                                       
-  FUNCTION....: dft_speech          
-  AUTHOR......: David Rowe                           
-  DATE CREATED: 27/5/94 
-
-  Finds the DFT of the current speech input speech frame.
-
-\*---------------------------------------------------------------------------*/
-
-void dft_speech(float Sn[], COMP Sw[])
-{
-  int i;
-  
-  for(i=0; i<FFT_ENC; i++) {
-    Sw[i].real = 0.0;
-    Sw[i].imag = 0.0;
-  }
-
-  /* Centre analysis window on time axis, we need to arrange input
-     to FFT this way to make FFT phases correct */
-  
-  /* move 2nd half to start of FFT input vector */
-
-  for(i=0; i<NW/2; i++)
-    Sw[i].real = Sn[i+M/2]*w[i+M/2];
-
-  /* move 1st half to end of FFT input vector */
-
-  for(i=0; i<NW/2; i++)
-    Sw[FFT_ENC-NW/2+i].real = Sn[i+M/2-NW/2]*w[i+M/2-NW/2];
-
-  four1(&Sw[-1].imag,FFT_ENC,-1);
-}
-
-/*---------------------------------------------------------------------------*\
-                                                                     
-  FUNCTION....: two_stage_pitch_refinement                     
-  AUTHOR......: David Rowe
-  DATE CREATED: 27/5/94                                
-
-  Refines the current pitch estimate using the harmonic sum pitch
-  estimation technique.
-
-\*---------------------------------------------------------------------------*/
-
-void two_stage_pitch_refinement()
-{
-  float pmin,pmax,pstep;       /* pitch refinment minimum, maximum and step */ 
-
-  /* Coarse refinement */
-
-  pmax = TWO_PI/model.Wo + 5;
-  pmin = TWO_PI/model.Wo - 5;
-  pstep = 1.0;
-  hs_pitch_refinement(pmin,pmax,pstep);
-  
-  /* Fine refinement */
-  
-  pmax = TWO_PI/model.Wo + 1;
-  pmin = TWO_PI/model.Wo - 1;
-  pstep = 0.25;
-  hs_pitch_refinement(pmin,pmax,pstep);
-  
-  /* Limit range */
-  
-  if (model.Wo < TWO_PI/P_MAX)
-    model.Wo = TWO_PI/P_MAX;
-  if (model.Wo > TWO_PI/P_MIN)
-    model.Wo = TWO_PI/P_MIN;
-
-  model.L = floor(PI/model.Wo);
-}
-
-/*---------------------------------------------------------------------------*\
-                                                                
- FUNCTION....: hs_pitch_refinement                             
- AUTHOR......: David Rowe                      
- DATE CREATED: 27/5/94                                                      
-                                                                         
- Harmonic sum pitch refinement function.                          
-                                                                           
- pmin   pitch search range minimum         
- pmax  pitch search range maximum          
- step   pitch search step size             
- model current pitch estimate in model.Wo  
-                                                                           
- model         refined pitch estimate in model.Wo  
-                                                                            
-\*---------------------------------------------------------------------------*/
-
-void hs_pitch_refinement(float pmin, float pmax, float pstep)
-{
-  int m;               /* loop variable */
-  int b;               /* bin for current harmonic centre */
-  float E;             /* energy for current pitch*/
-  float Wo;            /* current "test" fundamental freq. */
-  float Wom;           /* Wo that maximises E */
-  float Em;            /* mamimum energy */
-  float r;             /* number of rads/bin */
-  float p;             /* current pitch */
-  
-  /* Initialisation */
-  
-  model.L = PI/model.Wo;       /* use initial pitch est. for L */
-  Em = 0.0;
-  r = TWO_PI/FFT_ENC;
-  
-  /* Determine harmonic sum for a range of Wo values */
-
-  for(p=pmin; p<=pmax; p+=pstep) {
-    E = 0.0;
-    Wo = TWO_PI/p;
-
-    /* Sum harmonic magnitudes */
-
-    for(m=1; m<=model.L; m++) {
-      b = floor(m*Wo/r + 0.5);
-      E += Sw[b].real*Sw[b].real + Sw[b].imag*Sw[b].imag;
-    }  
-
-    /* Compare to see if this is a maximum */
-    
-    if (E > Em) {
-      Em = E;
-      Wom = Wo;
-    }
-  }
-
-  model.Wo = Wom;
-}
-
diff --git a/codec2/src/spec.c b/codec2/src/spec.c
deleted file mode 100644 (file)
index e8cd710..0000000
+++ /dev/null
@@ -1,82 +0,0 @@
-/*---------------------------------------------------------------------------*\
-                                                          
-  FILE........: spec.c                                             
-  AUTHOR......: David Rowe                                          
-  DATE CREATED: 27/5/94                                         
-                                                               
-  Functions for estimating the sinusoidal model parameters.     
-                                                                   
-\*---------------------------------------------------------------------------*/
-
-/*
-  Copyright (C) 2009 David Rowe
-
-  All rights reserved.
-
-  This program is free software; you can redistribute it and/or modify
-  it under the terms of the GNU General Public License version 2, as
-  published by the Free Software Foundation.  This program is
-  distributed in the hope that it will be useful, but WITHOUT ANY
-  WARRANTY; without even the implied warranty of MERCHANTABILITY or
-  FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public
-  License for more details.
-
-  You should have received a copy of the GNU General Public License
-  along with this program; if not, write to the Free Software
-  Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
-*/
-
-#include "defines.h"
-#include "spec.h"
-
-/*---------------------------------------------------------------------------*\
-                                                                             
-  FUNCTION....: estimate_amplitudes                          
-  AUTHOR......: David Rowe             
-  DATE CREATED: 27/5/94                               
-                                                                             
-  Estimates the complex amplitudes of the harmonics.    
-                                                                             
-\*---------------------------------------------------------------------------*/
-
-void estimate_amplitudes(MODEL *model, float Sw[])
-{
-  int   i,m;           /* loop variables */
-  int   am,bm;         /* bounds of current harmonic */
-  int   b;             /* DFT bin of centre of current harmonic */
-  float den;           /* denominator of amplitude expression */
-  float r;             /* number of rads/bin */
-  float E;
-  int   offset;
-  COMP  Am;
-
-  r = TWO_PI/FFT_ENC;
-  for(i=0; i<FFT_ENC; i++) {
-      Sw_[i].real = 1.0;
-      Sw_[i].imag = 0.0;
-  }
-
-  for(m=1; m<=model.L; m++) {
-    den = 0.0;
-    am = floor((m - 0.5)*model.Wo/r + 0.5);
-    bm = floor((m + 0.5)*model.Wo/r + 0.5);
-    b = floor(m*model.Wo/r + 0.5);
-
-    /* Estimate ampltude of harmonic */
-
-    den = 0.0;
-    Am.real = Am.imag = 0.0;
-    for(i=am; i<bm; i++) {
-      den += Sw[i].real*Sw[i].real + Sw[i].imag*Sw[i].imag;
-      offset = i + FFT_ENC/2 - floor(m*model.Wo/r + 0.5);
-      Am.real += Sw[i].real*W[offset].real;
-      Am.imag += Sw[i].imag*W[offset].real;
-    }
-
-    model.A[m] = sqrt(den);
-
-    /* Estimate phase of harmonic */
-
-    model.phi[m] = atan2(Sw[b].imag,Sw[b].real);
-}
-
diff --git a/codec2/src/synth.c b/codec2/src/synth.c
deleted file mode 100644 (file)
index 76e5be6..0000000
+++ /dev/null
@@ -1,84 +0,0 @@
-/*---------------------------------------------------------------------------*\
-                                                                             
-  FILE........: synth.c                                           
-  AUTHOR......: David Rowe                                             
-  DATE CREATED: 20/2/95                                                 
-                                                                             
-  Function for synthesising a speech signal in the frequency domain from      
-  the sinusodal model parameters.                                             
-                                                                             
-\*---------------------------------------------------------------------------*/
-
-/*
-  Copyright (C) 2009 David Rowe
-
-  All rights reserved.
-
-  This program is free software; you can redistribute it and/or modify
-  it under the terms of the GNU General Public License version 2, as
-  published by the Free Software Foundation.  This program is
-  distributed in the hope that it will be useful, but WITHOUT ANY
-  WARRANTY; without even the implied warranty of MERCHANTABILITY or
-  FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public
-  License for more details.
-
-  You should have received a copy of the GNU General Public License
-  along with this program; if not, write to the Free Software
-  Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
-*/
-
-#include "defines.h"
-#include "synth.h"
-
-void synthesise(
-  float   Pn[],                /* time domain Parzen window              */
-  MODEL *model,                /* ptr to model parameters for this frame */
-  float  Sn_[],                /* time domain synthesised signal         */
-  int    shift          /* used to handle transition frames       */
-)
-{
-    int   i,l,j,b;     /* loop variables */
-    COMP  Sw_[FFT_DEC];        /* DFT of synthesised signal */
-
-    if (shift) {
-       /* Update memories */
-
-       for(i=0; i<N-1; i++) {
-           Sn_[i] = Sn_[i+N];
-       }
-       Sn_[N-1] = 0.0;
-    }
-
-    for(i=0; i<FFT_DEC; i++) {
-       Sw_[i].real = 0.0;
-       Sw_[i].imag = 0.0;
-    }
-
-    /* Now set up frequency domain synthesised speech */
-
-    for(l=1; l<=model->L; l++) {
-       b = floor(l*model->Wo*FFT_DEC/TWO_PI + 0.5);
-       Sw_[b].real = model->A[l]*cos(model->phi[l]);
-       Sw_[b].imag = model->A[l]*sin(model->phi[l]);
-       Sw_[FFT_DEC-b].real = Sw_[b].real;
-       Sw_[FFT_DEC-b].imag = -Sw_[b].imag;
-    }
-
-    /* Perform inverse DFT */
-
-    four1(&Sw_[-1].imag,FFT_DEC,1);
-
-    /* Overlap add to previous samples */
-
-    for(i=0; i<N-1; i++) {
-       Sn_[i] += Sw_[FFT_DEC-N+1+i].real*Pn[i];
-    }
-
-    if (shift)
-       for(i=N-1,j=0; i<2*N; i++,j++)
-           Sn_[i] = Sw_[j].real*Pn[i];
-    else
-       for(i=N-1,j=0; i<2*N; i++,j++)
-           Sn_[i] += Sw_[j].real*Pn[i];
-}
-
diff --git a/codec2/src/synth.h b/codec2/src/synth.h
deleted file mode 100644 (file)
index 817f237..0000000
+++ /dev/null
@@ -1,37 +0,0 @@
-/*---------------------------------------------------------------------------*\
-                                                                             
-  FILE........: synth.h                                         
-  AUTHOR......: David Rowe                                             
-  DATE CREATED: 11/9/09                                                 
-                                                                             
-  Function for synthesising a speech signal in the frequency domain from      
-  the sinusodal model parameters.                                             
-                                                                             
-\*---------------------------------------------------------------------------*/
-
-/*
-  Copyright (C) 2009 David Rowe
-
-  All rights reserved.
-
-  This program is free software; you can redistribute it and/or modify
-  it under the terms of the GNU General Public License version 2, as
-  published by the Free Software Foundation.  This program is
-  distributed in the hope that it will be useful, but WITHOUT ANY
-  WARRANTY; without even the implied warranty of MERCHANTABILITY or
-  FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public
-  License for more details.
-
-  You should have received a copy of the GNU General Public License
-  along with this program; if not, write to the Free Software
-  Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
-*/
-
-#ifndef __SYNTH__
-#define __SYNTH__
-
-#include "sine.h"
-
-void synthesise(float Pn[], MODEL *model, float Sn_[], int shift);
-
-#endif
diff --git a/codec2/src/window.c b/codec2/src/window.c
deleted file mode 100644 (file)
index 54b2517..0000000
+++ /dev/null
@@ -1,138 +0,0 @@
-/*---------------------------------------------------------------------------*\
-                                                                  
-  FILE........: window.c
-  AUTHOR......: David Rowe                               
-  DATE CREATED: 11/5/94            
-                                        
-  Generates the time domain analysis window and it's DFT.
-                                                          
-\*---------------------------------------------------------------------------*/
-
-/*
-  Copyright (C) 2009 David Rowe
-
-  All rights reserved.
-
-  This program is free software; you can redistribute it and/or modify
-  it under the terms of the GNU General Public License version 2, as
-  published by the Free Software Foundation.  This program is
-  distributed in the hope that it will be useful, but WITHOUT ANY
-  WARRANTY; without even the implied warranty of MERCHANTABILITY or
-  FITNESS FOR A PARTICULAR PURPOSE.  See the GNU General Public
-  License for more details.
-
-  You should have received a copy of the GNU General Public License
-  along with this program; if not, write to the Free Software
-  Foundation, Inc., 675 Mass Ave, Cambridge, MA 02139, USA.
-*/
-
-#include <math.h>
-#include "defines.h"
-#include "window.h"
-
-float make_window(
-    float w[],   /* time domain analysis window      */
-    COMP  W[]    /* w[] in frequency domain          */
-)
-{
-  float m;
-  COMP  temp;
-  int   i,j;
-
-  /* 
-     Generate Hamming window centered on M-sample pitch analysis window
-  
-  0            M/2           M-1
-  |-------------|-------------|
-        |-------|-------|
-            NW samples
-
-     All our analysis/synthsis is centred on the M/2 sample.               
-  */
-
-  m = 0.0;
-  for(i=0; i<M/2-NW/2; i++)
-    w[i] = 0.0;
-  for(i=M/2-NW/2,j=0; i<M/2+NW/2; i++,j++) {
-    w[i] = 0.5 - 0.5*cos(TWO_PI*j/(NW-1));
-    m += w[i]*w[i];
-  }
-  for(i=M/2+NW/2; i<M; i++)
-    w[i] = 0.0;
-  /* Normalise - makes freq domain amplitude estimation straight
-     forward */
-
-  m = 1.0/sqrt(m*FFT_ENC);
-  for(i=0; i<M; i++) {
-    w[i] *= m;
-  }
-
-  /* 
-     Generate DFT of analysis window, used for later processing.  Note
-     we modulo FFT_ENC shift the time domain window w[], this makes the
-     imaginary part of the DFT W[] equal to zero as the shifted w[] is
-     even about the n=0 time axis if NW is odd.  Having the imag part
-     of the DFT W[] makes computation easier.
-
-     0                      FFT_ENC-1
-     |-------------------------|
-
-      ----\               /----
-           \             / 
-            \           /          <- shifted version of window w[n]
-             \         /
-              \       /
-               -------
-
-     |---------|     |---------|      
-       NW/2              NW/2
-  */
-
-  for(i=0; i<FFT_ENC; i++) {
-    W[i].real = 0.0;
-    W[i].imag = 0.0;
-  }
-  for(i=0; i<NW/2; i++)
-    W[i].real = w[i+M/2];
-  for(i=FFT_ENC-NW/2,j=M/2-NW/2; i<FFT_ENC; i++,j++)
-    W[i].real = w[j];
-
-  four1(&W[-1].imag,FFT_ENC,-1);         /* "Numerical Recipes in C" FFT */
-
-  /* 
-      Re-arrange W[] to be symmetrical about FFT_ENC/2.  Makes later 
-      analysis convenient.
-
-   Before:
-
-
-     0                 FFT_ENC-1
-     |----------|---------|
-     __                   _       
-       \                 /          
-        \_______________/      
-
-   After:
-
-     0                 FFT_ENC-1
-     |----------|---------|
-               ___                        
-              /   \                
-     ________/     \_______     
-
-  */
-       
-      
-  for(i=0; i<FFT_ENC/2; i++) {
-    temp.real = W[i].real;
-    temp.imag = W[i].imag;
-    W[i].real = W[i+FFT_ENC/2].real;
-    W[i].imag = W[i+FFT_ENC/2].imag;
-    W[i+FFT_ENC/2].real = temp.real;
-    W[i+FFT_ENC/2].imag = temp.imag;
-  }
-
-  return(m);
-}
-
diff --git a/codec2/src/window.h b/codec2/src/window.h
deleted file mode 100644 (file)
index da2afee..0000000
+++ /dev/null
@@ -1,16 +0,0 @@
-/*---------------------------------------------------------------------------*\
-                                                                  
-  FILE........: window.h
-  AUTHOR......: David Rowe                               
-  DATE CREATED: 16/8/2010            
-                                        
-  Generates the time domain analysis window and it's DFT.
-                                                          
-\*---------------------------------------------------------------------------*/
-
-#ifndef __WINDOW__
-#define __WINDOW__
-
-float make_window(float w[], COMP W[]);
-
-#endif