summaryrefslogtreecommitdiff
path: root/media/libaom/src/av1/encoder/rd.h
diff options
context:
space:
mode:
Diffstat (limited to 'media/libaom/src/av1/encoder/rd.h')
-rw-r--r--media/libaom/src/av1/encoder/rd.h189
1 files changed, 85 insertions, 104 deletions
diff --git a/media/libaom/src/av1/encoder/rd.h b/media/libaom/src/av1/encoder/rd.h
index 1addbaeb96..8d0277e3bf 100644
--- a/media/libaom/src/av1/encoder/rd.h
+++ b/media/libaom/src/av1/encoder/rd.h
@@ -19,6 +19,7 @@
#include "av1/encoder/block.h"
#include "av1/encoder/context_tree.h"
#include "av1/encoder/cost.h"
+#include "av1/encoder/ratectrl.h"
#ifdef __cplusplus
extern "C" {
@@ -35,9 +36,9 @@ extern "C" {
(((D) * (1 << RDDIV_BITS)) - \
ROUND_POWER_OF_TWO(((int64_t)(R)) * (RM), AV1_PROB_COST_SHIFT))
-#define RDCOST_DBL(RM, R, D) \
+#define RDCOST_DBL_WITH_NATIVE_BD_DIST(RM, R, D, BD) \
(((((double)(R)) * (RM)) / (double)(1 << AV1_PROB_COST_SHIFT)) + \
- ((double)(D) * (1 << RDDIV_BITS)))
+ ((double)((D) >> (2 * (BD - 8))) * (1 << RDDIV_BITS)))
#define QIDX_SKIP_THRESH 115
@@ -78,24 +79,9 @@ typedef struct RD_OPT {
int RDMULT;
- double r0, arf_r0;
- double mc_saved_base, mc_count_base;
+ double r0;
} RD_OPT;
-typedef struct {
- // Cost of transmitting the actual motion vector.
- // mv_component[0][i] is the cost of motion vector with horizontal component
- // (mv_row) equal to i - MV_MAX.
- // mv_component[1][i] is the cost of motion vector with vertical component
- // (mv_col) equal to i - MV_MAX.
- int mv_component[2][MV_VALS];
-
- // joint_mv[i] is the cost of transmitting joint mv(MV_JOINT_TYPE) of
- // type i.
- // TODO(huisu@google.com): we can update dv_joint_cost per SB.
- int joint_mv[MV_JOINTS];
-} IntraBCMVCosts;
-
static INLINE void av1_init_rd_stats(RD_STATS *rd_stats) {
#if CONFIG_RD_DEBUG
int plane;
@@ -104,19 +90,13 @@ static INLINE void av1_init_rd_stats(RD_STATS *rd_stats) {
rd_stats->dist = 0;
rd_stats->rdcost = 0;
rd_stats->sse = 0;
- rd_stats->skip = 1;
+ rd_stats->skip_txfm = 1;
rd_stats->zero_rate = 0;
#if CONFIG_RD_DEBUG
// This may run into problems when monochrome video is
// encoded, as there will only be 1 plane
for (plane = 0; plane < MAX_MB_PLANE; ++plane) {
rd_stats->txb_coeff_cost[plane] = 0;
- {
- int r, c;
- for (r = 0; r < TXB_COEFF_COST_MAP_SIZE; ++r)
- for (c = 0; c < TXB_COEFF_COST_MAP_SIZE; ++c)
- rd_stats->txb_coeff_cost_map[plane][r][c] = 0;
- }
}
#endif
}
@@ -129,62 +109,49 @@ static INLINE void av1_invalid_rd_stats(RD_STATS *rd_stats) {
rd_stats->dist = INT64_MAX;
rd_stats->rdcost = INT64_MAX;
rd_stats->sse = INT64_MAX;
- rd_stats->skip = 0;
+ rd_stats->skip_txfm = 0;
rd_stats->zero_rate = 0;
#if CONFIG_RD_DEBUG
// This may run into problems when monochrome video is
// encoded, as there will only be 1 plane
for (plane = 0; plane < MAX_MB_PLANE; ++plane) {
rd_stats->txb_coeff_cost[plane] = INT_MAX;
- {
- int r, c;
- for (r = 0; r < TXB_COEFF_COST_MAP_SIZE; ++r)
- for (c = 0; c < TXB_COEFF_COST_MAP_SIZE; ++c)
- rd_stats->txb_coeff_cost_map[plane][r][c] = INT16_MAX;
- }
}
#endif
}
static INLINE void av1_merge_rd_stats(RD_STATS *rd_stats_dst,
const RD_STATS *rd_stats_src) {
- assert(rd_stats_dst->rate != INT_MAX && rd_stats_src->rate != INT_MAX);
+ if (rd_stats_dst->rate == INT_MAX || rd_stats_src->rate == INT_MAX) {
+ // If rd_stats_dst or rd_stats_src has invalid rate, we will make
+ // rd_stats_dst invalid.
+ av1_invalid_rd_stats(rd_stats_dst);
+ return;
+ }
rd_stats_dst->rate = (int)AOMMIN(
((int64_t)rd_stats_dst->rate + (int64_t)rd_stats_src->rate), INT_MAX);
if (!rd_stats_dst->zero_rate)
rd_stats_dst->zero_rate = rd_stats_src->zero_rate;
rd_stats_dst->dist += rd_stats_src->dist;
rd_stats_dst->sse += rd_stats_src->sse;
- rd_stats_dst->skip &= rd_stats_src->skip;
+ rd_stats_dst->skip_txfm &= rd_stats_src->skip_txfm;
#if CONFIG_RD_DEBUG
// This may run into problems when monochrome video is
// encoded, as there will only be 1 plane
for (int plane = 0; plane < MAX_MB_PLANE; ++plane) {
rd_stats_dst->txb_coeff_cost[plane] += rd_stats_src->txb_coeff_cost[plane];
- {
- // TODO(angiebird): optimize this part
- int r, c;
- int ref_txb_coeff_cost = 0;
- for (r = 0; r < TXB_COEFF_COST_MAP_SIZE; ++r)
- for (c = 0; c < TXB_COEFF_COST_MAP_SIZE; ++c) {
- rd_stats_dst->txb_coeff_cost_map[plane][r][c] +=
- rd_stats_src->txb_coeff_cost_map[plane][r][c];
- ref_txb_coeff_cost += rd_stats_dst->txb_coeff_cost_map[plane][r][c];
- }
- assert(ref_txb_coeff_cost == rd_stats_dst->txb_coeff_cost[plane]);
- }
}
#endif
}
static INLINE void av1_accumulate_rd_stats(RD_STATS *rd_stats, int64_t dist,
- int rate, int skip, int64_t sse,
+ int rate, int skip_txfm, int64_t sse,
int zero_rate) {
assert(rd_stats->rate != INT_MAX && rate != INT_MAX);
rd_stats->rate += rate;
if (!rd_stats->zero_rate) rd_stats->zero_rate = zero_rate;
rd_stats->dist += dist;
- rd_stats->skip &= skip;
+ rd_stats->skip_txfm &= skip_txfm;
rd_stats->sse += sse;
}
@@ -225,14 +192,25 @@ struct TileDataEnc;
struct AV1_COMP;
struct macroblock;
-int av1_compute_rd_mult_based_on_qindex(const struct AV1_COMP *cpi, int qindex);
+/*!\brief Compute rdmult based on q index and frame update type
+ *
+ * \param[in] bit_depth bit depth
+ * \param[in] update_type frame update type
+ * \param[in] qindex q index
+ *
+ * \return rdmult
+ */
+int av1_compute_rd_mult_based_on_qindex(aom_bit_depth_t bit_depth,
+ FRAME_UPDATE_TYPE update_type,
+ int qindex);
int av1_compute_rd_mult(const struct AV1_COMP *cpi, int qindex);
void av1_initialize_rd_consts(struct AV1_COMP *cpi);
-void av1_initialize_me_consts(const struct AV1_COMP *cpi, MACROBLOCK *x,
- int qindex);
+// Sets the multiplier to convert mv cost to l1 error during motion search.
+void av1_set_sad_per_bit(const struct AV1_COMP *cpi, int *sadperbit,
+ int qindex);
void av1_model_rd_from_var_lapndz(int64_t var, unsigned int n,
unsigned int qstep, int *rate, int64_t *dist);
@@ -243,7 +221,7 @@ void av1_model_rd_surffit(BLOCK_SIZE bsize, double sse_norm, double xm,
double yl, double *rate_f, double *distbysse_f);
int av1_get_switchable_rate(const MACROBLOCK *x, const MACROBLOCKD *xd,
- InterpFilter interp_filter);
+ InterpFilter interp_filter, int dual_filter);
YV12_BUFFER_CONFIG *av1_get_scaled_ref_frame(const struct AV1_COMP *cpi,
int ref_frame);
@@ -261,7 +239,11 @@ void av1_set_rd_speed_thresholds(struct AV1_COMP *cpi);
void av1_update_rd_thresh_fact(const AV1_COMMON *const cm,
int (*fact)[MAX_MODES], int rd_thresh,
- BLOCK_SIZE bsize, THR_MODES best_mode_index);
+ BLOCK_SIZE bsize, THR_MODES best_mode_index,
+ THR_MODES inter_mode_start,
+ THR_MODES inter_mode_end,
+ THR_MODES intra_mode_start,
+ THR_MODES intra_mode_end);
static INLINE void reset_thresh_freq_fact(MACROBLOCK *const x) {
for (int i = 0; i < BLOCK_SIZES_ALL; ++i) {
@@ -271,73 +253,57 @@ static INLINE void reset_thresh_freq_fact(MACROBLOCK *const x) {
}
}
-static INLINE int rd_less_than_thresh(int64_t best_rd, int thresh,
+static INLINE int rd_less_than_thresh(int64_t best_rd, int64_t thresh,
int thresh_fact) {
- return best_rd < ((int64_t)thresh * thresh_fact >> 5) || thresh == INT_MAX;
+ return best_rd < (thresh * thresh_fact >> 5) || thresh == INT_MAX;
}
void av1_mv_pred(const struct AV1_COMP *cpi, MACROBLOCK *x,
uint8_t *ref_y_buffer, int ref_y_stride, int ref_frame,
BLOCK_SIZE block_size);
-static INLINE void set_error_per_bit(MACROBLOCK *x, int rdmult) {
- x->errorperbit = rdmult >> RD_EPB_SHIFT;
- x->errorperbit += (x->errorperbit == 0);
+// Sets the multiplier to convert mv cost to l2 error during motion search.
+static INLINE void av1_set_error_per_bit(int *errorperbit, int rdmult) {
+ *errorperbit = AOMMAX(rdmult >> RD_EPB_SHIFT, 1);
}
// Get the threshold for R-D optimization of coefficients depending upon mode
// decision/winner mode processing
-static INLINE uint32_t get_rd_opt_coeff_thresh(
- const uint32_t *const coeff_opt_dist_threshold,
- int enable_winner_mode_for_coeff_opt, int is_winner_mode) {
- // Default initialization of threshold
- uint32_t coeff_opt_thresh = coeff_opt_dist_threshold[DEFAULT_EVAL];
+static INLINE void get_rd_opt_coeff_thresh(
+ const uint32_t (*const coeff_opt_threshold)[2],
+ TxfmSearchParams *txfm_params, int enable_winner_mode_for_coeff_opt,
+ int is_winner_mode) {
+ if (!enable_winner_mode_for_coeff_opt) {
+ // Default initialization of threshold
+ txfm_params->coeff_opt_thresholds[0] = coeff_opt_threshold[DEFAULT_EVAL][0];
+ txfm_params->coeff_opt_thresholds[1] = coeff_opt_threshold[DEFAULT_EVAL][1];
+ return;
+ }
// TODO(any): Experiment with coeff_opt_dist_threshold values when
// enable_winner_mode_for_coeff_opt is ON
// TODO(any): Skip the winner mode processing for blocks with lower residual
// energy as R-D optimization of coefficients would have been enabled during
// mode decision
- if (enable_winner_mode_for_coeff_opt) {
- // Use conservative threshold during mode decision and perform R-D
- // optimization of coeffs always for winner modes
- if (is_winner_mode)
- coeff_opt_thresh = coeff_opt_dist_threshold[WINNER_MODE_EVAL];
- else
- coeff_opt_thresh = coeff_opt_dist_threshold[MODE_EVAL];
- }
- return coeff_opt_thresh;
-}
-// Used to reset the state of tx/mb rd hash information
-static INLINE void reset_hash_records(MACROBLOCK *const x,
- int use_inter_txb_hash) {
- int32_t record_idx;
-
- // Reset the state for use_inter_txb_hash
- if (use_inter_txb_hash) {
- for (record_idx = 0;
- record_idx < ((MAX_MIB_SIZE >> 1) * (MAX_MIB_SIZE >> 1)); record_idx++)
- x->txb_rd_record_8X8[record_idx].num =
- x->txb_rd_record_8X8[record_idx].index_start = 0;
- for (record_idx = 0;
- record_idx < ((MAX_MIB_SIZE >> 2) * (MAX_MIB_SIZE >> 2)); record_idx++)
- x->txb_rd_record_16X16[record_idx].num =
- x->txb_rd_record_16X16[record_idx].index_start = 0;
- for (record_idx = 0;
- record_idx < ((MAX_MIB_SIZE >> 3) * (MAX_MIB_SIZE >> 3)); record_idx++)
- x->txb_rd_record_32X32[record_idx].num =
- x->txb_rd_record_32X32[record_idx].index_start = 0;
- for (record_idx = 0;
- record_idx < ((MAX_MIB_SIZE >> 4) * (MAX_MIB_SIZE >> 4)); record_idx++)
- x->txb_rd_record_64X64[record_idx].num =
- x->txb_rd_record_64X64[record_idx].index_start = 0;
+ // Use conservative threshold during mode decision and perform R-D
+ // optimization of coeffs always for winner modes
+ if (is_winner_mode) {
+ txfm_params->coeff_opt_thresholds[0] =
+ coeff_opt_threshold[WINNER_MODE_EVAL][0];
+ txfm_params->coeff_opt_thresholds[1] =
+ coeff_opt_threshold[WINNER_MODE_EVAL][1];
+ } else {
+ txfm_params->coeff_opt_thresholds[0] = coeff_opt_threshold[MODE_EVAL][0];
+ txfm_params->coeff_opt_thresholds[1] = coeff_opt_threshold[MODE_EVAL][1];
}
+}
- // Reset the state for use_intra_txb_hash
- x->txb_rd_record_intra.num = x->txb_rd_record_intra.index_start = 0;
+// Used to reset the state of mb rd hash information
+static INLINE void reset_mb_rd_record(MB_RD_RECORD *const mb_rd_record) {
+ if (!mb_rd_record) return;
// Reset the state for use_mb_rd_hash
- x->mb_rd_record.num = x->mb_rd_record.index_start = 0;
+ mb_rd_record->num = mb_rd_record->index_start = 0;
}
void av1_setup_pred_block(const MACROBLOCKD *xd,
@@ -350,18 +316,33 @@ void av1_setup_pred_block(const MACROBLOCKD *xd,
int av1_get_intra_cost_penalty(int qindex, int qdelta,
aom_bit_depth_t bit_depth);
-void av1_fill_mode_rates(AV1_COMMON *const cm, MACROBLOCK *x,
+void av1_fill_mode_rates(AV1_COMMON *const cm, ModeCosts *mode_costs,
FRAME_CONTEXT *fc);
-void av1_fill_coeff_costs(MACROBLOCK *x, FRAME_CONTEXT *fc,
+void av1_fill_lr_rates(ModeCosts *mode_costs, FRAME_CONTEXT *fc);
+
+void av1_fill_coeff_costs(CoeffCosts *coeff_costs, FRAME_CONTEXT *fc,
const int num_planes);
-void av1_fill_mv_costs(const FRAME_CONTEXT *fc, int integer_mv, int usehp,
- MACROBLOCK *x);
+void av1_fill_mv_costs(const nmv_context *nmvc, int integer_mv, int usehp,
+ MvCosts *mv_costs);
+
+void av1_fill_dv_costs(const nmv_context *ndvc, IntraBCMVCosts *dv_costs);
int av1_get_adaptive_rdmult(const struct AV1_COMP *cpi, double beta);
-int av1_get_deltaq_offset(const struct AV1_COMP *cpi, int qindex, double beta);
+int av1_get_deltaq_offset(aom_bit_depth_t bit_depth, int qindex, double beta);
+
+/*!\brief Adjust current superblock's q_index based on delta q resolution
+ *
+ * \param[in] delta_q_res delta q resolution
+ * \param[in] prev_qindex previous superblock's q index
+ * \param[in] curr_qindex current superblock's q index
+ *
+ * \return the current superblock's adjusted q_index
+ */
+int av1_adjust_q_from_delta_q_res(int delta_q_res, int prev_qindex,
+ int curr_qindex);
#ifdef __cplusplus
} // extern "C"