summaryrefslogtreecommitdiff
diff options
context:
space:
mode:
authorJerome Jiang <jianj@google.com>2023-06-07 19:10:43 +0000
committerGerrit Code Review <noreply-gerritcodereview@google.com>2023-06-07 19:10:43 +0000
commitda9735a37e726439a24b32fc3c1979a6e5996591 (patch)
tree9e336d95cedbd0ddc1e77034fa4c8e9009033466
parentaafa55cc3f7f3eb5dda67ac6a8766a36d4d41628 (diff)
parentffb93451095809b710576194c374c84c1d36d4cd (diff)
downloadlibvpx-da9735a37e726439a24b32fc3c1979a6e5996591.tar
libvpx-da9735a37e726439a24b32fc3c1979a6e5996591.tar.gz
libvpx-da9735a37e726439a24b32fc3c1979a6e5996591.tar.bz2
libvpx-da9735a37e726439a24b32fc3c1979a6e5996591.zip
Merge "Fix more typos (2/n)" into main
-rw-r--r--vp8/encoder/onyx_if.c2
-rw-r--r--vp9/encoder/vp9_block.h6
-rw-r--r--vp9/encoder/vp9_denoiser.c2
-rw-r--r--vp9/encoder/vp9_encodeframe.c26
-rw-r--r--vp9/encoder/vp9_encoder.c48
-rw-r--r--vp9/encoder/vp9_firstpass.c28
-rw-r--r--vp9/encoder/vp9_noise_estimate.c2
-rw-r--r--vp9/simple_encode.h2
-rw-r--r--vpx/vp8cx.h4
9 files changed, 60 insertions, 60 deletions
diff --git a/vp8/encoder/onyx_if.c b/vp8/encoder/onyx_if.c
index b18963275..c65afc643 100644
--- a/vp8/encoder/onyx_if.c
+++ b/vp8/encoder/onyx_if.c
@@ -2251,7 +2251,7 @@ void vp8_remove_compressor(VP8_COMP **comp) {
#if 0
{
printf("\n_pick_loop_filter_level:%d\n", cpi->time_pick_lpf / 1000);
- printf("\n_frames recive_data encod_mb_row compress_frame Total\n");
+ printf("\n_frames receive_data encod_mb_row compress_frame Total\n");
printf("%6d %10ld %10ld %10ld %10ld\n", cpi->common.current_video_frame, cpi->time_receive_data / 1000, cpi->time_encode_mb_row / 1000, cpi->time_compress_data / 1000, (cpi->time_receive_data + cpi->time_compress_data) / 1000);
}
#endif
diff --git a/vp9/encoder/vp9_block.h b/vp9/encoder/vp9_block.h
index f4653a82f..7fa00cd19 100644
--- a/vp9/encoder/vp9_block.h
+++ b/vp9/encoder/vp9_block.h
@@ -85,10 +85,10 @@ struct macroblock {
// The equivalent error at the current rdmult of one whole bit (not one
// bitcost unit).
int errorperbit;
- // The equivalend SAD error of one (whole) bit at the current quantizer
+ // The equivalent SAD error of one (whole) bit at the current quantizer
// for large blocks.
int sadperbit16;
- // The equivalend SAD error of one (whole) bit at the current quantizer
+ // The equivalent SAD error of one (whole) bit at the current quantizer
// for sub-8x8 blocks.
int sadperbit4;
int rddiv;
@@ -128,7 +128,7 @@ struct macroblock {
// from extending outside the UMV borders
MvLimits mv_limits;
- // Notes transform blocks where no coefficents are coded.
+ // Notes transform blocks where no coefficients are coded.
// Set during mode selection. Read during block encoding.
uint8_t zcoeff_blk[TX_SIZES][256];
diff --git a/vp9/encoder/vp9_denoiser.c b/vp9/encoder/vp9_denoiser.c
index baea8ebb3..b40d5c615 100644
--- a/vp9/encoder/vp9_denoiser.c
+++ b/vp9/encoder/vp9_denoiser.c
@@ -387,7 +387,7 @@ void vp9_denoiser_denoise(VP9_COMP *cpi, MACROBLOCK *mb, int mi_row, int mi_col,
consec_zeromv = VPXMIN(cpi->consec_zero_mv[bl_index], consec_zeromv);
// No need to keep checking 8x8 blocks if any of the sub-blocks
// has small consec_zeromv (since threshold for no_skin based on
- // zero/small motion in skin detection is high, i.e, > 4).
+ // zero/small motion in skin detection is high, i.e., > 4).
if (consec_zeromv < 4) {
i = ymis;
break;
diff --git a/vp9/encoder/vp9_encodeframe.c b/vp9/encoder/vp9_encodeframe.c
index a979ae1c9..2381c7368 100644
--- a/vp9/encoder/vp9_encodeframe.c
+++ b/vp9/encoder/vp9_encodeframe.c
@@ -1706,7 +1706,7 @@ static int choose_partitioning(VP9_COMP *cpi, const TileInfo *const tile,
const int y16_idx = ((j >> 1) << 1);
// For inter frames: if variance4x4downsample[] == 1 for this 16x16
// block, then the variance is based on 4x4 down-sampling, so use vt2
- // in set_vt_partioning(), otherwise use vt.
+ // in set_vt_partitioning(), otherwise use vt.
v16x16 *vtemp = (!is_key_frame && variance4x4downsample[i2 + j] == 1)
? &vt2[i2 + j]
: &vt.split[i].split[j];
@@ -3470,11 +3470,11 @@ static void simple_motion_search(const VP9_COMP *const cpi, MACROBLOCK *const x,
// Features used: QP; spatial block size contexts; variance of prediction
// residue after simple_motion_search.
#define FEATURES 12
-static void ml_predict_var_rd_paritioning(const VP9_COMP *const cpi,
- MACROBLOCK *const x,
- PC_TREE *const pc_tree,
- BLOCK_SIZE bsize, int mi_row,
- int mi_col, int *none, int *split) {
+static void ml_predict_var_rd_partitioning(const VP9_COMP *const cpi,
+ MACROBLOCK *const x,
+ PC_TREE *const pc_tree,
+ BLOCK_SIZE bsize, int mi_row,
+ int mi_col, int *none, int *split) {
const VP9_COMMON *const cm = &cpi->common;
const NN_CONFIG *nn_config = NULL;
const MACROBLOCKD *const xd = &x->e_mbd;
@@ -4092,8 +4092,8 @@ static int rd_pick_partition(VP9_COMP *cpi, ThreadData *td,
mi_row + num_8x8_blocks_high_lookup[bsize] <= cm->mi_rows &&
mi_col + num_8x8_blocks_wide_lookup[bsize] <= cm->mi_cols;
if (do_rd_ml_partition_var_pruning) {
- ml_predict_var_rd_paritioning(cpi, x, pc_tree, bsize, mi_row, mi_col,
- &partition_none_allowed, &do_split);
+ ml_predict_var_rd_partitioning(cpi, x, pc_tree, bsize, mi_row, mi_col,
+ &partition_none_allowed, &do_split);
} else {
vp9_zero(pc_tree->mv);
}
@@ -4820,9 +4820,9 @@ static void pred_pixel_ready_reset(PC_TREE *pc_tree, BLOCK_SIZE bsize) {
#define FEATURES 6
#define LABELS 2
-static int ml_predict_var_paritioning(VP9_COMP *cpi, MACROBLOCK *x,
- BLOCK_SIZE bsize, int mi_row,
- int mi_col) {
+static int ml_predict_var_partitioning(VP9_COMP *cpi, MACROBLOCK *x,
+ BLOCK_SIZE bsize, int mi_row,
+ int mi_col) {
VP9_COMMON *const cm = &cpi->common;
const NN_CONFIG *nn_config = NULL;
@@ -4954,7 +4954,7 @@ static void nonrd_pick_partition(VP9_COMP *cpi, ThreadData *td,
if (partition_none_allowed || do_split) do_rect = 0;
if (partition_none_allowed && do_split) {
const int ml_predicted_partition =
- ml_predict_var_paritioning(cpi, x, bsize, mi_row, mi_col);
+ ml_predict_var_partitioning(cpi, x, bsize, mi_row, mi_col);
if (ml_predicted_partition == PARTITION_NONE) do_split = 0;
if (ml_predicted_partition == PARTITION_SPLIT) partition_none_allowed = 0;
}
@@ -5633,7 +5633,7 @@ static void encode_nonrd_sb_row(VP9_COMP *cpi, ThreadData *td,
if ((cpi->oxcf.rc_mode == VPX_VBR && cpi->rc.high_source_sad &&
cpi->oxcf.speed < 6 && !frame_is_intra_only(cm) &&
(cpi->refresh_golden_frame || cpi->refresh_alt_ref_frame))) {
- // Use lower max_partition_size for low resoultions.
+ // Use lower max_partition_size for low resolutions.
if (cm->width <= 352 && cm->height <= 288)
x->max_partition_size = BLOCK_32X32;
else
diff --git a/vp9/encoder/vp9_encoder.c b/vp9/encoder/vp9_encoder.c
index 9d5c0030a..d03d87a8a 100644
--- a/vp9/encoder/vp9_encoder.c
+++ b/vp9/encoder/vp9_encoder.c
@@ -139,7 +139,7 @@ static int compute_context_model_thresh(const VP9_COMP *const cpi) {
// frame context probability model is less than a certain threshold.
// The first component is the most critical part to guarantee adaptivity.
// Other parameters are estimated based on normal setting of hd resolution
- // parameters. e.g frame_size = 1920x1080, bitrate = 8000, qindex_factor < 50
+ // parameters. e.g. frame_size = 1920x1080, bitrate = 8000, qindex_factor < 50
const int thresh =
((FRAME_SIZE_FACTOR * frame_size - FRAME_RATE_FACTOR * bitrate) *
qindex_factor) >>
@@ -2836,7 +2836,7 @@ void vp9_remove_compressor(VP9_COMP *cpi) {
#if 0
{
printf("\n_pick_loop_filter_level:%d\n", cpi->time_pick_lpf / 1000);
- printf("\n_frames recive_data encod_mb_row compress_frame Total\n");
+ printf("\n_frames receive_data encod_mb_row compress_frame Total\n");
printf("%6d %10ld %10ld %10ld %10ld\n", cpi->common.current_video_frame,
cpi->time_receive_data / 1000, cpi->time_encode_sb_row / 1000,
cpi->time_compress_data / 1000,
@@ -5020,8 +5020,8 @@ static int setup_interp_filter_search_mask(VP9_COMP *cpi) {
#ifdef ENABLE_KF_DENOISE
// Baseline kernel weights for denoise
-static uint8_t dn_kernal_3[9] = { 1, 2, 1, 2, 4, 2, 1, 2, 1 };
-static uint8_t dn_kernal_5[25] = { 1, 1, 1, 1, 1, 1, 1, 2, 1, 1, 1, 2, 4,
+static uint8_t dn_kernel_3[9] = { 1, 2, 1, 2, 4, 2, 1, 2, 1 };
+static uint8_t dn_kernel_5[25] = { 1, 1, 1, 1, 1, 1, 1, 2, 1, 1, 1, 2, 4,
2, 1, 1, 1, 2, 1, 1, 1, 1, 1, 1, 1 };
static INLINE void add_denoise_point(int centre_val, int data_val, int thresh,
@@ -5038,17 +5038,17 @@ static void spatial_denoise_point(uint8_t *src_ptr, const int stride,
int sum_weight = 0;
int sum_val = 0;
int thresh = strength;
- int kernal_size = 5;
+ int kernel_size = 5;
int half_k_size = 2;
int i, j;
int max_diff = 0;
uint8_t *tmp_ptr;
- uint8_t *kernal_ptr;
+ uint8_t *kernel_ptr;
// Find the maximum deviation from the source point in the locale.
tmp_ptr = src_ptr - (stride * (half_k_size + 1)) - (half_k_size + 1);
- for (i = 0; i < kernal_size + 2; ++i) {
- for (j = 0; j < kernal_size + 2; ++j) {
+ for (i = 0; i < kernel_size + 2; ++i) {
+ for (j = 0; j < kernel_size + 2; ++j) {
max_diff = VPXMAX(max_diff, abs((int)*src_ptr - (int)tmp_ptr[j]));
}
tmp_ptr += stride;
@@ -5056,19 +5056,19 @@ static void spatial_denoise_point(uint8_t *src_ptr, const int stride,
// Select the kernel size.
if (max_diff > (strength + (strength >> 1))) {
- kernal_size = 3;
+ kernel_size = 3;
half_k_size = 1;
thresh = thresh >> 1;
}
- kernal_ptr = (kernal_size == 3) ? dn_kernal_3 : dn_kernal_5;
+ kernel_ptr = (kernel_size == 3) ? dn_kernel_3 : dn_kernel_5;
// Apply the kernel
tmp_ptr = src_ptr - (stride * half_k_size) - half_k_size;
- for (i = 0; i < kernal_size; ++i) {
- for (j = 0; j < kernal_size; ++j) {
- add_denoise_point((int)*src_ptr, (int)tmp_ptr[j], thresh, *kernal_ptr,
+ for (i = 0; i < kernel_size; ++i) {
+ for (j = 0; j < kernel_size; ++j) {
+ add_denoise_point((int)*src_ptr, (int)tmp_ptr[j], thresh, *kernel_ptr,
&sum_val, &sum_weight);
- ++kernal_ptr;
+ ++kernel_ptr;
}
tmp_ptr += stride;
}
@@ -5083,17 +5083,17 @@ static void highbd_spatial_denoise_point(uint16_t *src_ptr, const int stride,
int sum_weight = 0;
int sum_val = 0;
int thresh = strength;
- int kernal_size = 5;
+ int kernel_size = 5;
int half_k_size = 2;
int i, j;
int max_diff = 0;
uint16_t *tmp_ptr;
- uint8_t *kernal_ptr;
+ uint8_t *kernel_ptr;
// Find the maximum deviation from the source point in the locale.
tmp_ptr = src_ptr - (stride * (half_k_size + 1)) - (half_k_size + 1);
- for (i = 0; i < kernal_size + 2; ++i) {
- for (j = 0; j < kernal_size + 2; ++j) {
+ for (i = 0; i < kernel_size + 2; ++i) {
+ for (j = 0; j < kernel_size + 2; ++j) {
max_diff = VPXMAX(max_diff, abs((int)src_ptr - (int)tmp_ptr[j]));
}
tmp_ptr += stride;
@@ -5101,19 +5101,19 @@ static void highbd_spatial_denoise_point(uint16_t *src_ptr, const int stride,
// Select the kernel size.
if (max_diff > (strength + (strength >> 1))) {
- kernal_size = 3;
+ kernel_size = 3;
half_k_size = 1;
thresh = thresh >> 1;
}
- kernal_ptr = (kernal_size == 3) ? dn_kernal_3 : dn_kernal_5;
+ kernel_ptr = (kernel_size == 3) ? dn_kernel_3 : dn_kernel_5;
// Apply the kernel
tmp_ptr = src_ptr - (stride * half_k_size) - half_k_size;
- for (i = 0; i < kernal_size; ++i) {
- for (j = 0; j < kernal_size; ++j) {
- add_denoise_point((int)*src_ptr, (int)tmp_ptr[j], thresh, *kernal_ptr,
+ for (i = 0; i < kernel_size; ++i) {
+ for (j = 0; j < kernel_size; ++j) {
+ add_denoise_point((int)*src_ptr, (int)tmp_ptr[j], thresh, *kernel_ptr,
&sum_val, &sum_weight);
- ++kernal_ptr;
+ ++kernel_ptr;
}
tmp_ptr += stride;
}
diff --git a/vp9/encoder/vp9_firstpass.c b/vp9/encoder/vp9_firstpass.c
index e4c8a0e4a..567080a2d 100644
--- a/vp9/encoder/vp9_firstpass.c
+++ b/vp9/encoder/vp9_firstpass.c
@@ -607,10 +607,10 @@ static int get_smooth_intra_threshold(VP9_COMMON *cm) {
#define KERNEL_SIZE 3
// Baseline Kernal weights for first pass noise metric
-static uint8_t fp_dn_kernal_3[KERNEL_SIZE * KERNEL_SIZE] = { 1, 2, 1, 2, 4,
+static uint8_t fp_dn_kernel_3[KERNEL_SIZE * KERNEL_SIZE] = { 1, 2, 1, 2, 4,
2, 1, 2, 1 };
-// Estimate noise at a single point based on the impace of a spatial kernal
+// Estimate noise at a single point based on the impace of a spatial kernel
// on the point value
static int fp_estimate_point_noise(uint8_t *src_ptr, const int stride) {
int sum_weight = 0;
@@ -620,23 +620,23 @@ static int fp_estimate_point_noise(uint8_t *src_ptr, const int stride) {
int diff;
int dn_diff;
uint8_t *tmp_ptr;
- uint8_t *kernal_ptr;
+ uint8_t *kernel_ptr;
uint8_t dn_val;
uint8_t centre_val = *src_ptr;
- kernal_ptr = fp_dn_kernal_3;
+ kernel_ptr = fp_dn_kernel_3;
- // Apply the kernal
+ // Apply the kernel
tmp_ptr = src_ptr - stride - 1;
for (i = 0; i < KERNEL_SIZE; ++i) {
for (j = 0; j < KERNEL_SIZE; ++j) {
diff = abs((int)centre_val - (int)tmp_ptr[j]);
max_diff = VPXMAX(max_diff, diff);
if (diff <= FP_DN_THRESH) {
- sum_weight += *kernal_ptr;
- sum_val += (int)tmp_ptr[j] * (int)*kernal_ptr;
+ sum_weight += *kernel_ptr;
+ sum_val += (int)tmp_ptr[j] * (int)*kernel_ptr;
}
- ++kernal_ptr;
+ ++kernel_ptr;
}
tmp_ptr += stride;
}
@@ -662,13 +662,13 @@ static int fp_highbd_estimate_point_noise(uint8_t *src_ptr, const int stride) {
int dn_diff;
uint8_t *tmp_ptr;
uint16_t *tmp_ptr16;
- uint8_t *kernal_ptr;
+ uint8_t *kernel_ptr;
uint16_t dn_val;
uint16_t centre_val = *CONVERT_TO_SHORTPTR(src_ptr);
- kernal_ptr = fp_dn_kernal_3;
+ kernel_ptr = fp_dn_kernel_3;
- // Apply the kernal
+ // Apply the kernel
tmp_ptr = src_ptr - stride - 1;
for (i = 0; i < KERNEL_SIZE; ++i) {
tmp_ptr16 = CONVERT_TO_SHORTPTR(tmp_ptr);
@@ -676,10 +676,10 @@ static int fp_highbd_estimate_point_noise(uint8_t *src_ptr, const int stride) {
diff = abs((int)centre_val - (int)tmp_ptr16[j]);
max_diff = VPXMAX(max_diff, diff);
if (diff <= FP_DN_THRESH) {
- sum_weight += *kernal_ptr;
- sum_val += (int)tmp_ptr16[j] * (int)*kernal_ptr;
+ sum_weight += *kernel_ptr;
+ sum_val += (int)tmp_ptr16[j] * (int)*kernel_ptr;
}
- ++kernal_ptr;
+ ++kernel_ptr;
}
tmp_ptr += stride;
}
diff --git a/vp9/encoder/vp9_noise_estimate.c b/vp9/encoder/vp9_noise_estimate.c
index 9696529c5..4ee6e51ba 100644
--- a/vp9/encoder/vp9_noise_estimate.c
+++ b/vp9/encoder/vp9_noise_estimate.c
@@ -202,7 +202,7 @@ void vp9_update_noise_estimate(VP9_COMP *const cpi) {
VPXMIN(cpi->consec_zero_mv[bl_index1],
VPXMIN(cpi->consec_zero_mv[bl_index2],
cpi->consec_zero_mv[bl_index3])));
- // Only consider blocks that are likely steady background. i.e, have
+ // Only consider blocks that are likely steady background. i.e., have
// been encoded as zero/low motion x (= thresh_consec_zeromv) frames
// in a row. consec_zero_mv[] defined for 8x8 blocks, so consider all
// 4 sub-blocks for 16x16 block. And exclude this frame if
diff --git a/vp9/simple_encode.h b/vp9/simple_encode.h
index 7920e95ee..d610a5e15 100644
--- a/vp9/simple_encode.h
+++ b/vp9/simple_encode.h
@@ -309,7 +309,7 @@ struct EncodeFrameResult {
// The tpl stats stored in the vector is according to the encoding order.
// For example, suppose there are N show frames for the current GOP.
// Then tpl_stats_info[0] stores the information of the first frame to be
- // encoded for this GOP, i.e, the AltRef frame.
+ // encoded for this GOP, i.e., the AltRef frame.
std::vector<TplStatsInfo> tpl_stats_info;
ImageBuffer coded_frame;
diff --git a/vpx/vp8cx.h b/vpx/vp8cx.h
index c4e04084c..3c0278c84 100644
--- a/vpx/vp8cx.h
+++ b/vpx/vp8cx.h
@@ -302,7 +302,7 @@ enum vp8e_enc_control_id {
* the feature is off, i.e., no golden frame boost in CBR mode and
* average bitrate target is used.
*
- * For example, to allow 100% more bits, i.e, 2X, in a golden frame
+ * For example, to allow 100% more bits, i.e., 2X, in a golden frame
* than average frame, set this to 100.
*
* Supported in codecs: VP9
@@ -598,7 +598,7 @@ enum vp8e_enc_control_id {
* the feature is off, i.e., no golden frame boost in CBR mode and
* average bitrate target is used.
*
- * For example, to allow 100% more bits, i.e, 2X, in a golden frame
+ * For example, to allow 100% more bits, i.e., 2X, in a golden frame
* than average frame, set this to 100.
*
* Supported in codecs: VP8