| Index: source/libvpx/vp9/encoder/vp9_encodemb.c
|
| ===================================================================
|
| --- source/libvpx/vp9/encoder/vp9_encodemb.c (revision 240950)
|
| +++ source/libvpx/vp9/encoder/vp9_encodemb.c (working copy)
|
| @@ -25,6 +25,26 @@
|
| #include "vp9/encoder/vp9_rdopt.h"
|
| #include "vp9/encoder/vp9_tokenize.h"
|
|
|
| +void vp9_setup_interp_filters(MACROBLOCKD *xd,
|
| + INTERPOLATION_TYPE mcomp_filter_type,
|
| + VP9_COMMON *cm) {
|
| + if (xd->mi_8x8 && xd->mi_8x8[0]) {
|
| + MB_MODE_INFO *const mbmi = &xd->mi_8x8[0]->mbmi;
|
| +
|
| + set_scale_factors(xd, mbmi->ref_frame[0] - LAST_FRAME,
|
| + mbmi->ref_frame[1] - LAST_FRAME,
|
| + cm->active_ref_scale);
|
| + } else {
|
| + set_scale_factors(xd, -1, -1, cm->active_ref_scale);
|
| + }
|
| +
|
| + xd->subpix.filter_x = xd->subpix.filter_y =
|
| + vp9_get_filter_kernel(mcomp_filter_type == SWITCHABLE ?
|
| + EIGHTTAP : mcomp_filter_type);
|
| +
|
| + assert(((intptr_t)xd->subpix.filter_x & 0xff) == 0);
|
| +}
|
| +
|
| void vp9_subtract_block_c(int rows, int cols,
|
| int16_t *diff_ptr, ptrdiff_t diff_stride,
|
| const uint8_t *src_ptr, ptrdiff_t src_stride,
|
| @@ -43,13 +63,12 @@
|
|
|
| static void subtract_plane(MACROBLOCK *x, BLOCK_SIZE bsize, int plane) {
|
| struct macroblock_plane *const p = &x->plane[plane];
|
| - const MACROBLOCKD *const xd = &x->e_mbd;
|
| - const struct macroblockd_plane *const pd = &xd->plane[plane];
|
| - const int bw = plane_block_width(bsize, pd);
|
| - const int bh = plane_block_height(bsize, pd);
|
| + const struct macroblockd_plane *const pd = &x->e_mbd.plane[plane];
|
| + const BLOCK_SIZE plane_bsize = get_plane_block_size(bsize, pd);
|
| + const int bw = 4 * num_4x4_blocks_wide_lookup[plane_bsize];
|
| + const int bh = 4 * num_4x4_blocks_high_lookup[plane_bsize];
|
|
|
| - vp9_subtract_block(bh, bw, p->src_diff, bw,
|
| - p->src.buf, p->src.stride,
|
| + vp9_subtract_block(bh, bw, p->src_diff, bw, p->src.buf, p->src.stride,
|
| pd->dst.buf, pd->dst.stride);
|
| }
|
|
|
| @@ -117,6 +136,7 @@
|
| ENTROPY_CONTEXT *a, ENTROPY_CONTEXT *l,
|
| TX_SIZE tx_size) {
|
| MACROBLOCKD *const xd = &mb->e_mbd;
|
| + struct macroblock_plane *p = &mb->plane[plane];
|
| struct macroblockd_plane *pd = &xd->plane[plane];
|
| const int ref = is_inter_block(&xd->mi_8x8[0]->mbmi);
|
| vp9_token_state tokens[1025][2];
|
| @@ -124,7 +144,7 @@
|
| const int16_t *coeff_ptr = BLOCK_OFFSET(mb->plane[plane].coeff, block);
|
| int16_t *qcoeff_ptr;
|
| int16_t *dqcoeff_ptr;
|
| - int eob = pd->eobs[block], final_eob, sz = 0;
|
| + int eob = p->eobs[block], final_eob, sz = 0;
|
| const int i0 = 0;
|
| int rc, x, next, i;
|
| int64_t rdmult, rddiv, rd_cost0, rd_cost1;
|
| @@ -133,29 +153,30 @@
|
| PLANE_TYPE type = pd->plane_type;
|
| int err_mult = plane_rd_mult[type];
|
| const int default_eob = 16 << (tx_size << 1);
|
| - const int16_t *scan, *nb;
|
| +
|
| const int mul = 1 + (tx_size == TX_32X32);
|
| uint8_t token_cache[1024];
|
| - const int ib = txfrm_block_to_raster_block(plane_bsize, tx_size, block);
|
| const int16_t *dequant_ptr = pd->dequant;
|
| const uint8_t *const band_translate = get_band_translate(tx_size);
|
| + const scan_order *so = get_scan(xd, tx_size, type, block);
|
| + const int16_t *scan = so->scan;
|
| + const int16_t *nb = so->neighbors;
|
|
|
| assert((!type && !plane) || (type && plane));
|
| dqcoeff_ptr = BLOCK_OFFSET(pd->dqcoeff, block);
|
| - qcoeff_ptr = BLOCK_OFFSET(pd->qcoeff, block);
|
| - get_scan(xd, tx_size, type, ib, &scan, &nb);
|
| + qcoeff_ptr = BLOCK_OFFSET(p->qcoeff, block);
|
| assert(eob <= default_eob);
|
|
|
| /* Now set up a Viterbi trellis to evaluate alternative roundings. */
|
| rdmult = mb->rdmult * err_mult;
|
| - if (mb->e_mbd.mi_8x8[0]->mbmi.ref_frame[0] == INTRA_FRAME)
|
| + if (!is_inter_block(&mb->e_mbd.mi_8x8[0]->mbmi))
|
| rdmult = (rdmult * 9) >> 4;
|
| rddiv = mb->rddiv;
|
| /* Initialize the sentinel node of the trellis. */
|
| tokens[eob][0].rate = 0;
|
| tokens[eob][0].error = 0;
|
| tokens[eob][0].next = default_eob;
|
| - tokens[eob][0].token = DCT_EOB_TOKEN;
|
| + tokens[eob][0].token = EOB_TOKEN;
|
| tokens[eob][0].qc = 0;
|
| *(tokens[eob] + 1) = *(tokens[eob] + 0);
|
| next = eob;
|
| @@ -179,7 +200,7 @@
|
| t0 = (vp9_dct_value_tokens_ptr + x)->token;
|
| /* Consider both possible successor states. */
|
| if (next < default_eob) {
|
| - band = get_coef_band(band_translate, i + 1);
|
| + band = band_translate[i + 1];
|
| pt = trellis_get_coeff_context(scan, nb, i, t0, token_cache);
|
| rate0 +=
|
| mb->token_costs[tx_size][type][ref][band][0][pt]
|
| @@ -222,21 +243,19 @@
|
| /* If we reduced this coefficient to zero, check to see if
|
| * we need to move the EOB back here.
|
| */
|
| - t0 = tokens[next][0].token == DCT_EOB_TOKEN ?
|
| - DCT_EOB_TOKEN : ZERO_TOKEN;
|
| - t1 = tokens[next][1].token == DCT_EOB_TOKEN ?
|
| - DCT_EOB_TOKEN : ZERO_TOKEN;
|
| + t0 = tokens[next][0].token == EOB_TOKEN ? EOB_TOKEN : ZERO_TOKEN;
|
| + t1 = tokens[next][1].token == EOB_TOKEN ? EOB_TOKEN : ZERO_TOKEN;
|
| } else {
|
| t0 = t1 = (vp9_dct_value_tokens_ptr + x)->token;
|
| }
|
| if (next < default_eob) {
|
| - band = get_coef_band(band_translate, i + 1);
|
| - if (t0 != DCT_EOB_TOKEN) {
|
| + band = band_translate[i + 1];
|
| + if (t0 != EOB_TOKEN) {
|
| pt = trellis_get_coeff_context(scan, nb, i, t0, token_cache);
|
| rate0 += mb->token_costs[tx_size][type][ref][band][!x][pt]
|
| [tokens[next][0].token];
|
| }
|
| - if (t1 != DCT_EOB_TOKEN) {
|
| + if (t1 != EOB_TOKEN) {
|
| pt = trellis_get_coeff_context(scan, nb, i, t1, token_cache);
|
| rate1 += mb->token_costs[tx_size][type][ref][band][!x][pt]
|
| [tokens[next][1].token];
|
| @@ -264,16 +283,16 @@
|
| /* There's no choice to make for a zero coefficient, so we don't
|
| * add a new trellis node, but we do need to update the costs.
|
| */
|
| - band = get_coef_band(band_translate, i + 1);
|
| + band = band_translate[i + 1];
|
| t0 = tokens[next][0].token;
|
| t1 = tokens[next][1].token;
|
| /* Update the cost of each path if we're past the EOB token. */
|
| - if (t0 != DCT_EOB_TOKEN) {
|
| + if (t0 != EOB_TOKEN) {
|
| tokens[next][0].rate +=
|
| mb->token_costs[tx_size][type][ref][band][1][0][t0];
|
| tokens[next][0].token = ZERO_TOKEN;
|
| }
|
| - if (t1 != DCT_EOB_TOKEN) {
|
| + if (t1 != EOB_TOKEN) {
|
| tokens[next][1].rate +=
|
| mb->token_costs[tx_size][type][ref][band][1][0][t1];
|
| tokens[next][1].token = ZERO_TOKEN;
|
| @@ -284,7 +303,7 @@
|
| }
|
|
|
| /* Now pick the best path through the whole trellis. */
|
| - band = get_coef_band(band_translate, i + 1);
|
| + band = band_translate[i + 1];
|
| pt = combine_entropy_contexts(*a, *l);
|
| rate0 = tokens[next][0].rate;
|
| rate1 = tokens[next][1].rate;
|
| @@ -313,7 +332,7 @@
|
| }
|
| final_eob++;
|
|
|
| - xd->plane[plane].eobs[block] = final_eob;
|
| + mb->plane[plane].eobs[block] = final_eob;
|
| *a = *l = (final_eob > 0);
|
| }
|
|
|
| @@ -348,65 +367,51 @@
|
| struct macroblock_plane *const p = &x->plane[plane];
|
| struct macroblockd_plane *const pd = &xd->plane[plane];
|
| int16_t *coeff = BLOCK_OFFSET(p->coeff, block);
|
| - int16_t *qcoeff = BLOCK_OFFSET(pd->qcoeff, block);
|
| + int16_t *qcoeff = BLOCK_OFFSET(p->qcoeff, block);
|
| int16_t *dqcoeff = BLOCK_OFFSET(pd->dqcoeff, block);
|
| - const int16_t *scan, *iscan;
|
| - uint16_t *eob = &pd->eobs[block];
|
| - const int bwl = b_width_log2(plane_bsize), bw = 1 << bwl;
|
| - const int twl = bwl - tx_size, twmask = (1 << twl) - 1;
|
| - int xoff, yoff;
|
| + const scan_order *scan_order;
|
| + uint16_t *eob = &p->eobs[block];
|
| + const int diff_stride = 4 * num_4x4_blocks_wide_lookup[plane_bsize];
|
| + int i, j;
|
| int16_t *src_diff;
|
| + txfrm_block_to_raster_xy(plane_bsize, tx_size, block, &i, &j);
|
| + src_diff = &p->src_diff[4 * (j * diff_stride + i)];
|
|
|
| switch (tx_size) {
|
| case TX_32X32:
|
| - scan = vp9_default_scan_32x32;
|
| - iscan = vp9_default_iscan_32x32;
|
| - block >>= 6;
|
| - xoff = 32 * (block & twmask);
|
| - yoff = 32 * (block >> twl);
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| + scan_order = &vp9_default_scan_orders[TX_32X32];
|
| if (x->use_lp32x32fdct)
|
| - vp9_fdct32x32_rd(src_diff, coeff, bw * 4);
|
| + vp9_fdct32x32_rd(src_diff, coeff, diff_stride);
|
| else
|
| - vp9_fdct32x32(src_diff, coeff, bw * 4);
|
| + vp9_fdct32x32(src_diff, coeff, diff_stride);
|
| vp9_quantize_b_32x32(coeff, 1024, x->skip_block, p->zbin, p->round,
|
| p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + pd->dequant, p->zbin_extra, eob, scan_order->scan,
|
| + scan_order->iscan);
|
| break;
|
| case TX_16X16:
|
| - scan = vp9_default_scan_16x16;
|
| - iscan = vp9_default_iscan_16x16;
|
| - block >>= 4;
|
| - xoff = 16 * (block & twmask);
|
| - yoff = 16 * (block >> twl);
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - vp9_fdct16x16(src_diff, coeff, bw * 4);
|
| + scan_order = &vp9_default_scan_orders[TX_16X16];
|
| + vp9_fdct16x16(src_diff, coeff, diff_stride);
|
| vp9_quantize_b(coeff, 256, x->skip_block, p->zbin, p->round,
|
| p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + pd->dequant, p->zbin_extra, eob,
|
| + scan_order->scan, scan_order->iscan);
|
| break;
|
| case TX_8X8:
|
| - scan = vp9_default_scan_8x8;
|
| - iscan = vp9_default_iscan_8x8;
|
| - block >>= 2;
|
| - xoff = 8 * (block & twmask);
|
| - yoff = 8 * (block >> twl);
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - vp9_fdct8x8(src_diff, coeff, bw * 4);
|
| + scan_order = &vp9_default_scan_orders[TX_8X8];
|
| + vp9_fdct8x8(src_diff, coeff, diff_stride);
|
| vp9_quantize_b(coeff, 64, x->skip_block, p->zbin, p->round,
|
| p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + pd->dequant, p->zbin_extra, eob,
|
| + scan_order->scan, scan_order->iscan);
|
| break;
|
| case TX_4X4:
|
| - scan = vp9_default_scan_4x4;
|
| - iscan = vp9_default_iscan_4x4;
|
| - xoff = 4 * (block & twmask);
|
| - yoff = 4 * (block >> twl);
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - x->fwd_txm4x4(src_diff, coeff, bw * 4);
|
| + scan_order = &vp9_default_scan_orders[TX_4X4];
|
| + x->fwd_txm4x4(src_diff, coeff, diff_stride);
|
| vp9_quantize_b(coeff, 16, x->skip_block, p->zbin, p->round,
|
| p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + pd->dequant, p->zbin_extra, eob,
|
| + scan_order->scan, scan_order->iscan);
|
| break;
|
| default:
|
| assert(0);
|
| @@ -419,51 +424,54 @@
|
| MACROBLOCK *const x = args->x;
|
| MACROBLOCKD *const xd = &x->e_mbd;
|
| struct optimize_ctx *const ctx = args->ctx;
|
| + struct macroblock_plane *const p = &x->plane[plane];
|
| struct macroblockd_plane *const pd = &xd->plane[plane];
|
| - const int raster_block = txfrm_block_to_raster_block(plane_bsize, tx_size,
|
| - block);
|
| -
|
| int16_t *const dqcoeff = BLOCK_OFFSET(pd->dqcoeff, block);
|
| - uint8_t *const dst = raster_block_offset_uint8(plane_bsize, raster_block,
|
| - pd->dst.buf, pd->dst.stride);
|
| + int i, j;
|
| + uint8_t *dst;
|
| + txfrm_block_to_raster_xy(plane_bsize, tx_size, block, &i, &j);
|
| + dst = &pd->dst.buf[4 * j * pd->dst.stride + 4 * i];
|
|
|
| // TODO(jingning): per transformed block zero forcing only enabled for
|
| // luma component. will integrate chroma components as well.
|
| if (x->zcoeff_blk[tx_size][block] && plane == 0) {
|
| - int x, y;
|
| - pd->eobs[block] = 0;
|
| - txfrm_block_to_raster_xy(plane_bsize, tx_size, block, &x, &y);
|
| - ctx->ta[plane][x] = 0;
|
| - ctx->tl[plane][y] = 0;
|
| + p->eobs[block] = 0;
|
| + ctx->ta[plane][i] = 0;
|
| + ctx->tl[plane][j] = 0;
|
| return;
|
| }
|
|
|
| - vp9_xform_quant(plane, block, plane_bsize, tx_size, arg);
|
| + if (!x->skip_recode)
|
| + vp9_xform_quant(plane, block, plane_bsize, tx_size, arg);
|
|
|
| - if (x->optimize)
|
| + if (x->optimize && (!x->skip_recode || !x->skip_optimize)) {
|
| vp9_optimize_b(plane, block, plane_bsize, tx_size, x, ctx);
|
| + } else {
|
| + ctx->ta[plane][i] = p->eobs[block] > 0;
|
| + ctx->tl[plane][j] = p->eobs[block] > 0;
|
| + }
|
|
|
| - if (x->skip_encode || pd->eobs[block] == 0)
|
| + if (x->skip_encode || p->eobs[block] == 0)
|
| return;
|
|
|
| switch (tx_size) {
|
| case TX_32X32:
|
| - vp9_idct32x32_add(dqcoeff, dst, pd->dst.stride, pd->eobs[block]);
|
| + vp9_idct32x32_add(dqcoeff, dst, pd->dst.stride, p->eobs[block]);
|
| break;
|
| case TX_16X16:
|
| - vp9_idct16x16_add(dqcoeff, dst, pd->dst.stride, pd->eobs[block]);
|
| + vp9_idct16x16_add(dqcoeff, dst, pd->dst.stride, p->eobs[block]);
|
| break;
|
| case TX_8X8:
|
| - vp9_idct8x8_add(dqcoeff, dst, pd->dst.stride, pd->eobs[block]);
|
| + vp9_idct8x8_add(dqcoeff, dst, pd->dst.stride, p->eobs[block]);
|
| break;
|
| case TX_4X4:
|
| // this is like vp9_short_idct4x4 but has a special case around eob<=1
|
| // which is significant (not just an optimization) for the lossless
|
| // case.
|
| - xd->itxm_add(dqcoeff, dst, pd->dst.stride, pd->eobs[block]);
|
| + xd->itxm_add(dqcoeff, dst, pd->dst.stride, p->eobs[block]);
|
| break;
|
| default:
|
| - assert(!"Invalid transform size");
|
| + assert(0 && "Invalid transform size");
|
| }
|
| }
|
|
|
| @@ -472,20 +480,20 @@
|
| struct encode_b_args *const args = arg;
|
| MACROBLOCK *const x = args->x;
|
| MACROBLOCKD *const xd = &x->e_mbd;
|
| + struct macroblock_plane *const p = &x->plane[plane];
|
| struct macroblockd_plane *const pd = &xd->plane[plane];
|
| - const int raster_block = txfrm_block_to_raster_block(plane_bsize, tx_size,
|
| - block);
|
| -
|
| int16_t *const dqcoeff = BLOCK_OFFSET(pd->dqcoeff, block);
|
| - uint8_t *const dst = raster_block_offset_uint8(plane_bsize, raster_block,
|
| - pd->dst.buf, pd->dst.stride);
|
| + int i, j;
|
| + uint8_t *dst;
|
| + txfrm_block_to_raster_xy(plane_bsize, tx_size, block, &i, &j);
|
| + dst = &pd->dst.buf[4 * j * pd->dst.stride + 4 * i];
|
|
|
| vp9_xform_quant(plane, block, plane_bsize, tx_size, arg);
|
|
|
| - if (pd->eobs[block] == 0)
|
| + if (p->eobs[block] == 0)
|
| return;
|
|
|
| - xd->itxm_add(dqcoeff, dst, pd->dst.stride, pd->eobs[block]);
|
| + xd->itxm_add(dqcoeff, dst, pd->dst.stride, p->eobs[block]);
|
| }
|
|
|
| void vp9_encode_sby(MACROBLOCK *x, BLOCK_SIZE bsize) {
|
| @@ -505,9 +513,10 @@
|
| struct optimize_ctx ctx;
|
| struct encode_b_args arg = {x, &ctx};
|
|
|
| - vp9_subtract_sb(x, bsize);
|
| + if (!x->skip_recode)
|
| + vp9_subtract_sb(x, bsize);
|
|
|
| - if (x->optimize) {
|
| + if (x->optimize && (!x->skip_recode || !x->skip_optimize)) {
|
| int i;
|
| for (i = 0; i < MAX_MB_PLANE; ++i)
|
| optimize_init_b(i, bsize, &arg);
|
| @@ -525,118 +534,117 @@
|
| struct macroblock_plane *const p = &x->plane[plane];
|
| struct macroblockd_plane *const pd = &xd->plane[plane];
|
| int16_t *coeff = BLOCK_OFFSET(p->coeff, block);
|
| - int16_t *qcoeff = BLOCK_OFFSET(pd->qcoeff, block);
|
| + int16_t *qcoeff = BLOCK_OFFSET(p->qcoeff, block);
|
| int16_t *dqcoeff = BLOCK_OFFSET(pd->dqcoeff, block);
|
| - const int16_t *scan, *iscan;
|
| + const scan_order *scan_order;
|
| TX_TYPE tx_type;
|
| MB_PREDICTION_MODE mode;
|
| - const int bwl = b_width_log2(plane_bsize), bw = 1 << bwl;
|
| - const int twl = bwl - tx_size, twmask = (1 << twl) - 1;
|
| - int xoff, yoff;
|
| + const int bwl = b_width_log2(plane_bsize);
|
| + const int diff_stride = 4 * (1 << bwl);
|
| uint8_t *src, *dst;
|
| int16_t *src_diff;
|
| - uint16_t *eob = &pd->eobs[block];
|
| + uint16_t *eob = &p->eobs[block];
|
| + int i, j;
|
| + txfrm_block_to_raster_xy(plane_bsize, tx_size, block, &i, &j);
|
| + dst = &pd->dst.buf[4 * (j * pd->dst.stride + i)];
|
| + src = &p->src.buf[4 * (j * p->src.stride + i)];
|
| + src_diff = &p->src_diff[4 * (j * diff_stride + i)];
|
|
|
| if (xd->mb_to_right_edge < 0 || xd->mb_to_bottom_edge < 0)
|
| - extend_for_intra(xd, plane_bsize, plane, block, tx_size);
|
| + extend_for_intra(xd, plane_bsize, plane, i, j);
|
|
|
| // if (x->optimize)
|
| // vp9_optimize_b(plane, block, plane_bsize, tx_size, x, args->ctx);
|
|
|
| switch (tx_size) {
|
| case TX_32X32:
|
| - scan = vp9_default_scan_32x32;
|
| - iscan = vp9_default_iscan_32x32;
|
| + scan_order = &vp9_default_scan_orders[TX_32X32];
|
| mode = plane == 0 ? mbmi->mode : mbmi->uv_mode;
|
| - block >>= 6;
|
| - xoff = 32 * (block & twmask);
|
| - yoff = 32 * (block >> twl);
|
| - dst = pd->dst.buf + yoff * pd->dst.stride + xoff;
|
| - src = p->src.buf + yoff * p->src.stride + xoff;
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - vp9_predict_intra_block(xd, block, bwl, TX_32X32, mode,
|
| - dst, pd->dst.stride, dst, pd->dst.stride);
|
| - vp9_subtract_block(32, 32, src_diff, bw * 4,
|
| - src, p->src.stride, dst, pd->dst.stride);
|
| - if (x->use_lp32x32fdct)
|
| - vp9_fdct32x32_rd(src_diff, coeff, bw * 4);
|
| - else
|
| - vp9_fdct32x32(src_diff, coeff, bw * 4);
|
| - vp9_quantize_b_32x32(coeff, 1024, x->skip_block, p->zbin, p->round,
|
| - p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + vp9_predict_intra_block(xd, block >> 6, bwl, TX_32X32, mode,
|
| + x->skip_encode ? src : dst,
|
| + x->skip_encode ? p->src.stride : pd->dst.stride,
|
| + dst, pd->dst.stride);
|
| + if (!x->skip_recode) {
|
| + vp9_subtract_block(32, 32, src_diff, diff_stride,
|
| + src, p->src.stride, dst, pd->dst.stride);
|
| + if (x->use_lp32x32fdct)
|
| + vp9_fdct32x32_rd(src_diff, coeff, diff_stride);
|
| + else
|
| + vp9_fdct32x32(src_diff, coeff, diff_stride);
|
| + vp9_quantize_b_32x32(coeff, 1024, x->skip_block, p->zbin, p->round,
|
| + p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| + pd->dequant, p->zbin_extra, eob, scan_order->scan,
|
| + scan_order->iscan);
|
| + }
|
| if (!x->skip_encode && *eob)
|
| vp9_idct32x32_add(dqcoeff, dst, pd->dst.stride, *eob);
|
| break;
|
| case TX_16X16:
|
| tx_type = get_tx_type_16x16(pd->plane_type, xd);
|
| - scan = get_scan_16x16(tx_type);
|
| - iscan = get_iscan_16x16(tx_type);
|
| + scan_order = &vp9_scan_orders[TX_16X16][tx_type];
|
| mode = plane == 0 ? mbmi->mode : mbmi->uv_mode;
|
| - block >>= 4;
|
| - xoff = 16 * (block & twmask);
|
| - yoff = 16 * (block >> twl);
|
| - dst = pd->dst.buf + yoff * pd->dst.stride + xoff;
|
| - src = p->src.buf + yoff * p->src.stride + xoff;
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - vp9_predict_intra_block(xd, block, bwl, TX_16X16, mode,
|
| - dst, pd->dst.stride, dst, pd->dst.stride);
|
| - vp9_subtract_block(16, 16, src_diff, bw * 4,
|
| - src, p->src.stride, dst, pd->dst.stride);
|
| - vp9_fht16x16(tx_type, src_diff, coeff, bw * 4);
|
| - vp9_quantize_b(coeff, 256, x->skip_block, p->zbin, p->round,
|
| - p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + vp9_predict_intra_block(xd, block >> 4, bwl, TX_16X16, mode,
|
| + x->skip_encode ? src : dst,
|
| + x->skip_encode ? p->src.stride : pd->dst.stride,
|
| + dst, pd->dst.stride);
|
| + if (!x->skip_recode) {
|
| + vp9_subtract_block(16, 16, src_diff, diff_stride,
|
| + src, p->src.stride, dst, pd->dst.stride);
|
| + vp9_fht16x16(tx_type, src_diff, coeff, diff_stride);
|
| + vp9_quantize_b(coeff, 256, x->skip_block, p->zbin, p->round,
|
| + p->quant, p->quant_shift, qcoeff, dqcoeff,
|
| + pd->dequant, p->zbin_extra, eob, scan_order->scan,
|
| + scan_order->iscan);
|
| + }
|
| if (!x->skip_encode && *eob)
|
| vp9_iht16x16_add(tx_type, dqcoeff, dst, pd->dst.stride, *eob);
|
| break;
|
| case TX_8X8:
|
| tx_type = get_tx_type_8x8(pd->plane_type, xd);
|
| - scan = get_scan_8x8(tx_type);
|
| - iscan = get_iscan_8x8(tx_type);
|
| + scan_order = &vp9_scan_orders[TX_8X8][tx_type];
|
| mode = plane == 0 ? mbmi->mode : mbmi->uv_mode;
|
| - block >>= 2;
|
| - xoff = 8 * (block & twmask);
|
| - yoff = 8 * (block >> twl);
|
| - dst = pd->dst.buf + yoff * pd->dst.stride + xoff;
|
| - src = p->src.buf + yoff * p->src.stride + xoff;
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| - vp9_predict_intra_block(xd, block, bwl, TX_8X8, mode,
|
| - dst, pd->dst.stride, dst, pd->dst.stride);
|
| - vp9_subtract_block(8, 8, src_diff, bw * 4,
|
| - src, p->src.stride, dst, pd->dst.stride);
|
| - vp9_fht8x8(tx_type, src_diff, coeff, bw * 4);
|
| - vp9_quantize_b(coeff, 64, x->skip_block, p->zbin, p->round, p->quant,
|
| - p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + vp9_predict_intra_block(xd, block >> 2, bwl, TX_8X8, mode,
|
| + x->skip_encode ? src : dst,
|
| + x->skip_encode ? p->src.stride : pd->dst.stride,
|
| + dst, pd->dst.stride);
|
| + if (!x->skip_recode) {
|
| + vp9_subtract_block(8, 8, src_diff, diff_stride,
|
| + src, p->src.stride, dst, pd->dst.stride);
|
| + vp9_fht8x8(tx_type, src_diff, coeff, diff_stride);
|
| + vp9_quantize_b(coeff, 64, x->skip_block, p->zbin, p->round, p->quant,
|
| + p->quant_shift, qcoeff, dqcoeff,
|
| + pd->dequant, p->zbin_extra, eob, scan_order->scan,
|
| + scan_order->iscan);
|
| + }
|
| if (!x->skip_encode && *eob)
|
| vp9_iht8x8_add(tx_type, dqcoeff, dst, pd->dst.stride, *eob);
|
| break;
|
| case TX_4X4:
|
| tx_type = get_tx_type_4x4(pd->plane_type, xd, block);
|
| - scan = get_scan_4x4(tx_type);
|
| - iscan = get_iscan_4x4(tx_type);
|
| + scan_order = &vp9_scan_orders[TX_4X4][tx_type];
|
| if (mbmi->sb_type < BLOCK_8X8 && plane == 0)
|
| mode = xd->mi_8x8[0]->bmi[block].as_mode;
|
| else
|
| mode = plane == 0 ? mbmi->mode : mbmi->uv_mode;
|
|
|
| - xoff = 4 * (block & twmask);
|
| - yoff = 4 * (block >> twl);
|
| - dst = pd->dst.buf + yoff * pd->dst.stride + xoff;
|
| - src = p->src.buf + yoff * p->src.stride + xoff;
|
| - src_diff = p->src_diff + 4 * bw * yoff + xoff;
|
| vp9_predict_intra_block(xd, block, bwl, TX_4X4, mode,
|
| - dst, pd->dst.stride, dst, pd->dst.stride);
|
| - vp9_subtract_block(4, 4, src_diff, bw * 4,
|
| - src, p->src.stride, dst, pd->dst.stride);
|
| - if (tx_type != DCT_DCT)
|
| - vp9_short_fht4x4(src_diff, coeff, bw * 4, tx_type);
|
| - else
|
| - x->fwd_txm4x4(src_diff, coeff, bw * 4);
|
| - vp9_quantize_b(coeff, 16, x->skip_block, p->zbin, p->round, p->quant,
|
| - p->quant_shift, qcoeff, dqcoeff,
|
| - pd->dequant, p->zbin_extra, eob, scan, iscan);
|
| + x->skip_encode ? src : dst,
|
| + x->skip_encode ? p->src.stride : pd->dst.stride,
|
| + dst, pd->dst.stride);
|
| +
|
| + if (!x->skip_recode) {
|
| + vp9_subtract_block(4, 4, src_diff, diff_stride,
|
| + src, p->src.stride, dst, pd->dst.stride);
|
| + if (tx_type != DCT_DCT)
|
| + vp9_short_fht4x4(src_diff, coeff, diff_stride, tx_type);
|
| + else
|
| + x->fwd_txm4x4(src_diff, coeff, diff_stride);
|
| + vp9_quantize_b(coeff, 16, x->skip_block, p->zbin, p->round, p->quant,
|
| + p->quant_shift, qcoeff, dqcoeff,
|
| + pd->dequant, p->zbin_extra, eob, scan_order->scan,
|
| + scan_order->iscan);
|
| + }
|
| +
|
| if (!x->skip_encode && *eob) {
|
| if (tx_type == DCT_DCT)
|
| // this is like vp9_short_idct4x4 but has a special case around eob<=1
|
| @@ -667,3 +675,14 @@
|
| foreach_transformed_block_uv(xd, bsize, vp9_encode_block_intra, &arg);
|
| }
|
|
|
| +int vp9_encode_intra(MACROBLOCK *x, int use_16x16_pred) {
|
| + MB_MODE_INFO * mbmi = &x->e_mbd.mi_8x8[0]->mbmi;
|
| + x->skip_encode = 0;
|
| + mbmi->mode = DC_PRED;
|
| + mbmi->ref_frame[0] = INTRA_FRAME;
|
| + mbmi->tx_size = use_16x16_pred ? (mbmi->sb_type >= BLOCK_16X16 ? TX_16X16
|
| + : TX_8X8)
|
| + : TX_4X4;
|
| + vp9_encode_intra_block_y(x, mbmi->sb_type);
|
| + return vp9_get_mb_ss(x->plane[0].src_diff);
|
| +}
|
|
|