X-Git-Url: https://git.sesse.net/?a=blobdiff_plain;f=libavcodec%2Faacsbr.c;h=4d2ac6cbd26469e4d6f2fd2cbaa85ecc25f94ae4;hb=1f29e5d7a2b0950f3b6820896e97e2c02e6a10a9;hp=0df52490a4a21deb0d0779043a14a22e83755cb8;hpb=26f548bb59177cfc8c45ff633dd37b60cfd23edf;p=ffmpeg diff --git a/libavcodec/aacsbr.c b/libavcodec/aacsbr.c index 0df52490a4a..4d2ac6cbd26 100644 --- a/libavcodec/aacsbr.c +++ b/libavcodec/aacsbr.c @@ -32,6 +32,9 @@ #include "aacsbrdata.h" #include "fft.h" #include "aacps.h" +#include "sbrdsp.h" +#include "libavutil/internal.h" +#include "libavutil/libm.h" #include #include @@ -72,7 +75,6 @@ enum { static VLC vlc_sbr[10]; static const int8_t vlc_sbr_lav[10] = { 60, 60, 24, 24, 31, 31, 12, 12, 31, 12 }; -static const DECLARE_ALIGNED(16, float, zero64)[64]; #define SBR_INIT_VLC_STATIC(num, size) \ INIT_VLC_STATIC(&vlc_sbr[num], 9, sbr_tmp[num].table_size / sbr_tmp[num].elem_size, \ @@ -125,15 +127,30 @@ av_cold void ff_aac_sbr_init(void) ff_ps_init(); } -av_cold void ff_aac_sbr_ctx_init(SpectralBandReplication *sbr) -{ - sbr->kx[0] = sbr->kx[1] = 32; //Typo in spec, kx' inits to 32 +/** Places SBR in pure upsampling mode. */ +static void sbr_turnoff(SpectralBandReplication *sbr) { + sbr->start = 0; + // Init defults used in pure upsampling mode + sbr->kx[1] = 32; //Typo in spec, kx' inits to 32 + sbr->m[1] = 0; + // Reset values for first SBR header sbr->data[0].e_a[1] = sbr->data[1].e_a[1] = -1; + memset(&sbr->spectrum_params, -1, sizeof(SpectrumParameters)); +} + +av_cold void ff_aac_sbr_ctx_init(AACContext *ac, SpectralBandReplication *sbr) +{ + sbr->kx[0] = sbr->kx[1]; + sbr_turnoff(sbr); sbr->data[0].synthesis_filterbank_samples_offset = SBR_SYNTHESIS_BUF_SIZE - (1280 - 128); sbr->data[1].synthesis_filterbank_samples_offset = SBR_SYNTHESIS_BUF_SIZE - (1280 - 128); - ff_mdct_init(&sbr->mdct, 7, 1, 1.0/64); - ff_mdct_init(&sbr->mdct_ana, 7, 1, -2.0); + /* SBR requires samples to be scaled to +/-32768.0 to work correctly. + * mdct scale factors are adjusted to scale up from +/-1.0 at analysis + * and scale back down at synthesis. */ + ff_mdct_init(&sbr->mdct, 7, 1, 1.0 / (64 * 32768.0)); + ff_mdct_init(&sbr->mdct_ana, 7, 1, -2.0 * 32768.0); ff_ps_ctx_init(&sbr->ps); + ff_sbrdsp_init(&sbr->dsp); } av_cold void ff_aac_sbr_ctx_close(SpectralBandReplication *sbr) @@ -895,22 +912,23 @@ static void read_sbr_extension(AACContext *ac, SpectralBandReplication *sbr, { switch (bs_extension_id) { case EXTENSION_ID_PS: - if (!ac->m4ac.ps) { + if (!ac->oc[1].m4ac.ps) { av_log(ac->avctx, AV_LOG_ERROR, "Parametric Stereo signaled to be not-present but was found in the bitstream.\n"); skip_bits_long(gb, *num_bits_left); // bs_fill_bits *num_bits_left = 0; } else { #if 1 *num_bits_left -= ff_ps_read_data(ac->avctx, gb, &sbr->ps, *num_bits_left); + ac->avctx->profile = FF_PROFILE_AAC_HE_V2; #else - av_log_missing_feature(ac->avctx, "Parametric Stereo is", 0); + avpriv_report_missing_feature(ac->avctx, "Parametric Stereo"); skip_bits_long(gb, *num_bits_left); // bs_fill_bits *num_bits_left = 0; #endif } break; default: - av_log_missing_feature(ac->avctx, "Reserved SBR extensions are", 1); + avpriv_request_sample(ac->avctx, "Reserved SBR extensions"); skip_bits_long(gb, *num_bits_left); // bs_fill_bits *num_bits_left = 0; break; @@ -986,18 +1004,18 @@ static unsigned int read_sbr_data(AACContext *ac, SpectralBandReplication *sbr, if (id_aac == TYPE_SCE || id_aac == TYPE_CCE) { if (read_sbr_single_channel_element(ac, sbr, gb)) { - sbr->start = 0; + sbr_turnoff(sbr); return get_bits_count(gb) - cnt; } } else if (id_aac == TYPE_CPE) { if (read_sbr_channel_pair_element(ac, sbr, gb)) { - sbr->start = 0; + sbr_turnoff(sbr); return get_bits_count(gb) - cnt; } } else { av_log(ac->avctx, AV_LOG_ERROR, "Invalid bitstream - cannot apply SBR to element type %d\n", id_aac); - sbr->start = 0; + sbr_turnoff(sbr); return get_bits_count(gb) - cnt; } if (get_bits1(gb)) { // bs_extended_data @@ -1029,7 +1047,7 @@ static void sbr_reset(AACContext *ac, SpectralBandReplication *sbr) if (err < 0) { av_log(ac->avctx, AV_LOG_ERROR, "SBR reset failed. Switching SBR to pure upsampling mode.\n"); - sbr->start = 0; + sbr_turnoff(sbr); } } @@ -1052,9 +1070,9 @@ int ff_decode_sbr_extension(AACContext *ac, SpectralBandReplication *sbr, sbr->reset = 0; if (!sbr->sample_rate) - sbr->sample_rate = 2 * ac->m4ac.sample_rate; //TODO use the nominal sample rate for arbitrary sample rate support - if (!ac->m4ac.ext_sample_rate) - ac->m4ac.ext_sample_rate = 2 * ac->m4ac.sample_rate; + sbr->sample_rate = 2 * ac->oc[1].m4ac.sample_rate; //TODO use the nominal sample rate for arbitrary sample rate support + if (!ac->oc[1].m4ac.ext_sample_rate) + ac->oc[1].m4ac.ext_sample_rate = 2 * ac->oc[1].m4ac.sample_rate; if (crc) { skip_bits(gb, 10); // bs_sbr_crc_bits; TODO - implement CRC check @@ -1064,6 +1082,7 @@ int ff_decode_sbr_extension(AACContext *ac, SpectralBandReplication *sbr, //Save some state from the previous frame. sbr->kx[0] = sbr->kx[1]; sbr->m[0] = sbr->m[1]; + sbr->kx_and_m_pushed = 1; num_sbr_bits++; if (get_bits1(gb)) // bs_header_flag @@ -1133,33 +1152,20 @@ static void sbr_dequant(SpectralBandReplication *sbr, int id_aac) * @param x pointer to the beginning of the first sample window * @param W array of complex-valued samples split into subbands */ -static void sbr_qmf_analysis(DSPContext *dsp, FFTContext *mdct, const float *in, float *x, - float z[320], float W[2][32][32][2]) +static void sbr_qmf_analysis(AVFloatDSPContext *dsp, FFTContext *mdct, + SBRDSPContext *sbrdsp, const float *in, float *x, + float z[320], float W[2][32][32][2], int buf_idx) { - int i, k; - memcpy(W[0], W[1], sizeof(W[0])); + int i; memcpy(x , x+1024, (320-32)*sizeof(x[0])); memcpy(x+288, in, 1024*sizeof(x[0])); for (i = 0; i < 32; i++) { // numTimeSlots*RATE = 16*2 as 960 sample frames // are not supported dsp->vector_fmul_reverse(z, sbr_qmf_window_ds, x, 320); - for (k = 0; k < 64; k++) { - float f = z[k] + z[k + 64] + z[k + 128] + z[k + 192] + z[k + 256]; - z[k] = f; - } - //Shuffle to IMDCT - z[64] = z[0]; - for (k = 1; k < 32; k++) { - z[64+2*k-1] = z[ k]; - z[64+2*k ] = -z[64-k]; - } - z[64+63] = z[32]; - + sbrdsp->sum64x5(z); + sbrdsp->qmf_pre_shuffle(z); mdct->imdct_half(mdct, z, z+64); - for (k = 0; k < 32; k++) { - W[1][i][k][0] = -z[63-k]; - W[1][i][k][1] = z[k]; - } + sbrdsp->qmf_post_shuffle(W[buf_idx][i], z); x += 32; } } @@ -1168,21 +1174,23 @@ static void sbr_qmf_analysis(DSPContext *dsp, FFTContext *mdct, const float *in, * Synthesis QMF Bank (14496-3 sp04 p206) and Downsampled Synthesis QMF Bank * (14496-3 sp04 p206) */ -static void sbr_qmf_synthesis(DSPContext *dsp, FFTContext *mdct, +static void sbr_qmf_synthesis(FFTContext *mdct, + SBRDSPContext *sbrdsp, AVFloatDSPContext *dsp, float *out, float X[2][38][64], float mdct_buf[2][64], float *v0, int *v_off, const unsigned int div) { int i, n; const float *sbr_qmf_window = div ? sbr_qmf_window_ds : sbr_qmf_window_us; + const int step = 128 >> div; float *v; for (i = 0; i < 32; i++) { - if (*v_off == 0) { + if (*v_off < step) { int saved_samples = (1280 - 128) >> div; memcpy(&v0[SBR_SYNTHESIS_BUF_SIZE - saved_samples], v0, saved_samples * sizeof(float)); - *v_off = SBR_SYNTHESIS_BUF_SIZE - saved_samples - (128 >> div); + *v_off = SBR_SYNTHESIS_BUF_SIZE - saved_samples - step; } else { - *v_off -= 128 >> div; + *v_off -= step; } v = v0 + *v_off; if (div) { @@ -1191,22 +1199,14 @@ static void sbr_qmf_synthesis(DSPContext *dsp, FFTContext *mdct, X[0][i][32+n] = X[1][i][31-n]; } mdct->imdct_half(mdct, mdct_buf[0], X[0][i]); - for (n = 0; n < 32; n++) { - v[ n] = mdct_buf[0][63 - 2*n]; - v[63 - n] = -mdct_buf[0][62 - 2*n]; - } + sbrdsp->qmf_deint_neg(v, mdct_buf[0]); } else { - for (n = 1; n < 64; n+=2) { - X[1][i][n] = -X[1][i][n]; - } + sbrdsp->neg_odd_64(X[1][i]); mdct->imdct_half(mdct, mdct_buf[0], X[0][i]); mdct->imdct_half(mdct, mdct_buf[1], X[1][i]); - for (n = 0; n < 64; n++) { - v[ n] = -mdct_buf[0][63 - n] + mdct_buf[1][ n ]; - v[127 - n] = mdct_buf[0][63 - n] + mdct_buf[1][ n ]; - } + sbrdsp->qmf_deint_bfly(v, mdct_buf[1], mdct_buf[0]); } - dsp->vector_fmul_add(out, v , sbr_qmf_window , zero64, 64 >> div); + dsp->vector_fmul (out, v , sbr_qmf_window , 64 >> div); dsp->vector_fmul_add(out, v + ( 192 >> div), sbr_qmf_window + ( 64 >> div), out , 64 >> div); dsp->vector_fmul_add(out, v + ( 256 >> div), sbr_qmf_window + (128 >> div), out , 64 >> div); dsp->vector_fmul_add(out, v + ( 448 >> div), sbr_qmf_window + (192 >> div), out , 64 >> div); @@ -1220,45 +1220,20 @@ static void sbr_qmf_synthesis(DSPContext *dsp, FFTContext *mdct, } } -static void autocorrelate(const float x[40][2], float phi[3][2][2], int lag) -{ - int i; - float real_sum = 0.0f; - float imag_sum = 0.0f; - if (lag) { - for (i = 1; i < 38; i++) { - real_sum += x[i][0] * x[i+lag][0] + x[i][1] * x[i+lag][1]; - imag_sum += x[i][0] * x[i+lag][1] - x[i][1] * x[i+lag][0]; - } - phi[2-lag][1][0] = real_sum + x[ 0][0] * x[lag][0] + x[ 0][1] * x[lag][1]; - phi[2-lag][1][1] = imag_sum + x[ 0][0] * x[lag][1] - x[ 0][1] * x[lag][0]; - if (lag == 1) { - phi[0][0][0] = real_sum + x[38][0] * x[39][0] + x[38][1] * x[39][1]; - phi[0][0][1] = imag_sum + x[38][0] * x[39][1] - x[38][1] * x[39][0]; - } - } else { - for (i = 1; i < 38; i++) { - real_sum += x[i][0] * x[i][0] + x[i][1] * x[i][1]; - } - phi[2][1][0] = real_sum + x[ 0][0] * x[ 0][0] + x[ 0][1] * x[ 0][1]; - phi[1][0][0] = real_sum + x[38][0] * x[38][0] + x[38][1] * x[38][1]; - } -} - /** High Frequency Generation (14496-3 sp04 p214+) and Inverse Filtering * (14496-3 sp04 p214) * Warning: This routine does not seem numerically stable. */ -static void sbr_hf_inverse_filter(float (*alpha0)[2], float (*alpha1)[2], +static void sbr_hf_inverse_filter(SBRDSPContext *dsp, + float (*alpha0)[2], float (*alpha1)[2], const float X_low[32][40][2], int k0) { int k; for (k = 0; k < k0; k++) { - float phi[3][2][2], dk; + LOCAL_ALIGNED_16(float, phi, [3], [2][2]); + float dk; - autocorrelate(X_low[k], phi, 0); - autocorrelate(X_low[k], phi, 1); - autocorrelate(X_low[k], phi, 2); + dsp->autocorrelate(X_low[k], phi); dk = phi[2][1][0] * phi[1][0][0] - (phi[1][1][0] * phi[1][1][0] + phi[1][1][1] * phi[1][1][1]) / 1.000001f; @@ -1326,7 +1301,8 @@ static void sbr_chirp(SpectralBandReplication *sbr, SBRData *ch_data) /// Generate the subband filtered lowband static int sbr_lf_gen(AACContext *ac, SpectralBandReplication *sbr, - float X_low[32][40][2], const float W[2][32][32][2]) + float X_low[32][40][2], const float W[2][32][32][2], + int buf_idx) { int i, k; const int t_HFGen = 8; @@ -1334,14 +1310,15 @@ static int sbr_lf_gen(AACContext *ac, SpectralBandReplication *sbr, memset(X_low, 0, 32*sizeof(*X_low)); for (k = 0; k < sbr->kx[1]; k++) { for (i = t_HFGen; i < i_f + t_HFGen; i++) { - X_low[k][i][0] = W[1][i - t_HFGen][k][0]; - X_low[k][i][1] = W[1][i - t_HFGen][k][1]; + X_low[k][i][0] = W[buf_idx][i - t_HFGen][k][0]; + X_low[k][i][1] = W[buf_idx][i - t_HFGen][k][1]; } } + buf_idx = 1-buf_idx; for (k = 0; k < sbr->kx[0]; k++) { for (i = 0; i < t_HFGen; i++) { - X_low[k][i][0] = W[0][i + i_f - t_HFGen][k][0]; - X_low[k][i][1] = W[0][i + i_f - t_HFGen][k][1]; + X_low[k][i][0] = W[buf_idx][i + i_f - t_HFGen][k][0]; + X_low[k][i][1] = W[buf_idx][i + i_f - t_HFGen][k][1]; } } return 0; @@ -1354,12 +1331,11 @@ static int sbr_hf_gen(AACContext *ac, SpectralBandReplication *sbr, const float bw_array[5], const uint8_t *t_env, int bs_num_env) { - int i, j, x; + int j, x; int g = 0; int k = sbr->kx[1]; for (j = 0; j < sbr->num_patches; j++) { for (x = 0; x < sbr->patch_num_subbands[j]; x++, k++) { - float alpha[4]; const int p = sbr->patch_start_subband[j] + x; while (g <= sbr->n_q && k >= sbr->f_tablenoise[g]) g++; @@ -1371,26 +1347,10 @@ static int sbr_hf_gen(AACContext *ac, SpectralBandReplication *sbr, return -1; } - alpha[0] = alpha1[p][0] * bw_array[g] * bw_array[g]; - alpha[1] = alpha1[p][1] * bw_array[g] * bw_array[g]; - alpha[2] = alpha0[p][0] * bw_array[g]; - alpha[3] = alpha0[p][1] * bw_array[g]; - - for (i = 2 * t_env[0]; i < 2 * t_env[bs_num_env]; i++) { - const int idx = i + ENVELOPE_ADJUSTMENT_OFFSET; - X_high[k][idx][0] = - X_low[p][idx - 2][0] * alpha[0] - - X_low[p][idx - 2][1] * alpha[1] + - X_low[p][idx - 1][0] * alpha[2] - - X_low[p][idx - 1][1] * alpha[3] + - X_low[p][idx][0]; - X_high[k][idx][1] = - X_low[p][idx - 2][1] * alpha[0] + - X_low[p][idx - 2][0] * alpha[1] + - X_low[p][idx - 1][1] * alpha[2] + - X_low[p][idx - 1][0] * alpha[3] + - X_low[p][idx][1]; - } + sbr->dsp.hf_gen(X_high[k] + ENVELOPE_ADJUSTMENT_OFFSET, + X_low[p] + ENVELOPE_ADJUSTMENT_OFFSET, + alpha0[p], alpha1[p], bw_array[g], + 2 * t_env[0], 2 * t_env[bs_num_env]); } } if (k < sbr->m[1] + sbr->kx[1]) @@ -1401,8 +1361,8 @@ static int sbr_hf_gen(AACContext *ac, SpectralBandReplication *sbr, /// Generate the subband filtered lowband static int sbr_x_gen(SpectralBandReplication *sbr, float X[2][38][64], - const float X_low[32][40][2], const float Y[2][38][64][2], - int ch) + const float Y0[38][64][2], const float Y1[38][64][2], + const float X_low[32][40][2], int ch) { int k, i; const int i_f = 32; @@ -1416,8 +1376,8 @@ static int sbr_x_gen(SpectralBandReplication *sbr, float X[2][38][64], } for (; k < sbr->kx[0] + sbr->m[0]; k++) { for (i = 0; i < i_Temp; i++) { - X[0][i][k] = Y[0][i + i_f][k][0]; - X[1][i][k] = Y[0][i + i_f][k][1]; + X[0][i][k] = Y0[i + i_f][k][0]; + X[1][i][k] = Y0[i + i_f][k][1]; } } @@ -1429,8 +1389,8 @@ static int sbr_x_gen(SpectralBandReplication *sbr, float X[2][38][64], } for (; k < sbr->kx[1] + sbr->m[1]; k++) { for (i = i_Temp; i < i_f; i++) { - X[0][i][k] = Y[1][i][k][0]; - X[1][i][k] = Y[1][i][k][1]; + X[0][i][k] = Y1[i][k][0]; + X[1][i][k] = Y1[i][k][1]; } } return 0; @@ -1439,7 +1399,7 @@ static int sbr_x_gen(SpectralBandReplication *sbr, float X[2][38][64], /** High Frequency Adjustment (14496-3 sp04 p217) and Mapping * (14496-3 sp04 p217) */ -static void sbr_mapping(AACContext *ac, SpectralBandReplication *sbr, +static int sbr_mapping(AACContext *ac, SpectralBandReplication *sbr, SBRData *ch_data, int e_a[2]) { int e, i, m; @@ -1450,6 +1410,12 @@ static void sbr_mapping(AACContext *ac, SpectralBandReplication *sbr, uint16_t *table = ch_data->bs_freq_res[e + 1] ? sbr->f_tablehigh : sbr->f_tablelow; int k; + if (sbr->kx[1] != table[0]) { + av_log(ac->avctx, AV_LOG_ERROR, "kx != f_table{high,low}[0]. " + "Derived frequency tables were not regenerated.\n"); + sbr_turnoff(sbr); + return AVERROR_BUG; + } for (i = 0; i < ilim; i++) for (m = table[i]; m < table[i + 1]; m++) sbr->e_origmapped[e][m - sbr->kx[1]] = ch_data->env_facs[e+1][i]; @@ -1484,13 +1450,15 @@ static void sbr_mapping(AACContext *ac, SpectralBandReplication *sbr, } memcpy(ch_data->s_indexmapped[0], ch_data->s_indexmapped[ch_data->bs_num_env], sizeof(ch_data->s_indexmapped[0])); + return 0; } /// Estimation of current envelope (14496-3 sp04 p218) static void sbr_env_estimate(float (*e_curr)[48], float X_high[64][40][2], SpectralBandReplication *sbr, SBRData *ch_data) { - int e, i, m; + int e, m; + int kx1 = sbr->kx[1]; if (sbr->bs_interpol_freq) { for (e = 0; e < ch_data->bs_num_env; e++) { @@ -1499,12 +1467,7 @@ static void sbr_env_estimate(float (*e_curr)[48], float X_high[64][40][2], int iub = ch_data->t_env[e + 1] * 2 + ENVELOPE_ADJUSTMENT_OFFSET; for (m = 0; m < sbr->m[1]; m++) { - float sum = 0.0f; - - for (i = ilb; i < iub; i++) { - sum += X_high[m + sbr->kx[1]][i][0] * X_high[m + sbr->kx[1]][i][0] + - X_high[m + sbr->kx[1]][i][1] * X_high[m + sbr->kx[1]][i][1]; - } + float sum = sbr->dsp.sum_square(X_high[m+kx1] + ilb, iub - ilb); e_curr[e][m] = sum * recip_env_size; } } @@ -1522,14 +1485,11 @@ static void sbr_env_estimate(float (*e_curr)[48], float X_high[64][40][2], const int den = env_size * (table[p + 1] - table[p]); for (k = table[p]; k < table[p + 1]; k++) { - for (i = ilb; i < iub; i++) { - sum += X_high[k][i][0] * X_high[k][i][0] + - X_high[k][i][1] * X_high[k][i][1]; - } + sum += sbr->dsp.sum_square(X_high[k] + ilb, iub - ilb); } sum /= den; for (k = table[p]; k < table[p + 1]; k++) { - e_curr[e][k - sbr->kx[1]] = sum; + e_curr[e][k - kx1] = sum; } } } @@ -1596,7 +1556,8 @@ static void sbr_gain_calc(AACContext *ac, SpectralBandReplication *sbr, } /// Assembling HF Signals (14496-3 sp04 p220) -static void sbr_hf_assemble(float Y[2][38][64][2], const float X_high[64][40][2], +static void sbr_hf_assemble(float Y1[38][64][2], + const float X_high[64][40][2], SpectralBandReplication *sbr, SBRData *ch_data, const int e_a[2]) { @@ -1618,7 +1579,6 @@ static void sbr_hf_assemble(float Y[2][38][64][2], const float X_high[64][40][2] float (*g_temp)[48] = ch_data->g_temp, (*q_temp)[48] = ch_data->q_temp; int indexnoise = ch_data->f_indexnoise; int indexsine = ch_data->f_indexsine; - memcpy(Y[0], Y[1], sizeof(Y[0])); if (sbr->reset) { for (i = 0; i < h_SL; i++) { @@ -1640,63 +1600,44 @@ static void sbr_hf_assemble(float Y[2][38][64][2], const float X_high[64][40][2] for (e = 0; e < ch_data->bs_num_env; e++) { for (i = 2 * ch_data->t_env[e]; i < 2 * ch_data->t_env[e + 1]; i++) { int phi_sign = (1 - 2*(kx & 1)); + LOCAL_ALIGNED_16(float, g_filt_tab, [48]); + LOCAL_ALIGNED_16(float, q_filt_tab, [48]); + float *g_filt, *q_filt; if (h_SL && e != e_a[0] && e != e_a[1]) { + g_filt = g_filt_tab; + q_filt = q_filt_tab; for (m = 0; m < m_max; m++) { const int idx1 = i + h_SL; - float g_filt = 0.0f; - for (j = 0; j <= h_SL; j++) - g_filt += g_temp[idx1 - j][m] * h_smooth[j]; - Y[1][i][m + kx][0] = - X_high[m + kx][i + ENVELOPE_ADJUSTMENT_OFFSET][0] * g_filt; - Y[1][i][m + kx][1] = - X_high[m + kx][i + ENVELOPE_ADJUSTMENT_OFFSET][1] * g_filt; + g_filt[m] = 0.0f; + q_filt[m] = 0.0f; + for (j = 0; j <= h_SL; j++) { + g_filt[m] += g_temp[idx1 - j][m] * h_smooth[j]; + q_filt[m] += q_temp[idx1 - j][m] * h_smooth[j]; + } } } else { - for (m = 0; m < m_max; m++) { - const float g_filt = g_temp[i + h_SL][m]; - Y[1][i][m + kx][0] = - X_high[m + kx][i + ENVELOPE_ADJUSTMENT_OFFSET][0] * g_filt; - Y[1][i][m + kx][1] = - X_high[m + kx][i + ENVELOPE_ADJUSTMENT_OFFSET][1] * g_filt; - } + g_filt = g_temp[i + h_SL]; + q_filt = q_temp[i]; } + sbr->dsp.hf_g_filt(Y1[i] + kx, X_high + kx, g_filt, m_max, + i + ENVELOPE_ADJUSTMENT_OFFSET); + if (e != e_a[0] && e != e_a[1]) { - for (m = 0; m < m_max; m++) { - indexnoise = (indexnoise + 1) & 0x1ff; - if (sbr->s_m[e][m]) { - Y[1][i][m + kx][0] += - sbr->s_m[e][m] * phi[0][indexsine]; - Y[1][i][m + kx][1] += - sbr->s_m[e][m] * (phi[1][indexsine] * phi_sign); - } else { - float q_filt; - if (h_SL) { - const int idx1 = i + h_SL; - q_filt = 0.0f; - for (j = 0; j <= h_SL; j++) - q_filt += q_temp[idx1 - j][m] * h_smooth[j]; - } else { - q_filt = q_temp[i][m]; - } - Y[1][i][m + kx][0] += - q_filt * sbr_noise_table[indexnoise][0]; - Y[1][i][m + kx][1] += - q_filt * sbr_noise_table[indexnoise][1]; - } - phi_sign = -phi_sign; - } + sbr->dsp.hf_apply_noise[indexsine](Y1[i] + kx, sbr->s_m[e], + q_filt, indexnoise, + kx, m_max); } else { - indexnoise = (indexnoise + m_max) & 0x1ff; for (m = 0; m < m_max; m++) { - Y[1][i][m + kx][0] += + Y1[i][m + kx][0] += sbr->s_m[e][m] * phi[0][indexsine]; - Y[1][i][m + kx][1] += + Y1[i][m + kx][1] += sbr->s_m[e][m] * (phi[1][indexsine] * phi_sign); phi_sign = -phi_sign; } } + indexnoise = (indexnoise + m_max) & 0x1ff; indexsine = (indexsine + 1) & 3; } } @@ -1707,39 +1648,61 @@ static void sbr_hf_assemble(float Y[2][38][64][2], const float X_high[64][40][2] void ff_sbr_apply(AACContext *ac, SpectralBandReplication *sbr, int id_aac, float* L, float* R) { - int downsampled = ac->m4ac.ext_sample_rate < sbr->sample_rate; + int downsampled = ac->oc[1].m4ac.ext_sample_rate < sbr->sample_rate; int ch; int nch = (id_aac == TYPE_CPE) ? 2 : 1; + int err; + + if (!sbr->kx_and_m_pushed) { + sbr->kx[0] = sbr->kx[1]; + sbr->m[0] = sbr->m[1]; + } else { + sbr->kx_and_m_pushed = 0; + } if (sbr->start) { sbr_dequant(sbr, id_aac); } for (ch = 0; ch < nch; ch++) { /* decode channel */ - sbr_qmf_analysis(&ac->dsp, &sbr->mdct_ana, ch ? R : L, sbr->data[ch].analysis_filterbank_samples, + sbr_qmf_analysis(&ac->fdsp, &sbr->mdct_ana, &sbr->dsp, ch ? R : L, sbr->data[ch].analysis_filterbank_samples, (float*)sbr->qmf_filter_scratch, - sbr->data[ch].W); - sbr_lf_gen(ac, sbr, sbr->X_low, sbr->data[ch].W); + sbr->data[ch].W, sbr->data[ch].Ypos); + sbr_lf_gen(ac, sbr, sbr->X_low, + (const float (*)[32][32][2]) sbr->data[ch].W, + sbr->data[ch].Ypos); + sbr->data[ch].Ypos ^= 1; if (sbr->start) { - sbr_hf_inverse_filter(sbr->alpha0, sbr->alpha1, sbr->X_low, sbr->k[0]); + sbr_hf_inverse_filter(&sbr->dsp, sbr->alpha0, sbr->alpha1, + (const float (*)[40][2]) sbr->X_low, sbr->k[0]); sbr_chirp(sbr, &sbr->data[ch]); - sbr_hf_gen(ac, sbr, sbr->X_high, sbr->X_low, sbr->alpha0, sbr->alpha1, + sbr_hf_gen(ac, sbr, sbr->X_high, + (const float (*)[40][2]) sbr->X_low, + (const float (*)[2]) sbr->alpha0, + (const float (*)[2]) sbr->alpha1, sbr->data[ch].bw_array, sbr->data[ch].t_env, sbr->data[ch].bs_num_env); // hf_adj - sbr_mapping(ac, sbr, &sbr->data[ch], sbr->data[ch].e_a); - sbr_env_estimate(sbr->e_curr, sbr->X_high, sbr, &sbr->data[ch]); - sbr_gain_calc(ac, sbr, &sbr->data[ch], sbr->data[ch].e_a); - sbr_hf_assemble(sbr->data[ch].Y, sbr->X_high, sbr, &sbr->data[ch], - sbr->data[ch].e_a); + err = sbr_mapping(ac, sbr, &sbr->data[ch], sbr->data[ch].e_a); + if (!err) { + sbr_env_estimate(sbr->e_curr, sbr->X_high, sbr, &sbr->data[ch]); + sbr_gain_calc(ac, sbr, &sbr->data[ch], sbr->data[ch].e_a); + sbr_hf_assemble(sbr->data[ch].Y[sbr->data[ch].Ypos], + (const float (*)[40][2]) sbr->X_high, + sbr, &sbr->data[ch], + sbr->data[ch].e_a); + } } /* synthesis */ - sbr_x_gen(sbr, sbr->X[ch], sbr->X_low, sbr->data[ch].Y, ch); + sbr_x_gen(sbr, sbr->X[ch], + (const float (*)[64][2]) sbr->data[ch].Y[1-sbr->data[ch].Ypos], + (const float (*)[64][2]) sbr->data[ch].Y[ sbr->data[ch].Ypos], + (const float (*)[40][2]) sbr->X_low, ch); } - if (ac->m4ac.ps == 1) { + if (ac->oc[1].m4ac.ps == 1) { if (sbr->ps.start) { ff_ps_apply(ac->avctx, &sbr->ps, sbr->X[0], sbr->X[1], sbr->kx[1] + sbr->m[1]); } else { @@ -1748,12 +1711,14 @@ void ff_sbr_apply(AACContext *ac, SpectralBandReplication *sbr, int id_aac, nch = 2; } - sbr_qmf_synthesis(&ac->dsp, &sbr->mdct, L, sbr->X[0], sbr->qmf_filter_scratch, + sbr_qmf_synthesis(&sbr->mdct, &sbr->dsp, &ac->fdsp, + L, sbr->X[0], sbr->qmf_filter_scratch, sbr->data[0].synthesis_filterbank_samples, &sbr->data[0].synthesis_filterbank_samples_offset, downsampled); if (nch == 2) - sbr_qmf_synthesis(&ac->dsp, &sbr->mdct, R, sbr->X[1], sbr->qmf_filter_scratch, + sbr_qmf_synthesis(&sbr->mdct, &sbr->dsp, &ac->fdsp, + R, sbr->X[1], sbr->qmf_filter_scratch, sbr->data[1].synthesis_filterbank_samples, &sbr->data[1].synthesis_filterbank_samples_offset, downsampled);