3, 3, 3, 3, 3, 3, 3, 6, 6, 6, 6, 6, 6, 6, 6, 9
};
-static const uint8_t* run_value_bits[2] = {
+static const uint8_t *run_value_bits[2] = {
run_value_bits_long, run_value_bits_short
};
return pow(coef * Q, 0.75) + 0.4054;
}
-static void quantize_bands(int (*out)[2], const float *in, const float *scaled, int size, float Q34, int is_signed, int maxval)
+static void quantize_bands(int (*out)[2], const float *in, const float *scaled,
+ int size, float Q34, int is_signed, int maxval)
{
int i;
double qc;
for (i = 0; i < size; i++) {
qc = scaled[i] * Q34;
- out[i][0] = (int)FFMIN((int)qc, maxval);
+ out[i][0] = (int)FFMIN((int)qc, maxval);
out[i][1] = (int)FFMIN((int)(qc + 0.4054), maxval);
if (is_signed && in[i] < 0.0f) {
out[i][0] = -out[i][0];
}
}
-static void abs_pow34_v(float *out, const float* in, const int size)
+static void abs_pow34_v(float *out, const float *in, const int size)
{
#ifndef USE_REALLY_FULL_SEARCH
int i;
*
* @return quantization distortion
*/
-static float quantize_band_cost(struct AACEncContext *s, const float *in, const float *scaled, int size, int scale_idx, int cb,
- const float lambda, const float uplim, int *bits)
+static float quantize_band_cost(struct AACEncContext *s, const float *in,
+ const float *scaled, int size, int scale_idx,
+ int cb, const float lambda, const float uplim,
+ int *bits)
{
const float IQ = ff_aac_pow2sf_tab[200 + scale_idx - SCALE_ONE_POS + SCALE_DIV_512];
const float Q = ff_aac_pow2sf_tab[200 - scale_idx + SCALE_ONE_POS - SCALE_DIV_512];
int resbits = 0;
#ifndef USE_REALLY_FULL_SEARCH
const float Q34 = pow(Q, 0.75);
- const int range = aac_cb_range[cb];
+ const int range = aac_cb_range[cb];
const int maxval = aac_cb_maxval[cb];
int offs[4];
#endif /* USE_REALLY_FULL_SEARCH */
#endif /* USE_REALLY_FULL_SEARCH */
for (i = 0; i < size; i += dim) {
float mincost;
- int minidx = 0;
+ int minidx = 0;
int minbits = 0;
const float *vec;
#ifndef USE_REALLY_FULL_SEARCH
float rd = 0.0f;
int curbits;
int curidx = IS_CODEBOOK_UNSIGNED(cb) ? 0 : 40;
- int same = 0;
+ int same = 0;
for (k = 0; k < dim; k++) {
if ((j & (1 << k)) && quants[k][0] == quants[k][1]) {
same = 1;
continue;
for (k = 0; k < dim; k++)
curidx += quants[k][!!(j & (1 << k))] * offs[dim - 1 - k];
- curbits = ff_aac_spectral_bits[cb-1][curidx];
- vec = &ff_aac_codebook_vectors[cb-1][curidx*dim];
+ curbits = ff_aac_spectral_bits[cb-1][curidx];
+ vec = &ff_aac_codebook_vectors[cb-1][curidx*dim];
#else
mincost = INFINITY;
vec = ff_aac_codebook_vectors[cb-1];
rd = INFINITY;
break;
}
- if (vec[k] == 64.0f) {//FIXME: slow
+ if (vec[k] == 64.0f) { //FIXME: slow
if (t >= CLIPPED_ESCAPE) {
di = t - CLIPPED_ESCAPE;
curbits += 21;
rd += curbits;
if (rd < mincost) {
mincost = rd;
- minidx = j;
+ minidx = j;
minbits = curbits;
}
}
- cost += mincost;
+ cost += mincost;
resbits += minbits;
if (cost >= uplim)
return uplim;
return cost;
}
-static void quantize_and_encode_band(struct AACEncContext *s, PutBitContext *pb, const float *in, int size,
- int scale_idx, int cb, const float lambda)
+static void quantize_and_encode_band(struct AACEncContext *s, PutBitContext *pb,
+ const float *in, int size, int scale_idx,
+ int cb, const float lambda)
{
const float IQ = ff_aac_pow2sf_tab[200 + scale_idx - SCALE_ONE_POS + SCALE_DIV_512];
const float Q = ff_aac_pow2sf_tab[200 - scale_idx + SCALE_ONE_POS - SCALE_DIV_512];
int i, j, k;
#ifndef USE_REALLY_FULL_SEARCH
const float Q34 = pow(Q, 0.75);
- const int range = aac_cb_range[cb];
+ const int range = aac_cb_range[cb];
const int maxval = aac_cb_maxval[cb];
int offs[4];
float *scaled = s->scoefs;
#endif /* USE_REALLY_FULL_SEARCH */
for (i = 0; i < size; i += dim) {
float mincost;
- int minidx = 0;
+ int minidx = 0;
int minbits = 0;
const float *vec;
#ifndef USE_REALLY_FULL_SEARCH
float rd = 0.0f;
int curbits;
int curidx = IS_CODEBOOK_UNSIGNED(cb) ? 0 : 40;
- int same = 0;
+ int same = 0;
for (k = 0; k < dim; k++) {
if ((j & (1 << k)) && quants[k][0] == quants[k][1]) {
same = 1;
continue;
for (k = 0; k < dim; k++)
curidx += quants[k][!!(j & (1 << k))] * offs[dim - 1 - k];
- curbits = ff_aac_spectral_bits[cb-1][curidx];
- vec = &ff_aac_codebook_vectors[cb-1][curidx*dim];
+ curbits = ff_aac_spectral_bits[cb-1][curidx];
+ vec = &ff_aac_codebook_vectors[cb-1][curidx*dim];
#else
vec = ff_aac_codebook_vectors[cb-1];
mincost = INFINITY;
for (j = 0; j < ff_aac_spectral_sizes[cb-1]; j++, vec += dim) {
float rd = 0.0f;
int curbits = ff_aac_spectral_bits[cb-1][j];
- int curidx = j;
+ int curidx = j;
#endif /* USE_REALLY_FULL_SEARCH */
if (IS_CODEBOOK_UNSIGNED(cb)) {
for (k = 0; k < dim; k++) {
rd = INFINITY;
break;
}
- if (vec[k] == 64.0f) {//FIXME: slow
+ if (vec[k] == 64.0f) { //FIXME: slow
if (t >= CLIPPED_ESCAPE) {
di = t - CLIPPED_ESCAPE;
curbits += 21;
rd += curbits;
if (rd < mincost) {
mincost = rd;
- minidx = curidx;
+ minidx = curidx;
minbits = curbits;
}
}
BandCodingPath path[120][12];
int w, swb, cb, start, start2, size;
int i, j;
- const int max_sfb = sce->ics.max_sfb;
+ const int max_sfb = sce->ics.max_sfb;
const int run_bits = sce->ics.num_windows == 1 ? 5 : 3;
- const int run_esc = (1 << run_bits) - 1;
+ const int run_esc = (1 << run_bits) - 1;
int idx, ppos, count;
int stackrun[120], stackcb[120], stack_len;
float next_minrd = INFINITY;
abs_pow34_v(s->scoefs, sce->coeffs, 1024);
start = win*128;
for (cb = 0; cb < 12; cb++) {
- path[0][cb].cost = 0.0f;
+ path[0][cb].cost = 0.0f;
path[0][cb].prev_idx = -1;
- path[0][cb].run = 0;
+ path[0][cb].run = 0;
}
for (swb = 0; swb < max_sfb; swb++) {
start2 = start;
if (sce->zeroes[win*16 + swb]) {
for (cb = 0; cb < 12; cb++) {
path[swb+1][cb].prev_idx = cb;
- path[swb+1][cb].cost = path[swb][cb].cost;
- path[swb+1][cb].run = path[swb][cb].run + 1;
+ path[swb+1][cb].cost = path[swb][cb].cost;
+ path[swb+1][cb].run = path[swb][cb].run + 1;
}
} else {
float minrd = next_minrd;
cost_stay_here = path[swb][cb].cost + rd;
cost_get_here = minrd + rd + run_bits + 4;
if ( run_value_bits[sce->ics.num_windows == 8][path[swb][cb].run]
- != run_value_bits[sce->ics.num_windows == 8][path[swb][cb].run+1])
+ != run_value_bits[sce->ics.num_windows == 8][path[swb][cb].run+1])
cost_stay_here += run_bits;
if (cost_get_here < cost_stay_here) {
path[swb+1][cb].prev_idx = mincb;
//convert resulting path from backward-linked list
stack_len = 0;
- idx = 0;
+ idx = 0;
for (cb = 1; cb < 12; cb++) {
if (path[max_sfb][cb].cost < path[max_sfb][idx].cost)
idx = cb;
}
ppos = max_sfb;
- while(ppos > 0) {
+ while (ppos > 0) {
cb = idx;
stackrun[stack_len] = path[ppos][cb].run;
stackcb [stack_len] = cb;
sce->band_type[win*16 + start] = stackcb[i];
start++;
}
- while(count >= run_esc) {
+ while (count >= run_esc) {
put_bits(&s->pb, run_bits, run_esc);
count -= run_esc;
}
}
}
-static void encode_window_bands_info_fixed(AACEncContext *s, SingleChannelElement *sce,
- int win, int group_len, const float lambda)
+static void encode_window_bands_info_fixed(AACEncContext *s,
+ SingleChannelElement *sce,
+ int win, int group_len,
+ const float lambda)
{
encode_window_bands_info(s, sce, win, group_len, 1.0f);
}
} TrellisPath;
static void search_for_quantizers_anmr(AVCodecContext *avctx, AACEncContext *s,
- SingleChannelElement *sce, const float lambda)
+ SingleChannelElement *sce,
+ const float lambda)
{
int q, w, w2, g, start = 0;
int i;
float mincost;
for (i = 0; i < 256; i++) {
- paths[i].cost = 0.0f;
- paths[i].prev = -1;
+ paths[i].cost = 0.0f;
+ paths[i].prev = -1;
paths[i].min_val = i;
paths[i].max_val = i;
}
for (i = 256; i < 256*121; i++) {
- paths[i].cost = INFINITY;
- paths[i].prev = -2;
+ paths[i].cost = INFINITY;
+ paths[i].prev = -2;
paths[i].min_val = INT_MAX;
paths[i].max_val = 0;
}
float qmin, qmax;
int nz = 0;
- bandaddr[idx >> 8] = w*16+g;
+ bandaddr[idx >> 8] = w * 16 + g;
qmin = INT_MAX;
qmax = 0.0f;
for (w2 = 0; w2 < sce->ics.group_len[w]; w2++) {
minv = FFMIN(paths[idx - 256 + i].min_val, q);
maxv = FFMAX(paths[idx - 256 + i].max_val, q);
if (cost < paths[idx + q].cost && maxv-minv < SCALE_MAX_DIFF) {
- paths[idx + q].cost = cost;
- paths[idx + q].prev = idx - 256 + i;
+ paths[idx + q].cost = cost;
+ paths[idx + q].prev = idx - 256 + i;
paths[idx + q].min_val = minv;
paths[idx + q].max_val = maxv;
}
minv = FFMIN(paths[idx - 256 + i].min_val, q);
maxv = FFMAX(paths[idx - 256 + i].max_val, q);
if (cost < paths[idx + q].cost && maxv-minv < SCALE_MAX_DIFF) {
- paths[idx + q].cost = cost;
- paths[idx + q].prev = idx - 256 + i;
+ paths[idx + q].cost = cost;
+ paths[idx + q].prev = idx - 256 + i;
paths[idx + q].min_val = minv;
paths[idx + q].max_val = maxv;
}
}
sce->zeroes[w*16+g] = !nz;
start += sce->ics.swb_sizes[g];
- idx += 256;
+ idx += 256;
}
}
idx -= 256;
mincost = paths[idx].cost;
- minq = idx;
+ minq = idx;
for (i = 1; i < 256; i++) {
if (paths[idx + i].cost < mincost) {
mincost = paths[idx + i].cost;
minq = idx + i;
}
}
- while(minq >= 256) {
+ while (minq >= 256) {
sce->sf_idx[bandaddr[minq>>8]] = minq & 0xFF;
minq = paths[minq].prev;
}
/**
* two-loop quantizers search taken from ISO 13818-7 Appendix C
*/
-static void search_for_quantizers_twoloop(AVCodecContext *avctx, AACEncContext *s,
- SingleChannelElement *sce, const float lambda)
+static void search_for_quantizers_twoloop(AVCodecContext *avctx,
+ AACEncContext *s,
+ SingleChannelElement *sce,
+ const float lambda)
{
int start = 0, i, w, w2, g;
int destbits = avctx->bit_rate * 1024.0 / avctx->sample_rate / avctx->channels;
float dists[128], uplims[128];
int fflag, minscaler;
- int its = 0;
+ int its = 0;
int allz = 0;
float minthr = INFINITY;
abs_pow34_v(s->scoefs, sce->coeffs, 1024);
//perform two-loop search
//outer loop - improve quality
- do{
+ do {
int tbits, qstep;
minscaler = sce->sf_idx[0];
//inner loop - quantize spectrum to fit into given number of bits
qstep = its ? 1 : 32;
- do{
+ do {
int prev = -1;
tbits = 0;
fflag = 0;
if (!qstep && tbits > destbits*1.02)
qstep = 1;
if (sce->sf_idx[0] >= 217)break;
- }while(qstep);
+ } while (qstep);
fflag = 0;
minscaler = av_clip(minscaler, 60, 255 - SCALE_MAX_DIFF);
}
}
its++;
- }while(fflag && its < 10);
+ } while (fflag && its < 10);
}
static void search_for_quantizers_faac(AVCodecContext *avctx, AACEncContext *s,
- SingleChannelElement *sce, const float lambda)
+ SingleChannelElement *sce,
+ const float lambda)
{
int start = 0, i, w, w2, g;
float uplim[128], maxq[128];
for (w = 0; w < sce->ics.num_windows; w += sce->ics.group_len[w]) {
start = w*128;
for (g = 0; g < sce->ics.num_swb; g++) {
- float *coefs = sce->coeffs + start;
+ float *coefs = sce->coeffs + start;
const int size = sce->ics.swb_sizes[g];
int start2 = start, end2 = start + size, peakpos = start;
float maxval = -1, thr = 0.0f, t;
maxq[w*16+g] = fmaxf(maxq[w*16+g], fabsf(coefs[w2*128 + i]));
thr += t;
if (sce->ics.num_windows == 1 && maxval < t) {
- maxval = t;
+ maxval = t;
peakpos = start+i;
}
}
}
start += size;
thr = pow(thr / (avg_energy * (end2 - start2)), 0.3 + 0.1*(lastband - g) / lastband);
- t = 1.0 - (1.0 * start2 / last);
+ t = 1.0 - (1.0 * start2 / last);
uplim[w*16+g] = distfact / (1.4 * thr + t*t*t + 0.075);
}
}
for (w = 0; w < sce->ics.num_windows; w += sce->ics.group_len[w]) {
start = w*128;
for (g = 0; g < sce->ics.num_swb; g++) {
- const float *coefs = sce->coeffs + start;
- const float *scaled = s->scoefs + start;
- const int size = sce->ics.swb_sizes[g];
+ const float *coefs = sce->coeffs + start;
+ const float *scaled = s->scoefs + start;
+ const int size = sce->ics.swb_sizes[g];
int scf, prev_scf, step;
int min_scf = 0, max_scf = 255;
float curdiff;
continue;
}
sce->zeroes[w*16+g] = 0;
- scf = prev_scf = av_clip(SCALE_ONE_POS - SCALE_DIV_512 - log2(1/maxq[w*16+g])*16/3, 60, 218);
+ scf = prev_scf = av_clip(SCALE_ONE_POS - SCALE_DIV_512 - log2(1/maxq[w*16+g])*16/3, 60, 218);
step = 16;
for (;;) {
float dist = 0.0f;
}
static void search_for_quantizers_fast(AVCodecContext *avctx, AACEncContext *s,
- SingleChannelElement *sce, const float lambda)
+ SingleChannelElement *sce,
+ const float lambda)
{
int start = 0, i, w, w2, g;
int minq = 255;
sce->sf_idx[(w+w2)*16+g] = sce->sf_idx[w*16+g];
}
-static void search_for_ms(AACEncContext *s, ChannelElement *cpe, const float lambda)
+static void search_for_ms(AACEncContext *s, ChannelElement *cpe,
+ const float lambda)
{
int start = 0, i, w, w2, g;
float M[128], S[128];
float maxthr = fmaxf(band0->threshold, band1->threshold);
for (i = 0; i < sce0->ics.swb_sizes[g]; i++) {
M[i] = (sce0->coeffs[start+w2*128+i]
- + sce1->coeffs[start+w2*128+i])*0.5;
+ + sce1->coeffs[start+w2*128+i]) * 0.5;
S[i] = sce0->coeffs[start+w2*128+i]
- sce1->coeffs[start+w2*128+i];
}
ff_sine_window_init(ff_sine_1024, 1024);
ff_sine_window_init(ff_sine_128, 128);
- s->samples = av_malloc(2 * 1024 * avctx->channels * sizeof(s->samples[0]));
- s->cpe = av_mallocz(sizeof(ChannelElement) * aac_chan_configs[avctx->channels-1][0]);
- avctx->extradata = av_malloc(2);
+ s->samples = av_malloc(2 * 1024 * avctx->channels * sizeof(s->samples[0]));
+ s->cpe = av_mallocz(sizeof(ChannelElement) * aac_chan_configs[avctx->channels-1][0]);
+ avctx->extradata = av_malloc(2);
avctx->extradata_size = 2;
put_audio_specific_config(avctx);
- sizes[0] = swb_size_1024[i];
- sizes[1] = swb_size_128[i];
+ sizes[0] = swb_size_1024[i];
+ sizes[1] = swb_size_128[i];
lengths[0] = ff_aac_num_swb_1024[i];
lengths[1] = ff_aac_num_swb_128[i];
ff_psy_init(&s->psy, avctx, 2, sizes, lengths);
for (w = 0; w < ics0->num_windows*16; w += 16)
for (i = 0; i < ics0->max_sfb; i++)
if (cpe->ms_mask[w+i]) msc++;
- if (msc == 0 || ics0->max_sfb == 0) cpe->ms_mode = 0;
- else cpe->ms_mode = msc < ics0->max_sfb ? 1 : 2;
+ if (msc == 0 || ics0->max_sfb == 0)
+ cpe->ms_mode = 0;
+ else
+ cpe->ms_mode = msc < ics0->max_sfb ? 1 : 2;
}
}
/**
* Encode scalefactors.
*/
-static void encode_scale_factors(AVCodecContext *avctx, AACEncContext *s, SingleChannelElement *sce)
+static void encode_scale_factors(AVCodecContext *avctx, AACEncContext *s,
+ SingleChannelElement *sce)
{
int off = sce->sf_idx[0], diff;
int i, w;
for (i = 0; i < sce->ics.max_sfb; i++) {
if (!sce->zeroes[w*16 + i]) {
diff = sce->sf_idx[w*16 + i] - off + SCALE_DIFF_ZERO;
- if (diff < 0 || diff > 120) av_log(avctx, AV_LOG_ERROR, "Scalefactor difference is too big to be coded\n");
+ if (diff < 0 || diff > 120)
+ av_log(avctx, AV_LOG_ERROR, "Scalefactor difference is too big to be coded\n");
off = sce->sf_idx[w*16 + i];
put_bits(&s->pb, ff_aac_scalefactor_bits[diff], ff_aac_scalefactor_code[diff]);
}
int i;
put_bits(&s->pb, 1, !!pulse->num_pulse);
- if (!pulse->num_pulse) return;
+ if (!pulse->num_pulse)
+ return;
put_bits(&s->pb, 2, pulse->num_pulse - 1);
put_bits(&s->pb, 6, pulse->start);
}
for (w2 = w; w2 < w + sce->ics.group_len[w]; w2++) {
s->coder->quantize_and_encode_band(s, &s->pb, sce->coeffs + start + w2*128,
- sce->ics.swb_sizes[i],
- sce->sf_idx[w*16 + i],
- sce->band_type[w*16 + i],
- s->lambda);
+ sce->ics.swb_sizes[i],
+ sce->sf_idx[w*16 + i],
+ sce->band_type[w*16 + i],
+ s->lambda);
}
start += sce->ics.swb_sizes[i];
}
/**
* Encode one channel of audio data.
*/
-static int encode_individual_channel(AVCodecContext *avctx, AACEncContext *s, SingleChannelElement *sce, int common_window)
+static int encode_individual_channel(AVCodecContext *avctx, AACEncContext *s,
+ SingleChannelElement *sce,
+ int common_window)
{
put_bits(&s->pb, 8, sce->sf_idx[0]);
- if (!common_window) put_ics_info(s, &sce->ics);
+ if (!common_window)
+ put_ics_info(s, &sce->ics);
encode_band_info(s, sce);
encode_scale_factors(avctx, s, sce);
encode_pulses(s, &sce->pulse);
/**
* Write some auxiliary information about the created AAC file.
*/
-static void put_bitstream_info(AVCodecContext *avctx, AACEncContext *s, const char *name)
+static void put_bitstream_info(AVCodecContext *avctx, AACEncContext *s,
+ const char *name)
{
int i, namelen, padbits;
return 0;
if (data) {
if (!s->psypp) {
- memcpy(s->samples + 1024 * avctx->channels, data, 1024 * avctx->channels * sizeof(s->samples[0]));
+ memcpy(s->samples + 1024 * avctx->channels, data,
+ 1024 * avctx->channels * sizeof(s->samples[0]));
} else {
start_ch = 0;
samples2 = s->samples + 1024 * avctx->channels;
for (i = 0; i < chan_map[0]; i++) {
tag = chan_map[i+1];
chans = tag == TYPE_CPE ? 2 : 1;
- ff_psy_preprocess(s->psypp, (uint16_t*)data + start_ch, samples2 + start_ch, start_ch, chans);
+ ff_psy_preprocess(s->psypp, (uint16_t*)data + start_ch,
+ samples2 + start_ch, start_ch, chans);
start_ch += chans;
}
}
}
if (!avctx->frame_number) {
- memcpy(s->samples, s->samples + 1024 * avctx->channels, 1024 * avctx->channels * sizeof(s->samples[0]));
+ memcpy(s->samples, s->samples + 1024 * avctx->channels,
+ 1024 * avctx->channels * sizeof(s->samples[0]));
return 0;
}
memset(chan_el_counter, 0, sizeof(chan_el_counter));
for (i = 0; i < chan_map[0]; i++) {
FFPsyWindowInfo wi[2];
- tag = chan_map[i+1];
- chans = tag == TYPE_CPE ? 2 : 1;
- cpe = &s->cpe[i];
+ tag = chan_map[i+1];
+ chans = tag == TYPE_CPE ? 2 : 1;
+ cpe = &s->cpe[i];
samples2 = samples + start_ch;
- la = samples2 + 1024 * avctx->channels + start_ch;
+ la = samples2 + 1024 * avctx->channels + start_ch;
if (!data) la = NULL;
for (j = 0; j < chans; j++) {
IndividualChannelStream *ics = &cpe->ch[j].ics;
}
if (avctx->frame_bits > 6144*avctx->channels) {
- av_log(avctx, AV_LOG_ERROR, "input buffer violation %d > %d.\n", avctx->frame_bits, 6144*avctx->channels);
+ av_log(avctx, AV_LOG_ERROR, "input buffer violation %d > %d.\n",
+ avctx->frame_bits, 6144*avctx->channels);
}
if (!data)
s->last_frame = 1;
- memcpy(s->samples, s->samples + 1024 * avctx->channels, 1024 * avctx->channels * sizeof(s->samples[0]));
+ memcpy(s->samples, s->samples + 1024 * avctx->channels,
+ 1024 * avctx->channels * sizeof(s->samples[0]));
return put_bits_count(&s->pb)>>3;
}