[xiph-cvs] cvs commit: speex/libspeex preprocess.c speex_preprocess.h Makefile.am testdenoise.c denoise.c speex_denoise.h
Jean-Marc Valin
jm at xiph.org
Tue Sep 16 10:50:46 PDT 2003
jm 03/09/16 13:50:45
Modified: libspeex Makefile.am testdenoise.c
Added: libspeex preprocess.c speex_preprocess.h
Removed: libspeex denoise.c speex_denoise.h
Log:
Renamed the 'denoiser' to 'preprocessor', added options to enable/disable
the denoiser, the agc and the vad.
Revision Changes Path
1.54 +3 -3 speex/libspeex/Makefile.am
Index: Makefile.am
===================================================================
RCS file: /usr/local/cvsroot/speex/libspeex/Makefile.am,v
retrieving revision 1.53
retrieving revision 1.54
diff -u -r1.53 -r1.54
--- Makefile.am 19 Aug 2003 06:07:44 -0000 1.53
+++ Makefile.am 16 Sep 2003 17:50:45 -0000 1.54
@@ -1,6 +1,6 @@
## Process this file with automake to produce Makefile.in. -*-Makefile-*-
-# $Id: Makefile.am,v 1.53 2003/08/19 06:07:44 jm Exp $
+# $Id: Makefile.am,v 1.54 2003/09/16 17:50:45 jm Exp $
# Disable automatic dependency tracking if using other tools than gcc and gmake
#AUTOMAKE_OPTIONS = no-dependencies
@@ -37,7 +37,7 @@
speex_callbacks.c \
math_approx.c \
stereo.c \
- denoise.c \
+ preprocess.c \
smallft.c \
lbr_48k_tables.c \
jitter.c \
@@ -49,7 +49,7 @@
speex_header.h \
speex_callbacks.h \
speex_stereo.h \
- speex_denoise.h \
+ speex_preprocess.h \
speex_jitter.h \
speex_echo.h
<p><p>1.7 +7 -5 speex/libspeex/testdenoise.c
Index: testdenoise.c
===================================================================
RCS file: /usr/local/cvsroot/speex/libspeex/testdenoise.c,v
retrieving revision 1.6
retrieving revision 1.7
diff -u -r1.6 -r1.7
--- testdenoise.c 22 Aug 2003 05:10:47 -0000 1.6
+++ testdenoise.c 16 Sep 2003 17:50:45 -0000 1.7
@@ -1,4 +1,4 @@
-#include "speex_denoise.h"
+#include "speex_preprocess.h"
#include <stdio.h>
#define NN 160
@@ -9,9 +9,11 @@
short out[NN];
float x[NN];
int i;
- SpeexDenoiseState *st;
+ SpeexPreprocessState *st;
- st = speex_denoise_state_init(NN);
+ st = speex_preprocess_state_init(NN);
+ i=1;
+ speex_preprocess_ctl(st, SPEEX_PREPROCESS_SET_DENOISE, &i);
while (1)
{
int vad;
@@ -21,12 +23,12 @@
for (i=0;i<NN;i++)
x[i]=in[i];
- vad = speex_denoise(st, x, NULL);
+ vad = speex_preprocess(st, x, NULL);
for (i=0;i<NN;i++)
out[i]=x[i];
fprintf (stderr, "%d\n", vad);
fwrite(out, sizeof(short), NN, stdout);
}
- speex_denoise_state_destroy(st);
+ speex_preprocess_state_destroy(st);
return 0;
}
<p><p>1.1 speex/libspeex/preprocess.c
Index: preprocess.c
===================================================================
/* Copyright (C) 2003 Epic Games
Written by Jean-Marc Valin
File: preprocess.c
Preprocessor with denoising based on the algorithm by Ephraim and Malah
Redistribution and use in source and binary forms, with or without
modification, are permitted provided that the following conditions are
met:
1. Redistributions of source code must retain the above copyright notice,
this list of conditions and the following disclaimer.
2. Redistributions in binary form must reproduce the above copyright
notice, this list of conditions and the following disclaimer in the
documentation and/or other materials provided with the distribution.
3. The name of the author may not be used to endorse or promote products
derived from this software without specific prior written permission.
THIS SOFTWARE IS PROVIDED BY THE AUTHOR ``AS IS'' AND ANY EXPRESS OR
IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES
OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE
DISCLAIMED. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR ANY DIRECT,
INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
(INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR
SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT,
STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN
ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
POSSIBILITY OF SUCH DAMAGE.
*/
#include <math.h>
#include "speex_preprocess.h"
#include <stdio.h>
#include "misc.h"
#define STABILITY_TIME 20
#define NB_LAST_PS 10
#define max(a,b) ((a) > (b) ? (a) : (b))
#define min(a,b) ((a) < (b) ? (a) : (b))
#ifndef M_PI
#define M_PI 3.14159263
#endif
#define SQRT_M_PI_2 0.88623
#define LOUDNESS_EXP 3.5
#define NB_BANDS 8
tatic void conj_window(float *w, int len)
{
int i;
for (i=0;i<len;i++)
{
float x=4*((float)i)/len;
int inv=0;
if (x<1)
{
} else if (x<2)
{
x=2-x;
inv=1;
} else if (x<3)
{
x=x-2;
inv=1;
} else {
x=4-x;
}
x*=1.9979;
w[i]=(.5-.5*cos(x))*(.5-.5*cos(x));
if (inv)
w[i]=1-w[i];
w[i]=sqrt(w[i]);
}
}
SpeexPreprocessState *speex_preprocess_state_init(int frame_size)
{
int i;
int N, N3, N4;
SpeexPreprocessState *st = (SpeexPreprocessState *)speex_alloc(sizeof(SpeexPreprocessState));
st->frame_size = frame_size;
/* Round ps_size down to the nearest power of two */
#if 0
i=1;
st->ps_size = st->frame_size;
while(1)
{
if (st->ps_size & ~i)
{
st->ps_size &= ~i;
i<<=1;
} else {
break;
}
}
if (st->ps_size < 3*st->frame_size/4)
st->ps_size = st->ps_size * 3 / 2;
#else
st->ps_size = st->frame_size;
#endif
N = st->ps_size;
N3 = 2*N - st->frame_size;
N4 = st->frame_size - N3;
st->denoise_enabled = 1;
st->agc_enabled = 0;
st->agc_level = 8000;
st->vad_enabled = 0;
st->frame = (float*)speex_alloc(2*N*sizeof(float));
st->ps = (float*)speex_alloc(N*sizeof(float));
st->gain2 = (float*)speex_alloc(N*sizeof(float));
st->window = (float*)speex_alloc(2*N*sizeof(float));
st->noise = (float*)speex_alloc(N*sizeof(float));
st->old_ps = (float*)speex_alloc(N*sizeof(float));
st->gain = (float*)speex_alloc(N*sizeof(float));
st->prior = (float*)speex_alloc(N*sizeof(float));
st->post = (float*)speex_alloc(N*sizeof(float));
st->min_ps = (float*)speex_alloc(N*sizeof(float));
st->last_energy = (float*)speex_alloc(STABILITY_TIME*sizeof(float));
st->last_ps = (float*)speex_alloc(NB_LAST_PS*N*sizeof(float));
st->loudness_weight = (float*)speex_alloc(N*sizeof(float));
st->inbuf = (float*)speex_alloc(N3*sizeof(float));
st->outbuf = (float*)speex_alloc(N3*sizeof(float));
st->echo_noise = (float*)speex_alloc(N*sizeof(float));
st->noise_bands = (float*)speex_alloc(NB_BANDS*sizeof(float));
st->noise_bands2 = (float*)speex_alloc(NB_BANDS*sizeof(float));
st->speech_bands = (float*)speex_alloc(NB_BANDS*sizeof(float));
st->speech_bands2 = (float*)speex_alloc(NB_BANDS*sizeof(float));
st->noise_bandsN = st->speech_bandsN = 1;
conj_window(st->window, 2*N3);
for (i=2*N3;i<2*st->ps_size;i++)
st->window[i]=1;
if (N4>0)
{
for (i=N3-1;i>=0;i--)
{
st->window[i+N3+N4]=st->window[i+N3];
st->window[i+N3]=1;
}
}
for (i=0;i<N;i++)
{
st->noise[i]=1e4;
st->old_ps[i]=1e4;
st->gain[i]=1;
st->post[i]=1;
st->prior[i]=1;
}
for (i=0;i<N3;i++)
{
st->inbuf[i]=0;
st->outbuf[i]=0;
}
for (i=0;i<N;i++)
{
float ff=((float)i)*128.0/4000.0;
st->loudness_weight[i] = .35-.35*ff/16000+.73*exp(-.5*(ff-3800)*(ff-3800)/9e5);
st->loudness_weight[i] *= st->loudness_weight[i];
}
st->speech_prob = 0;
st->last_speech = 1000;
st->loudness = pow(6000,LOUDNESS_EXP);
st->loudness2 = 6000;
st->nb_loudness_adapt = 0;
drft_init(&st->fft_lookup,2*N);
st->nb_adapt=0;
st->consec_noise=0;
st->nb_preprocess=0;
st->nb_min_estimate=0;
st->last_update=0;
st->last_id=0;
return st;
}
void speex_preprocess_state_destroy(SpeexPreprocessState *st)
{
speex_free(st->frame);
speex_free(st->ps);
speex_free(st->gain2);
speex_free(st->window);
speex_free(st->noise);
speex_free(st->old_ps);
speex_free(st->gain);
speex_free(st->prior);
speex_free(st->post);
speex_free(st->min_ps);
speex_free(st->last_energy);
speex_free(st->last_ps);
speex_free(st->loudness_weight);
speex_free(st->echo_noise);
speex_free(st->noise_bands);
speex_free(st->noise_bands2);
speex_free(st->speech_bands);
speex_free(st->speech_bands2);
speex_free(st->inbuf);
speex_free(st->outbuf);
drft_clear(&st->fft_lookup);
speex_free(st);
}
tatic void update_noise(SpeexPreprocessState *st, float *ps, float *echo)
{
int i;
float beta;
st->nb_adapt++;
beta=1.0/st->nb_adapt;
if (beta < .05)
beta=.05;
if (!echo)
{
for (i=0;i<st->ps_size;i++)
st->noise[i] = (1-beta)*st->noise[i] + beta*ps[i];
} else {
for (i=0;i<st->ps_size;i++)
st->noise[i] = (1-beta)*st->noise[i] + beta*max(0,ps[i]-echo[i]);
#if 0
for (i=0;i<st->ps_size;i++)
st->noise[i] = 0;
#endif
}
}
tatic int speex_compute_vad(SpeexPreprocessState *st, float *ps, float mean_prior, float mean_post)
{
int i, is_speech=0;
int N = st->ps_size;
float scale=.5/N;
/* FIXME: Clean this up a bit */
{
float bands[NB_BANDS];
int j;
float p0, p1;
float tot_loudness=0;
float x = sqrt(mean_post);
for (i=5;i<N-10;i++)
{
tot_loudness += scale*st->ps[i] * st->loudness_weight[i];
}
for (i=0;i<NB_BANDS;i++)
{
bands[i]=1e4;
for (j=i*N/NB_BANDS;j<(i+1)*N/NB_BANDS;j++)
{
bands[i] += ps[j];
}
bands[i]=log(bands[i]);
}
/*p1 = .0005+.6*exp(-.5*(x-.4)*(x-.4)*11)+.1*exp(-1.2*x);
if (x<1.5)
p0=.1*exp(2*(x-1.5));
else
p0=.02+.1*exp(-.2*(x-1.5));
*/
p0=1/(1+exp(3*(1.5-x)));
p1=1-p0;
/*fprintf (stderr, "%f %f ", p0, p1);*/
/*p0 *= .99*st->speech_prob + .01*(1-st->speech_prob);
p1 *= .01*st->speech_prob + .99*(1-st->speech_prob);
st->speech_prob = p0/(p1+p0);
*/
if (st->noise_bandsN < 50 || st->speech_bandsN < 50)
{
if (mean_post > 5)
{
float adapt = 1./st->speech_bandsN++;
if (adapt<.005)
adapt = .005;
for (i=0;i<NB_BANDS;i++)
{
st->speech_bands[i] = (1-adapt)*st->speech_bands[i] + adapt*bands[i];
/*st->speech_bands2[i] = (1-adapt)*st->speech_bands2[i] + adapt*bands[i]*bands[i];*/
st->speech_bands2[i] = (1-adapt)*st->speech_bands2[i] + adapt*(bands[i]-st->speech_bands[i])*(bands[i]-st->speech_bands[i]);
}
} else {
float adapt = 1./st->noise_bandsN++;
if (adapt<.005)
adapt = .005;
for (i=0;i<NB_BANDS;i++)
{
st->noise_bands[i] = (1-adapt)*st->noise_bands[i] + adapt*bands[i];
/*st->noise_bands2[i] = (1-adapt)*st->noise_bands2[i] + adapt*bands[i]*bands[i];*/
st->noise_bands2[i] = (1-adapt)*st->noise_bands2[i] + adapt*(bands[i]-st->noise_bands[i])*(bands[i]-st->noise_bands[i]);
}
}
}
p0=p1=1;
for (i=0;i<NB_BANDS;i++)
{
float noise_var, speech_var;
float noise_mean, speech_mean;
float tmp1, tmp2, pr;
/*noise_var = 1.01*st->noise_bands2[i] - st->noise_bands[i]*st->noise_bands[i];
speech_var = 1.01*st->speech_bands2[i] - st->speech_bands[i]*st->speech_bands[i];*/
noise_var = st->noise_bands2[i];
speech_var = st->speech_bands2[i];
if (noise_var < .1)
noise_var = .1;
if (speech_var < .1)
speech_var = .1;
/*speech_var = sqrt(speech_var*noise_var);
noise_var = speech_var;*/
if (speech_var < .05*speech_var)
noise_var = .05*speech_var;
if (speech_var < .05*noise_var)
speech_var = .05*noise_var;
if (bands[i] < st->noise_bands[i])
speech_var = noise_var;
if (bands[i] > st->speech_bands[i])
noise_var = speech_var;
speech_mean = st->speech_bands[i];
noise_mean = st->noise_bands[i];
if (noise_mean < speech_mean - 5)
noise_mean = speech_mean - 5;
tmp1 = exp(-.5*(bands[i]-speech_mean)*(bands[i]-speech_mean)/speech_var)/sqrt(2*M_PI*speech_var);
tmp2 = exp(-.5*(bands[i]-noise_mean)*(bands[i]-noise_mean)/noise_var)/sqrt(2*M_PI*noise_var);
/*fprintf (stderr, "%f ", (float)(p0/(.01+p0+p1)));*/
/*fprintf (stderr, "%f ", (float)(bands[i]));*/
pr = tmp1/(1e-25+tmp1+tmp2);
/*if (bands[i] < st->noise_bands[i])
pr=.01;
if (bands[i] > st->speech_bands[i] && pr < .995)
pr=.995;*/
if (pr>.999)
pr=.999;
if (pr<.001)
pr=.001;
/*fprintf (stderr, "%f ", pr);*/
p0 *= pr;
p1 *= (1-pr);
}
p0 = pow(p0,.2);
p1 = pow(p1,.2);
#if 1
p0 *= 2;
p0=p0/(p1+p0);
if (st->last_speech>20)
{
float tmp = sqrt(tot_loudness)/st->loudness2;
tmp = 1-exp(-10*tmp);
if (p0>tmp)
p0=tmp;
}
p1=1-p0;
#else
if (sqrt(tot_loudness) < .6*st->loudness2 && p0>15*p1)
p0=15*p1;
if (sqrt(tot_loudness) < .45*st->loudness2 && p0>7*p1)
p0=7*p1;
if (sqrt(tot_loudness) < .3*st->loudness2 && p0>3*p1)
p0=3*p1;
if (sqrt(tot_loudness) < .15*st->loudness2 && p0>p1)
p0=p1;
/*fprintf (stderr, "%f %f ", (float)(sqrt(tot_loudness) /( .25*st->loudness2)), p0/(p1+p0));*/
#endif
p0 *= .99*st->speech_prob + .01*(1-st->speech_prob);
p1 *= .01*st->speech_prob + .99*(1-st->speech_prob);
st->speech_prob = p0/(1e-25+p1+p0);
/*fprintf (stderr, "%f %f %f ", tot_loudness, st->loudness2, st->speech_prob);*/
if (st->speech_prob>.35 || (st->last_speech < 20 && st->speech_prob>.1))
{
is_speech = 1;
st->last_speech = 0;
} else {
st->last_speech++;
if (st->last_speech<20)
is_speech = 1;
}
if (st->noise_bandsN > 50 && st->speech_bandsN > 50)
{
if (mean_post > 5)
{
float adapt = 1./st->speech_bandsN++;
if (adapt<.005)
adapt = .005;
for (i=0;i<NB_BANDS;i++)
{
st->speech_bands[i] = (1-adapt)*st->speech_bands[i] + adapt*bands[i];
/*st->speech_bands2[i] = (1-adapt)*st->speech_bands2[i] + adapt*bands[i]*bands[i];*/
st->speech_bands2[i] = (1-adapt)*st->speech_bands2[i] + adapt*(bands[i]-st->speech_bands[i])*(bands[i]-st->speech_bands[i]);
}
} else {
float adapt = 1./st->noise_bandsN++;
if (adapt<.005)
adapt = .005;
for (i=0;i<NB_BANDS;i++)
{
st->noise_bands[i] = (1-adapt)*st->noise_bands[i] + adapt*bands[i];
/*st->noise_bands2[i] = (1-adapt)*st->noise_bands2[i] + adapt*bands[i]*bands[i];*/
st->noise_bands2[i] = (1-adapt)*st->noise_bands2[i] + adapt*(bands[i]-st->noise_bands[i])*(bands[i]-st->noise_bands[i]);
}
}
}
<p> }
return is_speech;
}
tatic void speex_compute_agc(SpeexPreprocessState *st, float mean_prior)
{
int i;
int N = st->ps_size;
float scale=.5/N;
float agc_gain;
if ((mean_prior>3&&mean_prior>3))
{
float loudness=0;
float rate;
st->nb_loudness_adapt++;
rate=2.0/(1+st->nb_loudness_adapt);
if (rate < .005)
rate = .005;
if (rate < .1 && pow(loudness, LOUDNESS_EXP) > st->loudness)
rate = .1;
if (rate < .5 && pow(loudness, LOUDNESS_EXP) > 5*st->loudness)
rate = .5;
for (i=2;i<N;i++)
{
loudness += scale*st->ps[i] * st->gain2[i] * st->gain2[i] * st->loudness_weight[i];
}
loudness=sqrt(loudness);
/*if (loudness < 2*pow(st->loudness, 1.0/LOUDNESS_EXP) &&
loudness*2 > pow(st->loudness, 1.0/LOUDNESS_EXP))*/
st->loudness = (1-rate)*st->loudness + (rate)*pow(loudness, LOUDNESS_EXP);
st->loudness2 = (1-rate)*st->loudness2 + rate*pow(st->loudness, 1.0/LOUDNESS_EXP);
loudness = pow(st->loudness, 1.0/LOUDNESS_EXP);
/*fprintf (stderr, "%f %f %f\n", loudness, st->loudness2, rate);*/
}
agc_gain = st->agc_level/st->loudness2;
for (i=0;i<N;i++)
st->gain2[i] *= agc_gain;
}
int speex_preprocess(SpeexPreprocessState *st, float *x, float *echo)
{
int i;
int is_speech=1;
float mean_post=0;
float mean_prior=0;
float energy;
int N = st->ps_size;
int N3 = 2*N - st->frame_size;
int N4 = st->frame_size - N3;
float scale=.5/N;
float *ps=st->ps;
/* 'Build' input frame */
for (i=0;i<N3;i++)
st->frame[i]=st->inbuf[i];
for (i=0;i<st->frame_size;i++)
st->frame[N3+i]=x[i];
/* Update inbuf */
for (i=0;i<N3;i++)
st->inbuf[i]=x[N4+i];
/* Windowing */
for (i=0;i<2*N;i++)
st->frame[i] *= st->window[i];
/* Perform FFT */
drft_forward(&st->fft_lookup, st->frame);
/**************************************************************
* Denoise in spectral domain using Ephraim-Malah algorithm *
**************************************************************/
/* Power spectrum */
ps[0]=1;
for (i=1;i<N;i++)
ps[i]=1+st->frame[2*i-1]*st->frame[2*i-1] + st->frame[2*i]*st->frame[2*i];
energy=0;
for (i=1;i<N;i++)
energy += log(100+ps[i]);
energy /= 160;
st->last_energy[st->nb_preprocess%STABILITY_TIME]=energy;
if (st->nb_preprocess>=STABILITY_TIME)
{
float E=0, E2=0;
float std;
for (i=0;i<STABILITY_TIME;i++)
{
E+=st->last_energy[i];
E2+=st->last_energy[i]*st->last_energy[i];
}
E2=E2/STABILITY_TIME;
E=E/STABILITY_TIME;
std = sqrt(E2-E*E);
if (std<.15 && st->last_update>20)
{
update_noise(st, &st->last_ps[st->last_id*N], echo);
}
/*fprintf (stderr, "%f\n", std);*/
}
st->nb_preprocess++;
/* Noise estimation always updated for the 20 first times */
if (st->nb_adapt<15)
/*if (st->nb_adapt<25 && st->nb_adapt>15)*/
{
update_noise(st, ps, echo);
st->last_update=0;
}
/* Deal with residual echo if provided */
if (echo)
for (i=1;i<N;i++)
st->echo_noise[i] = (.7*st->echo_noise[i] + .3* echo[i]);
/* Compute a posteriori SNR */
for (i=1;i<N;i++)
{
st->post[i] = ps[i]/(1+st->noise[i]+st->echo_noise[i]) - 1;
if (st->post[i]>100)
st->post[i]=100;
/*if (st->post[i]<0)
st->post[i]=0;*/
mean_post+=st->post[i];
}
mean_post /= N;
if (mean_post<0)
mean_post=0;
/* Special case for first frame */
if (st->nb_adapt==1)
for (i=1;i<N;i++)
st->old_ps[i] = ps[i];
/* Compute a priori SNR */
{
/* A priori update rate */
float gamma;
float min_gamma=0.12;
gamma = 1.0/st->nb_preprocess;
/*Make update rate smaller when there's no speech*/
#if 0
if (mean_post<3.5 && mean_prior < 1)
min_gamma *= (mean_post+.5);
else
min_gamma *= 4.;
#else
min_gamma = .2*fabs(mean_prior - mean_post)*fabs(mean_prior - mean_post);
if (min_gamma>.6)
min_gamma = .6;
if (min_gamma<.01)
min_gamma = .01;
#endif
min_gamma = .6;
if (gamma<min_gamma)
gamma=min_gamma;
for (i=1;i<N;i++)
{
/* A priori SNR update */
st->prior[i] = gamma*max(0.0,st->post[i]) +
(1-gamma)*st->gain[i]*st->gain[i]*st->old_ps[i]/(1+st->noise[i]+st->echo_noise[i]);
if (st->prior[i]>100)
st->prior[i]=100;
mean_prior+=st->prior[i];
}
}
mean_prior /= N;
#if 0
for (i=0;i<N;i++)
{
fprintf (stderr, "%f ", st->prior[i]);
}
fprintf (stderr, "\n");
#endif
/*fprintf (stderr, "%f %f\n", mean_prior,mean_post);*/
if (st->nb_preprocess>=20)
{
int do_update = 0;
float noise_ener=0, sig_ener=0;
/* If SNR is low (both a priori and a posteriori), update the noise estimate*/
/*if (mean_prior<.23 && mean_post < .5)*/
if (mean_prior<.23 && mean_post < .5)
do_update = 1;
for (i=1;i<N;i++)
{
noise_ener += st->noise[i];
sig_ener += ps[i];
}
if (noise_ener > 3*sig_ener)
do_update = 1;
/*do_update = 0;*/
if (do_update)
{
st->consec_noise++;
} else {
st->consec_noise=0;
}
}
if (st->vad_enabled)
is_speech = speex_compute_vad(st, ps, mean_prior, mean_post);
<p> if (st->consec_noise>=3)
{
update_noise(st, st->old_ps, echo);
st->last_update=0;
} else {
st->last_update++;
}
<p> /* Compute gain according to the Ephraim-Malah algorithm */
for (i=1;i<N;i++)
{
float MM;
float theta;
float prior_ratio;
prior_ratio = st->prior[i]/(1.0001+st->prior[i]);
theta = (1+st->post[i])*prior_ratio;
#if 0
/* Spectral magnitude estimator */
/* Approximation of:
exp(-theta/2)*((1+theta)*I0(theta/2) + theta.*I1(theta/2))
because I don't feel like computing Bessel functions
*/
/*MM = -.22+1.155*sqrt(theta+1.1);*/
MM=-.22+1.163*sqrt(theta+1.1)-.0015*theta;
st->gain[i] = SQRT_M_PI_2*sqrt(prior_ratio/(1.0001+st->post[i]))*MM;
if (st->gain[i]>1)
{
st->gain[i]=1;
}
#else
/* log-spectral magnitude estimator */
if (theta<6)
MM = 0.74082*pow(theta+1,.61)/sqrt(.0001+theta);
else
MM=1;
st->gain[i] = prior_ratio * MM;
/*Put some (very arbitraty) limit on the gain*/
if (st->gain[i]>2)
{
st->gain[i]=2;
}
#endif
/*st->gain[i] = prior_ratio;*/
}
st->gain[0]=0;
st->gain[N-1]=0;
if (st->denoise_enabled)
{
for (i=1;i<N-1;i++)
{
st->gain2[i]=st->gain[i];
/* Limits noise reduction to -26 dB, put prevents some musical noise */
if (st->gain2[i]<.05)
st->gain2[i]=.05;
}
st->gain2[N-1]=0;
} else {
for (i=0;i<N;i++)
st->gain2[i] = 1;
}
if (st->agc_enabled)
speex_compute_agc(st, mean_prior);
#if 0
if (!is_speech)
{
for (i=0;i<N;i++)
st->gain2[i] = 0;
}
#if 0
else {
for (i=0;i<N;i++)
st->gain2[i] = 1;
}
#endif
#endif
/* Apply computed gain */
for (i=1;i<N;i++)
{
st->frame[2*i-1] *= st->gain2[i];
st->frame[2*i] *= st->gain2[i];
}
/* Get rid of the DC and very low frequencies */
st->frame[0]=0;
st->frame[1]=0;
st->frame[2]=0;
/* Nyquist frequency is mostly useless too */
st->frame[2*N-1]=0;
/* Inverse FFT with 1/N scaling */
drft_backward(&st->fft_lookup, st->frame);
for (i=0;i<2*N;i++)
st->frame[i] *= scale;
{
float max_sample=0;
for (i=0;i<2*N;i++)
if (fabs(st->frame[i])>max_sample)
max_sample = fabs(st->frame[i]);
if (max_sample>28000)
{
float damp = 28000./max_sample;
for (i=0;i<2*N;i++)
st->frame[i] *= damp;
}
}
for (i=0;i<2*N;i++)
st->frame[i] *= st->window[i];
/* Perform overlap and add */
for (i=0;i<N3;i++)
x[i] = st->outbuf[i] + st->frame[i];
for (i=0;i<N4;i++)
x[N3+i] = st->frame[N3+i];
/* Update outbuf */
for (i=0;i<N3;i++)
st->outbuf[i] = st->frame[st->frame_size+i];
/* Save old power spectrum */
for (i=1;i<N;i++)
st->old_ps[i] = ps[i];
for (i=1;i<N;i++)
st->last_ps[st->last_id*N+i] = ps[i];
st->last_id++;
if (st->last_id>=NB_LAST_PS)
st->last_id=0;
return is_speech;
}
<p>int speex_preprocess_ctl(SpeexPreprocessState *state, int request, void *ptr)
{
SpeexPreprocessState *st;
st=(SpeexPreprocessState*)state;
switch(request)
{
case SPEEX_PREPROCESS_SET_DENOISE:
st->denoise_enabled = (*(int*)ptr);
break;
case SPEEX_PREPROCESS_GET_DENOISE:
(*(int*)ptr) = st->denoise_enabled;
break;
case SPEEX_PREPROCESS_SET_AGC:
st->agc_enabled = (*(int*)ptr);
break;
case SPEEX_PREPROCESS_GET_AGC:
(*(int*)ptr) = st->agc_enabled;
break;
case SPEEX_PREPROCESS_SET_AGC_LEVEL:
st->agc_level = (*(float*)ptr);
if (st->agc_level<1)
st->agc_level=1;
if (st->agc_level>32768)
st->agc_level=32768;
break;
case SPEEX_PREPROCESS_GET_AGC_LEVEL:
(*(float*)ptr) = st->agc_level;
break;
case SPEEX_PREPROCESS_SET_VAD:
st->vad_enabled = (*(int*)ptr);
break;
case SPEEX_PREPROCESS_GET_VAD:
(*(int*)ptr) = st->vad_enabled;
break;
default:
speex_warning_int("Unknown speex_preprocess_ctl request: ", request);
return -1;
}
return 0;
}
<p><p>1.1 speex/libspeex/speex_preprocess.h
Index: speex_preprocess.h
===================================================================
/* Copyright (C) 2003 Epic Games
Written by Jean-Marc Valin
File: speex_preprocess.h
<p> Redistribution and use in source and binary forms, with or without
modification, are permitted provided that the following conditions are
met:
1. Redistributions of source code must retain the above copyright notice,
this list of conditions and the following disclaimer.
2. Redistributions in binary form must reproduce the above copyright
notice, this list of conditions and the following disclaimer in the
documentation and/or other materials provided with the distribution.
3. The name of the author may not be used to endorse or promote products
derived from this software without specific prior written permission.
THIS SOFTWARE IS PROVIDED BY THE AUTHOR ``AS IS'' AND ANY EXPRESS OR
IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES
OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE
DISCLAIMED. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR ANY DIRECT,
INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
(INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR
SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION)
HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT,
STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN
ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE
POSSIBILITY OF SUCH DAMAGE.
*/
<p>#include "smallft.h"
#ifdef __cplusplus
extern "C" {
#endif
typedef struct SpeexPreprocessState {
int frame_size; /**< Number of samples processed each time */
int ps_size; /**< Number of points in the power spectrum */
/* parameters */
int denoise_enabled;
int agc_enabled;
float agc_level;
int vad_enabled;
float *frame; /**< Processing frame (2*ps_size) */
float *ps; /**< Current power spectrum */
float *gain2; /**< Adjusted gains */
float *window; /**< Analysis/Synthesis window */
float *noise; /**< Noise estimate */
float *old_ps; /**< Power spectrum for last frame */
float *gain; /**< Ephraim Malah gain */
float *prior; /**< A-priori SNR */
float *post; /**< A-posteriori SNR */
float *min_ps; /**< */
float *last_energy; /**< Energy of the previous frames */
float *last_ps; /**< Power spectrum of the past frames */
float *loudness_weight; /**< */
float *echo_noise;
int last_id; /**< */
float *noise_bands;
float *noise_bands2;
int noise_bandsN;
float *speech_bands;
float *speech_bands2;
int speech_bandsN;
float *inbuf; /**< Input buffer (overlapped analysis) */
float *outbuf; /**< Output buffer (for overlap and add) */
float speech_prob;
int last_speech;
float loudness; /**< loudness estimate */
float loudness2; /**< loudness estimate */
int nb_adapt; /**< Number of frames used for adaptation so far */
int nb_loudness_adapt; /**< Number of frames used for loudness adaptation so far */
int consec_noise; /**< Number of consecutive noise frames */
int nb_preprocess; /**< Number of frames processed so far */
int nb_min_estimate; /**< */
int last_update; /**< */
float min_ener; /**< */
drft_lookup fft_lookup; /**< Lookup table for the FFT */
} SpeexPreprocessState;
/** Creates a new preprocessing state */
SpeexPreprocessState *speex_preprocess_state_init(int frame_size);
/** Destroys a denoising state */
void speex_preprocess_state_destroy(SpeexPreprocessState *st);
/** Preprocess a frame */
int speex_preprocess(SpeexPreprocessState *st, float *x, float *noise);
/** Used like the ioctl function to control the preprocessor parameters */
int speex_preprocess_ctl(SpeexPreprocessState *st, int request, void *ptr);
<p><p>#define SPEEX_PREPROCESS_SET_DENOISE 0
#define SPEEX_PREPROCESS_GET_DENOISE 1
#define SPEEX_PREPROCESS_SET_AGC 2
#define SPEEX_PREPROCESS_GET_AGC 3
#define SPEEX_PREPROCESS_SET_VAD 4
#define SPEEX_PREPROCESS_GET_VAD 5
#define SPEEX_PREPROCESS_SET_AGC_LEVEL 6
#define SPEEX_PREPROCESS_GET_AGC_LEVEL 7
#ifdef __cplusplus
}
#endif
<p><p>--- >8 ----
List archives: http://www.xiph.org/archives/
Ogg project homepage: http://www.xiph.org/ogg/
To unsubscribe from this list, send a message to 'cvs-request at xiph.org'
containing only the word 'unsubscribe' in the body. No subject is needed.
Unsubscribe messages sent to the list will be ignored/filtered.
More information about the commits
mailing list